diff --git a/doc/html/_sources/fix_ave_chunk.txt b/doc/html/_sources/fix_ave_chunk.txt
index 6c63d7d2d..12b1dcca1 100644
--- a/doc/html/_sources/fix_ave_chunk.txt
+++ b/doc/html/_sources/fix_ave_chunk.txt
@@ -1,496 +1,496 @@
 .. index:: fix ave/chunk
 
 fix ave/chunk command
 =====================
 
 Syntax
 """"""
 
 .. parsed-literal::
 
    fix ID group-ID ave/chunk Nevery Nrepeat Nfreq chunkID value1 value2 ... keyword args ...
 
 * ID, group-ID are documented in :doc:`fix <fix>` command
 * ave/chunk = style name of this fix command
 * Nevery = use input values every this many timesteps
 * Nrepeat = # of times to use input values for calculating averages
 * Nfreq = calculate averages every this many timesteps
 * chunkID = ID of :doc:`compute chunk/atom <compute_chunk_atom>` command
 * one or more input values can be listed
 * value = vx, vy, vz, fx, fy, fz, density/mass, density/number, temp, c_ID, c_ID[I], f_ID, f_ID[I], v_name
 .. parsed-literal::
 
      vx,vy,vz,fx,fy,fz = atom attribute (velocity, force component)
      density/number, density/mass = number or mass density
      temp = temperature
      c_ID = per-atom vector calculated by a compute with ID
      c_ID[I] = Ith column of per-atom array calculated by a compute with ID, I can include wildcard (see below)
      f_ID = per-atom vector calculated by a fix with ID
      f_ID[I] = Ith column of per-atom array calculated by a fix with ID, I can include wildcard (see below)
      v_name = per-atom vector calculated by an atom-style variable with name
 
 * zero or more keyword/arg pairs may be appended
 * keyword = *norm* or *ave* or *bias* or *adof* or *cdof* or *file* or *overwrite* or *title1* or *title2* or *title3*
 .. parsed-literal::
 
      *norm* arg = *all* or *sample* or *none* = how output on *Nfreq* steps is normalized
        all = output is sum of atoms across all *Nrepeat* samples, divided by atom count
        sample = output is sum of *Nrepeat* sample averages, divided by *Nrepeat*
        none = output is sum of *Nrepeat* sample sums, divided by *Nrepeat*
      *ave* args = *one* or *running* or *window M*
        one = output new average value every Nfreq steps
        running = output cumulative average of all previous Nfreq steps
        window M = output average of M most recent Nfreq steps
      *bias* arg = bias-ID
        bias-ID = ID of a temperature compute that removes a velocity bias for temperature calculation
      *adof* value = dof_per_atom
        dof_per_atom = define this many degrees-of-freedom per atom for temperature calculation
      *cdof* value = dof_per_chunk
        dof_per_chunk = define this many degrees-of-freedom per chunk for temperature calculation
      *file* arg = filename
        filename = file to write results to
      *overwrite* arg = none = overwrite output file with only latest output
      *format* arg = string
        string = C-style format string
      *title1* arg = string
        string = text to print as 1st line of output file
      *title2* arg = string
        string = text to print as 2nd line of output file
      *title3* arg = string
        string = text to print as 3rd line of output file
 
 
 
 Examples
 """"""""
 
 .. parsed-literal::
 
    fix 1 all ave/chunk 10000 1 10000 binchunk c_myCentro title1 "My output values"
    fix 1 flow ave/chunk 100 10 1000 molchunk vx vz norm sample file vel.profile
    fix 1 flow ave/chunk 100 5 1000 binchunk density/mass ave running
    fix 1 flow ave/chunk 100 5 1000 binchunk density/mass ave running
 
 **NOTE:**
 
 If you are trying to replace a deprectated fix ave/spatial command
 with the newer, more flexible fix ave/chunk and :doc:`compute chunk/atom <compute_chunk_atom>` commands, you simply need to split
 the fix ave/spatial arguments across the two new commands.  For
 example, this command:
 
 .. parsed-literal::
 
    fix 1 flow ave/spatial 100 10 1000 y 0.0 1.0 vx vz norm sample file vel.profile
 
 could be replaced by:
 
 .. parsed-literal::
 
    compute cc1 flow chunk/atom bin/1d y 0.0 1.0 
    fix 1 flow ave/chunk 100 10 1000 cc1 vx vz norm sample file vel.profile
 
 Description
 """""""""""
 
 Use one or more per-atom vectors as inputs every few timesteps, sum
 the values over the atoms in each chunk at each timestep, then average
 the per-chunk values over longer timescales.  The resulting chunk
 averages can be used by other :ref:`output commands <howto_15>` such as :doc:`thermo_style custom <thermo_style>`, and can also be written to a file.
 
 In LAMMPS, chunks are collections of atoms defined by a :doc:`compute chunk/atom <compute_chunk_atom>` command, which assigns each atom
 to a single chunk (or no chunk).  The ID for this command is specified
 as chunkID.  For example, a single chunk could be the atoms in a
 molecule or atoms in a spatial bin.  See the :doc:`compute chunk/atom <compute_chunk_atom>` doc page and ":ref:`Section_howto 23 <howto_23>` for details of how chunks can be
 defined and examples of how they can be used to measure properties of
 a system.
 
 Note that only atoms in the specified group contribute to the summing
 and averaging calculations.  The :doc:`compute chunk/atom <compute_chunk_atom>` command defines its own group as
 well as an optional region.  Atoms will have a chunk ID = 0, meaning
 they belong to no chunk, if they are not in that group or region.
 Thus you can specify the "all" group for this command if you simply
 want to use the chunk definitions provided by chunkID.
 
 Each specified per-atom value can be an atom attribute (position,
 velocity, force component), a mass or number density, or the result of
 a :doc:`compute <compute>` or :doc:`fix <fix>` or the evaluation of an
 atom-style :doc:`variable <variable>`.  In the latter cases, the
 compute, fix, or variable must produce a per-atom quantity, not a
 global quantity.  Note that the :doc:`compute property/atom <compute_property_atom>` command provides access to
 any attribute defined and stored by atoms.  If you wish to
 time-average global quantities from a compute, fix, or variable, then
 see the :doc:`fix ave/time <fix_ave_time>` command.
 
 The per-atom values of each input vector are summed and averaged
 independently of the per-atom values in other input vectors.
 
 :doc:`Computes <compute>` that produce per-atom quantities are those
 which have the word *atom* in their style name.  See the doc pages for
 individual :doc:`fixes <fix>` to determine which ones produce per-atom
 quantities.  :doc:`Variables <variable>` of style *atom* are the only
 ones that can be used with this fix since all other styles of variable
 produce global quantities.
 
 Note that for values from a compute or fix, the bracketed index I can
 be specified using a wildcard asterisk with the index to effectively
 specify multiple values.  This takes the form "*" or "*n" or "n*" or
 "m*n".  If N = the size of the vector (for *mode* = scalar) or the
 number of columns in the array (for *mode* = vector), then an asterisk
 with no numeric values means all indices from 1 to N.  A leading
 asterisk means all indices from 1 to n (inclusive).  A trailing
 asterisk means all indices from n to N (inclusive).  A middle asterisk
 means all indices from m to n (inclusive).
 
-Using a wildcard is the same as if the individual elements of the
-vector or columns of the array had been listed one by one.  E.g. these
-2 fix ave/chunk commands are equivalent, since the :doc:`compute property/atom <compute_property/atom>` command creates, in this
+Using a wildcard is the same as if the individual columns of the array
+had been listed one by one.  E.g. these 2 fix ave/chunk commands are
+equivalent, since the :doc:`compute property/atom <compute_property/atom>` command creates, in this
 case, a per-atom array with 3 columns:
 
 .. parsed-literal::
 
-   compute myAng all property/atom 50 angmomx angmomy angmomz
+   compute myAng all property/atom angmomx angmomy angmomz
    fix 1 all ave/chunk 100 1 100 cc1 c_myAng[*] file tmp.angmom
    fix 2 all ave/chunk 100 1 100 cc1 c_myAng[1] c_myAng[2] c_myAng[3] file tmp.angmom
 
 .. note::
 
    This fix works by creating an array of size *Nchunk* by Nvalues
    on each processor.  *Nchunk* is the number of chunks which is defined
    by the :doc:`compute chunk/atom <doc/compute_chunk_atom>` command.
    Nvalues is the number of input values specified.  Each processor loops
    over its atoms, tallying its values to the appropriate chunk.  Then
    the entire array is summed across all processors.  This means that
    using a large number of chunks will incur an overhead in memory and
    computational cost (summing across processors), so be careful to
    define a reasonable number of chunks.
 
 
 ----------
 
 
 The *Nevery*\ , *Nrepeat*\ , and *Nfreq* arguments specify on what
 timesteps the input values will be accessed and contribute to the
 average.  The final averaged quantities are generated on timesteps
 that are a multiples of *Nfreq*\ .  The average is over *Nrepeat*
 quantities, computed in the preceding portion of the simulation every
 *Nevery* timesteps.  *Nfreq* must be a multiple of *Nevery* and
 *Nevery* must be non-zero even if *Nrepeat* is 1.  Also, the timesteps
 contributing to the average value cannot overlap, i.e. Nrepeat*Nevery
 can not exceed Nfreq.
 
 For example, if Nevery=2, Nrepeat=6, and Nfreq=100, then values on
 timesteps 90,92,94,96,98,100 will be used to compute the final average
 on timestep 100.  Similarly for timesteps 190,192,194,196,198,200 on
 timestep 200, etc.  If Nrepeat=1 and Nfreq = 100, then no time
 averaging is done; values are simply generated on timesteps
 100,200,etc.
 
 Each input value can also be averaged over the atoms in each chunk.
 The way the averaging is done across the *Nrepeat* timesteps to
 produce output on the *Nfreq* timesteps, and across multiple *Nfreq*
 outputs, is determined by the *norm* and *ave* keyword settings, as
 discussed below.
 
 .. note::
 
    To perform per-chunk averaging within a *Nfreq* time window, the
    number of chunks *Nchunk* defined by the :doc:`compute chunk/atom <compute_chunk_atom>` command must remain constant.  If
    the *ave* keyword is set to *running* or *window* then *Nchunk* must
    remain constant for the duration of the simulation.  This fix forces
    the chunk/atom compute specified by chunkID to hold *Nchunk* constant
    for the appropriate time windows, by not allowing it to re-calcualte
    *Nchunk*\ , which can also affect how it assigns chunk IDs to atoms.
    More details are given on the :doc:`compute chunk/atom <compute_chunk_atom>` doc page.
 
 
 ----------
 
 
 The atom attribute values (vx,vy,vz,fx,fy,fz) are self-explanatory.
 As noted above, any other atom attributes can be used as input values
 to this fix by using the :doc:`compute property/atom <compute_property_atom>` command and then specifying
 an input value from that compute.
 
 The *density/number* value means the number density is computed for
 each chunk, i.e. number/volume.  The *density/mass* value means the
 mass density is computed for each chunk, i.e. total-mass/volume.  The
 output values are in units of 1/volume or density (mass/volume).  See
 the :doc:`units <units>` command doc page for the definition of density
 for each choice of units, e.g. gram/cm^3.  If the chunks defined by
 the :doc:`compute chunk/atom <compute_chunk_atom>` command are spatial
 bins, the volume is the bin volume.  Otherwise it is the volume of the
 entire simulation box.
 
 The *temp* value means the temperature is computed for each chunk, by
 the formula KE = DOF/2 k T, where KE = total kinetic energy of the
 chunk of atoms (sum of 1/2 m v^2), DOF = the total number of degrees
 of freedom for all atoms in the chunk, k = Boltzmann constant, and T =
 temperature.
 
 The DOF is calculated as N*adof + cdof, where N = number of atoms in
 the chunk, adof = degrees of freedom per atom, and cdof = degrees of
 freedom per chunk.  By default adof = 2 or 3 = dimensionality of
 system, as set via the :doc:`dimension <dimension>` command, and cdof =
 0.0.  This gives the usual formula for temperature.
 
 Note that currently this temperature only includes translational
 degrees of freedom for each atom.  No rotational degrees of freedom
 are included for finite-size particles.  Also no degrees of freedom
 are subtracted for any velocity bias or constraints that are applied,
 such as :doc:`compute temp/partial <compute_temp_partial>`, or :doc:`fix shake <fix_shake>` or :doc:`fix rigid <fix_rigid>`.  This is because
 those degrees of freedom (e.g. a constrained bond) could apply to sets
 of atoms that are both included and excluded from a specific chunk,
 and hence the concept is somewhat ill-defined.  In some cases, you can
 use the *adof* and *cdof* keywords to adjust the calculated degress of
 freedom appropriately, as explained below.
 
 Also note that a bias can be subtracted from atom velocities before
 they are used in the above formula for KE, by using the *bias*
 keyword.  This allows, for example, a thermal temperature to be
 computed after removal of a flow velocity profile.
 
 Note that the per-chunk temperature calculated by this fix and the
 :doc:`compute temp/chunk <compute_temp_chunk>` command can be different.
 The compute calculates the temperature for each chunk for a single
 snapshot.  This fix can do that but can also time average those values
 over many snapshots, or it can compute a temperature as if the atoms
 in the chunk on different timesteps were collected together as one set
 of atoms to calculate their temperature.  The compute allows the
 center-of-mass velocity of each chunk to be subtracted before
 calculating the temperature; this fix does not.
 
 If a value begins with "c_", a compute ID must follow which has been
 previously defined in the input script.  If no bracketed integer is
 appended, the per-atom vector calculated by the compute is used.  If a
 bracketed integer is appended, the Ith column of the per-atom array
 calculated by the compute is used.  Users can also write code for
 their own compute styles and :doc:`add them to LAMMPS <Section_modify>`.
 See the discussion above for how I can be specified with a wildcard
 asterisk to effectively specify multiple values.
 
 If a value begins with "f_", a fix ID must follow which has been
 previously defined in the input script.  If no bracketed integer is
 appended, the per-atom vector calculated by the fix is used.  If a
 bracketed integer is appended, the Ith column of the per-atom array
 calculated by the fix is used.  Note that some fixes only produce
 their values on certain timesteps, which must be compatible with
 *Nevery*\ , else an error results.  Users can also write code for their
 own fix styles and :doc:`add them to LAMMPS <Section_modify>`.  See the
 discussion above for how I can be specified with a wildcard asterisk
 to effectively specify multiple values.
 
 If a value begins with "v_", a variable name must follow which has
 been previously defined in the input script.  Variables of style
 *atom* can reference thermodynamic keywords and various per-atom
 attributes, or invoke other computes, fixes, or variables when they
 are evaluated, so this is a very general means of generating per-atom
 quantities to average within chunks.
 
 
 ----------
 
 
 Additional optional keywords also affect the operation of this fix
 and its outputs.
 
 The *norm* keyword affects how averaging is done for the per-chunk
 values that are output every *Nfreq* timesteps.
 
 It the *norm* setting is *all*\ , which is the default, a chunk value is
 summed over all atoms in all *Nrepeat* samples, as is the count of
 atoms in the chunk.  The averaged output value for the chunk on the
 *Nfreq* timesteps is Total-sum / Total-count.  In other words it is an
 average over atoms across the entire *Nfreq* timescale.
 
 If the *norm* setting is *sample*\ , the chunk value is summed over atoms
 for each sample, as is the count, and an "average sample value" is
 computed for each sample, i.e. Sample-sum / Sample-count.  The output
 value for the chunk on the *Nfreq* timesteps is the average of the
 *Nrepeat* "average sample values", i.e. the sum of *Nrepeat* "average
 sample values" divided by *Nrepeat*\ .  In other words it is an average
 of an average.
 
 If the *norm* setting is *none*\ , a similar computation as for the
 *sample* seting is done, except the individual "average sample values"
 are "summed sample values".  A summed sample value is simply the chunk
 value summed over atoms in the sample, without dividing by the number
 of atoms in the sample.  The output value for the chunk on the
 *Nfreq* timesteps is the average of the *Nrepeat* "summed sample
 values", i.e. the sum of *Nrepeat* "summed sample values" divided by
 *Nrepeat*\ .
 
 The *ave* keyword determines how the per-chunk values produced every
 *Nfreq* steps are averaged with values produced on previous steps that
 were multiples of *Nfreq*\ , before they are accessed by another output
 command or written to a file.
 
 If the *ave* setting is *one*\ , which is the default, then the chunk
 values produced on timesteps that are multiples of *Nfreq* are
 independent of each other; they are output as-is without further
 averaging.
 
 If the *ave* setting is *running*\ , then the chunk values produced on
 timesteps that are multiples of *Nfreq* are summed and averaged in a
 cumulative sense before being output.  Each output chunk value is thus
 the average of the chunk value produced on that timestep with all
 preceding values for the same chunk.  This running average begins when
 the fix is defined; it can only be restarted by deleting the fix via
 the :doc:`unfix <unfix>` command, or re-defining the fix by
 re-specifying it.
 
 If the *ave* setting is *window*\ , then the chunk values produced on
 timesteps that are multiples of *Nfreq* are summed and averaged within
 a moving "window" of time, so that the last M values for the same
 chunk are used to produce the output.  E.g. if M = 3 and Nfreq = 1000,
 then the output on step 10000 will be the average of the individual
 chunk values on steps 8000,9000,10000.  Outputs on early steps will
 average over less than M values if they are not available.
 
 The *bias* keyword specifies the ID of a temperature compute that
 removes a "bias" velocity from each atom, specified as *bias-ID*\ .  It
 is only used when the *temp* value is calculated, to compute the
 thermal temperature of each chunk after the translational kinetic
 energy components have been altered in a prescribed way, e.g.  to
 remove a flow velocity profile.  See the doc pages for individual
 computes that calculate a temperature to see which ones implement a
 bias.
 
 The *adof* and *cdof* keywords define the values used in the degree of
 freedom (DOF) formula described above for for temperature calculation
 for each chunk.  They are only used when the *temp* value is
 calculated.  They can be used to calculate a more appropriate
 temperature for some kinds of chunks.  Here are 3 examples:
 
 If spatially binned chunks contain some number of water molecules and
 :doc:`fix shake <fix_shake>` is used to make each molecule rigid, then
 you could calculate a temperature with 6 degrees of freedom (DOF) (3
 translational, 3 rotational) per molecule by setting *adof* to 2.0.
 
 If :doc:`compute temp/partial <compute_temp_partial>` is used with the
 *bias* keyword to only allow the x component of velocity to contribute
 to the temperature, then *adof* = 1.0 would be appropriate.
 
 If each chunk consists of a large molecule, with some number of its
 bonds constrained by :doc:`fix shake <fix_shake>` or the entire molecule
 by :doc:`fix rigid/small <fix_rigid>`, *adof* = 0.0 and *cdof* could be
 set to the remaining degrees of freedom for the entire molecule
 (entire chunk in this case), e.g. 6 for 3d, or 3 for 2d, for a rigid
 molecule.
 
 The *file* keyword allows a filename to be specified.  Every *Nfreq*
 timesteps, a section of chunk info will be written to a text file in
 the following format.  A line with the timestep and number of chunks
 is written.  Then one line per chunk is written, containing the chunk
 ID (1-Nchunk), an optional original ID value, optional coordinate
 values for chunks that represent spatial bins, the number of atoms in
 the chunk, and one or more calculated values.  More explanation of the
 optional values is given below.  The number of values in each line
 corresponds to the number of values specified in the fix ave/chunk
 command.  The number of atoms and the value(s) are summed or average
 quantities, as explained above.
 
 The *overwrite* keyword will continuously overwrite the output file
 with the latest output, so that it only contains one timestep worth of
 output.  This option can only be used with the *ave running* setting.
 
 The *format* keyword sets the numeric format of each value when it is
 printed to a file via the *file* keyword.  Note that all values are
 floating point quantities.  The default format is %g.  You can specify
 a higher precision if desired, e.g. %20.16g.
 
 The *title1* and *title2* and *title3* keywords allow specification of
 the strings that will be printed as the first 3 lines of the output
 file, assuming the *file* keyword was used.  LAMMPS uses default
 values for each of these, so they do not need to be specified.
 
 By default, these header lines are as follows:
 
 .. parsed-literal::
 
    # Chunk-averaged data for fix ID and group name
    # Timestep Number-of-chunks
    # Chunk (OrigID) (Coord1) (Coord2) (Coord3) Ncount value1 value2 ...
 
 In the first line, ID and name are replaced with the fix-ID and group
 name.  The second line describes the two values that are printed at
 the first of each section of output.  In the third line the values are
 replaced with the appropriate value names, e.g. fx or c_myCompute\ **2**\ .
 
 The words in parenthesis only appear with corresponding columns if the
 chunk style specified for the :doc:`compute chunk/atom <compute_chunk_atom>` command supports them.  The OrigID
 column is only used if the *compress* keyword was set to *yes* for the
 :doc:`compute chunk/atom <compute_chunk_atom>` command.  This means that
 the original chunk IDs (e.g. molecule IDs) will have been compressed
 to remove chunk IDs with no atoms assigned to them.  Thus a compresed
 chunk ID of 3 may correspond to an original chunk ID or molecule ID of
 415.  The OrigID column will list 415 for the 3rd chunk.
 
 The CoordN columns only appear if a *binning* style was used in the
 :doc:`compute chunk/atom <compute_chunk_atom>` command.  For *bin/1d*\ ,
 *bin/2d*\ , and *bin/3d* styles the column values are the center point
 of the bin in the corresponding dimension.  Just Coord1 is used for
 *bin/1d*\ , Coord2 is added for *bin/2d*\ , Coord3 is added for *bin/3d*\ .
 For *bin/sphere*\ , just Coord1 is used, and it is the radial
 coordinate.  For *bin/cylinder*\ , Coord1 and Coord2 are used.  Coord1
 is the radial coordinate (away from the cylinder axis), and coord2 is
 the coordinate along the cylinder axis.
 
 Note that if the value of the *units* keyword used in the :doc:`compute chunk/atom command <compute_chunk_atom>` is *box* or *lattice*\ , the
 coordinate values will be in distance :doc:`units <units>`.  If the
 value of the *units* keyword is *reduced*\ , the coordinate values will
 be in unitless reduced units (0-1).  This is not true for the Coord1 value
 of style *bin/sphere* or *bin/cylinder* which both represent radial
 dimensions.  Those values are always in distance :doc:`units <units>`.
 
 
 ----------
 
 
 Restart, fix_modify, output, run start/stop, minimize info
 """"""""""""""""""""""""""""""""""""""""""""""""""""""""""
 
 No information about this fix is written to :doc:`binary restart files <restart>`.  None of the :doc:`fix_modify <fix_modify>` options
 are relevant to this fix.
 
 This fix computes a global array of values which can be accessed by
 various :ref:`output commands <howto_15>`.  The values can
 only be accessed on timesteps that are multiples of *Nfreq* since that
 is when averaging is performed.  The global array has # of rows =
 the number of chunks *Nchunk* as calculated by the specified :doc:`compute chunk/atom <compute_chunk_atom>` command.  The # of columns =
 M+1+Nvalues, where M = 1 to 4, depending on whether the optional
 columns for OrigID and CoordN are used, as explained above.
 Following the optional columns, the next column contains the count of
 atoms in the chunk, and the remaining columns are the Nvalue
 quantities.  When the array is accessed with a row I that exceeds the
 current number of chunks, than a 0.0 is returned by the fix instead of
 an error, since the number of chunks can vary as a simulation runs
 depending on how that value is computed by the compute chunk/atom
 command.
 
 The array values calculated by this fix are treated as "intensive",
 since they are typically already normalized by the count of atoms in
 each chunk.
 
 No parameter of this fix can be used with the *start/stop* keywords of
 the :doc:`run <run>` command.  This fix is not invoked during :doc:`energy minimization <minimize>`.
 
 Restrictions
 """"""""""""
  none
 
 Related commands
 """"""""""""""""
 
 :doc:`compute <compute>`, :doc:`fix ave/atom <fix_ave_atom>`, :doc:`fix ave/histo <fix_ave_histo>`, :doc:`fix ave/time <fix_ave_time>`,
 :doc:`variable <variable>`, :doc:`fix ave/correlate <fix_ave_correlate>`
 
 Default
 """""""
 
 The option defaults are norm = all, ave = one, bias = none, no file output, and
 title 1,2,3 = strings as described above.
 
 
 .. _lws: http://lammps.sandia.gov
 .. _ld: Manual.html
 .. _lc: Section_commands.html#comm
diff --git a/doc/html/fix_ave_chunk.html b/doc/html/fix_ave_chunk.html
index 69b4b9a5e..e7bfd3183 100644
--- a/doc/html/fix_ave_chunk.html
+++ b/doc/html/fix_ave_chunk.html
@@ -1,610 +1,610 @@
 
 
 <!DOCTYPE html>
 <!--[if IE 8]><html class="no-js lt-ie9" lang="en" > <![endif]-->
 <!--[if gt IE 8]><!--> <html class="no-js" lang="en" > <!--<![endif]-->
 <head>
   <meta charset="utf-8">
   
   <meta name="viewport" content="width=device-width, initial-scale=1.0">
   
   <title>fix ave/chunk command &mdash; LAMMPS documentation</title>
   
 
   
   
 
   
 
   
   
     
 
   
 
   
   
     <link rel="stylesheet" href="_static/css/theme.css" type="text/css" />
   
 
   
     <link rel="stylesheet" href="_static/sphinxcontrib-images/LightBox2/lightbox2/css/lightbox.css" type="text/css" />
   
 
   
     <link rel="top" title="LAMMPS documentation" href="index.html"/> 
 
   
   <script src="_static/js/modernizr.min.js"></script>
 
 </head>
 
 <body class="wy-body-for-nav" role="document">
 
   <div class="wy-grid-for-nav">
 
     
     <nav data-toggle="wy-nav-shift" class="wy-nav-side">
       <div class="wy-side-nav-search">
         
 
         
           <a href="Manual.html" class="icon icon-home"> LAMMPS
         
 
         
         </a>
 
         
 <div role="search">
   <form id="rtd-search-form" class="wy-form" action="search.html" method="get">
     <input type="text" name="q" placeholder="Search docs" />
     <input type="hidden" name="check_keywords" value="yes" />
     <input type="hidden" name="area" value="default" />
   </form>
 </div>
 
         
       </div>
 
       <div class="wy-menu wy-menu-vertical" data-spy="affix" role="navigation" aria-label="main navigation">
         
           
           
               <ul>
 <li class="toctree-l1"><a class="reference internal" href="Section_intro.html">1. Introduction</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_start.html">2. Getting Started</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_commands.html">3. Commands</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_packages.html">4. Packages</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_accelerate.html">5. Accelerating LAMMPS performance</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_howto.html">6. How-to discussions</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_example.html">7. Example problems</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_perf.html">8. Performance &amp; scalability</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_tools.html">9. Additional tools</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_modify.html">10. Modifying &amp; extending LAMMPS</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_python.html">11. Python interface to LAMMPS</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_errors.html">12. Errors</a></li>
 <li class="toctree-l1"><a class="reference internal" href="Section_history.html">13. Future and history</a></li>
 </ul>
 
           
         
       </div>
       &nbsp;
     </nav>
 
     <section data-toggle="wy-nav-shift" class="wy-nav-content-wrap">
 
       
       <nav class="wy-nav-top" role="navigation" aria-label="top navigation">
         <i data-toggle="wy-nav-top" class="fa fa-bars"></i>
         <a href="Manual.html">LAMMPS</a>
       </nav>
 
 
       
       <div class="wy-nav-content">
         <div class="rst-content">
           <div role="navigation" aria-label="breadcrumbs navigation">
   <ul class="wy-breadcrumbs">
     <li><a href="Manual.html">Docs</a> &raquo;</li>
       
     <li>fix ave/chunk command</li>
       <li class="wy-breadcrumbs-aside">
         
           
             <a href="http://lammps.sandia.gov">Website</a>
             <a href="Section_commands.html#comm">Commands</a>
         
       </li>
   </ul>
   <hr/>
   
 </div>
           <div role="main" class="document" itemscope="itemscope" itemtype="http://schema.org/Article">
            <div itemprop="articleBody">
             
   <div class="section" id="fix-ave-chunk-command">
 <span id="index-0"></span><h1>fix ave/chunk command</h1>
 <div class="section" id="syntax">
 <h2>Syntax</h2>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">fix</span> <span class="n">ID</span> <span class="n">group</span><span class="o">-</span><span class="n">ID</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="n">Nevery</span> <span class="n">Nrepeat</span> <span class="n">Nfreq</span> <span class="n">chunkID</span> <span class="n">value1</span> <span class="n">value2</span> <span class="o">...</span> <span class="n">keyword</span> <span class="n">args</span> <span class="o">...</span>
 </pre></div>
 </div>
 <ul class="simple">
 <li>ID, group-ID are documented in <a class="reference internal" href="fix.html"><span class="doc">fix</span></a> command</li>
 <li>ave/chunk = style name of this fix command</li>
 <li>Nevery = use input values every this many timesteps</li>
 <li>Nrepeat = # of times to use input values for calculating averages</li>
 <li>Nfreq = calculate averages every this many timesteps</li>
 <li>chunkID = ID of <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command</li>
 <li>one or more input values can be listed</li>
 <li>value = vx, vy, vz, fx, fy, fz, density/mass, density/number, temp, c_ID, c_ID[I], f_ID, f_ID[I], v_name</li>
 </ul>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">vx</span><span class="p">,</span><span class="n">vy</span><span class="p">,</span><span class="n">vz</span><span class="p">,</span><span class="n">fx</span><span class="p">,</span><span class="n">fy</span><span class="p">,</span><span class="n">fz</span> <span class="o">=</span> <span class="n">atom</span> <span class="n">attribute</span> <span class="p">(</span><span class="n">velocity</span><span class="p">,</span> <span class="n">force</span> <span class="n">component</span><span class="p">)</span>
 <span class="n">density</span><span class="o">/</span><span class="n">number</span><span class="p">,</span> <span class="n">density</span><span class="o">/</span><span class="n">mass</span> <span class="o">=</span> <span class="n">number</span> <span class="ow">or</span> <span class="n">mass</span> <span class="n">density</span>
 <span class="n">temp</span> <span class="o">=</span> <span class="n">temperature</span>
 <span class="n">c_ID</span> <span class="o">=</span> <span class="n">per</span><span class="o">-</span><span class="n">atom</span> <span class="n">vector</span> <span class="n">calculated</span> <span class="n">by</span> <span class="n">a</span> <span class="n">compute</span> <span class="k">with</span> <span class="n">ID</span>
 <span class="n">c_ID</span><span class="p">[</span><span class="n">I</span><span class="p">]</span> <span class="o">=</span> <span class="n">Ith</span> <span class="n">column</span> <span class="n">of</span> <span class="n">per</span><span class="o">-</span><span class="n">atom</span> <span class="n">array</span> <span class="n">calculated</span> <span class="n">by</span> <span class="n">a</span> <span class="n">compute</span> <span class="k">with</span> <span class="n">ID</span><span class="p">,</span> <span class="n">I</span> <span class="n">can</span> <span class="n">include</span> <span class="n">wildcard</span> <span class="p">(</span><span class="n">see</span> <span class="n">below</span><span class="p">)</span>
 <span class="n">f_ID</span> <span class="o">=</span> <span class="n">per</span><span class="o">-</span><span class="n">atom</span> <span class="n">vector</span> <span class="n">calculated</span> <span class="n">by</span> <span class="n">a</span> <span class="n">fix</span> <span class="k">with</span> <span class="n">ID</span>
 <span class="n">f_ID</span><span class="p">[</span><span class="n">I</span><span class="p">]</span> <span class="o">=</span> <span class="n">Ith</span> <span class="n">column</span> <span class="n">of</span> <span class="n">per</span><span class="o">-</span><span class="n">atom</span> <span class="n">array</span> <span class="n">calculated</span> <span class="n">by</span> <span class="n">a</span> <span class="n">fix</span> <span class="k">with</span> <span class="n">ID</span><span class="p">,</span> <span class="n">I</span> <span class="n">can</span> <span class="n">include</span> <span class="n">wildcard</span> <span class="p">(</span><span class="n">see</span> <span class="n">below</span><span class="p">)</span>
 <span class="n">v_name</span> <span class="o">=</span> <span class="n">per</span><span class="o">-</span><span class="n">atom</span> <span class="n">vector</span> <span class="n">calculated</span> <span class="n">by</span> <span class="n">an</span> <span class="n">atom</span><span class="o">-</span><span class="n">style</span> <span class="n">variable</span> <span class="k">with</span> <span class="n">name</span>
 </pre></div>
 </div>
 <ul class="simple">
 <li>zero or more keyword/arg pairs may be appended</li>
 <li>keyword = <em>norm</em> or <em>ave</em> or <em>bias</em> or <em>adof</em> or <em>cdof</em> or <em>file</em> or <em>overwrite</em> or <em>title1</em> or <em>title2</em> or <em>title3</em></li>
 </ul>
 <pre class="literal-block">
 <em>norm</em> arg = <em>all</em> or <em>sample</em> or <em>none</em> = how output on <em>Nfreq</em> steps is normalized
   all = output is sum of atoms across all <em>Nrepeat</em> samples, divided by atom count
   sample = output is sum of <em>Nrepeat</em> sample averages, divided by <em>Nrepeat</em>
   none = output is sum of <em>Nrepeat</em> sample sums, divided by <em>Nrepeat</em>
 <em>ave</em> args = <em>one</em> or <em>running</em> or <em>window M</em>
   one = output new average value every Nfreq steps
   running = output cumulative average of all previous Nfreq steps
   window M = output average of M most recent Nfreq steps
 <em>bias</em> arg = bias-ID
   bias-ID = ID of a temperature compute that removes a velocity bias for temperature calculation
 <em>adof</em> value = dof_per_atom
   dof_per_atom = define this many degrees-of-freedom per atom for temperature calculation
 <em>cdof</em> value = dof_per_chunk
   dof_per_chunk = define this many degrees-of-freedom per chunk for temperature calculation
 <em>file</em> arg = filename
   filename = file to write results to
 <em>overwrite</em> arg = none = overwrite output file with only latest output
 <em>format</em> arg = string
   string = C-style format string
 <em>title1</em> arg = string
   string = text to print as 1st line of output file
 <em>title2</em> arg = string
   string = text to print as 2nd line of output file
 <em>title3</em> arg = string
   string = text to print as 3rd line of output file
 </pre>
 </div>
 <div class="section" id="examples">
 <h2>Examples</h2>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">fix</span> <span class="mi">1</span> <span class="nb">all</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">10000</span> <span class="mi">1</span> <span class="mi">10000</span> <span class="n">binchunk</span> <span class="n">c_myCentro</span> <span class="n">title1</span> <span class="s2">&quot;My output values&quot;</span>
 <span class="n">fix</span> <span class="mi">1</span> <span class="n">flow</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">100</span> <span class="mi">10</span> <span class="mi">1000</span> <span class="n">molchunk</span> <span class="n">vx</span> <span class="n">vz</span> <span class="n">norm</span> <span class="n">sample</span> <span class="n">file</span> <span class="n">vel</span><span class="o">.</span><span class="n">profile</span>
 <span class="n">fix</span> <span class="mi">1</span> <span class="n">flow</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">100</span> <span class="mi">5</span> <span class="mi">1000</span> <span class="n">binchunk</span> <span class="n">density</span><span class="o">/</span><span class="n">mass</span> <span class="n">ave</span> <span class="n">running</span>
 <span class="n">fix</span> <span class="mi">1</span> <span class="n">flow</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">100</span> <span class="mi">5</span> <span class="mi">1000</span> <span class="n">binchunk</span> <span class="n">density</span><span class="o">/</span><span class="n">mass</span> <span class="n">ave</span> <span class="n">running</span>
 </pre></div>
 </div>
 <p><strong>NOTE:</strong></p>
 <p>If you are trying to replace a deprectated fix ave/spatial command
 with the newer, more flexible fix ave/chunk and <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> commands, you simply need to split
 the fix ave/spatial arguments across the two new commands.  For
 example, this command:</p>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">fix</span> <span class="mi">1</span> <span class="n">flow</span> <span class="n">ave</span><span class="o">/</span><span class="n">spatial</span> <span class="mi">100</span> <span class="mi">10</span> <span class="mi">1000</span> <span class="n">y</span> <span class="mf">0.0</span> <span class="mf">1.0</span> <span class="n">vx</span> <span class="n">vz</span> <span class="n">norm</span> <span class="n">sample</span> <span class="n">file</span> <span class="n">vel</span><span class="o">.</span><span class="n">profile</span>
 </pre></div>
 </div>
 <p>could be replaced by:</p>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">compute</span> <span class="n">cc1</span> <span class="n">flow</span> <span class="n">chunk</span><span class="o">/</span><span class="n">atom</span> <span class="nb">bin</span><span class="o">/</span><span class="mi">1</span><span class="n">d</span> <span class="n">y</span> <span class="mf">0.0</span> <span class="mf">1.0</span>
 <span class="n">fix</span> <span class="mi">1</span> <span class="n">flow</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">100</span> <span class="mi">10</span> <span class="mi">1000</span> <span class="n">cc1</span> <span class="n">vx</span> <span class="n">vz</span> <span class="n">norm</span> <span class="n">sample</span> <span class="n">file</span> <span class="n">vel</span><span class="o">.</span><span class="n">profile</span>
 </pre></div>
 </div>
 </div>
 <div class="section" id="description">
 <h2>Description</h2>
 <p>Use one or more per-atom vectors as inputs every few timesteps, sum
 the values over the atoms in each chunk at each timestep, then average
 the per-chunk values over longer timescales.  The resulting chunk
 averages can be used by other <a class="reference internal" href="Section_howto.html#howto-15"><span class="std std-ref">output commands</span></a> such as <a class="reference internal" href="thermo_style.html"><span class="doc">thermo_style custom</span></a>, and can also be written to a file.</p>
 <p>In LAMMPS, chunks are collections of atoms defined by a <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command, which assigns each atom
 to a single chunk (or no chunk).  The ID for this command is specified
 as chunkID.  For example, a single chunk could be the atoms in a
 molecule or atoms in a spatial bin.  See the <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> doc page and &#8220;<a class="reference internal" href="Section_howto.html#howto-23"><span class="std std-ref">Section_howto 23</span></a> for details of how chunks can be
 defined and examples of how they can be used to measure properties of
 a system.</p>
 <p>Note that only atoms in the specified group contribute to the summing
 and averaging calculations.  The <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command defines its own group as
 well as an optional region.  Atoms will have a chunk ID = 0, meaning
 they belong to no chunk, if they are not in that group or region.
 Thus you can specify the &#8220;all&#8221; group for this command if you simply
 want to use the chunk definitions provided by chunkID.</p>
 <p>Each specified per-atom value can be an atom attribute (position,
 velocity, force component), a mass or number density, or the result of
 a <a class="reference internal" href="compute.html"><span class="doc">compute</span></a> or <a class="reference internal" href="fix.html"><span class="doc">fix</span></a> or the evaluation of an
 atom-style <a class="reference internal" href="variable.html"><span class="doc">variable</span></a>.  In the latter cases, the
 compute, fix, or variable must produce a per-atom quantity, not a
 global quantity.  Note that the <a class="reference internal" href="compute_property_atom.html"><span class="doc">compute property/atom</span></a> command provides access to
 any attribute defined and stored by atoms.  If you wish to
 time-average global quantities from a compute, fix, or variable, then
 see the <a class="reference internal" href="fix_ave_time.html"><span class="doc">fix ave/time</span></a> command.</p>
 <p>The per-atom values of each input vector are summed and averaged
 independently of the per-atom values in other input vectors.</p>
 <p><a class="reference internal" href="compute.html"><span class="doc">Computes</span></a> that produce per-atom quantities are those
 which have the word <em>atom</em> in their style name.  See the doc pages for
 individual <a class="reference internal" href="fix.html"><span class="doc">fixes</span></a> to determine which ones produce per-atom
 quantities.  <a class="reference internal" href="variable.html"><span class="doc">Variables</span></a> of style <em>atom</em> are the only
 ones that can be used with this fix since all other styles of variable
 produce global quantities.</p>
 <p>Note that for values from a compute or fix, the bracketed index I can
 be specified using a wildcard asterisk with the index to effectively
 specify multiple values.  This takes the form &#8220;*&#8221; or &#8220;<em>n&#8221; or &#8220;n</em>&#8221; or
 &#8220;m*n&#8221;.  If N = the size of the vector (for <em>mode</em> = scalar) or the
 number of columns in the array (for <em>mode</em> = vector), then an asterisk
 with no numeric values means all indices from 1 to N.  A leading
 asterisk means all indices from 1 to n (inclusive).  A trailing
 asterisk means all indices from n to N (inclusive).  A middle asterisk
 means all indices from m to n (inclusive).</p>
-<p>Using a wildcard is the same as if the individual elements of the
-vector or columns of the array had been listed one by one.  E.g. these
-2 fix ave/chunk commands are equivalent, since the <span class="xref doc">compute property/atom</span> command creates, in this
+<p>Using a wildcard is the same as if the individual columns of the array
+had been listed one by one.  E.g. these 2 fix ave/chunk commands are
+equivalent, since the <span class="xref doc">compute property/atom</span> command creates, in this
 case, a per-atom array with 3 columns:</p>
-<div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">compute</span> <span class="n">myAng</span> <span class="nb">all</span> <span class="nb">property</span><span class="o">/</span><span class="n">atom</span> <span class="mi">50</span> <span class="n">angmomx</span> <span class="n">angmomy</span> <span class="n">angmomz</span>
+<div class="highlight-default"><div class="highlight"><pre><span></span><span class="n">compute</span> <span class="n">myAng</span> <span class="nb">all</span> <span class="nb">property</span><span class="o">/</span><span class="n">atom</span> <span class="n">angmomx</span> <span class="n">angmomy</span> <span class="n">angmomz</span>
 <span class="n">fix</span> <span class="mi">1</span> <span class="nb">all</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">100</span> <span class="mi">1</span> <span class="mi">100</span> <span class="n">cc1</span> <span class="n">c_myAng</span><span class="p">[</span><span class="o">*</span><span class="p">]</span> <span class="n">file</span> <span class="n">tmp</span><span class="o">.</span><span class="n">angmom</span>
 <span class="n">fix</span> <span class="mi">2</span> <span class="nb">all</span> <span class="n">ave</span><span class="o">/</span><span class="n">chunk</span> <span class="mi">100</span> <span class="mi">1</span> <span class="mi">100</span> <span class="n">cc1</span> <span class="n">c_myAng</span><span class="p">[</span><span class="mi">1</span><span class="p">]</span> <span class="n">c_myAng</span><span class="p">[</span><span class="mi">2</span><span class="p">]</span> <span class="n">c_myAng</span><span class="p">[</span><span class="mi">3</span><span class="p">]</span> <span class="n">file</span> <span class="n">tmp</span><span class="o">.</span><span class="n">angmom</span>
 </pre></div>
 </div>
 <div class="admonition note">
 <p class="first admonition-title">Note</p>
 <p class="last">This fix works by creating an array of size <em>Nchunk</em> by Nvalues
 on each processor.  <em>Nchunk</em> is the number of chunks which is defined
 by the <span class="xref doc">compute chunk/atom</span> command.
 Nvalues is the number of input values specified.  Each processor loops
 over its atoms, tallying its values to the appropriate chunk.  Then
 the entire array is summed across all processors.  This means that
 using a large number of chunks will incur an overhead in memory and
 computational cost (summing across processors), so be careful to
 define a reasonable number of chunks.</p>
 </div>
 <hr class="docutils" />
 <p>The <em>Nevery</em>, <em>Nrepeat</em>, and <em>Nfreq</em> arguments specify on what
 timesteps the input values will be accessed and contribute to the
 average.  The final averaged quantities are generated on timesteps
 that are a multiples of <em>Nfreq</em>.  The average is over <em>Nrepeat</em>
 quantities, computed in the preceding portion of the simulation every
 <em>Nevery</em> timesteps.  <em>Nfreq</em> must be a multiple of <em>Nevery</em> and
 <em>Nevery</em> must be non-zero even if <em>Nrepeat</em> is 1.  Also, the timesteps
 contributing to the average value cannot overlap, i.e. Nrepeat*Nevery
 can not exceed Nfreq.</p>
 <p>For example, if Nevery=2, Nrepeat=6, and Nfreq=100, then values on
 timesteps 90,92,94,96,98,100 will be used to compute the final average
 on timestep 100.  Similarly for timesteps 190,192,194,196,198,200 on
 timestep 200, etc.  If Nrepeat=1 and Nfreq = 100, then no time
 averaging is done; values are simply generated on timesteps
 100,200,etc.</p>
 <p>Each input value can also be averaged over the atoms in each chunk.
 The way the averaging is done across the <em>Nrepeat</em> timesteps to
 produce output on the <em>Nfreq</em> timesteps, and across multiple <em>Nfreq</em>
 outputs, is determined by the <em>norm</em> and <em>ave</em> keyword settings, as
 discussed below.</p>
 <div class="admonition note">
 <p class="first admonition-title">Note</p>
 <p class="last">To perform per-chunk averaging within a <em>Nfreq</em> time window, the
 number of chunks <em>Nchunk</em> defined by the <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command must remain constant.  If
 the <em>ave</em> keyword is set to <em>running</em> or <em>window</em> then <em>Nchunk</em> must
 remain constant for the duration of the simulation.  This fix forces
 the chunk/atom compute specified by chunkID to hold <em>Nchunk</em> constant
 for the appropriate time windows, by not allowing it to re-calcualte
 <em>Nchunk</em>, which can also affect how it assigns chunk IDs to atoms.
 More details are given on the <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> doc page.</p>
 </div>
 <hr class="docutils" />
 <p>The atom attribute values (vx,vy,vz,fx,fy,fz) are self-explanatory.
 As noted above, any other atom attributes can be used as input values
 to this fix by using the <a class="reference internal" href="compute_property_atom.html"><span class="doc">compute property/atom</span></a> command and then specifying
 an input value from that compute.</p>
 <p>The <em>density/number</em> value means the number density is computed for
 each chunk, i.e. number/volume.  The <em>density/mass</em> value means the
 mass density is computed for each chunk, i.e. total-mass/volume.  The
 output values are in units of 1/volume or density (mass/volume).  See
 the <a class="reference internal" href="units.html"><span class="doc">units</span></a> command doc page for the definition of density
 for each choice of units, e.g. gram/cm^3.  If the chunks defined by
 the <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command are spatial
 bins, the volume is the bin volume.  Otherwise it is the volume of the
 entire simulation box.</p>
 <p>The <em>temp</em> value means the temperature is computed for each chunk, by
 the formula KE = DOF/2 k T, where KE = total kinetic energy of the
 chunk of atoms (sum of 1/2 m v^2), DOF = the total number of degrees
 of freedom for all atoms in the chunk, k = Boltzmann constant, and T =
 temperature.</p>
 <p>The DOF is calculated as N*adof + cdof, where N = number of atoms in
 the chunk, adof = degrees of freedom per atom, and cdof = degrees of
 freedom per chunk.  By default adof = 2 or 3 = dimensionality of
 system, as set via the <a class="reference internal" href="dimension.html"><span class="doc">dimension</span></a> command, and cdof =
 0.0.  This gives the usual formula for temperature.</p>
 <p>Note that currently this temperature only includes translational
 degrees of freedom for each atom.  No rotational degrees of freedom
 are included for finite-size particles.  Also no degrees of freedom
 are subtracted for any velocity bias or constraints that are applied,
 such as <a class="reference internal" href="compute_temp_partial.html"><span class="doc">compute temp/partial</span></a>, or <a class="reference internal" href="fix_shake.html"><span class="doc">fix shake</span></a> or <a class="reference internal" href="fix_rigid.html"><span class="doc">fix rigid</span></a>.  This is because
 those degrees of freedom (e.g. a constrained bond) could apply to sets
 of atoms that are both included and excluded from a specific chunk,
 and hence the concept is somewhat ill-defined.  In some cases, you can
 use the <em>adof</em> and <em>cdof</em> keywords to adjust the calculated degress of
 freedom appropriately, as explained below.</p>
 <p>Also note that a bias can be subtracted from atom velocities before
 they are used in the above formula for KE, by using the <em>bias</em>
 keyword.  This allows, for example, a thermal temperature to be
 computed after removal of a flow velocity profile.</p>
 <p>Note that the per-chunk temperature calculated by this fix and the
 <a class="reference internal" href="compute_temp_chunk.html"><span class="doc">compute temp/chunk</span></a> command can be different.
 The compute calculates the temperature for each chunk for a single
 snapshot.  This fix can do that but can also time average those values
 over many snapshots, or it can compute a temperature as if the atoms
 in the chunk on different timesteps were collected together as one set
 of atoms to calculate their temperature.  The compute allows the
 center-of-mass velocity of each chunk to be subtracted before
 calculating the temperature; this fix does not.</p>
 <p>If a value begins with &#8220;<a href="#id1"><span class="problematic" id="id2">c_</span></a>&#8221;, a compute ID must follow which has been
 previously defined in the input script.  If no bracketed integer is
 appended, the per-atom vector calculated by the compute is used.  If a
 bracketed integer is appended, the Ith column of the per-atom array
 calculated by the compute is used.  Users can also write code for
 their own compute styles and <a class="reference internal" href="Section_modify.html"><span class="doc">add them to LAMMPS</span></a>.
 See the discussion above for how I can be specified with a wildcard
 asterisk to effectively specify multiple values.</p>
 <p>If a value begins with &#8220;<a href="#id3"><span class="problematic" id="id4">f_</span></a>&#8221;, a fix ID must follow which has been
 previously defined in the input script.  If no bracketed integer is
 appended, the per-atom vector calculated by the fix is used.  If a
 bracketed integer is appended, the Ith column of the per-atom array
 calculated by the fix is used.  Note that some fixes only produce
 their values on certain timesteps, which must be compatible with
 <em>Nevery</em>, else an error results.  Users can also write code for their
 own fix styles and <a class="reference internal" href="Section_modify.html"><span class="doc">add them to LAMMPS</span></a>.  See the
 discussion above for how I can be specified with a wildcard asterisk
 to effectively specify multiple values.</p>
 <p>If a value begins with &#8220;<a href="#id5"><span class="problematic" id="id6">v_</span></a>&#8221;, a variable name must follow which has
 been previously defined in the input script.  Variables of style
 <em>atom</em> can reference thermodynamic keywords and various per-atom
 attributes, or invoke other computes, fixes, or variables when they
 are evaluated, so this is a very general means of generating per-atom
 quantities to average within chunks.</p>
 <hr class="docutils" />
 <p>Additional optional keywords also affect the operation of this fix
 and its outputs.</p>
 <p>The <em>norm</em> keyword affects how averaging is done for the per-chunk
 values that are output every <em>Nfreq</em> timesteps.</p>
 <p>It the <em>norm</em> setting is <em>all</em>, which is the default, a chunk value is
 summed over all atoms in all <em>Nrepeat</em> samples, as is the count of
 atoms in the chunk.  The averaged output value for the chunk on the
 <em>Nfreq</em> timesteps is Total-sum / Total-count.  In other words it is an
 average over atoms across the entire <em>Nfreq</em> timescale.</p>
 <p>If the <em>norm</em> setting is <em>sample</em>, the chunk value is summed over atoms
 for each sample, as is the count, and an &#8220;average sample value&#8221; is
 computed for each sample, i.e. Sample-sum / Sample-count.  The output
 value for the chunk on the <em>Nfreq</em> timesteps is the average of the
 <em>Nrepeat</em> &#8220;average sample values&#8221;, i.e. the sum of <em>Nrepeat</em> &#8220;average
 sample values&#8221; divided by <em>Nrepeat</em>.  In other words it is an average
 of an average.</p>
 <p>If the <em>norm</em> setting is <em>none</em>, a similar computation as for the
 <em>sample</em> seting is done, except the individual &#8220;average sample values&#8221;
 are &#8220;summed sample values&#8221;.  A summed sample value is simply the chunk
 value summed over atoms in the sample, without dividing by the number
 of atoms in the sample.  The output value for the chunk on the
 <em>Nfreq</em> timesteps is the average of the <em>Nrepeat</em> &#8220;summed sample
 values&#8221;, i.e. the sum of <em>Nrepeat</em> &#8220;summed sample values&#8221; divided by
 <em>Nrepeat</em>.</p>
 <p>The <em>ave</em> keyword determines how the per-chunk values produced every
 <em>Nfreq</em> steps are averaged with values produced on previous steps that
 were multiples of <em>Nfreq</em>, before they are accessed by another output
 command or written to a file.</p>
 <p>If the <em>ave</em> setting is <em>one</em>, which is the default, then the chunk
 values produced on timesteps that are multiples of <em>Nfreq</em> are
 independent of each other; they are output as-is without further
 averaging.</p>
 <p>If the <em>ave</em> setting is <em>running</em>, then the chunk values produced on
 timesteps that are multiples of <em>Nfreq</em> are summed and averaged in a
 cumulative sense before being output.  Each output chunk value is thus
 the average of the chunk value produced on that timestep with all
 preceding values for the same chunk.  This running average begins when
 the fix is defined; it can only be restarted by deleting the fix via
 the <a class="reference internal" href="unfix.html"><span class="doc">unfix</span></a> command, or re-defining the fix by
 re-specifying it.</p>
 <p>If the <em>ave</em> setting is <em>window</em>, then the chunk values produced on
 timesteps that are multiples of <em>Nfreq</em> are summed and averaged within
 a moving &#8220;window&#8221; of time, so that the last M values for the same
 chunk are used to produce the output.  E.g. if M = 3 and Nfreq = 1000,
 then the output on step 10000 will be the average of the individual
 chunk values on steps 8000,9000,10000.  Outputs on early steps will
 average over less than M values if they are not available.</p>
 <p>The <em>bias</em> keyword specifies the ID of a temperature compute that
 removes a &#8220;bias&#8221; velocity from each atom, specified as <em>bias-ID</em>.  It
 is only used when the <em>temp</em> value is calculated, to compute the
 thermal temperature of each chunk after the translational kinetic
 energy components have been altered in a prescribed way, e.g.  to
 remove a flow velocity profile.  See the doc pages for individual
 computes that calculate a temperature to see which ones implement a
 bias.</p>
 <p>The <em>adof</em> and <em>cdof</em> keywords define the values used in the degree of
 freedom (DOF) formula described above for for temperature calculation
 for each chunk.  They are only used when the <em>temp</em> value is
 calculated.  They can be used to calculate a more appropriate
 temperature for some kinds of chunks.  Here are 3 examples:</p>
 <p>If spatially binned chunks contain some number of water molecules and
 <a class="reference internal" href="fix_shake.html"><span class="doc">fix shake</span></a> is used to make each molecule rigid, then
 you could calculate a temperature with 6 degrees of freedom (DOF) (3
 translational, 3 rotational) per molecule by setting <em>adof</em> to 2.0.</p>
 <p>If <a class="reference internal" href="compute_temp_partial.html"><span class="doc">compute temp/partial</span></a> is used with the
 <em>bias</em> keyword to only allow the x component of velocity to contribute
 to the temperature, then <em>adof</em> = 1.0 would be appropriate.</p>
 <p>If each chunk consists of a large molecule, with some number of its
 bonds constrained by <a class="reference internal" href="fix_shake.html"><span class="doc">fix shake</span></a> or the entire molecule
 by <a class="reference internal" href="fix_rigid.html"><span class="doc">fix rigid/small</span></a>, <em>adof</em> = 0.0 and <em>cdof</em> could be
 set to the remaining degrees of freedom for the entire molecule
 (entire chunk in this case), e.g. 6 for 3d, or 3 for 2d, for a rigid
 molecule.</p>
 <p>The <em>file</em> keyword allows a filename to be specified.  Every <em>Nfreq</em>
 timesteps, a section of chunk info will be written to a text file in
 the following format.  A line with the timestep and number of chunks
 is written.  Then one line per chunk is written, containing the chunk
 ID (1-Nchunk), an optional original ID value, optional coordinate
 values for chunks that represent spatial bins, the number of atoms in
 the chunk, and one or more calculated values.  More explanation of the
 optional values is given below.  The number of values in each line
 corresponds to the number of values specified in the fix ave/chunk
 command.  The number of atoms and the value(s) are summed or average
 quantities, as explained above.</p>
 <p>The <em>overwrite</em> keyword will continuously overwrite the output file
 with the latest output, so that it only contains one timestep worth of
 output.  This option can only be used with the <em>ave running</em> setting.</p>
 <p>The <em>format</em> keyword sets the numeric format of each value when it is
 printed to a file via the <em>file</em> keyword.  Note that all values are
 floating point quantities.  The default format is %g.  You can specify
 a higher precision if desired, e.g. %20.16g.</p>
 <p>The <em>title1</em> and <em>title2</em> and <em>title3</em> keywords allow specification of
 the strings that will be printed as the first 3 lines of the output
 file, assuming the <em>file</em> keyword was used.  LAMMPS uses default
 values for each of these, so they do not need to be specified.</p>
 <p>By default, these header lines are as follows:</p>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="c1"># Chunk-averaged data for fix ID and group name</span>
 <span class="c1"># Timestep Number-of-chunks</span>
 <span class="c1"># Chunk (OrigID) (Coord1) (Coord2) (Coord3) Ncount value1 value2 ...</span>
 </pre></div>
 </div>
 <p>In the first line, ID and name are replaced with the fix-ID and group
 name.  The second line describes the two values that are printed at
 the first of each section of output.  In the third line the values are
 replaced with the appropriate value names, e.g. fx or c_myCompute<strong>2</strong>.</p>
 <p>The words in parenthesis only appear with corresponding columns if the
 chunk style specified for the <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command supports them.  The OrigID
 column is only used if the <em>compress</em> keyword was set to <em>yes</em> for the
 <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command.  This means that
 the original chunk IDs (e.g. molecule IDs) will have been compressed
 to remove chunk IDs with no atoms assigned to them.  Thus a compresed
 chunk ID of 3 may correspond to an original chunk ID or molecule ID of
 415.  The OrigID column will list 415 for the 3rd chunk.</p>
 <p>The CoordN columns only appear if a <em>binning</em> style was used in the
 <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command.  For <em>bin/1d</em>,
 <em>bin/2d</em>, and <em>bin/3d</em> styles the column values are the center point
 of the bin in the corresponding dimension.  Just Coord1 is used for
 <em>bin/1d</em>, Coord2 is added for <em>bin/2d</em>, Coord3 is added for <em>bin/3d</em>.
 For <em>bin/sphere</em>, just Coord1 is used, and it is the radial
 coordinate.  For <em>bin/cylinder</em>, Coord1 and Coord2 are used.  Coord1
 is the radial coordinate (away from the cylinder axis), and coord2 is
 the coordinate along the cylinder axis.</p>
 <p>Note that if the value of the <em>units</em> keyword used in the <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom command</span></a> is <em>box</em> or <em>lattice</em>, the
 coordinate values will be in distance <a class="reference internal" href="units.html"><span class="doc">units</span></a>.  If the
 value of the <em>units</em> keyword is <em>reduced</em>, the coordinate values will
 be in unitless reduced units (0-1).  This is not true for the Coord1 value
 of style <em>bin/sphere</em> or <em>bin/cylinder</em> which both represent radial
 dimensions.  Those values are always in distance <a class="reference internal" href="units.html"><span class="doc">units</span></a>.</p>
 </div>
 <hr class="docutils" />
 <div class="section" id="restart-fix-modify-output-run-start-stop-minimize-info">
 <h2>Restart, fix_modify, output, run start/stop, minimize info</h2>
 <p>No information about this fix is written to <a class="reference internal" href="restart.html"><span class="doc">binary restart files</span></a>.  None of the <a class="reference internal" href="fix_modify.html"><span class="doc">fix_modify</span></a> options
 are relevant to this fix.</p>
 <p>This fix computes a global array of values which can be accessed by
 various <a class="reference internal" href="Section_howto.html#howto-15"><span class="std std-ref">output commands</span></a>.  The values can
 only be accessed on timesteps that are multiples of <em>Nfreq</em> since that
 is when averaging is performed.  The global array has # of rows =
 the number of chunks <em>Nchunk</em> as calculated by the specified <a class="reference internal" href="compute_chunk_atom.html"><span class="doc">compute chunk/atom</span></a> command.  The # of columns =
 M+1+Nvalues, where M = 1 to 4, depending on whether the optional
 columns for OrigID and CoordN are used, as explained above.
 Following the optional columns, the next column contains the count of
 atoms in the chunk, and the remaining columns are the Nvalue
 quantities.  When the array is accessed with a row I that exceeds the
 current number of chunks, than a 0.0 is returned by the fix instead of
 an error, since the number of chunks can vary as a simulation runs
 depending on how that value is computed by the compute chunk/atom
 command.</p>
 <p>The array values calculated by this fix are treated as &#8220;intensive&#8221;,
 since they are typically already normalized by the count of atoms in
 each chunk.</p>
 <p>No parameter of this fix can be used with the <em>start/stop</em> keywords of
 the <a class="reference internal" href="run.html"><span class="doc">run</span></a> command.  This fix is not invoked during <a class="reference internal" href="minimize.html"><span class="doc">energy minimization</span></a>.</p>
 </div>
 <div class="section" id="restrictions">
 <h2>Restrictions</h2>
 <blockquote>
 <div>none</div></blockquote>
 </div>
 <div class="section" id="related-commands">
 <h2>Related commands</h2>
 <p><a class="reference internal" href="compute.html"><span class="doc">compute</span></a>, <a class="reference internal" href="fix_ave_atom.html"><span class="doc">fix ave/atom</span></a>, <a class="reference internal" href="fix_ave_histo.html"><span class="doc">fix ave/histo</span></a>, <a class="reference internal" href="fix_ave_time.html"><span class="doc">fix ave/time</span></a>,
 <a class="reference internal" href="variable.html"><span class="doc">variable</span></a>, <a class="reference internal" href="fix_ave_correlate.html"><span class="doc">fix ave/correlate</span></a></p>
 </div>
 <div class="section" id="default">
 <h2>Default</h2>
 <p>The option defaults are norm = all, ave = one, bias = none, no file output, and
 title 1,2,3 = strings as described above.</p>
 </div>
 </div>
 
 
            </div>
           </div>
           <footer>
   
 
   <hr/>
 
   <div role="contentinfo">
     <p>
         &copy; Copyright 2013 Sandia Corporation.
     </p>
   </div>
   Built with <a href="http://sphinx-doc.org/">Sphinx</a> using a <a href="https://github.com/snide/sphinx_rtd_theme">theme</a> provided by <a href="https://readthedocs.org">Read the Docs</a>.
 
 </footer>
 
         </div>
       </div>
 
     </section>
 
   </div>
   
 
 
   
 
     <script type="text/javascript">
         var DOCUMENTATION_OPTIONS = {
             URL_ROOT:'./',
             VERSION:'',
             COLLAPSE_INDEX:false,
             FILE_SUFFIX:'.html',
             HAS_SOURCE:  true
         };
     </script>
       <script type="text/javascript" src="_static/jquery.js"></script>
       <script type="text/javascript" src="_static/underscore.js"></script>
       <script type="text/javascript" src="_static/doctools.js"></script>
       <script type="text/javascript" src="https://cdn.mathjax.org/mathjax/latest/MathJax.js?config=TeX-AMS-MML_HTMLorMML"></script>
       <script type="text/javascript" src="_static/sphinxcontrib-images/LightBox2/lightbox2/js/jquery-1.11.0.min.js"></script>
       <script type="text/javascript" src="_static/sphinxcontrib-images/LightBox2/lightbox2/js/lightbox.min.js"></script>
       <script type="text/javascript" src="_static/sphinxcontrib-images/LightBox2/lightbox2-customize/jquery-noconflict.js"></script>
 
   
 
   
   
     <script type="text/javascript" src="_static/js/theme.js"></script>
   
 
   
   
   <script type="text/javascript">
       jQuery(function () {
           SphinxRtdTheme.StickyNav.enable();
       });
   </script>
    
 
 </body>
 </html>
\ No newline at end of file
diff --git a/doc/html/searchindex.js b/doc/html/searchindex.js
index 6e3c50366..00ca6184a 100644
--- a/doc/html/searchindex.js
+++ b/doc/html/searchindex.js
@@ -1 +1 @@
-Search.setIndex({envversion:50,filenames:["Manual","Section_accelerate","Section_howto","Section_python","accelerate_intel","angle_charmm","angle_class2","angle_cosine","angle_cosine_delta","angle_cosine_periodic","angle_cosine_shift","angle_cosine_shift_exp","angle_cosine_squared","angle_dipole","angle_fourier","angle_fourier_simple","angle_harmonic","angle_quartic","angle_sdk","balance","bond_class2","bond_fene","bond_fene_expand","bond_harmonic","bond_harmonic_shift","bond_harmonic_shift_cut","bond_morse","bond_nonlinear","bond_quartic","compute_centro_atom","compute_cna_atom","compute_dpd","compute_fep","compute_gyration","compute_gyration_chunk","compute_heat_flux","compute_hexorder_atom","compute_msd_nongauss","compute_orientorder_atom","compute_pressure","compute_reduce","compute_saed","compute_sna_atom","compute_stress_atom","compute_xrd","create_atoms","dihedral_charmm","dihedral_class2","dihedral_cosine_shift_exp","dihedral_fourier","dihedral_harmonic","dihedral_helix","dihedral_multi_harmonic","dihedral_nharmonic","dihedral_opls","dihedral_quadratic","dihedral_spherical","dihedral_style","dump","dump_image","fix_atc","fix_ave_atom","fix_ave_chunk","fix_ave_correlate","fix_ave_histo","fix_ave_time","fix_balance","fix_bond_swap","fix_box_relax","fix_ehex","fix_eos_cv","fix_eos_table_rx","fix_gld","fix_lb_fluid","fix_nh","fix_nphug","fix_orient","fix_pimd","fix_qbmsst","fix_restrain","fix_rx","fix_shake","fix_spring_rg","fix_ti_rs","fix_ti_spring","fix_ttm","fix_wall","fix_wall_region","improper_class2","improper_cossq","improper_cvff","improper_distance","improper_fourier","improper_harmonic","improper_ring","improper_umbrella","minimize","neb","pair_adp","pair_airebo","pair_beck","pair_body","pair_bop","pair_born","pair_buck","pair_buck_long","pair_charmm","pair_class2","pair_colloid","pair_comb","pair_coul","pair_coul_diel","pair_cs","pair_dipole","pair_dpd","pair_dpd_fdt","pair_eam","pair_edip","pair_eff","pair_eim","pair_exp6_rx","pair_gauss","pair_gayberne","pair_gran","pair_gromacs","pair_hbond_dreiding","pair_list","pair_lj","pair_lj96","pair_lj_cubic","pair_lj_expand","pair_lj_long","pair_lj_sf","pair_lj_smooth","pair_lj_smooth_linear","pair_lj_soft","pair_lubricate","pair_lubricateU","pair_mdf","pair_meam","pair_meam_spline","pair_meam_sw_spline","pair_mgpt","pair_mie","pair_morse","pair_multi_lucy","pair_multi_lucy_rx","pair_nb3b_harmonic","pair_nm","pair_polymorphic","pair_resquared","pair_sdk","pair_smtbq","pair_snap","pair_soft","pair_sph_idealgas","pair_sph_taitwater","pair_sph_taitwater_morris","pair_srp","pair_sw","pair_tersoff","pair_tersoff_mod","pair_tersoff_zbl","pair_vashishta","pair_yukawa","pair_yukawa_colloid","pair_zbl","thermo_style","tutorial_github"],objects:{},objnames:{},objtypes:{},terms:{"00a":83,"00b":83,"02214e23":35,"0b1":3,"0e4":123,"0x98b5e0":59,"100k":1,"1024x1024":59,"10e":112,"10x":[96,97,102],"12th":80,"16e":80,"16g":[62,65],"16x":1,"18986e":96,"1_prop":2,"1fluid":[120,146],"1st":[2,5,32,46,62,63,64,65,71,74,80,98,99,102,109,116,118,119,120,133,134,139,140,141,145,146,147,149,153,159,160,161,162,163],"2000k":59,"20x":102,"23899e":96,"2400k":59,"2697v2":4,"2697v4":4,"298k":111,"2k_ss":118,"2nd":[2,3,21,22,62,63,64,65,68,71,74,88,96,97,99,109,118,125,139,145,146,153,159,160,161,162,163],"2theta":44,"2x5":118,"36x":4,"3806504e":[2,35],"3n_k":72,"3nk":78,"3rd":[5,37,62,63,64,65,71,109,118,120,125,145,146,153,159,160,161,162,163],"3x3":35,"4857990943e":118,"49e":80,"4_94":3,"4th":[2,46,80,98,99,102,116,119,120,123,139,145,146,147,149,153,159,160,162,163],"50k":1,"512k":4,"524k":4,"5_1":102,"5th":[96,120],"66e":80,"6x6":2,"7120p":4,"8706e":152,"8706q":152,"8730m":152,"8730n":152,"8x1":2,"8x2":2,"948q":152,"9jan09":123,"9th":97,"break":[28,118],"case":[1,2,3,4,19,21,22,29,30,40,45,46,58,59,61,62,63,64,65,66,68,73,74,75,76,78,79,80,85,86,87,96,97,99,106,108,110,112,116,118,122,123,125,135,136,137,139,142,145,146,147,149,154,158,160,162,166,167,168],"catch":1,"char":[2,152],"class":[1,2,3,57,107,163],"default":[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28],"export":[4,59],"final":[2,3,19,32,43,61,62,63,64,65,66,68,74,75,78,80,83,85,96,97,98,99,102,116,119,120,135,139,147,149,159,160,162,163,168],"float":[2,4,58,62,65,118],"function":[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,35,39,40,42,46,47,48,49,50,51,52,53,54,55,56,58,60,63,68,71,72,73,74,75,77,79,80,81,83,84,85,86,88,89,90,92,93,94,95,96,98,99,100,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,154,155,156,157,159,160,161,162,163,164,165,166],"import":[1,2,3,37,45,50,68,74,85,135,142],"int":[2,3,85],"long":[1,2,4,18,32,39,43,46,51,59,60,63,69,74,81,85,96,97,100],"new":[0,2,3,19,32,45,58,59,62,64,65,66,67,68,69,74,75,77,81,96,97,116,139,142,145,146,167,168],"null":[2,35,36,38,39,40,43,45,58,61,63,80,82,98,99,109,116,119,123,139,140,141,147,149,153,159,160,161,162,163],"public":[0,119,145,146,152],"return":[2,3,4,19,40,45,62,74,123,167],"short":[1,2,4,74,99,102,103,104,105,106,109,110,112,118,127,131,135,138,139,144,148,151,152,168],"static":[2,19,59,66,74,123],"switch":[1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,35,39,42,44,46,47,48,49,50,51,52,53,54,55,59,73,74,75,81,83,84,88,89,90,92,93,94,95,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,142,144,147,148,150,151,154,159,160,161,162,163,164,165,166,168],"true":[2,58,62,66,74,76,77,118,123,152,159],"try":[1,62,73,83,84,168],"var":[3,45],"void":[2,19,66],"while":[1,3,29,37,42,50,58,68,72,73,74,78,80,96,102,111,116,160,162,163],_j1m1m1:42,_j2m2m2:42,_manifold_rattl:168,_wirnsberg:69,a12:150,a2m:[2,35],a_0:[73,85,102],a_0_real:73,a_1:85,a_2:85,a_3:85,a_4:85,a_c:108,a_cc:108,a_f:162,a_ij:102,a_pi:102,a_sigma:102,a_ss:108,aat:47,aberdeen:[31,70],abil:[68,74,118],abl:[3,58,67],ablat:85,about:[0,1,2,3,4,19,41,45,58,59,60,61,62,63,64,65,66,67,68,69,73,75,76,79,81,82,83,84,85,86,87,96,97,101,106,110,165,168],abov:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,32,33,34,35,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,58,59,61,62,63,64,65,66,67,68,74,75,77,79,80,88,89,90,91,92,93,94,95,97,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],abscissa:[145,146],absolut:[80,96,123,127],absorb:85,abstol:80,ac3:44,acceler:0,accelri:2,accept:[32,45,67,80,105,131,168],acceptor:125,access:[0,2,3,4,29,30,31,33,34,35,36,37,38,39,40,41,42,43,44,60,61,62,63,64,65,66,67,68,69,72,73,74,75,76,78,79,81,82,83,84,85,86,87,99,121,123,125,139,154,167],accident:168,accidenti:94,accomod:74,accomplish:4,accord:[2,31,59,71,73,74,78,83,84,85,86,87,118,123,130,133,149,152,154,155,156,157,158],accordingli:[3,136,137,158],account:[2,32,41,44,57,63,64,69,74,76,81,82,85,92,110,115,123,127,131,136,137,139,142,152,168],accumul:[2,31,63],accur:[1,2,19,66,80,81,87,102,118,122,123,150,160,162],accuraci:[1,2,19,58,66,69,74,81,99,118,145,146],achiev:[1,2,4,13,19,66,69,74,77,78],ackland1:116,ackland2:116,ackland:116,acknowledg:0,acolor:59,acquir:[2,68,74],across:[1,2,19,40,62,64,66,80,85,87,97],act:[2,73,83,84,85,87,96,113,122,123,125,150,158],acta:[41,44,98],actinid:142,action:[2,3,72,84],activ:[3,4,32,72,80,135],actual:[1,2,58,76,122,124,130,136,137,158,167],adapt:[2,32,80,135,136,154],adapti:76,adaptiv:99,add:[0,1,2,3,4,32,35,40,45,58,59,60,61,62,63,64,65,69,73,74,75,76,79,81,84,85,86,87,99,103,104,107,110,118,127,139,144,148,151,168],add_molecul:60,add_speci:60,add_to_nodeset:60,added:168,addforc:96,adding:[79,168],addit:[1,2,4,5,13,19,45,56,57,59,66,68,69,71,73,74,75,76,81,86,87,97,98,99,102,103,104,106,109,110,113,115,116,117,118,119,123,124,126,127,135,137,138,139,140,141,142,145,146,147,148,149,151,152,153,159,160,161,162,163,166,168],addition:[0,2,3,4,59,62,63,64,65,85,97,122,150,168],address:[3,59,168],addtorqu:96,adequ:97,adher:13,adhikari:73,adiabat:0,adiam:59,adjac:[45,69,97,160],adjiman:143,adjust:[2,4,19,41,44,58,59,62,66,68,74,75,76,78,80,86,96,97,99,136,137,152,162],admiss:75,adof:62,adopt:79,advanc:[4,102],advantag:[1,2,3,19,66,117],advect:2,advis:[80,97],affect:[1,2,40,43,59,62,63,64,65,67,68,69,82,85,94,96,97,118,136,137],affin:[4,109],afshar:114,after:[2,3,6,19,45,47,56,58,59,60,62,63,66,67,68,73,74,78,80,81,83,84,86,88,96,98,99,102,109,116,117,118,119,120,135,136,137,139,140,141,142,145,146,147,149,152,153,159,160,161,162,163,167,168],afterword:19,ag1:44,ag2:44,again:[2,3,42,58,69,88,97,136,137],against:[3,97],aggreg:[2,82],aggress:69,agre:[96,99],ahd:125,aidan:0,aim:2,aka:59,al2o3:152,al2o3_001:41,al3:44,ala:[73,152],alat:[76,139],albe:[149,160,162],albeit:79,alchem:32,alcu:[98,102],alcu_eam:149,alderton:113,alejandr:74,algebra:142,algorithm:[0,1,2,19,60,66,67,69,73,77,81,85,96,115,118,137,142],alia:4,alias:1,align:[2,13,19,66],alkali:118,all:[0,1,2,3,4,19,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,83,84,85,86,87,88,92,96,97,98,99,101,102,103,104,105,106,107,109,110,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,131,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,165,166,167,168],allen:[13,32,113,122],allentildeslei:32,alloc:[2,3],alloi:[98,102,110],allow:[1,2,3,4,19,36,38,44,45,57,58,59,60,62,63,64,65,66,67,68,72,73,74,76,78,79,80,81,82,83,84,85,86,87,96,97,99,102,103,104,105,106,110,116,118,123,124,125,127,131,136,137,142,149,150,152,158,165,167,168],almost:[4,78,85,158],alo:110,alon:[2,67],along:[2,13,29,32,41,44,45,58,59,62,67,69,73,78,81,82,85,87,96,97,110,113,123,127,131,139],alonso:[140,141],alpha:[2,26,73,78,96,98,100,103,110,114,115,116,117,119,120,125,126,127,139,144,161,167],alpha_c:135,alpha_i:153,alpha_lj:135,alphabet:57,alreadi:[45,62,66,78,97,114,124,129,137,158,166],also:[0,1,2,3,4,13,18,19,28,29,30,31,32,33,34,36,37,38,39,40,42,43,45,46,57,58,59,61,62,63,64,65,66,67,68,70,71,72,73,74,75,76,77,78,79,80,81,82,85,87,96,97,102,105,106,111,112,113,114,116,117,118,122,123,125,131,135,136,139,142,147,149,150,151,155,156,157,159,160,161,162,163,167,168],alter:[2,3,19,45,58,59,62,67,68,74,97],altern:[1,2,3,4,35,45,58,63,70,74,80,89,93,96,98,99,110,115,116,117,119,127,135,139,140,141,147,149,153,159,160,162,163,167],alternat:96,although:[4,13,74],aluminum:166,alwai:[0,2,3,4,28,62,63,65,86,87,88,96,104,107,116,130,142,145,146,152,154,160,162,166],amaz:3,amber2lmp:0,amber:0,ambient:59,amd:142,among:[4,43,73],amorph:[45,161],amount:[1,2,59,68,74,76,80,114],amplitud:94,amzallag:152,analag:2,analalog:2,analog:[2,38,42,123],analysi:[30,142,153],analyt:[1,41,44,81,102,129,142,149],analyz:[2,97,142],andersen:81,anderson:114,andzelm:158,ang:[4,76],angl:[0,1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,28,32,36,38,39,41,42,43,44,45,47,48,49,51,53,55,56,57,58,59,67,74,79,81,88,89,90,92,93,94,95,96,99,102,110,117,125,127,131,135,140,141,147,163,167],angle1:79,angle2:79,angle:[4,13],angle_coeff:[5,6,7,8,9,10,11,12,13,14,15,16,17,18],angle_cosine_shift:11,angle_cosine_shift_exp:[10,48],angle_cutof:125,angle_cutoff:125,angle_hybrid:13,angle_styl:[0,2],angleangl:88,angleangletors:47,angletors:47,angmom:[2,62],angmomi:[58,62],angmomx:[58,62],angmomz:[58,62],angstrom:[2,41,44,45,58,59,86,98,99,106,116,135,139,147,162,166],angular:[2,13,42,45,58,81,98,102,109,123,136,137,139,142,149,160,161],anharmon:[11,27,48],ani:[1,2,3,4,13,19,29,30,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,56,58,59,62,63,65,66,67,68,69,71,73,74,75,76,77,80,81,85,86,87,96,97,99,102,105,106,109,110,113,114,116,117,119,122,131,142,145,146,149,150,153,159,160,161,162,163,167,168],anihil:[135,144],anim:[3,59,97],animat:59,anion:[119,152],aniso:[68,74,75],anisotrop:[122,150],ann:143,annoi:168,annot:[159,160,161,162,163],anoth:[2,3,4,13,59,62,64,65,67,69,72,74,75,85,96,97,110,114,118,119,122,125,126,127,135,150,154,158,160,161,162,168],another:[1,2,32],ansi:4,anthoni:84,antisymmetri:118,antonelli:[83,84],any:[1,2,58,59,158],anymor:84,anyth:[3,45,159,160,162,168],anywher:[45,139,153],aparam:32,apart:[101,154],api:3,appear:[2,3,19,32,36,38,42,45,58,59,62,66,68,88,96,97,108,116,139,145,146,152,163],append:[1,3,4,19,29,32,34,35,36,37,38,39,40,41,42,43,44,45,59,61,62,63,64,65,66,67,68,69,72,73,74,75,77,78,79,81,84,86,102,118,158,167],appendix:[13,113,152],appl:[68,74,163],appli:[2,13,19,32,37,42,43,44,45,46,57,58,59,60,62,66,68,69,70,71,72,73,74,75,76,77,78,79,81,84,85,96,97,101,103,104,106,110,113,118,120,123,124,125,127,133,137,142,146,148,151,158,165],applic:[1,2,4,67,76,79,162],applicat:60,appling:68,apply:[32,68,81,82],approach:[2,4,56,58,60,72,77,84,85,102,110,112,115,122,142,150,158],appropri:[1,2,3,30,35,40,57,58,62,63,65,67,68,73,74,75,77,78,86,87,97,99,102,105,108,109,110,117,123,131,135,142,159,160,161,162,163],approxim:[2,41,44,73,77,81,96,112,118,120,122,136,137,142,146,150,152,165],april:3,apu:[136,137],aqua:59,ar_thermal:60,ar_ttm:60,arbitrari:[2,58,59,74,77,80,159],arbitrarili:[3,42,68,74,110],arch:1,architectur:142,archiv:2,archive:3,area:[2,19,35,39,66,73,123],arg:[3,19,32,40,45,58,62,63,64,65,66,69,79,84,86,97,103,104,106,107,112,113,115,118,124,127,131,135,136,137,138,144,148,151,167],argument:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,32,35,38,39,42,43,45,46,47,48,49,50,51,52,53,54,55,58,61,62,63,64,65,66,68,71,74,75,80,81,85,88,89,90,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,110,112,113,114,115,116,117,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,138,139,140,141,144,145,146,147,148,149,150,151,152,153,154,159,160,161,162,163,164,165,166,167],aris:165,arithmet:[2,106,108,130],arl:[31,70],army:[31,70],around:[1,2,29,30,42,45,46,56,59,68,74,86,87,152],arrang:42,arrheniu:80,arriv:4,articl:[2,152],artifici:[78,155,156],arxiv:[42,153],ascend:19,ascii:[97,116,119,139],ash:[136,137],aside:[45,139],ask:[3,168],asoci:59,aspect:[2,122,150],aspher:0,asphere:[122,150],asq:[136,137],assign:[1,2,3,19,34,41,42,43,44,45,58,59,62,64,66,67,68,73,74,75,77,97,102,116,119,122,125,145,146,150,166,167],assignemnt:2,associ:[2,32,33,34,57,58,59,68,72,73,74,79,80,82,96,97,110,114,115,116,118,125,127,131,145,146,158],assum:[2,3,45,62,63,64,65,68,73,76,85,86,91,97,102,105,108,118,125,126,131,136,137,167,168],assume:97,assumpt:98,astar:139,astart:154,asterisk:[32,40,58,61,62,63,64,65,125,158,167],astop:[96,154],asu:116,asub:139,asymmetr:[69,102,116],asynchron:4,atc_fe_output:60,athomp:0,atm2pa:2,atom1:79,atom2:79,atom3:79,atom4:79,atom:[0,1],atom_element_map:60,atom_modifi:[3,58,97],atom_styl:[2,31,45,59,70,71,74,80,97,101,108,113,115,118,119,122,123,137,150,165],atom_weight:60,atomey:[2,3,58,59],atomfil:2,atomic:[0,152],atomic_charg:60,atomic_numb:149,atomist:[2,60,142],atoms:58,attach:[2,77],attatch:84,attempt:[2,19,66,67,97,167],attend:60,attrac:139,attract:[0,21,22,99,105,108,131,139,143,152,165],attribut:[2,3,32,40,58,59,61,62,64,67,68,74,75,102,118,167],atw:[136,137],atwater:161,atwt:139,atyp:[110,127,131,135],au1:44,au3:44,aug:3,augment:[68,139],augt1:139,author:[116,117],auto:[2,3,35,63],autocorrel:35,autom:59,automat:[2,4,18,73,109,116,139,142,166,168],auxiliari:[1,2,3,58],avail:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,39,42,46,47,48,49,50,51,52,53,54,55,58,59,62,64,65,68,72,74,75,80,81,84,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,139,140,144,147,148,149,150,151,153,154,159,160,161,162,163,164,165,166],availabl:4,avalo:115,ave_chunk:2,aveforc:2,avendano:143,averag:[2,19,31,32,35,36,37,41,44,58,60,61,62,63,64,65,66,68,74,75,78,80,88,99,115,118,120,139,146,167],avesq:40,avi:59,avoid:[1,2,18,45,59,63,64,65,76,77,87,102,118,135,139,144],avx2:4,avx512:4,avx:4,awai:[2,58,59,62,67,76,86,110,127,131],awar:117,axel:168,axi:[2,19,29,36,41,44,45,59,62,66,85,92,95],axial:75,azimuth:59,b_k:153,ba2:44,babadi:150,back:[1,2,3,45,58,74,83,84,97,123],backbon:[67,81,94],background:[32,39,43,66,85,97,108,136,137,139],backtrack:96,backward:97,baczewski:72,bad:97,badli:[68,74],balanc:[1,2,4],ball:[42,136,137],bammann:60,band:[2,42,97,102,142,152],bandwidth:1,bandwith:59,bar:[32,59],barashev:116,barostat:[0,1],barostt:2,barr:109,barrier:[2,95,97,109,121],bartok2010:153,bartok2013:153,bartok:[42,153],base:[2,3,4,5,32,35,41,44,45,58,59,60,66,77,80,99,100,102,114,118,122,125,127,136,140,141,148,149,152,159,161,162,163,167,168],bashford:[2,5,46,106],basi:[2,42,45,86],basic:[2,19,43,59,60,66,74,76,87,98,142],basin:97,bask:[116,139,149],bath:78,batom1:[40,58],batom2:[40,58],bayli:[2,46],bb13:47,bcc:[29,30],bcolor:59,bdiam:59,be2:44,bead:[21,22,67,77,158],bear:[2,72],becaus:[0,1,2,4,19,36,38,42,45,58,59,62,66,67,68,72,74,78,85,87,90,96,97,106,110,112,114,118,119,122,123,124,125,126,135,136,137,139,145,146,150,158,168],becker:[98,116],becom:[1,2,4,19,28,58,59,66,67,69,73,74,86,87,97,99,108,110,116,118,122,127,149,150,159,163,165,168],been:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,39,40,46,47,48,49,50,51,52,53,54,55,58,59,61,62,63,64,65,66,67,68,73,74,75,78,81,85,86,88,89,90,92,93,94,95,96,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,140,141,142,144,147,148,150,151,154,158,159,160,161,162,163,164,165,166,167],befor:[1,2,13,19,33,34,37,45,62,64,65,66,68,73,74,78,86,96,97,119,120,123,135,139,142,146,167,168],begin:[40,58,60,61,62,63,64,65,66,71,80,97,116,120,142,145,146,149,152,154,158,166,167],begun:80,behav:[11,48,96],behavior:[58,59,67,68,72,74,78,85,102,118,139,166],behaviour:2,behind:78,believ:3,bellott:[2,5,46,106],bellow:92,belong:62,below:[1,2,3,4,19,28,35,39,40,41,42,43,44,45,46,57,58,59,60,61,62,63,64,65,66,67,68,71,74,75,76,78,79,80,81,83,84,85,86,96,97,98,99,102,103,106,107,108,110,113,116,118,119,120,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,143,145,146,150,151,153,154,158,163,164,165,166,167,168],bench:[1,2,3],benchmark:[1,3,4,19,66],benedict:142,benefit:[1,4,72],bennet:32,berardi:[122,150],beraun:85,berendsen:[2,74,75,81],bern:[77,109,122,152],bernendsen:2,beryllium:118,best:[1,2,4,74,79,102,110,127,131],beta:[2,78,98,100,116,117,119,139,160,161,162,167],beta_:102,beta_k:153,beta_pi:102,beta_sigma:102,beta_t:161,better:[2,4,11,42,48,66,73,74,97,160,168],betwe:101,between:1,beutler:135,bewteen:63,beyond:[2,32,58,64,74,121,133,167],bflag1:59,bflag2:59,bgq:142,bi3:44,bi5:44,bia:[2,39,43,62,74],bias:2,biersack:[139,162,166],big:[58,78,108,168],bin:[2,3,34,58,62,64,78],binari:[2,4,57,58,59,60,61,62,63,64,65,66,67,68,69,72,73,74,75,76,78,79,81,82,83,84,85,86,87,98,99,100,101,102,103,104,105,106,107,108,109,110,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],binary2txt:[0,58],binchunk:62,bind:[102,152],binsiz:4,biolog:2,biologi:51,biomolecul:106,bios:4,bisect:[19,66],bisector:[2,110,127,131],bispectrum:[42,153],bit:[3,168],bitrat:59,bkgd_dyn:139,bks:78,blank:[59,71,80,97,102,117,120,139,145,146,147,153,159,160,161,162,163],blast:85,blend:139,block:[2,35,42,45,87,102,118,149,153,168],blow:[86,87,154],blue:[59,67],bluegen:[58,142],board:113,bodi:0,body:101,bodyforc:73,bodyforcei:73,bodyforcex:73,bodyforcez:73,bogu:68,bohr:[116,118,142,162],boltzmann:[2,32,35,39,62,67,71,73,75,114],bond:[0,1,2,4,6,13,18,20,21,22,23,24,25,26,27,28,32,35,36,38,39,40,42,43,45,46,47,56,57,58,59,62],bond_coeff:[2,20,21,22,23,24,25,26,27,28],bond_harmon:[24,25],bond_harmonic_shift:25,bond_interact:60,bond_styl:[0,2],bondangl:6,bondbond13:47,bondbond:6,bonet:115,book:[165,168],bookmark:0,boost:1,border:[4,85],boresch:32,boreschkarplu:32,born:[2,32],boron:118,botero:118,both:[1,2,3,4,11,28,32,45,48,57,58,59,62,63,64,65,67,68,69,73,74,78,81,83,84,85,86,87,88,96,97,99,102,103,104,105,106,107,108,113,114,116,117,118,122,123,125,127,129,131,132,133,135,136,137,142,143,144,148,150,151,159,160,161,162,163,167],bottleneck:1,bottom:73,bound:[2,10,11,19,48,58,64,66,74,86,87,96,118],boundari:[2,33,34,35,37,39,41,43,44,45,58,59,60,61,64,68,73,74,76,78,82,85,86,87,124,136,137,142,167],boundary_dynam:60,boundary_faceset:60,boundary_integr:60,bounds:[2,19,58,66],bount:3,box:[0,1],boxcolor:59,boxxlo:3,bptype:158,br1:44,bracket:[2,19,40,58,61,62,63,64,65,66,167],bragg:[41,44],branch:[3,168],branicio2009:163,branicio:[30,163],breakdown:[1,99],brennan:[31,70,115,145,146,158],brenner:99,brick:[19,66],brief:[1,2,74,99,102],briefli:[2,77,109,152,168],brilliantov:123,broadwel:4,broken:[28,29,74,102],brook:2,brown:[4,41,43],brownian:[2,37,136,137],brows:0,browser:59,bryantsev:125,btype:[58,110,127,131,135,158],buc:104,buck:[2,4,32,103],buckingham:[103,104,105,112,138],buckplusattr:152,buffer:59,bufi:59,bug:0,bui:59,build:[0,1,2],built:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,20,21,22,23,24,25,26,27,28,31,32,37,39,41,42,44,46,47,48,49,50,51,52,53,54,55,56,57,58,67,69,70,71,72,73,74,75,76,77,78,80,81,83,84,85,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],bulatov:[140,141],bulk:[2,29,73,76,111,139,142,152],bundl:[59,168],button:168,bypass:2,c11:[63,139],c12:63,c13:63,c1n:63,c21:63,c22:63,c23:63,c2n:63,c31:63,c32:63,c33:63,c34:63,c3n:63,c41:63,c42:63,c43:63,c44:63,c_0:[85,99,156,157],c_1:[40,41,44,58,72],c_2:[40,41,44,58],c_3:40,c_cluster:2,c_cstherm:2,c_dist:40,c_doubl:3,c_e:85,c_flux:35,c_forc:40,c_gauss:121,c_hb:125,c_i:71,c_id:[2,32,40,58,61,62,63,64,65,167],c_ij:2,c_ijkl:2,c_index:40,c_k:72,c_my_stress:61,c_myang:62,c_mycentro:62,c_mychunk:[2,34],c_mycom:64,c_mycomput:62,c_myf:58,c_mypress:63,c_myrdf:65,c_mytemp:[63,64,65,167],c_n_k:72,c_p:43,c_peratom:43,c_pi:102,c_press:40,c_prop:2,c_sigma:102,c_size:2,c_stress:58,c_thermo_press:[63,64,65],c_thermo_temp:65,c_xrd:64,ca2:44,cach:4,cacul:81,calcforc:73,calclat:35,calcluat:[37,39,43,110],calcualt:[35,62],calcul:[0,1],caldwel:[2,46],calhoun:77,call:[1,2,3,4,58,77,99,108,165,168],callabl:3,callback:3,caltech:[2,118],calucl:2,calul:[3,29],can:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],cannot:[1,2,3,4,19,28,40,58,59,61,62,63,64,65,66,67,68,72,74,78,85,86,87,96,97,104,105,107,116,122,124,127,131,133,135,148,150,151,158],canon:[74,77,84,142],cao1:77,cao2:77,cao:77,capabl:[3,4,99,107],capac:[70,85,155],capolungo:[41,44],captur:[2,99,105,118,123,131,139],carbid:110,carbon:[59,94,99,109,139],card:[4,32,125],care:[2,45,56,62,73,74,101],carefulli:[3,28],carlo:[2,67],caro:116,carri:[4,85,123],carrillo:4,cartesian:[2,98],cascad:85,cat:[4,59],cate:73,categori:[0,99],cation:[119,152],caus:[1,2,4,45,58,68,74,76,80,81,86,87,96,97,125,127,133,136,137],caution:1,cautious:99,caveat:99,cbecker:[98,116],cc1:[2,34,62],ccc:[117,159,160,162,163],ccflag:4,ccflags:[4,58],ccm6:116,ccsi:[117,159,160,162,163],ccu:102,cd2:44,cdeam:116,cdll:3,cdof:[2,62],cdte:102,cdte_bop:102,cdtese:102,cdzn:102,cdznte:102,ce3:44,ce4:44,cell:[2,41,44,45,58,68,74,75,78,85,118,142,167],cella:[2,167],cellalpha:[2,167],cellb:[2,167],cellbeta:[2,167],cellc:[2,167],cellgamma:[2,167],center:[2,9,33,34,37,41,45,59,62,64,68,72,74,82,84,86,87,88,101,117,118,122,123,136,137,139,140,141,159,160,161,162,163],centr:69,central:[29,36,38,42,76,81,82,91,142,147,163],centro:2,centroid:77,centrosymmetri:29,certain:[1,2,40,58,59,61,62,63,64,65,67],cfg:[2,58,59],cg_type:151,ch2:81,ch2lmp:[0,2],ch3:81,chain:[0,2,13,28,67,74,75,77,81,84,94,113,114,158],challeng:2,champaign:136,chan:142,chandler:[98,116],chandrasekhar:[2,127],chang:[1,2,3,4,19,22,32,45,58,59,60,66,67,68,73,74,75,76,78,79,80,81,83,84,85,87,96,97,114,118,123,136,137,139,142,152,158,167,168],change_box:2,changeabl:58,chapter:77,charact:[2,19,58,59,66,71,80,118,120,126,145,146,149,152],character:[2,29,38,42,153],characterist:83,charg:[1,2,3,32,41,44,45,58,103,104,109,110,112,113,116,118,119,127,131,135,148,152,162,163,165,166],charmm:0,cheaper:[122,150],check:[2,3,19,35,66,79,81,84,96,97,126,167],checkout:168,chem:[2,5,6,9,20,21,22,32,38,39,43,46,47,54,69,72,73,74,77,78,83,84,86,88,94,95,97,99,103,106,107,109,110,111,113,114,115,118,121,122,124,125,127,131,132,135,139,143,145,146,148,152,158],chemic:[31,41,44,58,60,120,146],chemistri:[78,99,102,118],chen:85,cheng:109,chi:[76,119,122],chiral:94,chmod:3,cho:139,choic:[2,4,19,28,29,32,43,56,62,66,67,73,74,77,97,135],choos:[1,2,13,28,32,40,59,67,68,73,74,75],chose:[160,162],chosen:[2,42,45,51,59,68,72,73,74,75,77,115,118,123,126,129,151,160],chunk:0,chunkid:[34,62],ciccotti:81,cieplak:[2,46],cii:63,cij:63,circular:2,circumv:[36,38],citat:[0,73],cite:152,cl1:44,clarendon:[13,113],clarifi:[160,162],clark:148,classic:[0,2,4,77,78,85,95,118],classifi:163,clean:2,cleanli:167,clear:[2,3],clebsch:42,click:[3,45,57,59,97,168],climb:97,clockwis:46,clone:168,close:[2,3,19,43,58,67,68,73,74,81,87,97,99,102,110,111,139,145,146,162,168],closer:[19,58,66,68,83,97],closest:[76,122,150,158],cloud:152,cluster:[2,4,43,58,69,81],cmax:139,cmd:[3,77],cmdarg:3,cmin:139,cmm:[18,151],cn1:63,cn2:63,cna:29,cnn:63,co2:[44,80,81,120],coars:[13,18,28,51,71,80,120,124,146,151],coarsest:42,code:[0,1],coeff:[6,46,47,56,88,126,154],coeffici:0,coefficienct:114,coefficient0:116,coefficient1:116,coeffieci:[2,100],coeffincientn:116,coexist:118,cohes:[2,119,139],coincid:[87,106,136,137],cold:2,coleman:[41,44],collect:[2,34,45,58,62,108],colliex:44,collis:[73,123,166],colloid:2,color:[19,58,59,66,72,78],column:[2,29,34,36,38,40,42,43,44,58,61,62,63,64,65,78,85,99,121,125,167],colvar:0,com:[2,37,64,69,101,168],comand:67,combiant:111,combin:[2,3,18,32,56,58,59,60,64,69,74,77,87,88,108,110,111,115,118,119,120,134,135,153,159,160,162,163,165],come:[0,2,13,68,74,83,84,159,160,162,163,167,168],comit:168,comm:[0,3,30,97,114],comm_modifi:[2,102,108,114,118,123],comm_styl:[19,66],comm_world:3,command:[0,1],comment:[3,46,58,71,80,85,97,98,116,117,119,120,126,139,145,146,147,152,153,159,160,161,162,163,168],commit:168,commmand:2,common:[0,1,2,3,4,30,68,77,87,88,123,125,159,160,162],commonli:[2,9,37,38,58,59,95,124,129,153,160,162],commun:[1,2,3,4,19,59,66,68,73,74,85,115],comp:[81,97,118,150,157,161],compar:[1,2,4,41,44,57,96,97,139,152],comparison:0,compass:[6,20,47,57,88,107],compat:[3,19,40,50,58,61,62,63,64,65,66,69,86,142],compens:[2,118],compil:[4,58,59,142],complain:3,complement:139,complementari:[110,127],complet:[2,3,19,66,77,97,119],complex:[2,3,9,36,38,42,45,73,87,97,118,142],complic:2,compon:[2,29,30,33,34,35,36,37,38,39,40,42,43,58,59,61,62,63,64,65,67,68,69,73,74,75,77,81,87,96,97,114,118,123,136,137,152,153,167],componenet:2,composit:[2,73,116],compound:[109,118,119,163],compres:62,compress:[2,58,59,62,75,78],compris:[87,120,150],compton:[41,44],comput:[0,1],computation:[2,85,102],compute_modifi:[67,68,74,75,167],compute_sa:41,compute_xrd:44,concav:87,concentr:[71,80,116,120,146],concept:[2,62],conceptu:[2,68,97,110,139],concern:[2,30,32,72],concis:3,concurr:4,conden:[85,160,162],condens:[2,85,99,112,116,127,163],condit:[2,39,41,43,44,58,59,60,73,75,76,78,81,82,85,115,118,124],conducit:2,conduct:0,confer:[4,142],config:58,configur:[1,2,4,58,59,68,77,96,97,99,102,117,139,142,159,160,162,163,167,168],conflict:168,conform:[2,67,68,79,94,97,118],confus:163,conjuct:114,conjug:118,conjunct:[2,32,45,73,97,103,104,110,114,118,125,127,148,151],connect:[2,32,67,81,97,111,123,158,162],conner:99,connor:99,consecut:[3,45,110,127,131],consequ:[1,2,85,126],conserv:[13,67,72,73,74,80,81,97,113,114,115,123,133,152],consid:[2,29,32,58,61,63,66,67,85,118,150,152,158,167],consider:2,consist:[2,3,39,45,51,62,72,74,75,78,79,80,97,99,102,108,110,118,122,136,137,139,142,145,146,150,152],consistent_fe_initi:60,constant:0,constantli:69,constitu:[2,86,87,108,150],constrain:[2,62,69,72,81,82,96,118],constraint:[19,39,43,62,66,69,81,82,86,96,137],construct:[2,28,29,30,36,38,41,42,44,68,74,79,80,87,113,142,158,159],constructor:3,consult:4,consum:1,contact:[0,111,117,119,122,123,150],contain:[0,1,2,3,19,32,35,41,42,44,45,46,57,58,59,60,61,62,63,64,65,66,71,73,76,78,80,85,87,97,98,99,102,109,110,113,116,117,118,120,139,142,145,146,147,149,153,159,160,161,162,163,167,168],content:167,context:[2,4,40,165],contibut:29,contin:4,continu:[0,2,19,62,63,64,65,66,67,68,69,72,74,75,78,83,84,85,87,102,114,129,132,150,161,167],continuum:[2,60,85],contour_integr:60,contract:[68,74],contrain:81,contrast:[1,2,165],contrib:85,contribut:[2,29,32,33,34,35,39,40,42,43,61,62,63,64,65,68,73,81,96,97,114,116,118,136,137,142,152,167,168],control:[2,3,4,11,13,19,32,35,42,48,58,59,60,66,68,74,75,80,85,118,122,142,159,162],control_typ:60,convect:35,conveni:[2,13,58,65,153,168],convent:[13,50,55,57,79,116,118],converg:[2,19,58,59,66,67,68,75,78,79,81,96,97,109,110,127,152],convers:[42,59,63,110,111,112,118,127,131,135,148],convert:[2,5,6,8,12,16,17,18,35,45,47,58,59,63,65,88,89,93,94,97,98,116,142,160,162,166],convex:87,cool:69,cooordin:58,coord1:62,coord2:62,coord3:62,coord:[2,3,36,38,58,64,76,86,97],coordb:152,coordbb:152,coordiat:96,coordin:[1,2,3,19,32,33,34,42,45,58,59,61,62,64,66,67,68,69,74,76,81,82,84,85,96,97,98,99,101,117,152],coordn:62,coords:152,copi:[0,3,59,85,97,168],copper:166,coprocessor:[1,4],core:[0,1],coreshel:2,coreshell:[2,104,110,112],cornel:[2,46],corner:[2,59,87,168],corpor:4,corr:109,correct:[2,3,32,46,59,69,74,78,86,87,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,116,117,118,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],correction_max_iter:60,correctli:[3,58,74,81,87,97,112,137,142,168],correl:[2,35,36,42,62],correpond:71,correspond:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,29,32,39,41,42,44,46,47,48,49,50,51,52,53,54,55,56,58,59,62,64,68,69,71,73,74,75,76,77,80,81,86,87,88,89,90,92,93,94,95,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,139,140,142,144,146,147,148,149,150,151,152,153,154,159,160,161,162,163,164,165,166,167],correspondingli:[136,137],cosin:2,cosineshift:11,cost:[1,2,3,19,41,43,44,59,62,66,74,80,85,110,127,131,142,159],costheta0:[159,160,162,163],costheta:149,costli:[3,4],coul:[2,4,18,21,22,32,46,96],could:[2,3,19,32,34,39,58,59,62,63,66,78,85,86,87,96,99,121,125],coulomb:[2,43,96,103,104,105,106,107,109,110,111,112,113,118,123,124,127,131,135,138,148,151,152,162,163,165,167],coulommb:2,count:[1,2,3,19,35,40,46,62,64,66,74,81,87,96,97,121,125,167],counterbal:69,counterbalanc:13,counterclockwis:46,counterpart:58,coupl:0,couple:[2,3],cours:[4,58,72,79,86,136,154],cov:152,coval:[2,13,118,139,152],cover:[2,60,73,118],cpp:[1,2,3,32,58,81],cpu:[1,4,167],cpuinfo:4,cpuremain:167,cr2:44,cr3:44,crai:58,creat:[0,1,2,3,19,35,39,40,41,45,58,59,60,61,62,63,64,65,66,67,68,71,74,75,76,77,79,85,97,99,102,109,116,117,135,144,145,146,149,152,159,160,161,162,163,167,168],create_atom:[2,19,35],create_box:[2,19,35,45,68,74,158,167],create_elementset:60,create_faceset:60,create_nodeset:60,createatom:0,creation:45,criteria:[59,67,96],criterion:[19,45,66,67,96,97,109,118,123,152],critic:[2,24,25,85,96],cross:[4,33,58,59,61,97,106,114,116,124,125,127,129,131,149,151,160,162,166],crossov:1,crozier:0,crucial:78,crystal:[2,4,29,30,38,76,84,167],crystallin:[2,161],crystallogr:[41,44],crystallograph:167,crystallographi:[41,44],cs1:44,cs_chunk:2,csanyi:[42,153],cscl:139,csequ:2,csh:[3,4],cshrc:3,csic:[117,159,160,162,163],csinfo:2,csisi:[117,159,160,162,163],cst:116,cstherm:2,csvr:2,ctcm:[98,116],ctype:3,cu1:44,cu2:44,cu3au:139,cube:[2,87],cubes:[19,66],cubic:[38,73,76,116],cuda:1,cuh:102,cummul:[2,65,67,125,167],cumul:[2,62,64,74,75,97],current:[0,1,2,3,4,19,30,32,40,43,58,59,60,62,65,66,67,68,69,74,79,80,81,82,85,86,96,97,102,109,113,116,118,119,123,126,136,137,139,140,141,149,154,160,162,167,168],curv:[2,45],curvatur:[122,150,166],custom:[0,2,3,33,34,35,40,43],cut:[1,2,4,19],cuthi:76,cutinn:[136,137],cutlo:76,cutmax:149,cutoff1:[107,113,127,131,135,138,148,151],cutoff2:[103,104,105,107,112,113,127,131,135,138,148,151],cutoff:[2,4,21,22,28,29,30,32,36,38,42,67,71,76,78,86,87,96,98,99,100,101,102,103,104,105,106,107,108,110,111,112,113,114,115,116,117,118,119,120,121,122,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],cutoffa:117,cutoffc:117,cuu3:116,cval:44,cvff:4,cwiggl:86,cyan:59,cycl:[74,75],cyclic:46,cylind:[59,62,87],cylindr:2,cyrot:102,d3q15:73,d3q19:73,d_e:85,d_name:58,daan:84,damp:[2,74,75,78,96,97,103,104,106,110,113,118,123,127,135,148,151],dampflag:123,danger:[114,167],darden:113,darken:59,dash:123,dat:[2,35,60],data2xmovi:0,data:1,databas:0,date:[0,2],datum:[2,58,63],davenport:138,davi:86,david:[160,162],daw:[116,149],dcd:[2,58,59,77],deactiv:135,debug:[2,3,41,44,45,77],decai:[36,110,166],decid:[2,4,168],decod:59,decompos:[32,153],decomposit:[60,77],decoupl:2,decreas:[4,58,67,69],dedic:4,defect:[2,29,142],defin:[2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,70,71,73,74,75,76,77,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,99,100,101,103,104,105,106,107,108,110,111,113,114,115,117,118,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,142,143,144,145,146,147,148,149,150,151,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],definit:[2,42,62,63,64,65,70,75,86,102,108,115,118,149,153],defint:167,deform:[2,43,68,74,136,137],deg2theta:44,degre:[2,5,6,8,12,13,16,17,18,36,38,39,44,45,46,47,49,50,55,56,59,62,67,74,75,77,79,81,84,88,89,93,94,95,96,113,116,125,167],degress:62,delai:[2,167],delet:[28,62,63,64,65,67,74,158,168],delete_atom:45,delete_bond:[20,21,22,23,24,25,26,27,28],delete_el:60,delimit:80,dellago:[2,69],deloc:[118,152],delr:139,delta_1:102,delta_3:102,delta_7:102,delta_ij:[139,149],delta_pi:102,delta_r:149,delta_sigma:102,deltah_f:71,demo:3,demonstr:[78,139],dendrim:125,denniston:73,denot:[41,69,110,124],dens:[67,80,118],densiti:[2,19,42,45,60,62,66,73,85,86,98,99,102,116,139,140,141,145,146,149,150,152,155,156,157,167],depart:0,departur:78,depend:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,36,39,42,45,46,47,48,49,50,51,52,53,54,55,57,58,59,62,64,65,66,68,71,73,74,75,76,80,81,83,85,86,87,88,89,90,92,93,94,95,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,139,140,142,143,144,145,146,147,148,149,150,151,152,153,154,159,160,161,162,163,164,165,166,167],dependend:2,deposit:[74,81],deprect:62,depth:[26,59,85,120,122,150],der:[32,108,109,135,165],deriv:[2,32,42,63,68,69,74,75,76,83,84,85,86,87,99,102,108,113,118,119,124,129,133,134,139,142,165],derjagin:165,derlet:76,descib:59,describ:[0,1,2,3,4,19,29,30,41,42,43,44,45,51,54,58,62,63,64,65,66,67,68,71,72,73,74,75,76,77,78,80,83,84,86,96,97,99,101,103,104,106,107,108,109,110,113,116,118,119,120,122,123,124,127,128,129,130,131,132,133,134,135,136,137,138,139,142,143,145,146,149,150,151,152,153,154,158,159,160,161,162,163,164,165,166,168],descript:[2,3],descriptor:[42,58],design:[0,2,3,41,44,60,67,74,76,85,100,101,106,110,112,118,135,136,137,140,141,149],desir:[2,3,4,35,39,40,43,45,62,65,68,72,74,81,96,97,114,116,125,136,137,159,160,162,167],desktop:[2,59],destabil:102,destre:94,destroi:3,detail:[1,2,3,4,19,34,35,39,40,42,43,45,57,58,59,60,62,63,64,65,66,67,68,69,72,73,74,75,78,81,84,85,96,98,99,101,102,105,106,107,108,109,110,113,114,118,119,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,143,145,146,150,152,153,154,164,165,167,168],detect:[36,97,109,125,126],determin:[1,2,4,26,32,39,41,43,44,45,58,59,61,62,63,64,65,66,68,71,74,76,77,78,79,80,86,87,99,105,109,113,116,120,121,123,131,139,142,146,150,152,158,165],devan:151,devanathan:162,develop:[0,2,3,4,75,78,99,102,118,141,142,152,163],deviat:[75,76,121],devic:1,devin:109,devis:141,dfactor:59,dft:142,dhug:78,dhugoniot:78,dia:139,diag:80,diagnost:[4,67,80],diagon:[2,42,43,68,74],diagonalstyl:153,diagram:[19,41,44,57,66,77],diallo:125,diam:59,diamet:[2,45,58,59,108,122,123,129,150,165],diamond:[118,139],dick:2,did:[96,114,116,123,160,162],dielectr:[106,110,111,112,127,131,135,148],diff:[2,4],differ:[1,2,3,4,19,28,29,32,36,42,45,57,58,59,62,64,66,67,68,69,72,73,74,76,77,78,81,82,83,84,85,86,87,88,97,98,99,102,105,106,108,109,114,115,116,118,120,122,123,124,127,128,130,131,138,139,140,141,143,144,145,146,147,149,150,151,152,153,154,159,160,162,163,165,167],differenti:[1,2,13,80,110,149,161],difficult:[68,77,125],difficulti:[36,38,81],diffract:[41,44],diffraction:[41,44],diffus:0,diffuse:2,digit:142,dihedr:[0,4,28,36,38,39,42,43,45,46,47,48,49,50,51,52,53,54,55,56,57,67,79,89,90,91,93,96,99,102,106,167],dihedral_coeff:[46,47,48,49,50,51,52,53,54,55,56,57],dihedral_cosine_shift_exp:11,dihedral_styl:[0,2,43],dihydrid:118,dij:81,dilat:[68,74,75],dim:[45,139],dimens:[1,2,19,35,43,45,58,59,62,66,68,73,74,75,78,86,97,167],dimension:[36,39,41,42,44,62,85,97,149],dimensionless:[37,42,85,153,165],dimer:[2,139],dimstr:[19,66],dintel_offload_noaffinity:4,dipol:0,dipolar:[13,58],dipole:113,dir:[1,3,76,78,149],dirac:42,direc:149,direct:[2,4,13,29,38,41,42,44,45,46,58,59,73,75,76,78,83,84,85,86,87,96,97,114,115,123,137],directli:[2,3,32,42,58,59,73,80,87,98,99,103,104,105,110,113,116,118,127,131,148,151,158,167],directori:[0,1,2,3,4,83,84,97,98,99,102,109,110,116,117,119,135,139,140,141,142,147,149,152,153,159,160,161,162,163],disabl:[4,85,126],disadvantag:[2,66],disallow:[58,74],discard:[19,66,87],discontinu:[96,133],discourag:139,discret:[2,59,73],discuss:[0,1],disk:[2,36],disloc:[29,142],disord:[29,142],disp:0,dispar:150,disperion:[113,131],dispers:[2,105,113,131,136,163],displac:[2,37,68,74,76,123],displai:[3,57,58,59],disregard:142,dissip:[2,31,70,72,83,84,114,115,123,136,137],dist:[2,35,40,58,77,79,158],distanc:[2,5,6,20,21,22,23,24,25,26,27,28,30,33,34,36,37,38,40,41,42,45,47,58,59,62,67,68,69,73,74,75,76,78,79,81,82,84,85,86,87,88],distinct:[2,150],distinguish:[2,42,118],distort:98,distrbut:98,distribut:[0,2,3,19,32,42,57,66,72,73,74,98,102,110,116,117,119,139,140,141,147,149,150,159,160,161,162,163],distro:149,ditto:166,div:4,divd:40,diverg:[84,99],divid:[2,4,19,35,39,40,43,57,62,63,64,66,76,96,97,119,152,163],divis:[2,56,73,102,135,167],dl_poly:2,dlammps_ffmpeg:59,dlammps_gzip:[58,59],dlammps_jpeg:59,dlammps_memalign:4,dlammps_png:59,dlammps_xdr:58,dlm:74,dlmp_intel_offload:4,dlopen:2,dlvo:[108,165],dm_lb:73,doc:[0,1,2,3,32,34,37,39,40,43,45,57,58,59,61,62,63,64,65,74,87,96,97,98,99,101,109,110,116,117,119,125,139,140,141,147,149,153,159,160,162,163,167,168],docuement:150,doe:[0,1,2,3,19,28,29,32,35,40,41,44,45,46,57,58,59,60,62,66,67,68,69,71,72,73,74,85,86,87,89,90,91,93,94,97,98,99,100,101,102,105,106,107,108,109,110,111,113,114,116,117,118,120,121,122,123,124,126,129,130,132,133,134,136,137,139,140,141,142,145,146,149,150,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],doesn:[45,58,99,109,117,159,160,161,162,163],dof:[39,62],dof_per_atom:62,dof_per_chunk:62,doi:[2,76],domain:[2,19,41,44,59,66,68,73,74,77,85,86,97],domin:[1,118],don:[0,4,87,139,152,168],done:[1,2,19,45,56,58,59,60,62,64,65,66,67,68,71,74,77,81,83,84,96,97,99,105,116,131,137,138,139,145,146,158,167,168],donor:125,dot:43,doti:[102,149],doubl:[1,2,3,4,32,46,87,102,119,124,142],dover:60,down:[2,3,68,118,152],download:3,downsid:2,dpd:2,dpdtheta:[31,115],dpdtheta_i:[70,71],dr_ewald:41,drag:[2,35,74,75,82],dragforc:73,drai:[59,78],drain:96,dramat:[67,68,74,152],drautz:102,draw:59,drawn:[58,59,72],drayleigh:78,dreid:2,dreiding:0,drfourth:37,drho:[98,116,145,146],drift:[2,37,69,72],drive:[3,68,74,76,97],driven:[2,51],driver:2,drop:114,drsquar:37,drude:0,dt_collis:73,dt_lb:73,dt_md:73,dtqm:78,dudarev:44,due:[1,2,4,28,29,33,34,37,41,42,43,44,45,58,59,64,67,68,72,73,74,75,76,79,83,84,85,86,87,96,97,111,114,115,116,121,122,136,137,149,150,151,158,160,162,165,166,167],duffi:85,dullweb:74,dummi:[13,161],dump:[0,1],dump_modifi:[2,58,59],dunbrack:[2,5,46,106],duplic:[19,66,76],durat:[57,62,85,123],dure:[2,4,19,32,46,58,60,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,77,78,79,81,82,83,84,85,86,87,96,97,114,135,142,144,145,146,167],dvlo:165,dvx:2,dx_lb:73,dy3:44,dyanam:2,dynam:[0,2,3,4,19,31,37,45,58,59,60,66,67,70,72,74,75,77,78,79,83,84,85,96,97,114,115,118,136,137,157],dynamo:[98,116,139],dyre:132,e28637:13,e_1:102,e_2:102,e_a:80,e_b:119,e_ee:118,e_hbond:125,e_i:[2,102,119],e_j:[2,102],e_k:102,e_ke:118,e_kl:2,e_lj:[99,113],e_n:102,e_ne:118,e_nn:118,e_pr:118,e_rebo:99,e_torsion:99,e_tot:142,e_vol:142,eaa:88,eaat:47,each:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,32,33,34,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,71,72,73,74,75,76,77,80,81,82,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,162,163,164,165,166,167],eacn:[19,66],eam:[0,98,110],eangl:167,earli:[19,62,64,65,66],earlier:[97,123,139],earth:118,easi:[2,3,32,43,58,86],easier:[4,58,59],easili:[3,59,97],eat:47,eaxmpl:2,eba:6,ebb13:47,ebb:6,ebond:167,ebt:47,ec_ii:139,ec_ij:139,ec_jj:139,echo:[3,41,44],ecoul:167,ecp:118,edg:[2,19,41,44,58,59,86,87],edge:86,edih:167,edit:[4,168],edition:4,edu:[3,116,136],eebt:47,eff:0,effect:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,33,34,37,39,40,43,46,47,48,49,50,51,52,53,54,55,57,58,59,60,61,62,63,64,65,67,68,69,72,74,75,76,77,78,79,81,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,142,144,145,146,147,148,150,151,152,154,159,160,161,162,163,164,165,166,167],effici:[0,1,2,4,39,56,58,59,63,68,74,77,81,102,108,110,127,131,142,145,146,150],efficienc:4,efield:[81,96],eggebrecht:[110,152],ehex:2,eigenvalu:77,eimp:167,einstein:[2,84],either:[1,2,3,4,19,29,41,42,43,44,45,58,59,61,63,64,65,66,67,68,69,73,74,75,76,80,81,87,96,102,108,116,120,123,136,137,139,142,146,149,158,160,162],ejtehadi:[108,122,150],elaplong:167,elaps:[86,154,167],elast:[2,21,22,97,123,161],elastic:0,elba:13,electr:[2,60,119,166],electric:4,electrolyt:165,electron:[2,41,60,85,98,109,113,116,118,119,139,142,149,152,162,163,166],electron_integr:60,electron_temperatur:60,electron_unit:118,electroneg:[2,109,119,152],electroneg_compon:152,electrostat:[2,4,108,113,118,127,135,137,152,165],elem1:[119,139,153],elem2:[119,139,153],elem:152,element1:[98,116,152],element2:[98,116,152],element:[2,33,37,39,40,42,43,58,59,60,62,63,64,65,98,99,102,109,116,117,118,119,139,140,141,142,147,149,152,153,159,160,161,162,163,167],elementn:[98,116],elementset:60,elif:42,elig:125,elimin:[2,72,81,83,84],elj:113,ellips:2,ellipsoid:[2,45,58,96,122,137,150],elong:167,els:[40,59,61,62,63,64,65,74,85],elsewher:[139,167],elt:139,emac:0,email:[0,3,119],emb:87,emb_lin_neg:139,embed:[3,13,85,98,116,119,135,139,140,141,149],embt:47,emol:167,emphas:123,empir:[60,118],empiric:99,emploi:[69,161],empti:126,enabl:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,31,32,37,39,41,42,44,46,47,48,49,50,51,52,53,54,55,57,58,67,69,70,71,72,73,74,75,76,77,78,79,80,81,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],enclos:[2,58,139,152],encod:[58,59],encompass:2,encount:[38,64],encourag:[80,82],end:[1,2,3,4,19,47,58,59,63,64,65,67,69,72,74,79,80,85,97,114,116,122,138,142,150,153,154,167],endbondtors:47,energet:[67,99],energi:[0,1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,18,20,21,22,23,24,25,26,27,28,31,32,35,39,43,45,46,47,48,49,50,51,52,53,54,55,56,57,58,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114],energy_compon:152,enforc:[2,58,59,67,74,81,127],enforce2d:[2,96],eng:[3,58,109,141],engineer:[60,83,116],enginer:140,enhanc:[60,69],enlarg:59,enough:[45,66,78,86,87,110],enpub:116,ensembl:[2,32,35,74,77,78,114,152],ensight:2,ensur:[2,42,58,68,72,74,102,135,159,163],enter:[119,142,163],enthalpi:[80,116,167],entir:[0,2,3,19,31,39,41,43,44,45,62,66,67,69,72,74,75,76,77,80,82,85,113,131],entiti:[2,58],entri:[41,64,71,78,102,117,139,145,146,147,153,159,160,161,162,163],entry1:[145,146],enumer:58,enumuer:2,environ:[1,2,3,4,59,76,98,102,109,117,118,149,160],eos:71,epair:[99,121,125,167],epp:113,epq:113,eps0:165,eps14:135,epsilon0:162,epsilon:[2,18,21,22,27,28,32,46,86,87,96,101,106,107,108,110,111,112,113,120,122,124,125,126,127,128,129,130,131,132,133,134,135,138,143,148,150,151,159,164,165],epsilon_0:166,epsilon_14:106,epsilon_:150,epsilon_d:111,epsilon_i:[122,150],epsilon_i_:150,epsilon_i_a:[122,150],epsilon_i_b:[122,150],epsilon_i_c:[122,150],epsilon_j:[122,150],epsilon_j_:150,epsilon_j_a:[122,150],epsilon_j_b:[122,150],epsilon_j_c:[122,150],epsilon_lj:150,eqp:113,eqq:113,equal:[2,3,19,28,32,35,40,43,45,59,63,64,65,66,68,72,73,75,76,77,78,79,80,83,84,85,86,96,97,99,109,114,115,121,122,125,136,142,143,149,150,152,153,154,163,166,167],equat:[2,35,38,39,41,44,57,68,69,70,71,73,74,75,76,77,78,80,81,85,86,108,113,114,115,118,119,120,123,136,137,139,146,150,155,156,157,166],equation:[76,94],equilibr:[2,35,45,63,67,68,74,78,83,84,109,110],equilibrium:[1,2,6,8,10,11,12,13,16,17,18,20,23,24,25,26,27,47,48,68,72,73,74,75,78,79,81,84,88,89,93,94,109,139,147,152],equilibrium_start:60,equival:[2,13,40,58,61,62,63,64,65,68,74,79,99,114,118,152,160,162,167],equlibrium:2,er3:44,eradiu:118,eras:83,erat:137,erc:110,erfc:[110,127],erhart:[116,160,162],eros:139,erose_form:139,erot:2,errata:[160,162],erratum:86,error:[0,1,2,3,11,40,48,58,59,61,62,63,64,65,68,69,71,74,80,85,86,87,96,110,127,150,158,160,162],erta:123,especi:[4,45,66,78,79],essenti:[3,11,48,63,99,110,127,162,167],essential:75,essex:13,establish:32,estim:[1,2,19,29,35,43,60,66,80,167],esub:139,eta:[2,73,74,78,117,119,122,149,161,163],eta_dot:74,eta_ij:149,eta_ji:119,etail:167,etap:74,etap_dot:74,etc:[1,2,3,4,28,33,34,35,43,45,58,59,60,61,62,64,65,72,74,85,87,96,97,116,117,135,137,142,159,160,162,163,167],etol:[96,97],etot0:78,etot:[2,43,78,167],eu2:44,eu3:44,euler:[80,96,97],eulerian:60,europhi:73,evalu:[3,32,35,40,42,45,46,58,59,60,61,62,63,64,65,72,80,86,96,142,145,146,149,152,167],evanseck:[2,5,46,106],evaul:96,evdwl:167,even:[2,4,19,29,56,58,61,62,64,65,66,68,69,74,85,86,87,96,97,101,118,119,123,150,163,167],evenli:[19,43,66,73],event:[2,74,85],eventu:2,ever:28,everaer:[108,122,150],everi:[0,1,2,3,4,19,35,58,59,60,61,62,63,64,65,66,67,68,69,73,74,75,76,78,80,81,85,97,114,135,152,167,168],everyth:168,everywher:129,eviri:118,evolut:[69,73,77],evolv:[73,77],ewald:[2,41,43,96,103,104,105,110,113,118,127,131,148,151],ewald_disp:113,exact:[19,66,67,72,85],exactli:[2,19,35,45,64,66,72,78,114,116,123,136,145,146],examin:[2,67,80],exampl:[0,1],exce:[2,4,19,61,62,64,65,66,68,74,96],exceed:[19,66,74],excel:118,except:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,33,34,39,40,43,45,46,47,48,49,50,51,52,53,54,55,57,58,62,63,64,66,68,74,75,77,81,85,88,89,90,92,93,94,95,97,98,99,100,103,104,105,106,107,108,109,110,112,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166,167],excess:118,exchang:[2,60,69,85,118],excit:118,excite:118,exclud:[2,4,39,42,58,62,96,123,136,137,158],exclus:[1,4,32,46,109,142],excurs:74,execut:[1,2,3,59],exempl:152,exemplari:72,exemplifi:118,exert:[2,87],exhaust:60,exhibit:[36,69,74,118],exist:[2,3,29,45,57,59,68,88,89,90,91,93,115,158,168],exit:[3,19,58,66,167],expans:[42,56,58],expect:[1,4,19,66,76,78,139,142],expens:[2,76,85],experi:[2,79,97,114],experienc:[2,4],expir:167,explain:[1,2,3,19,30,58,59,62,63,65,66,68,74,76,97,101,116,152,154,168],explan:[2,42,58,62,76],explanatori:[40,58,61,62,64],explic:143,explicit:[2,3,32,80,99,102,106,116,118,126,136,168],explicitli:[2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,55,58,72,74,75,78,81,85,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,111,113,114,116,117,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,140,142,144,145,146,147,148,150,151,154,155,156,157,159,160,161,162,163,164,165,166,168],explictli:4,exploit:77,explor:[41,44],expon:[80,116,120,122,125,135,143,151],exponenti:[32,80,120,149,159,163,166],expos:3,exposit:[60,114],express:[2,42,45,68,76,80,85,102,116,118,129,139,152,153],expressiont:102,extend:[0,2],extens:[2,4,21,22,27,32,35,40,65,69,74,75,76,79,83,84,85,86,87,122,139,142,150,153,167],extensiv:167,extent:[1,19,21,58,66,99],exterior:[2,87],extern:[32,59,68,72,73,74,75,85,96,140,141],extra:[2,3,4,19,22,39,41,43,44,45,64,66,74,78,96,113,123,139],extract:[2,3,18,32,40,97,110,119,139,153],extract_atom:3,extract_comput:3,extract_fix:3,extract_glob:3,extract_vari:3,extrapol:1,extrem:[1,2,59,68,74,84,118,161],extrema:135,extreme:118,extrins:60,f_1:2,f_a:[160,161,162],f_ave:40,f_c:161,f_f:162,f_fix_id:78,f_harm:84,f_i:[13,149],f_id:[2,40,58,61,62,63,64,65,167],f_ij:149,f_indent:65,f_int:83,f_j:13,f_jj:35,f_k:149,f_langevin:85,f_max:78,f_r:[160,161,162],f_sigma:102,f_solid:84,f_ss:2,face:[2,86,87,122,139,150],facil:0,facilit:2,fact:[2,4,84,123,152],factor:[1,2,8,12,16,17,18,19,22,23,32,35,41,42,44,46,54,58,59,63,66,68,69,73,74,75,77,79,80,81,86,87,93,99,102,103,104,106,110,111,112,114,115,118,123,126,127,139,142,145,146,147,148,151,154,159,167],fail:[3,68,96,97,112],fairli:[3,168],faken:30,fall:[2,64],fals:152,famili:163,familiar:[0,3,168],fan:149,far:[2,58,66,68,74,76,79,86,89,93,97,167],farrel:[160,162],farther:58,fashion:[2,19,45,66,74,75,78,84,85,86,97,136],fast:[2,4,58,78,80,136,137,142,167],faster:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,37,39,46,47,48,49,50,51,52,53,54,55,58,66,74,75,81,83,85,88,89,90,92,93,94,95,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166],fastest:[1,2,85],fault:29,fava:122,favor:67,fcc:[2,29,30,35,38],fcold:69,fdt:[70,71,80],fdti:32,fe2:44,fe3:44,fe_md_boundari:60,featur:[0,2,3,42,59,67,72,77,87,96,168],fecr:116,feel:[76,87,97],fehlberg:80,felling:141,felt:87,fene:[2,4],fennel:[110,127],fep:0,ferguson:[2,46],fermi:[1,162],fermion:118,fernando:138,few:[1,2,3,61,62,63,64,65,69,74,81,96,97,99,152],fewer:[1,3,4],feynman:77,ffield:[109,119,152],fflag1:59,fflag2:59,ffmpeg:59,ffplai:59,fft:[1,3,43],fhot:69,ficiti:158,fictiti:[2,77,79,110,127,131,158],field:0,fifth:[2,120,147],figshar:76,figur:[1,4,78,168],fij:113,file0:76,file1:[3,71,76],file2:[3,71],file:[0,1],filenam:[4,19,58,59,60,62,63,64,65,66,71,76,80,85,97,98,99,102,110,116,117,119,120,139,140,141,145,146,147,149,152,153,159,160,161,162,163,167],filep:58,fill:[45,59,85,102,142,168],filter:60,finchham:[2,112],find:[0,2,3,4,30,32,40,67,68,71,76,79,96,97,110,127,131,139,145,146,152,168],fine:[4,84,168],finer:[42,45],finger:45,finish:[2,3,19,66],finit:0,finni:116,fire:[96,97],first:[0,1,2,3,4,6,19,21,22,28,29,35,37,38,39,40,43,44,47,58,59,62,63,64,65,66,67,71,72,73,74,76,77,78,81,82,83,84,85,88,96,97,98,99,101,102,103,104,106,109,110,116,118,119,120,123,124,126,127,131,136,137,139,141,142,145,146,147,149,152,153,158,159,160,161,162,163,166,167,168],fischer:[2,5,46,106],fit:[2,79,99,102,139,145,146,161,168],five:[30,78,102,140],fix:[0,1],fix_flux:60,fix_heat:69,fix_id:[68,74,75,78],fix_manifoldforc:168,fix_modifi:2,fix_nv:168,fix_rattl:81,fix_shak:81,fixedpoint:[68,74],fixid:[59,60],fji:113,flag:[3,4,33,34,41,44,58,59,65,67,99,125,126,139,142,158,168],flag_buck:105,flag_coul:[105,113,131],flag_lj:[113,131],flagfld:[136,137],flaghi:[136,137],flaglog:[136,137],flagvf:[136,137],flat:[2,4,85,86],fld:[86,136,137],flexibl:[2,59,62,118,161,167],flip:[2,74],fluctuat:[2,32,68,72,73,74,75,76,84,85,94,115],fluid:[2,40,68],flux:2,flv:59,fly:[19,59,60,81,102,142,167],fmass:77,fmax:[96,167],fmsec:74,fno:4,fnorm:[96,167],fnve:69,focu:81,foil:[42,76,153],fold:[4,82],follow:[0,1,2,3,4,5,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,35,36,38,40,42,43,45,46,48,49,50,51,52,53,54,55,56,58,59,60,61,62,63,64,65,66,70,71,72,73,74,75,77,78,79,80,81,83,84,85,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,168],foo:[3,58,59,80],foo_species:80,foot:2,forc:[0,1],forcefield:[79,125],forcegroup:73,ford:113,forgiv:74,fork:[58,168],form:[2,28,32,33,34,36,40,42,43,58,61,62,63,64,65,72,79,80,85,86,87,88,91,94,97,99,102,115,116,118,121,125,126,138,139,141,142,145,146,147,148,149,150,152,153,154,160,161,162,165,167],formal:[2,35,72,74,77,152],format:[2,19,58,59,62,64,65,66,71,80,85,97,98,99,102,116,119,120,126,139,141,145,146,151,153,163,167],formation:71,former:[2,19,66,85,102],formul:[1,2,43,74,79,81,99,102,116,118,122,139],formula:[2,6,28,29,30,32,33,34,35,39,41,43,44,45,47,57,58,62,63,64,65,76,82,86,88,90,99,101,102,106,107,108,113,114,116,117,122,123,124,125,126,127,129,130,131,133,134,136,137,139,143,144,150,151,154,159,160,161,162,163,164,165,167],forth:[1,2,3],fortran:[2,3,116,139],forward:[32,97],foster:[102,149],found:[2,30,58,67,69,73,110,113],four:[2,3,28,42,85,94,97,142],fourier:2,fourth:[2,4,37,79,106,120,147,152],fox:[2,41,46,157],fqq:113,fraction:[1,2,4,19,43,59,67,68,78,80,97,102,120,123,136,137],frame:[42,60,78,122],framer:59,framework:[98,153],frattl:69,free:[2,13,29,32,76,83,84,85,97,118,135,142,144,149,165],freedom:[2,39,62,67,74,75,77,81,84,96,113,167],freeli:[0,2,59],freez:2,frenkel:[2,69,84],frequenc:[2,4,77,78,80,114,118,152],frequent:[29,30,36,38,42,69],fri:78,friction:[2,78,85,123],from:[0,1],front:78,frontend:59,frozen:[2,39,72,121],fs2:[2,35],ftol:[96,97],fuction:110,fudg:81,fulfil:2,full:[1,2,4,35,59,63,69,73,76,80,102,116,118,119,122],fuller:96,fulli:[2,76,96,97,110,149,168],fulton:116,fumi:103,funcfl:116,fund:0,funrol:142,further:[2,37,59,62,64,65,73,77,85,96,97,98,101,109,142,152],furthermor:[11,48,69,80,115,118],futur:[0,2,66,72,97,140,141],g_jik:149,g_p:85,ga3:44,gaa:102,gai:122,gain:4,galindo:143,gamma0:13,gamma:[2,13,73,78,114,115,117,122,139,143,155,156,157,159,160,162,163,167],gamma_:85,gamma_ijk:160,gamma_n:123,gamma_p:85,gamma_t:123,gammaa:143,gammafactor:73,gammar:143,gan:[149,159,160,162,163],gan_sw:149,gan_tersoff:149,gao:[2,5,46,106],gap:[136,137,153],gather:3,gather_atom:3,gathert_atom:3,gauch:51,gauss:111,gaussian:[2,35,37,72,77,79,114,118,121],gavhan:4,gaybern:[2,4,96],gd3:44,gdot:137,ge4:44,gec:[160,162],gen:74,gener:0,gentler:86,gentli:117,geom:2,geometr:[2,45,58,66,74,87,97,101,107,108,110,113,118,120,122,124,127,128,129,130,131,132,133,134,135,136,137,138,143,146,150,154,164,165,167],geometri:[2,9,19,45,66,68],gerber:135,germann:[75,129],germano:122,get:[0,1,2,3,4,19,35,42,45,58,59,61,66,68,87,97,110,163,168],get_natom:3,get_rank:3,get_siz:3,gewald:2,gezelt:[110,127],ghost:[2,4,30,68,74,114,115,118,123,126],gif:59,gifsicl:59,gillan:153,gingold:[155,156],git:168,give:[0,1,2,3,4,28,36,38,45,58,62,63,64,65,68,74,76,96,99,102,118,125,139,142,150,160,161,162],given:[2,3,4,11,38,42,43,48,57,58,62,68,69,72,73,74,75,76,77,78,79,80,81,82,85,86,87,98,99,102,103,104,105,107,108,109,110,111,114,115,116,118,119,120,122,123,125,127,128,129,131,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,166],glosli:142,glotzer:114,glue:3,gnu:0,gnuplot:3,goddard:[2,9,95,118,125],goe:[28,42,45,69,96,113,117,124,129,132,154,166],gold:29,goldman:78,good:[1,2,4,19,30,41,44,66,74,81,97,98,108,116,142,163,167,168],gordan:42,gordon:2,got:168,gould:[2,46],gov:[0,98,116,119],govern:73,gpa:99,gpl:0,gpt:142,gpu:[1,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,74,75,81,88,89,90,92,93,94,95,98,99],grab:2,grad:2,gradient:[2,68,69,85,97,137,145,146],graft:67,grain:[2,13,18,28,45,51,71,76,80,120,124,142,146,151],gram:[62,116],gran:[2,86,87],granular:0,graph:3,graphic:3,graviti:2,grdient:60,great:[78,168],greater:[1,68,72,74,76,101,103,104,105],greatli:[41,69],green:[2,35,59,77,102,168],green_kubo:2,grest:[21,22,67,105,123,131],grid:[19,41,44,66,73,85],grigera:2,gromac:96,gromacs:[2,58,96,124],groot:114,ground:[2,31,70,118],group:[2,3,4,19,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,97,152,163,167],group_id:3,grow:[2,74,76,80,123],growth:2,gsmooth_factor:139,guarante:[45,58],guess:[58,168],gui:[3,168],guid:[1,155,156,157],guidelin:1,gullet:139,gulp:2,gunnel:142,gunsteren:135,guo:[2,5,46,51,106],gyrat:2,gzip:[58,59,97],h12:122,h2o:[120,146],had:[2,3,40,58,61,62,63,64,65,67,68,72,74,75,85,114,123,158,167],hafskjold:[2,69],half:[1,2,4,19,59,61,66,74,85,86,87,102,108,118,142],halfwai:[19,59,168],halperin:36,halsei:123,halt:[19,66,69],halv:59,hamak:[86,87,108,150],hamilton:29,hamiltonian:[74,118],han:116,hand:[2,28,29,45,55,59,73,80,110,118],handl:[4,59,118,136,163],happen:[2,63],hara:161,hard:[1,79,152],harden:154,harder:[86,87],hardi:60,hardwar:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,74,75,81,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166],harmon:[2,4],harmonic_fix_wal:137,harrison:99,hartre:[116,118,142],hassl:79,hat:2,have:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,34,35,36,37,38,39,42,43,45,46,47,48,49,50,51,52,53,54,55,58,59,61,62,63,65,66,67,68,72,73,74,75,76,77,78,81,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,102,103,104,105,106,107,108,109,110,113,114,115,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,144,145,146,147,148,149,150,151,152,154,159,160,161,162,163,164,165,166,167,168],hbond:2,hcn:80,hcp:[29,30,139],he1:44,head:[2,6,47,88,99,121,125,168],header:[2,58,59,62,63,64,65,78,85,98,102,116,158],heat:2,heavili:[19,66],heavisid:85,hebenstreit:4,height:[59,97,121],held:[2,80,97,123],helic:51,helium:100,help:[4,58,68,76,102,144,160,162,168],henc:[1,5,6,10,16,17,18,29,47,62,74,86,87,88,89,93,94,110,121,135,149],henderson:27,henkelman1:97,henkelman2:97,henkelman:97,here:[1,2,3,4,19,29,41,44,50,57,58,59,62,66,67,72,73,76,78,85,86,96,97,99,102,119,122,125,126,138,149,150,152,166,168],hertzian:[2,123],hertzsch:123,heterogen:37,hex:[45,69],hexagon:[36,139],hexat:36,hey:43,hf4:44,hfo:109,hftn:[96,97],hg1:44,hg2:44,hibb:77,hierarchi:[105,106,127,128,131,138,143],higdon:[136,137],high:[1,2,4,19,38,58,59,66,68,85,96,99,102,118,122,142,145,146,150,166],higher:[1,4,42,62,65,69,96,99,118,152],highest:[69,97],highli:[2,4,45,59,74,78,96,118],highlight:2,hight:121,hill:77,histo:[2,44,61,62,63],histogram:[1,2,63,64,65],histor:119,histori:[0,2],ho3:44,hoc:94,hoh:[2,110,127,131],hold:[2,62,79,96,97,123,135,165],holdem:79,holian:[75,129],holm:76,home:3,homepag:59,hone:77,hood:142,hook:[2,3],hookean:123,hoover:[2,74,75,77,84,114],hop:[67,97,102,152],hope:[19,66],hopefulli:96,horn:2,host:4,hot:2,hove:139,how:[0,1],howev:[1,2,3,4,18,19,35,41,42,44,58,59,63,65,66,67,68,72,73,74,76,77,78,85,97,107,108,116,117,123,139,142,145,146,149,159,162,167,168],howto:[2,58,74,110,125,127,131],hoyt:60,hpc:1,htm:116,html:[0,3,121,137],htmldoc:0,http:[0,2,3,76,98,116,136,168],https:168,htype:[110,127,131,135],hubbard:111,huge:168,huggin:[103,104],hugh:60,hugoniostat:75,hugoniot:[75,78],hundr:69,hura:2,hybrid:[1,2,4,32,57,74,98,99,109,110,114,116,119,122,123,125,126,135,139,140,141,142,147,149,150,152,153,158,159,160,161,162,163,166],hydrat:121,hydrocarbon:[99,109,118],hydrodynam:[73,136,137],hydrogen:[2,99,102,110,118,125,127,131,135],hydrostat:[68,74,75],hynninen:[111,121],hyoungki:141,hyper:[4,77],hyperbol:111,hyperspher:42,i_0:85,i_1:149,i_csid:2,i_mpi_pin_domain:4,i_mpi_shm_lmt:4,i_n:149,i_nam:58,ialloi:139,ibar:139,ibead:77,ibm:[58,142],icc:142,ice:2,icm:168,icms:168,icosohedr:30,id1:[97,126],id2:[97,126],id_press:[68,74,75],id_temp:[67,68,74,75],idea:[1,2,3,19,43,59,66,76,168],ideal:[2,30,76,136,155,168],idealiz:2,ident:[1,4,42,58,64,68,72,74,76,77,97,103,104,110,112,116,127,129,135,147,152,153,163,166],identifi:[1,2,29,45,71,125,126,139,145,146],idn:97,ielement:139,ignor:[2,3,4,19,32,58,59,63,64,65,66,68,74,75,79,85,86,87,97,98,107,108,116,117,119,122,126,139,145,146,147,149,150,159,160,161,162,163],iii:[2,9,95,125],ijj:163,ijk:[92,94,95,102,149,163],ijl:94,ikeshoji:[2,69],ikj:163,ill:62,illinoi:136,illustr:[1,2,3,4,76,77,97],imag:[2,3,33,34,41,45],image2pip:59,image:[58,59],imagemagick:59,imagin:[102,117,140,141,147,149,159,160,161,162,163],imaginari:[2,36,77],imbal:[1,19,66,80],imbalanc:[19,66],img:59,immedi:[0,45,80,81],immers:73,impact:[1,2,99],impart:2,impei:[2,127],implement:[1,2,11,31,32,38,41,44,45,48,57,62,69,70,73,74,77,78,80,81,85,94,96,97,98,102,109,110,112,114,115,116,117,118,127,131,135,139,150,160,162],impli:[2,32,43,59,79],implicit:[2,72,86],implict:111,important:84,impos:[2,39,69,76,83,84,86,87,96,97],imposs:1,improp:[0,4,39,43,45,67,88,89,90,91,92,93,94,95,96,167],improper:[4,94],improper_coeff:[88,89,90,91,92,93,94,95],improper_styl:[0,2],improv:[0,1,4,19,66,69,74,125,127,142,159,161],in3:44,inaccur:[1,2],inaccuraci:87,inact:[125,167],inappropri:45,incid:[41,44],includ:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,32,33,34,35,36,37,38,39,40,41,42,43,44,46,47,48,49,50,51,52,53,54,55,57,58,59,60,61,62,63,64,65,67,68,72,73,74,75,76,77,78,79,80,81,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,144,147,148,149,150,151,153,154,159,160,161,162,163,164,165,166,167,168],inclus:[0,32,40,58,61,62,63,64,65,167],incompat:3,incomplet:3,incompress:118,inconsist:67,incorpor:[56,78,102,111,168],incorrect:139,incorrectli:123,increas:[1,2,4,41,43,58,59,67,69,71,79,80,97,99,118,122,145,146,161],increasingli:118,increment:[3,66,74,152],incur:[62,85],indefinit:83,indent:[65,96],independ:[2,3,19,35,40,45,61,62,63,64,65,66,67,68,72,73,74,84,85,123,142],indetermin:58,index:[0,2,3,40,58,61,62,63,64,65,71,77,85,145,146,167],indic:[2,3,4,6,28,31,33,35,37,39,40,43,47,58,59,61,62,63,64,65,68,74,85,88,94,109,119,139,142,147,152,160,162,167,168],indirectli:2,indium:153,individu:[0,1,2,3,4,32,39,40,43,45,57,58,59,61,62,63,64,65,68,69,73,74,81,96,103,104,106,107,110,116,118,124,126,127,131,148,151,167],induc:0,ineffici:[2,29,30,36,38,42,59,74],inerti:137,inertia:[2,137],infer:[66,119,167],infin:[96,167],infininti:59,infinit:[73,85,118],infinitesim:2,inflect:[111,129],influenc:[19,160,161,162],inform:[0,1,2,3,4,19,40,41,44,45,46,58,59,60,61,62,63,64,65,66,67,68,69,73,76,79,81,82,83,86,87,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],infrequ:[2,74,114],infti:[111,136,137],ingtegr:102,inher:96,inherit:2,inhomogen:85,inidividu:96,init:152,init_fil:85,initi:[2,3,19,32,58,59,60,63,66,67,68,71,72,73,74,75,77,78,79,80,83,84,85,86,96,97,99,113,114,142,145,146,152,167],initial:2,initialt:85,inlclud:3,inner2:[106,124],inner:[4,58,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],inner_distance_cutoff:125,innner:133,inorgan:[2,163],inp:[153,163],input1:40,input2:40,input:[0,1],insert:[45,153,158],insid:[2,3,45,58,61,69,73,86,87],inside:[73,129],insight:2,instabl:[73,113],instal:[1,2,3,4,58,59,97,105,106,127,131,135,142,168],install:0,instanc:[2,3,121,149],instantan:[2,67,68,72,74,75,78,167],instanti:[2,3,60],instead:[1,2,3,4,19,29,34,40,46,58,62,64,65,66,68,73,104,105,116,126,128,135,139,142,144],instruct:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,59,74,75,81,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166],instruction:3,insuffici:2,insult:74,insur:[2,3,30,45,58,59,85,86,87,108,122,150,167],integ:[2,3,29,38,40,42,45,46,49,50,53,56,58,59,62,67,72,73,78,80,85,92,114,115,139,153],integral:[77,145,146],intel:1,intel_coprocessor:4,intel_cpu_intelmpi:4,intel_cpu_mpich:4,intel_cpu_openpmi:4,intend:[2,18,72],intens:[1,2,33,34,35,37,39,40,41,44,62,63,64,65,66,67,74,75,85,167],intensiv:167,inter:[58,67,97,102],interact:[1,2,3,13,28,32,36,38,39,42,43,46,51,56,57,58,67,76,77,79,80,85,86,87,89,90,91,93,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,146,148,149,150,151,152,153,154,158,159,160,161,162,163,164,165,166,167],interatom:[45,58,83,84,98,102,116,118,139,142,152,161],intercept:41,interchang:2,interconvert:118,interesect:87,interest:[1,3,44,77,84,117,137],interf:168,interfac:0,interfer:[74,99],interg:2,interi:137,interior:[2,19,87],interlac:139,interleav:[2,45],intermedi:[2,59,76,94,97],intermolecular:99,intern:[0,2,3,4,5,6,8,12,16,17,18,31,32,43,47,59,60,70,71,74,75,80,88,89,93,94,96,115,120,145,146,155,167],internal:59,internal_element_set:60,internal_quadratur:60,internat:[4,41,44,60],interpenetr:139,interpentr:[155,156],interpol:[2,59,60,71,73,76,97,102,145,146,160],interpret:[2,3,56,59,64,123,154],interrupt:78,intersect:[2,41,87],intersert:87,interspers:96,interstiti:142,interv:[2,35,63,74,78,152],intestieti:41,intial:[2,99],intiial:19,intramolecular:13,introduc:[2,36,38,59,69,74,78,94,98,110,118,127,131,135,159],introduct:0,inv:[41,44],invalid:[33,97,136,137],invari:[38,42],invent:81,invers:[2,26,41,44,78,94,95,103,110,127,164,165],invert:[1,2],invis:87,invoc:67,invok:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,33,34,39,40,45,46,47,48,49,50,51,52,53,54,55,58,59,60,61,62,63,64,65,66,67,68,69,72,73,74,75,76,81,82,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,140,144,147,148,150,151,153,154,159,160,161,162,163,164,165,166,167],involv:[2,40,73,96,97,101,122,159,160,162],ion:[2,85,102,111,119,121,139,142,152,162,166],ionic:[2,103,104,111,118,119,148,152],ioniz:[109,118],ipp:0,ir3:44,ir4:44,irregular:[2,19,66,68,74],irrelev:147,irrespect:[136,137],irrevers:80,isbn:165,isenthalp:74,ismail:[105,131],isn:[3,69],iso:[68,74,75],isobar:[74,115],isodem:118,isoenerget:115,isoenthalp:115,isol:123,isomorph:77,isotherm:[74,115],isotrop:[2,36,122,136,137],issu:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,30,39,46,47,48,49,50,51,52,53,54,55,59,67,68,69,74,75,77,81,84,88,89,90,92,93,94,95,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,150,151,154,158,159,160,161,162,163,164,165,166,167],issue:60,item:[2,19,58,66],iter:[2,19,66,68,81,96,97,152,167],iterat:96,ith:[40,58,61,62,63,64,65,167],itself:[2,3,35,58,59,63,85,97,110,119,122,145,146],ityp:45,izumi:161,j0jt:35,j20:63,j_m:42,jackson:143,jacs:[2,46],janssen:76,januari:139,jaramillo:118,jcp:86,jeffer:4,jello:74,jeremi:141,jik:102,jmm:42,job:81,jochim:74,join:[2,29,123],joint:125,jon:29,jone:[1,2,21,22,32,46,60,69,86,87,96,99,101,104,105,106,107,108,113,122,124,125,126,127,128,129,131,132,134,135,138,143,149,150,151],jonsson:[30,97,152],jorgensen:[2,54,110,127,131],journal:[51,60,116,142,155,156],jpeg:59,jpg:[58,59],judici:2,jump:[2,18,75],jun:4,just:[2,3,13,35,43,58,59,62,85,97,99,101,149,168],justo:117,jusufi:[111,121],jut:87,k11:35,k22:35,k33:35,k_2:91,k_4:91,k_sigma:102,k_ub:5,kalia:163,kapfer:38,kappa:[2,35,110,115,127,164,165],kappa_:85,karplu:32,karttunen:73,kate:0,kaufmann:4,kayser:111,kcal2j:35,ke_eta_dot:74,ke_etap_dot:74,ke_omega_dot:74,keblinski:[110,152],keef:41,keep:[55,80,84,96,110,135,153,167,168],kei:[2,163],kelchner:29,kemper:109,kepler:1,kept:[2,75,83,84],kernel:[4,60,72,142,155,156,157],keword:59,keyword:[2,4,19,29,32,34,36,37,38,39,40,41,42,43,44,45,58,59,60,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],keywrod:118,khersonskii:42,khvostov:4,kim:[139,140,141],kind:[1,2,3,19,30,40,58,59,62,63,64,66,67,81,97,102,118],kinemat:[136,137],kinet:[2,32,35,39,43,62,68,69,74,75,78,80,96,118,120,146,167],kjl:94,klein:[2,60,74,127,151],kmax:41,kmp_affinity:4,knight:4,knl:4,knock:85,know:[3,19,96,117,168],knowledg:59,known:[42,59,69,83],kokko:1,kokkos:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,74,75,81,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166],kollman:[2,46],kone:[83,84],koning00a:83,koning00b:83,koning96:[83,84],koning97:84,koning99:83,kraker:4,kremer:[21,22],kress:[140,141],kspace:[0,1,2,32,39,43,96,103,104,105,106,110,113,127,131,135,137,151,167],kspace_modifi:[2,4],kspace_styl:0,kstart:79,kstop:79,kth:[72,77],kub:5,kubo:[2,35],kumagai:161,kumar:[136,137],kuronen:149,kutta:80,l12:139,l_box:118,l_skin:85,la3:44,label:[58,69,77,97],laboratori:[0,31,70,78],lack:[4,118],lackmann:102,ladd:84,lafitt:143,lag:85,lagrangian:[2,60,78],lagrangian_posit:78,lagrangian_spe:78,lambda1:[160,161,162,163],lambda2:[160,161,162],lambda3:[160,162],lambda4:163,lambda:[32,41,44,73,83,84,85,98,117,135,144,159],lambda_fin:83,lambda_initi:83,lamda:[27,144],laminar:157,lammp:[0,3,97,139,142,168],lammps2pdb:2,lammps_clos:2,lammps_command:2,lammps_extract_atom:2,lammps_extract_comput:2,lammps_extract_fix:2,lammps_extract_glob:2,lammps_extract_vari:2,lammps_fil:2,lammps_get_coord:2,lammps_get_natom:2,lammps_ns:2,lammps_open:2,lammps_potentials:109,lammps_put_coord:2,lammps_quest:2,lammps_rk4:80,lammps_set_vari:2,lammps_sppark:2,lammps_vers:2,lamms:2,lamoureux:2,land:4,landron:152,lane:1,langevin:[2,72,74,75,78,79,84,85,97,113,114],languag:[2,3],larentzo:[31,70],larg:[0,1,2,4,19,29,43,45,51,58,59,62,66,67,68,69,73,74,78,79,81,85,86,87,94,96,108,114,118,122,123,126,142,145,146,150],larger:[1,2,3,19,29,45,59,63,64,65,69,73,74,79,85,86,87,96,97,102,108,110,111,118,123,127,131,137,158],largest:[2,45,96,145,146,158],laser:85,last:[1,2,3,40,43,56,58,59,62,63,64,65,66,80,96,97,100,101,102,103,108,109,114,115,116,121,122,123,124,125,128,130,132,133,134,137,143,144,150,152,154,158,164,165,167],lat:139,later:[2,3,63,75,96,99,102,168],latest:[62,63,64,65],latitud:42,lattc:139,latter:[2,3,4,19,32,61,62,63,66,68,74,80,87,102,104,105,106,107,113,127,131,135,142,148,151,152,167],lattic:[2,19,29,30,35,36,41,44,45,62,66,73,76,86,87,98,116,139,167],launch:[1,2,3,4],laupretr:94,law:2,layer:[2,85],layout:1,lb_fluid:73,lbtype:73,ld_library_path:3,lead:[2,9,19,32,40,58,61,62,63,64,65,66,73,75,78,80,81,94,97,110,127,131,133,142,167,168],least:[2,41,44,69],leav:[3,6,19,43,47,66,68,74,81,88],lee2:139,lee:[60,139],left:[2,3,19,57,59,67,76,80,168],leftmost:[19,66],legaci:4,leimkuhl:74,leiu:114,lenart:[111,121],length:[2,3,4,6,19,27,28,29,31,32,33,34,35,37,39,40,41,44,47,58,59,64,65,66,67,68,71,73,74,75,76,81,85,86,87,96,97,99,102,103,104,110,111,118,121,125,127,139,145,146,160,164,165,167],lennard:[1,2,21,22,32,46,69,86,87,96,99,101,104,105,106,107,108,113,122,124,125,126,127,128,129,131,132,134,135],lenoski:[140,141],less:[1,2,4,19,36,38,62,64,65,66,67,68,69,74,76,96,102,106,122,123,136,137,150,159,162,165],let:[1,50,63,71,81,108,145,146],lett:[42,73,83,84,102,116,118,122,135,145,146,153],letter:[19,66,77],level:[3,58,59,74,76,79,82,86,87,102,105,106,127,128,131,138,142,143],lever:158,levin:123,lgr_po:78,lgr_vel:78,li1:44,liang:109,lib:[1,3,4,109],libdir:3,liblammp:3,liblammps_foo:3,liblammps_g:3,libmpi:3,librari:[0,1],licens:[0,59],lie:[2,29],like:[2,3,4,28,58,59,68,74,76,78,80,86,87,97,102,108,113,114,115,118,119,123,125,132,133,139,153,162,164,165,167,168],likelihood:[41,44,67],likewis:[1,2,19,60,66,74,75,97,98,101,102,110,116,119,142],limit:[2,4,11,41,42,44,45,48,59,68,69,72,74,78,96,111,118,123,137,151,154],limit_eradiu:118,line:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,39,42,43,46,47,48,49,50,51,52,53,54,55,58,59,62,63,64,65,66,68,71,74,75,76,78,80,81,85,88,89,90,92,93,94,95,96,97,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,139,140,142,144,145,146,147,148,149,150,151,152,153,154,159,160,161,162,163,164,165,166,167,168],linear:[2,9,11,42,48,60,67,68,71,74,79,81,85,86,89,90,91,93,97,123,133],linearli:[2,40,86,97],lineflag:2,lineforc:96,lingo:3,link:[2,3,57,59,139],linkflags:4,linux:[3,4,59],liouvil:74,lipid:13,liquid:[2,4,13,19,32,36,43,66,68,74,78,113,142,148,161],lisal:[115,158],list:[0,1,2,3,4,6,19,29,30,32,36,38,39,40,42,43,47,57,58,59,60,61,62,63,64,65,66,67,71,74,76,80,81,88,89,90,91,93,94,96,97,98,99,102,103,104,106,107,109,110,112,114,115,116,117,118,119,120,122,124,125],listfil:126,literatur:[2,139,152,159],lithium:118,littl:[1,4,69,74],littmark:[139,162,166],liu:125,lj126:2,lj12_4:151,lj12_6:151,lj93:2,lj9_6:151,lj_flag:99,lmp1:3,lmp2:3,lmp2arc:[0,2],lmp2cfg:[0,2],lmp2vmd:[0,58],lmp:3,lmp_g:[2,3],lmp_linux:2,lmp_machin:[1,4],lmp_mpi:77,lmpptr:3,load:[1,2,3,4,19,59,66,78,80,109],loadabl:3,localized_lambda:60,localtemp:80,locat:[2,3,11,41,44,48,56,58,69,73,84,87,110,119,120,121,127,129,131],lockstep:[68,74],log:[1,2,4,78,81,97,99,121,125,136,137,167],logfil:[0,2],logic:[3,4,19,45,66],lomdahl:[75,129],longer:[1,2,28,58,61,62,63,64,65,74,76,78,80,81,86,87,99,123,152],longest:[19,66],look:[1,2,3,28,58,59,153,168],lookup:[145,146],loop:[2,3,43,59,62,96,97,142,152,167],loopmax:152,lopez:74,lorentz:44,lose:[2,68,74,123],loss:2,lossi:59,lossless:59,low:[1,2,19,58,59,66,142,145,146,165],lower:[2,3,4,19,59,63,64,66,68,73,74,78,86,111,139],lowercas:[0,59],lowest:42,lrt:4,lsurfac:85,ltbbmalloc:4,lu3:44,lubric:2,lubricateu:[86,136],luci:80,lumped_lambda_solv:60,lyulin:94,m4v:59,m_eff:123,m_i:82,m_u:73,m_v:73,machin:[1,2,3,4,58,59,74,96,142,168],mackai:73,mackerel:[2,5,46,106],macos:59,made:[2,3,19,58,59,66,84,122,123,150,154,168],madura:[2,127],magazin:116,magda:86,magic:3,magnitud:[2,29,37,45,58,96,113,123],mai:[0,1,2,3,4,13,19,29,32,33,34,36,37,38,39,40,41,42,43,44,45,57,58,59,62,63,64,65,66,68,69,72,73,74,75,77,78,79,80,81,84,85,86,87,96,97,99,101,102,108,114,118,123,133,135,137,139,140,141,142,145,146,151,153,158,163,166,167,168],mail:168,main:[2,3,73,83,84,116,152],mainboard:1,mainli:148,maintain:[4,98,116,168],make:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,31,32,37,39,41,42,44,46,47,48,49,50,51,52,53,54,55,56,57,58,59,62,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,83,84,85,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,168],makefil:[3,4,58,142],maks:123,manag:[58,77],manbi:153,mandadapu:60,mandatori:58,manh:102,mani:[1,2,4,19,35,45,58,59,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,80,81,85,96,97,109,118,121,125,145,146,152,153,160,162],manifold:168,manipul:[19,66,110,149],manner:[2,3,19,43,59,64,66,74,83,84,86,87,97,116,118,136],manual:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,41,44,46,47,48,49,50,51,52,53,54,55,58,59,74,75,81,88,89,90,92,93,94,95,97,98,99,100,101,103,104,105,106,107,108,109,110,112,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166,167],manybodi:[43,96],manybody:[98,99,102,109,116,119,147,149,159,160,161,162,163],map:[3,41,42,44,45,59,60,69,79,97,98,99,102,109,116,117,119,139,140,141,147,149,152,153,158,159,160,161,162,163],mara:152,march:139,mark:[124,135,152],maroonmpi:3,marrink:124,marsaglia:72,martin:139,martyna:74,mask:76,mask_direct:60,mass:[2,32,33,34,35,37,45,58,60,62,69,72,73,74,77,78,81,82,84,85,98,101,102,116,118,119,123,136,137,140,141,142,149,152,155,156,157,167],mass_matrix:60,massdelta:81,massiv:[0,59,73,77],massless:[2,110,127,131,135],master:97,mat:[60,109,161],match:[2,3,19,66,67,71,74,102,125,133,139,145,146],mater:[30,98,141,149,152],materi:[2,29,60,76,85,110,116,117,118,123,139,140,142],material_fil:60,math:[4,74],mathemat:[41,42,44,45,68,72,86,153],mathrm:168,matlab:0,matric:[42,122],matrix:[2,35,63,68,80,142],matter:[2,85,99,112,116,118,139,151,152,160,162,163,166],mattson:[31,39,43,70],max2theta:44,max:[2,40,64,66,68,80,81,96,97,152,167],max_step:80,maxev:96,maxim:97,maximum:[2,9,19,21,27,28,36,38,40,41,44,58,63,64,66,69,76,80,81,97,102,121,136,137,152,167],maxit:[96,167],maxstep:80,maxx:149,mayer:[103,104,152],mayo:[2,9,95,125],mbt:47,mcdram:4,mcgraw:77,mclachlan:74,mdregion:60,mdump:[19,66],meam:110,meam_sw_splin:141,meamf:139,mean:[2,3,4,19,28,32,35,36,37,38,39,40,42,43,45,46,57,58,59,61,62,63,64,65,66,67,68,69,72,74,75,76,77,80,81,85,86,87,89,90,91,93,96,97,103,104,105,106,110,114,116,118,122,123,125,127,128,131,138,139,143,145,146,148,149,150,151,158,159,160,161,162,165,167],meant:2,measur:0,mechan:[2,3,31,60,69,70,77,80,102,118,129,142],meck:38,media:59,medium:165,meet:[59,67],mehl:98,mei:138,melros:[136,137],melt:[67,102,142,161],member:[46,102],membran:[13,165],memori:[2,4,62,72,85,102],mendelev:116,mention:[1,2,3,73,75,86,97,99],menu:59,mep:97,mer:67,mercuri:168,meremianin:42,merg:168,merz:[2,46],mesh:[1,2,19,41,44,60,66,73,142],mesoparticl:[70,71,115],messag:[0,2,3,59,69,136,137,168],met:[19,66,96,97],metal:[45,60,78,86,98,99,102,109,116,117,118,119,139,140,141,142,149,152,159,160,161,162,163,167],methan:78,methin:94,method:[1,2,3,4,19,32,35,43,60,63,66,71,73,74,77,78,80,81,83,84,96,97,98,102,109,110,116,118,119,139,140,141,145,146,149,152,163],methodolog:[2,30,43,77],metric:167,mezei:32,mg2:44,mgoh:147,mgptfast:142,micel:82,micelle2d:0,michael:141,mickel:38,microscal:136,mid:[142,158],middl:[2,4,19,32,40,47,58,61,62,63,64,65,66,79,88,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],middlebondtors:47,midpoint:158,might:[2,4,9,152,168],migrat:[19,58,66,76],mikami:[2,74],mike:4,mil:116,militz:76,million:[19,66],mimic:[2,28,110,121,127],mimim:[68,97],min2theta:44,min:[2,40,42,64,80,152,158],min_modifi:[68,96],min_step:80,min_styl:[96,97],mind:72,minim:[0,2,19,45,58,59],minima:[51,56,95],minimi:97,minimizaiton:97,minimum:[9,10,11,21,37,40,44,48,58,59,64,68,79,80,86,87,95,96,97,106,118,120,122,124,125,127,129,131,136,137,151,158],minmiz:68,minstep:80,mintmir:110,minu:97,misc:[2,10,11,13,24,25,37,48,58,72,76,77,83,84,85,89,91,94,111,113,116,117,121,126,132,138,140,141,144,148,158],miscellan:60,mishin:98,mishra:4,miss:[64,126,167],mitchel:[2,112],mitig:74,mix:[1,2,4,64,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],mixtur:[2,74,108,120,139,146],mixture_ref_t:139,mjpeg:59,mkv:59,mlutipl:65,mn2:44,mn3:44,mn4:44,mo3:44,mo5:[44,142],mo6:44,mobil:[2,37,43,59],mode:[1,2,3,4,34,40,44,58,59,61,62,63,64,65,74,77,110,118,142,152,167],model:[0,1],modern:4,modest:1,modif:[2,4,32,139,142,150,162,168],modifi:[0,1,2,3,32,59,69,79,81,84,99,113,116,118,135,139,140,141,144,152,161,168],modin:60,modul:3,modulu:[123,139],mol:[45,58,81,113,122,151],molchunk:[34,62],mole:[116,120],molecul:[2,13,33,34,43,45,58,62,67,69,71,79,80,81,106,110,122,127,131,150],molecular:[0,2,4,27,45,51,58,60,69,77,78,79,85,100,102,105,118,167],molecule:[5,7,8,9,12,16,21,22,23,26,27,28,46,50,51,52,54,57,90,93,95,106,127],moltempl:0,molybdenum:142,mom:[2,35,79],moment:[2,45,58,73,74,82,113,117,152],momenta:[69,118],momentum:[2,13,42,45,58,60,72,73,74,137],momon:67,monaghan:[155,156],monitor:[2,68,74,78,81,96,97,113,167],mono:[30,136],monodispers:[123,136,137],monom:[28,67],monoton:[71,97],mont:[2,67],month:0,moor:[31,43,70,145,146],more:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,31,32,34,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,168],morgan:4,moriarti:142,moriarty1:142,moriarty2:142,moriarty3:142,mors:2,mosi2:139,moskalev:42,most:[0,1,2,3,4,19,29,57,58,59,62,64,65,66,68,74,77,78,99,118,122,139,162,167,168],mostli:[3,59],motiion:2,motion:[2,69,73,74,75,76,77,79,85,87,97,113,118,136,137],motiv:76,mov:59,move:[1,2,3,37,62,64,65,68,73,74,76,78,79,85,86,87,96,97,110,114,136,137,142,167],movement:[2,96,167],mp2:99,mp4:59,mpeg:59,mpg:59,mpi4pi:3,mpi:[0,1,2],mpi_barrier:1,mpi_comm:2,mpicc:3,mpich:4,mpiio:58,mpirun:[1,2,3,4,77],mplayer:59,msd:2,msi2lmp:0,msmse:[41,44],msse3:142,msst:[75,78],mtk:[74,75],mu_j:13,muccioli:122,much:[1,2,3,58,59,68,78,99,122,150,168],mui:58,muller:[2,35,143],multi:[0,1],multibodi:[145,146],multicent:118,multicor:1,multinod:4,multiphys:3,multipl:[0,1],multipli:[32,35,57,63,73,76,96,99],multiscal:3,multisect:[19,66],multistag:32,multithread:4,murdick:102,murti:161,must:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,32,39,40,41,44,45,46,47,48,49,50,51,52,53,54,55,56,58,59,60,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,78,79,80,81,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],mutli:2,mux:[58,59],muz:58,mxn:77,my_stress:61,myang:62,mychunk:[2,34],mycom:64,mydump:58,myflux:35,myforc:58,myhug:75,myke:35,mymol:81,mympi:3,mype:35,mypress:[40,58,63],myramp:43,myrdf:65,myspher:87,mystress:35,mytemp:167,n_f:78,n_hbond:125,n_ij:123,n_ion:85,n_k:72,n_particl:31,na1:44,nabla:85,nacl:[2,139],nacl_cs_x0:2,nakano:[97,163],namd:58,name:[0,1,2,3,4,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,77,78,79,80,81,82,83,84,86,87,97,98,99,102,104,116,117,119,122,123,126,139,140,141,147,149,152,153,159,160,161,162,163,167,168],namespac:2,nanoindent:29,nanomet:58,nanoparticl:66,nanosecond:69,narrow:2,narulkar:[160,162],nation:0,nativ:[1,2,58],natom:[2,3,167],natur:[2,42,74,76,116,118,119,139,149],navi:116,navier:73,nb3:44,nb3bharmon:147,nb5:44,nbin:64,nbodi:142,nbot:102,nbuild:167,nchunk:[2,34,62],ncoeff:153,ncount:[62,63],nd3:44,ndanger:167,nden:[2,35],ndof:[74,75],nearbi:[87,99,136,137,165],nearest:[29,30,36,38,73,76,87,126,139,145,146,152],nearli:[2,28,66,118,142],neb:2,neb_combin:97,neb_fin:97,necessari:[2,3,4,32,57,66,68,72,80,135,142,152],necessarili:[69,89,90,91,93],need:[1,2,3,19,28,29,30,35,36,38,39,42,43,45,46,56,57,58,59,60,62,63,64,65,66,68,71,73,74,79,85,86,97,98,99,100,102,103,104,105,106,107,108,109,110,112,113,114,116,117,118,119,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,168],needless:2,neg:[2,11,22,33,42,43,48,50,59,68,72,75,76,80,86,119,130,139,167],neglect:[125,137],neglig:[2,3,32,74,159],neigh_modifi:[2,4,66,96,114,167],neighbor:[1,2,4,19,29,30,36,38,42,43,45,58,59,66,67,76,77,97,108,110,114,116,117,119,120,126,127,131,139,146,149,152,153,158,159,160,161,162,163,167],neighborhood:[10,29,36,153],neighobr:[2,110,127,131],neither:[19,60,67,99,118,136,137],nelem:153,nelement:[98,116],nelson:[36,38],nemd:0,net:[2,3,76,137],netpbm:59,network:58,neutral:[110,127,152],never:[63,68,74,76,81,86,116,139,153,163],neveri:[61,62,63,64,65,67,69,73,97,152],newer:[62,139],newtion:[102,142,149],newton:[4,13,99,109,117,140,141,152,158,159,160,161,162,163],newtonian:72,next:[1,2,3,29,35,59,62,71,72,80,81,85,96,97,102,120,123,136,137,145,146,149,168],nfile:[58,71,145,146],nfreq:[61,62,63,64,65,66],nfs:58,ngb:76,ngp:37,nguyen:102,nhc:77,ni2:44,ni3:44,ni_000:41,nialh_jea:116,nice:[2,168],nickla:141,nine:[119,152],nissila:[73,152],nist:[98,116],niter:[19,66],nitrid:110,niu3:116,nkb:78,nlocal:3,nlvalu:38,nmpimd:77,nn2:139,nnn:[36,38],no2:[71,80,120],no_affin:4,no_histori:2,noced:96,nocheck:126,nodal:[2,60,71,85,145,146],node:[1,4,19,41,44,66,73,85,126],node_area:73,node_group:60,nodeless:118,nodes:[19,66],nodeset:60,nodeset_to_elementset:60,noforc:[2,137],nois:[2,72,73,78,85],nomenclatur:2,nomin:[58,74],non:[0,1],nonbond:147,none:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,33,34,35,36,38,39,40,43,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,79,80,81,82,85,86,87,88,89,90,91,92,93,95,96,97,98,99,100,101,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,138,139,140,141,143,144,145,146,147,148,150,151,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],nonequilibrium:[83,84,118],nongaussian:37,nonlinear:[21,22],noordhoek:109,nor:[19,60,109],nord:[149,160,162],nordlund:[149,160,162],norm:[2,40,62,80,96,97,158,167],normal:[2,3,4,19,29,30,35,39,40,45,46,62,63,64,66,68,74,76,77,85,86,87,88,89,90,91,93,96,97,108,109,122,123,142,158,166,167],norman:85,nose:[2,74,75,77,84,114],notat:[2,29,42,74,116,163],note:[1,2,3,4,8,9,12,16,17,18,19,23,28,30,32,33,34,35,37,39,40,41,42,43,44,45,46,50,54,57,58,59,60,61,62,63,64,65,66,67,68,70,71,73,74,75,77,78,79,80,82,85,86,87,88,89,90,91,93,96,97,98,99,102,103,104,105,106,108,110,111,113,114,115,116,119,122,123,124,125,126,127,129,131,136,137,139,140,141,142,143,145,146,147,149,150,151,152,153,154,158,159,160,162,163,165,166,167,168],notes:[32,135],noth:168,notic:[0,2,84,85],novemb:139,now:[2,3,4,22,58,72,87,116,118,123,154,168],np3:44,np4:44,np6:44,npair:63,nparticl:101,npartit:167,nph:2,nphi:4,nproc:[3,58],npt:[2,4,32,68],nrepeat:[61,62,63,64,65],nreset:[68,74,75],nreset_ref:68,nrho:[98,116],nrl:116,nstart:[63,64,65],nstat:76,nstep:[68,74],ntabl:[145,146],nth:[40,64],ntheta:102,ntype:[42,45,58,118,125,149],nuclear:[78,118,166],nuclei:118,nucleu:162,nudg:[2,97],num_step:80,numa:1,numactl:4,number:[1,2,3,4,11,19,29,30,31,32,34,35,36,38,39,40,41,42,44,45,48,57,58,59,61,62,63,64,65,66,67,71,72,73,74,75,76,77,78,80,81,83,84,85,86,96,97,98,99,102,109,114,116,117,118,119,125,139,140,141,142,145,146,147,149,150,152,153,158,159,160,161,162,163,166,167],numer:[1,2,3,19,32,38,40,56,58,59,60,61,62,63,64,65,69,72,74,77,81,85,86,96,113,139,145,146,166,167],numpi:3,nvalu:[62,65],nvcc:1,nve:[1,2,4,32,35,45,60,69,72,74,75,79,81,85,113,122,136,137,150,152,154],nvidia:1,nvt:[2,4,32,35,60,63,64,65,69],nvtfe:60,nxnode:85,object:[2,3,59,68,73,96],observ:[4,74,78],obtain:[1,4,13,30,32,38,73,75,77,99,113,139,152,160,162],obviou:166,obvious:59,occ:121,occasion:74,occlus:59,occup:121,occur:[1,2,3,37,56,58,66,67,68,71,83,118,135,145,146],occurr:94,oct:3,octahedr:9,odd:[19,38,66,74,85],ode:80,off:[1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,42,43,44,46,47,48,49,50,51,52,53,54,55,57,58,59,65,67,72,74,75,81,86,87,88,89,90,92,93,94,95,96,97,98,99,100,103,104,105,106,107,108,109,110,112,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,139,140,144,145,146,147,148,150,151,152,154,158,159,160,161,162,163,164,165,166],offer:[2,110,152],offload:[1,4],offset:[2,45,59,110,127,131],often:[1,2,4,57,59,64,65,66,68,74,77,96,97,109,114,127,160,162,168],ohio:141,old:[2,68,74,139,154],older:[4,68,74,154],oleinik:102,olfason:[2,9,95,125],ollila:73,olmsted:[60,76],omega0:95,omega:[2,74,86,92,95,113,123,142],omega_dot:74,omega_ij:115,omega_ijk:162,omega_ik:160,omegadd:[145,146],omegai:58,omegax:58,omegaz:58,omgea:2,omiss:0,omit:[69,105,113,131],omp:[1,4],omp_num_threads:4,on_the_fli:60,onc:[0,1,2,3,4,19,46,59,66,80,97,122,124,149,150],once:[0,2,19,35,66,168],one:[2,13,35,42,59,74,75,85,102,111,137,152],onli:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,36,37,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,80,81,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],only:[2,4,19,29,58,59,63,65,68,69,76,96,97,98,99,102,106,109,116,117,119,125,136,137,139,140,141,147,149,153,159,160,161,162,163,167],onset:[78,94],onto:[42,67,69,73,158],open:[0,3,58,59,168],opencl:1,opengl:2,openmp:[1,4],openmpi:4,oper:[1,2,3,4,19,35,40,45,62,63,64,65,66,67,69,74,75,81,84,85,97,142,168],opl:4,opls:[54,57],oppelstrup:142,oppos:[2,58,79],opposit:[2,13,29,46,76,97,110,135],opt:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,74,75,81,88,89,90,92,93,94,95,98,99,100,103,104,105],optim:0,optimiz:[4,96,109],option:[0,1],optional:153,options:[4,142],orang:59,orbit:[102,110,118,152],order:[2,3,4,11,13,19,32,33,34,36,38,39,42,43,48,57,58,59,61,63,64,65,67,68,69,71,73,74,76,78,79,80,81,85,88,89,90,91,93,94,97,98,99,102,109,115,116,118,119,122,123,127,135,139,142,145,146,150,152,159,160,161,162,163],ordinari:[80,125],org:[2,3,76],organ:[0,2,109],organometal:9,orient:[2,13,29,35,36,38,45,58,74],orientord:36,origid:62,origin:[2,41,45,59,62,69,74,77,84,98,99,100,102,110,113,114,116,125,139,160,162,168],orlikowski:142,orsi:13,orthogon:0,orthograph:59,orthorhomb:78,os4:44,oscil:[2,74,78,86],ose:59,oserror:3,other:[0,1],otherwis:[1,41,46,57,62,74,80,95,96,126,136,137,149],otyp:[110,127,131,135],our:[2,73,81,160,162],out:[1,2,3,6,19,34,35,37,47,58,59,66,73,85,87,88,89,93,97,118,138,167],outer2:[106,124],outer:[4,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],outer_distance_cutoff:125,outermost:[74,76,79,82,86,87],outlin:[2,59],output:[0,1],output_frequ:60,outsid:[45,58,59,64,69,87,97,103,104,110,118,127,129,148,151],outut:2,outward:[86,87],over:[1,2,4,11,19,32,33,34,36,37,38,42,43,48,59,61,62,63,64,65,66,72,74,76,78,79,80,86,87,88,97,108,114,116,117,118,119,125,136,139,142,149,153,154,159,160,161,162,163,167],overal:[2,9,68,74,77,81,118,125,153],overhead:[2,3,19,62,66,69],overlai:[2,4,32,85,110,114,125,126,135,153,166],overlap:[4,45,61,62,64,65,96,114,118,123,135,154],overli:80,overload:1,overrid:[4,45,59,68,74,125,139],overridden:[2,45,59,75,136,154],overview:[0,1,2],overwrit:[3,62,63,64,65,139],overwritten:125,own:[2,3,19,30,34,40,58,60,61,62,63,64,65,66,67,68,72,73,74,75,77,97,99,102,109,117,149,159,160,161,162,163,168],oxford:[13,32,113],oxid:[109,110,152],oxygen:[2,110,127,131,152],p10:123,p_e:85,p_ik:149,p_pi:102,pacakg:4,pack:[102,139],packag:0,packet:[59,118],pad:[58,59,77],page:[0,1,2,3,32,34,37,39,40,43,45,57,58,59,61,62,63,64,65,74,87,96,97,98,99,101,109,110,116,117,119,125,139,140,141,147,149,153,159,160,162,163,167],painless:168,pair:1,pair_:32,pair_charmm:135,pair_coeff:[2,32,35,46,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],pair_dzugatov:168,pair_eam:98,pair_interact:60,pair_list:126,pair_lj:135,pair_lj_soft_coul_soft:32,pair_modifi:[2,32,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],pair_sph:[155,156,157],pair_styl:[0,1,2,4,18,28,32,35,42,46,72,86,87,96],pair_writ:133,pairwis:[0,1,2,28,29,36,38,39,42,43,46,57,67,72,86,96,98,101,103,104,105,106,108,110,114,115,116,118,119,123,125,126,127,128,131,136,137,138,139,140,141,143,144,148,151,154,158,162,164,165,167],pakketeretet2:168,pan:59,panagiotopoulo:[111,121],papaconstantopoulo:98,paper:[2,42,51,73,85,97,99,105,110,123,125,129,131,160,162],paquai:168,paraemt:150,paragraph:[86,145,146],parallel:[0,1,2],parallel_studio_xe_2016:4,parallelepip:2,param:120,paramet:0,parameter:[41,44,99,102,109,110,116,117,118,119,139,140,141,149,152,159,160,161,162,163],parameter_fil:60,parameterizaion:110,parametr:[2,18,117,151],paramt:[37,150],paramter:109,paratem:135,parenthes:[71,80,120,123,145,146],parenthesi:[4,62],parinello:2,pariticl:66,park:[60,141],parmin:142,parrinello1981:68,parrinello:[68,74,78],pars:0,part:[0,1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,31,36,37,39,41,42,43,44,46,47,48,49,50,51,52,53,54,55,57,58,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],partial:[1,2,62,68,73,75,77,139],partic:2,particip:[56,101],particl:0,particular:[1,2,29,42,45,58,59,66,67,72,73,74,76,79,81,88,101,102,103,104,106,107,108,112,115,117,118,122,124,127,131,135,138,144,147,148,150,151,159,160,161,162,163,167,168],particularli:[2,9,59,68,118],partit:[2,19,66,77,97,105,106,118,127,128,131,138,143,149,167],partner:67,pass:[2,3,33,34,37,58,59,68,74,86,158],password:168,past:[0,58,78,114],patch:0,patel:142,path:[2,3,77,85,97,98,99,102,116,117,119,139,140,141,147,149,152,153,159,160,162,163],pathtolammp:152,patrick:161,pattern:30,paul:0,pauli:[118,152],paves:77,payn:[42,153],pb2:44,pb4:44,pbc:86,pchain:[74,75],pcie:1,pd2:44,pd4:44,pdamp:[74,75],pdb:2,pdf:[0,155,156,157],pe_eta:74,pe_etap:74,pe_omega:74,pe_strain:74,peak:121,pearlman:32,pencil:2,peng:44,per:[0,1],peratom:43,perceiv:59,percent:[4,68,159],percentag:[1,68,74],perfect:[2,19,29,30,36,66,76,97],perfectli:[19,66],perfom:[2,97],perform:0,performac:1,pergamon:[139,162,166],peri:[2,45],peridynam:2,perimitt:111,period:2,perioid:86,perl:2,perman:[28,79,125],permit:[2,73,142],permitt:[111,162,165,166],permut:[117,159,160,162,163],perpendicular:[2,59,76,86],perram:122,persepct:59,person:168,persp:59,perspect:59,perturb:[29,32,86],peskin:73,pettifor:102,pettifor_1:102,pettifor_2:102,pettifor_3:102,pfactor:59,phase:[4,74,102,127,161],phenomena:118,phi0:[55,79],phi1:47,phi2:[47,117,159],phi3:[47,117,159],phi:[1,4,36,38,42,56,57,59,79,90,98,102,116,119,139,140,141],phi_ij:[102,119,149],phillip:114,phillpot:[109,110,152],philosoph:116,philosophi:2,phonon:[0,60,85],phophor:153,phosphid:153,phy:[2,5,6,9,20,21,22,29,30,32,36,38,39,42,43,46,47,54,68,69,72,73,74,75,77,78,81,83,84,85,86,88,94,95,97,99,102,103,106,107,108,109,110,111,112,113,114,115,116,117,118,121,122,123,124,125,127,129,131,132,135,136,137,138,139,141,143,145,146,148,149,150,152,153,158,159,160,161,162,163],physic:[2,4,27,56,60,69,73,85,97,99,100,105,108,116,125,142,155,156,157],physica:[136,137],picosecond:167,picosend:118,piec:[3,42,74],pimd:2,pin:4,pipe:[2,58,59],pipelin:[2,4],pisarev:85,pishevar:114,pitera:2,pixel:59,pizza:[2,3,19,58,59,66],pka:85,place:[2,3,19,32,45,58,59,67,69,72,74,85,86,125,167],placehold:[98,99,109,116,119,139,140,141,147,149,153,158,159,160,161,162,163],placement:127,plai:[2,59],plain:135,plan:[2,4],planar:[2,76,94,95],planck:77,plane:[2,19,36,59,60,66,76,85,88,89,90,91,92,93,95,137],planeforc:96,plasma:[85,118],platform:[1,4,58,59],plath:[2,35],player:59,pleas:[0,3,4,60,73,117,119,152],plimpton:[0,4,29,39,43,67,76,123],ploop:[74,75],plos:13,plot:[3,4,78,133,135],plu:[3,68,75,118],pm3:44,png:[58,59],pni:59,poariz:2,poem:2,poems:2,point:[1,2,3,4,13,19,29,41,42,44,45,50,58,59,62,65,66,68,71,73,74,77,78,85,87,96,97,101,109,111,113,115,118,122,129,142,145,146,149,150,152,158,161,165,167],pointer:3,poisson:123,poisson_solv:60,polar:[2,38,42,44,60,109,110,127],polar_off:109,polar_on:109,polariz:0,politano:152,polydispers:[108,123,136,137,165],polyethylen:99,polygon:2,polym:[0,2,21,22,28,67,77,81,82,114,158],polynomi:[116,133,152],poor:[19,66,81,133],poorli:96,popular:[58,117],porou:73,portabl:58,portion:[1,3,19,28,35,43,58,61,62,64,65,66,68,69,73,74,103,104,105,106,107,110,111,113,114,118,120,121,122,124,125,127,131,135,138,148,150,151,162,168],poschel:123,posit:[2,11,19,22,29,33,34,40,41,42,43,44,45,48,50,56,59,61,62,64,66,67,68,69,72,73,74,76,77,78,80,81,83,84,85,86,87,88,97,99,101,114,115,118,121,130,145,146,152,158],possibl:[1,2,3,19,29,32,42,43,58,60,66,67,70,76,80,85,92,96,125,139,152,163,167],post:[0,2,35,58,60,78],pot:123,potentail:119,potenti:0,potentiel:135,potin:142,pour:[2,81],power:[3,4,37,42,102],pparam:32,ppm:[58,59],ppn:4,pppm:[0,1],pproni:72,pr3:44,pr4:44,practic:[68,74,163,168],prb:[160,162],prd:[2,97],pre:[2,79,86,102,123,145,146,152,154],prec:[4,152],preced:[2,46,61,62,63,64,65,80,97,102,125,167],preceed:[3,63,86],precis:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,55,58,62,65,68,69,74,75,81,88,89,90,92,93,94,95,96,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,142,144,147,148,150,151,152,154,159,160,161,162,163,164,165,166,167],predefin:[55,118],predict:[1,2],prefactor:[8,9,12,16,17,18,57,63,86,89,93,94,96,108,121,147,150,151,154,165],prefer:[79,99,168],prefix:[3,59,80],preliminari:[71,145,146],prematur:96,preprint:[42,153],prescrib:[2,60,62],presenc:[58,73,136,137,142,165],present:[1,4,59,72,73,87,109,118,126,135,142,150,152],preserv:[68,74,81],press:[2,4,13,32,43,68,74,75,113,139,162,165,167],pressur:[1,2],pressure_with_eviri:118,presum:[30,97],prevent:[2,56,94,96,97,114,155,156,158],previou:[0,2,3,62,64,65,66,96,102,123,125,139,145,146,167],previous:[3,40,45,58,61,62,63,64,65,81,85,86,123,167],price:[2,113],primari:[0,2,85],prime:[124,142,160,162],primit:[2,87],princip:152,principl:[2,3,118,142,159,168],print:[0,1,2,3,4,19,35,40,42,58,59,62,63,64,65,67,68,73,74,75,76,78,80,81,96,97,99,114,121,125,152,167],printfluid:73,prism:2,privileg:3,probab:154,probabl:[56,66,67,74,86,96,145,146],problem:[0,1,2,3,19,35,60,66,68,79,84,87,96,97,110,113,125,168],proc:[1,3,4,58],proce:[19,28,66,97,142,167],procedur:[2,19,66,74,75,83,84,96,97,99],proceed:142,procesor:19,process:1,processor:[1,2,3,4,19,45,58,59,60,62,66,67,68,72,73,74,77,81,85,97,114,152],processsor:[19,66],procp1:58,produc:[1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,39,40,43,46,47,48,49,50,51,52,53,54,55,58,59,61,62,63,64,65,66,67,72,74,75,78,80,81,85,86,88,89,90,92,93,94,95,96,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,147,148,149,150,151,154,159,160,161,162,163,164,165,166,167],product:[2,4,42,80,118,120,146],profil:[2,62,65,69,97],program:[2,3,4,58,59,73,116],progress:[1,19,66,78,96,97,167],project:[2,168],promot:102,prompt:3,proni:72,prop:2,propag:[74,78,118],propens:2,proper:[67,76,139,168],properli:[97,115],properti:0,proport:[2,19,32,66,78,80,123],propos:[2,42,68,74,127,141,161],protein:[4,45,82],proton:[162,166],prouduc:65,prove:[31,70,73],provid:[1,2,3,4,13,29,41,44,45,59,61,62,65,67,68,73,74,78,83,84,97,99,102,109,110,114,117,118,123,125,126,135,136,139,141,142,149,152,153,158,159,160,161,162,163,167,168],pscrozi:0,psec:74,pseudo:118,pseudopotenti:142,psf:2,psi:[119,165],psi_ij:119,pstart:[74,75],pstop:[74,75],pstyle:32,psxevar:4,pt2:44,pt4:44,ptarget:68,pthread:4,ptr:[2,3],pu3:44,pu4:44,pu6:44,publish:[73,110,139,142,160,162],pull:168,puls:85,pump:[136,137],purchas:59,pure:[3,140,141,160,162],purport:3,purpos:[2,41,44,45,58,65,67,68,76,77,79,105,131,142],push:[76,96,123,154,168],put:[2,3,45,58],pxx:[68,74,167],pxy:[2,167],pxz:[2,167],pydir:3,pyi:[68,74,167],pymol:3,pymol_aspher:0,pympi:3,pypar:3,python:[0,2],pythonpath:3,pyz:[2,167],pzz:[68,74,78,167],q_1:152,q_2:152,q_3:152,q_i:[119,135],q_j:135,qdist:[110,127,131,135],qeq:[2,109,110,152],qeqall:152,qeqallparallel:152,qfile:110,qinitmod:152,qoffload:4,qopenmp:4,qoverrid:4,qtb:78,quadrant:4,quadratur:[32,60],quadrupl:98,quadruplet:[57,88,89,90,91,93,94],qualiti:[59,99],quantic:152,quantit:[37,123],quantiti:1,quantum:[2,42,77,78,99,102,118,142,152],quantum_temperatur:78,quartic_spher:60,quartz:78,quasi:77,quaternion:[2,45,122],queri:[3,28],quest:2,question:[76,168],quick:[0,4],quickli:[36,66,96,97,99],quickmin:[96,97],quicktim:59,quit:[73,153,167],quot:139,quotat:152,r10:102,r12:122,r_1:42,r_2:42,r_c:[111,113,121,162],r_cut:[102,138],r_e:119,r_fu:[136,137],r_i:[13,42],r_ii:42,r_ij:[13,102,118,149,166],r_ik:149,r_j:13,r_jik:149,r_m:138,r_me:111,r_mh:121,r_min:112,r_ub:5,ra2:44,rad2theta:44,radial:[42,62,96,118,125,145,146],radian:[5,6,8,12,16,17,18,44,47,55,79,88,89,93,94],radiat:[41,44,85],radii:[42,67,108,116,122,123,136,137,142,165],radit:118,radiu:[2,33,34,41,42,58,59,73,82,86,87,102,108,118,119,123,127,135,136,137,138,139,152,153,162,165],rahman:[2,68,74,78],rai:44,ram:162,raman:4,ramp:[2,72,74,78,86,106,114,124,135,136,138,154,166],ran:[2,3],random:[2,45,59,67,72,73,74,77,78,85,114,115],randomli:45,rang:[1,2,4,38,39,40,42,43,44,51,58,59,60,96,99,100,102,103,104,105,106,107,108,110,111,112,113,114,116,118,120,122,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,142,143,144,148,149,150,151,152,158,162,164,165,166,167],rank:[2,3],rankin:75,rapid:[2,3],rapidli:[67,74,110,114],rare:2,rasmol:2,rasmussen:122,raster3d:2,rate:[2,4,60,78,80,83,84,120,136,137,146,167],rather:[2,19,39,59,66,72,85,118,145,146],ratio:[2,32,42,66,122,123,150,155],rattl:69,rattle:[69,81],rattle_debug:81,ravelo:[75,129],raw:4,rayleigh:78,rb1:44,rbb:152,rcb:[19,66],rcm:[33,34],rcmx:[33,34],rcmy:[33,34],rcold:69,rcutfac:[42,153],rd1:97,rdf:65,rdn:97,rdt:97,reach:[2,19,66,68,75,80,111],reacquaint:168,react:2,reactant:[80,118],reaction:[71,80,82,97,118,120,146],reactiv:99,read:[2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,67,68,71,74,75,77,80,81,84,85,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],read_data:[2,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,33,34,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,67,77,79,80,88,89,90,91,92,93,94,95,97,100,101,103,104,105,106,107,108,110,111,113,114,115,118,121,122,124,125,127,128,129,130,131,132,133,134,135,136,137,138,143,144,148,149,150,151,152,154,158,164,165,167],read_dump:[58,97],read_restart:[2,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,45,46,47,48,49,50,51,52,53,54,55,57,60,68,73,74,75,77,85,88,89,90,91,92,93,94,95,97,100,101,103,104,105,106,107,108,110,111,113,114,115,118,121,122,123,124,127,128,129,130,131,132,133,134,135,136,137,138,143,144,148,150,151,154,158,164,165,167],readabl:59,readi:3,readme:[1,2,3,4,58,142],real:[2,3,11,14,15,35,36,38,42,45,48,77,78,86,92,110,142,162],realli:[1,39,43,168],reamin:[86,87],rearrang:97,reason:[2,3,45,56,62,83,84,97,111,118,119,121,137],reax:[0,78],rebal:[19,66],rebalanc:[19,66],rebuild:[3,4,114,167],rebuilt:[58,59],recalcul:32,receiv:76,recent:[3,4,62,64,65,66,139],reciproc:[2,41,44,103,104,105,110,113,118,127,131,148,151],recogn:[30,74,80,116,139],recomend:2,recommed:80,recommend:[4,59,69,78,84,118,136,137,142,150,152,168],recompil:[1,81],reconstruct:152,recov:[68,69,74],rectangl:[19,66],rectangular:[19,66],rectilinear:[41,44],rector:27,recurs:[19,66,102],recust:19,red:[59,67,77],reduc:[1,2,11,19,39],reduct:[40,41,44,78],redund:119,reed:78,ref:[83,84],refactor:2,refer:[2,3,4,13,32,40,45,58,60,61,62,63,64,65,67,68,69,74,75,76,77,78,81,88,95,98,122,139,141,142,150,156,157,160,162,167],referenc:[2,58,63,110,125,147,150,167],reflect:[2,41,42,44,57,59,86,102],refresh:60,regard:[2,81],regardless:[45,64,74],regim:[2,111],region:[0,2,19,35],region_styl:87,regoin:2,regspher:45,regul:2,regular:[1,19,58,59,66,85,111],reinder:4,reinhardt:[83,84],reject:[45,67],rel:[1,2,11,18,19,36,42,45,48,66,69,76,80,85,96,118,122,123,136,137,139,150,165,167],relat:[1,2],relationship:[2,152,165],relax:2,releas:0,relev:[2,19,45,60,61,62,63,64,65,66,69,72,73,81,82,85,86,96,100,108,110,111,113,114,118,121,122,123,124,125,126,128,129,130,132,133,134,136,137,144,145,146,150,154,158,164,165,166],reli:[118,166],reltol:80,remain:[19,32,56,57,58,62,63,68,74,85,102,118,135,142,167,168],remaina:102,remaind:[45,58,162],remap:[2,45],remedi:2,rememb:168,remot:168,remov:[2,28,36,38,42,45,62,74,80,81,97,113,137,142,168],remove_molecul:60,remove_sourc:60,remove_speci:60,ren:44,renam:168,render:[58,59],rendon:74,reneighbor:[66,114,167],repeat:[2,59,67,68,80,102,160,162],repes:58,replac:[2,3,19,33,34,40,58,59,62,63,64,65,66,67,75,99,110,123,129,145,146,167],replica:0,report:[0,1,4,41,44,78,79,80,85,97,113,118,139],repositori:168,reprens:85,repres:[1,2,19,29,34,51,58,59,62,63,64,65,68,71,72,73,74,77,80,85,87,97,98,102,122,135,136,137,139,140,141,148,149],represent:[2,58,72,77,85,102,118,122,142,150],reproduc:[4,74,110,116,123],repul:139,repuls:[2,18,21,22,86,87,99,102,108,110,114,118,120,123,125,135,139,143,152,158,162,163,165,166],request:[2,19,58,73,168],requir:[1,2,3,4,18,19,28,31,32,41,43,44,45,46,56,58,59,60,63,64,65,66,67,70,71,72,73,74,80,81,85,86,88,96,97,98,99,101,102,106,108,109,110,114,115,116,117,118,119,122,123,125,133,135,136,137,139,140,141,142,144,145,146,147,149,150,151,152,153,158,159,160,161,162,163,165,166,167],rerun:[36,38,42,58,59],rescal:[2,63,64,65,69,74,75,83,84],research:[31,70,73,142],resembl:168,resepct:2,reservoir:[35,69,85],reset:[2,3,33,34,68,74,75,81,85,96,137,167],reset_atomic_reference_posit:60,reset_tim:60,reset_timestep:[2,35,167],resist:2,resolut:152,resolv:[68,77,137,168],resourc:[98,116],respa:[4,74,76,79,82,86,87,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],respecifi:142,respect:[1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,29,32,33,39,41,44,46,47,48,49,50,51,52,53,54,55,59,64,67,68,69,73,74,75,81,85,86,88,89,90,92,93,94,95,96,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,139,140,142,144,147,148,150,151,152,153,154,159,160,161,162,163,164,165,166],respond:[2,118],respons:2,resquar:[2,122],rest:[2,79,102,137,139,167],restart1:77,restart2:77,restart2data:0,restart:[0,1],restor:[45,167],restrain:13,restraint:[79,126],restratin:79,restrict:[1,2],result:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,34,35,39,40,41,43,44,45,46,47,48,49,50,51,52,53,54,55,58,59,61,62,63,64,65,66,67,68,69,72,73,74,75,77,80,81,83,84,85,86,88,89,90,92,93,94,95,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,139,140,142,144,145,146,147,148,150,151,154,159,160,161,162,163,164,165,166],retain:[99,102,142],retriev:[2,140,141],rev:[2,29,36,38,42,43,74,75,83,84,102,108,109,110,113,116,117,118,122,123,129,136,137,138,139,141,145,146,149,150,153,159,160,161,162,163],revers:[2,32,50,67,74,76,83,97,135],review:[42,142,153,168],rewrap:58,rfac0:[42,153],rg0:82,rh3:44,rh4:44,rheolog:2,rhi:[145,146],rho0:[139,156,157],rho0_meam:139,rho:[73,98,103,104,105,116,138,139,140,141,145,146,150,155],rho_0:[156,157],rho_alpha_beta:116,rho_bkgd:139,rho_colloid:86,rho_e:85,rho_i:[140,141],rho_ref_meam:139,rho_wal:86,rhodopsin:[1,4],rhosum:[155,156,157],rhot:69,rhs:80,rick:[109,152],right:[2,3,19,29,45,55,57,66,67,73,76,80,110,168],rightmost:[19,66],rii:[33,34],rij:[36,38,76,114,115,145,146,158],rin:[125,132,133],ring:[2,46,77],rino:[30,163],rirj:123,risi:[42,153],risk:79,rix:[33,34],rk4:80,rkf45:80,rlo:[145,146],rmin0:[42,153],rmin:129,rms:80,rnemd:2,robust:96,rock:139,rockett:149,role:2,ronchetti:38,root:[3,32,33,34,116],rose:139,ross:139,rosski:77,rot:[2,35,77,79],rotat:[2,42,45,58,62,87,96,113,122,150,167],rotation:38,rough:[2,45,59],roughli:[19,59,74,97],round:[1,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,74,75,81,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,144,145,146,147,148,150,151,154,159,160,161,162,163,164,165,166],rous:72,rout:[32,125,135],routin:[2,3,4,73,142],roux:2,row:[2,34,44,62,63,64,65,85,118],rozero:139,rrespa:[1,4,74,98,99,100,101,103,104,105,106,107,108,109,110,111,113,114,116,117,118,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,136,137,138,139,140,141,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],rsq:[145,146],rsurfac:85,ru3:44,ru4:44,rub:5,rubia:[140,141],rule:[0,2,13,29,45,63,67,74,87,98,100,101,107,108,113,125,130,139,143,154,158,159,160,162,166],run1:2,run2:2,run3:2,run4:2,run5:2,run6:2,run7:2,run8:2,run:[0,1],run_styl:[4,74,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,121,122,123,124,125,126,127,128,129,130,131,132,133,134,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],rung:80,runtim:59,rutherford:85,rutuparna:[160,162],rxn:80,ryckaert:[81,94],rydberg:142,s0st:2,s2050:1,s2629:116,s319:60,s_i:[2,118],s_ij:2,saddl:97,sadigh:[116,140,141],saed_vtk:41,safe:[59,168],safran:165,sagui:113,sai:[1,168],said:96,sakai:161,sall:152,salt:[111,121,139],salter:152,same:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,33,34,35,36,37,38,39,40,42,43,45,46,47,48,49,50,51,52,53,54,55,58,59,60,61,62,63,64,65,66,67,68,69,72,73,74,75,76,77,78,79,81,83,84,85,87,88,89,90,92,93,94,95,97,98,99,100,102,103,104,105,106,107,108,109,110,111,112,113,114,116,117,118,119,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,143,144,147,148,149,150,151,152,154,158,159,160,161,162,163,164,165,166,167,168],sampl:[1,2,3,35,59,62,63,74,77,82,84,102],sample_frequ:60,sandia:[0,29,119,139],saniti:79,satellit:2,satisfi:[30,41,42,44,68,69,73,75,81,96,123],satur:111,save:[2,59,67,72,80,85,102],sb3:44,sb5:44,sc3:44,scalabl:[0,1,4],scale:[0,1,2,4,35,40,42,46,58,59,60,63,68,73,74,75,77,78,83,84,85,98,99,111,118,120,123,136,137,139,142,167],scalegamma:73,scalexi:[68,74,75],scalexz:[68,74,75],scaleyz:[68,74,75],scatter:[3,41,44],scatter_atom:3,scatter_coord:3,scenario:[2,67,87],schaik:135,schell:161,schemat:67,scheme:[2,72,74,77,81,85],schmid:114,schroding:118,schroeder:38,sci:[30,109,141,149,152],scienc:[60,67,76,83,116,140,152,161],scientif:[42,116],scm:3,scratch:[19,66],screen:[0,1,2,3,4,41,44,59,73,81,97,106,110,127,139,159,162,163,164,165,166,167],screenshot:3,scripe:3,script:[0,1],sea:3,search:[0,36,38,96,97,123],secant:71,second:[1,2,3,4,28,29,35,37,38,39,43,44,56,58,62,63,64,65,67,69,71,72,77,79,81,82,83,84,85,96,97,101,102,103,104,105,109,110,116,118,119,120,123,124,126,129,139,147,152,159,161,162,163,166,167],second_mo:152,secondari:51,section:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,31,32,33,34,35,37,39,41,42,44,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,62,63,64,65,66,67,69,70,71,72,73,74,75,76,77,78,80,81,83,84,85,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],section_acceler:[5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,74,75,81,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,140,144,147,148,150,151,154,159,160,161,162,163,164,165,166],section_accerl:116,section_command:[0,1],section_exampl:2,section_howto:[2,3,29,30,32,33,34,36,38,40,42,43,62,101,112],section_modifi:[2,58,59,167],section_python:2,section_start:[2,3,97,167],section_tool:2,see:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],seed:[45,59,67,72,73,77,78,85,114,115],seek:[19,66],seem:[2,68,139],seen:[4,73,87],segment:[2,59,114,158],select:[2,40,41,44,45,59,86,97,125,126,139,152],self:[2,40,58,61,62,64,78,79,80,82,84,96,109,110,142,149,152],semi:60,semimet:118,semin:4,send:[0,3],sens:[1,2,19,57,58,62,64,65,66,67,72,78,85,97,110,127,131,160,161,162],sensit:[2,30,68],sep:[2,3],separ:[2,4,19,42,45,56,59,60,63,66,67,68,74,77,81,103,104,110,111,113,115,127,136,137,139,145,146,147,153,159,162,165],seper:111,sequenc:[19,58,59,66,97,149],sequenti:149,seri:[2,4,42,58,59,63,65,72,99,122,139,142,145,146,150,154,167],serial:1,serv:[2,158],server:1,set:[0,1],set_vari:[2,3],setarea:73,sete:[62,67],setenv:3,setfl:[98,116],setforc:[2,96,97],setgamma:73,settl:68,setup:[2,3,4,32,35,57,60,67],seven:141,sever:[1,2,3,4,32,57,58,60,68,73,74,96,102,105,116,131,135,139,149,152,167],sexton:142,sfactor:59,shade:59,shake:[2,13,39,43,62,69],shan:109,shape:[2,19,45,59,66,68,74,78,87,101,122,150],shardlow:[70,80,115],share:[0,1,2],sharp:[87,139,162],shear:[2,68,73,74,123,136,137],shell:0,shenderova:99,shift:[1,2],shiga:[2,74],shini:59,shinoda:[2,74,151],shiny:59,shlib:3,shm:4,shock:[75,78,129],shockvel:78,shortcut:[68,74],shorter:76,shortest:59,should:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,32,35,39,43,45,46,47,48,49,50,51,52,53,54,55,58,59,66,67,68,72,73,74,75,76,77,78,79,80,81,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,103,104,105,106,107,108,109,110,112,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,139,140,142,144,145,146,147,148,150,151,152,154,158,159,160,161,162,163,164,165,166,167,168],show:[2,3,97,125,139,142],shown:[1,4,19,41,42,44,57,66,67,69,74,76,77,118,119,122,123,135,142,150,152],shrink:[2,19,58,59,66,73,76,96,110,127,131],shrunk:80,shut:[2,3],si4:44,sic:[110,139,147,159,160,162,163],sic_tersoff:149,sicc:[117,159,160,162,163],sicg:[160,162],sicsi:[117,159,160,162,163],side:[19,45,61,66,67,73,76,80,86,87,97,110,122,123,150],sige:[160,162],sigma0:102,sigma14:135,sigma1:102,sigma2:102,sigma:[2,21,22,28,32,46,58,73,76,86,87,99,101,102,103,106,107,108,113,114,115,117,118,122,124,125,126,127,128,129,130,131,132,133,134,135,138,143,150,151,159],sigma_14:106,sigma_:111,sigma_c:108,sigma_cc:[99,108],sigma_h:121,sigma_i:119,sigma_ss:108,sign:[2,50,57,142,168],signifi:[34,120,146],signific:[72,80,118,122,139,142],significantli:[1,2,43,73,74,79,118,159],sij:63,silbert:123,silicon:[117,139,159],sim:151,similar:[2,3,4,19,22,32,39,43,45,58,62,66,72,78,79,86,99,101,102,114,116,118,123,135,136,144,149,167],similarli:[2,39,58,59,61,62,64,65,74,81,87,88,97,99,105,123,131,159],simluat:[2,136],simlul:85,simpl:[1,2,3,4],simpler:3,simplest:34,simpli:[1,2,3,34,62,64,65,68,74,77,97,105,113,131,139,167],simplif:118,simplifi:[79,142],simplist:3,simul:[0,1],simulatan:4,simulationub:152,simultan:[2,4],sin:[56,86,149],sinc:[0,1,2,3,6,19,28,29,30,33,34,40,41,46,58,59,61,62,63,64,65,66,67,68,73,74,75,76,77,80,85,86,87,88,96,97,98,99,102,104,105,106,107,108,109,113,114,116,117,122,123,124,126,127,129,130,131,132,133,134,135,136,137,138,139,140,141,142,145,146,148,149,150,151,152,153,154,159,160,161,162,163,166,167,168],sinclair:[76,116],sine:149,singapor:42,singh:98,singl:[1,2,3,4,19,32,34,40,45,56,58,59,61,62,63,64,65,66,67,68,73,74,75,77,79,81,85,86,97,98,99,102,106,109,116,117,118,119,123,124,125,139,140,141,142,147,148,149,150,152,153,154,159,160,161,162,163],singleel:102,singular:[56,135,136,137,144],sinnott:[99,109],sinusoid:[45,86],sio2:163,sio:109,sirk:[43,158],sisic:[117,159,160,162,163],sisisi:[117,159,160,161,162,163],site:[0,1,2,3,29,32,69,73,81,98,102,110,116,120,121,127,131,135,144,146,148],situat:[68,73,74,77,102],sival:44,six:[2,42,63,64,147,149],sixth:147,sixthpow:107,size:[0,1],sjplimp:[0,3],skew:[2,59,74],skin:[30,85,167],skip:[4,46,126],slab:2,slater:[110,152],sleight:28,slepoi:139,slice:[2,41,77],slider:3,slight:[69,85],slightli:[1,2,4,58,59,74,99,110,127,131,160,162,163],sligthli:113,sliozberg:158,sllod:[2,4],slope:[2,84,111],slot:1,slow:[2,72,74,97,152],slower:[1,102],slowest:85,slowli:[66,96,142,154],sm3:44,small:[2,19,29,32,41,43,44,58,62,66,67,69,72,74,76,78,80,81,94,96,97,99,108,110,111,112,127,136,137,139,150,153,159,162,168],smaller:[1,2,4,58,59,73,80,84],smallest:29,smd:82,smith:148,smooth:[2,87,102,106,110,124,129,132],smoother:45,smoothli:[28,42,106,124,133,135,138,162,166],smt:4,smtb:152,smulat:142,sn2:44,sn4:44,snap:[42,58,59],snapcoeff:153,snapparam:153,snapshot:[0,1],snc4:4,soc:125,sodani:4,soderlind:142,soft:[3,32,96,114,120],softer:[86,87],softwar:[1,2,3,4],sole:[97,149],solid:[2,19,29,30,35,43,60,66,68,74,76,84,103,129,142],solut:[2,68,80,81,87],solv:[69,73,80,81,84,85,137],solvat:45,solvent:[66,72,74,106,108,110,111,121,127,136,137,150],solver:[0,1,2,19,43,60,66,71,80,110,112,120,127,135,146],some:[1,2,3,4,19,37,40,45,50,57,58,59,61,62,63,64,65,66,67,68,74,80,85,86,96,97,101,102,110,116,118,142,167,168],someon:96,someth:[3,68,74,86,168],sometim:[2,68,74],somewhat:[29,62,74],somewher:118,soon:67,sort:[4,58,97],sound:[73,156,157],soundspe:[156,157],sourc:[0,3,4,60,68,85,135],source_integr:60,sourceforg:3,south:42,space:[2,3,4,19,41,42,44,45,59,64,66,73,74,77,86,97,103,104,105,110,113,116,118,127,131,139,142,145,146,148,149,151,165,167],spahn:123,span:[69,98,99,102,109,116,119,139,140,141,147,149,153,159,160,161,162,163],spars:80,spatial:[2,19,29,34,58,60,62,63,65,66,85],spc:0,spce:69,spcpu:167,spearot:[41,44],speci:[42,71,80,116,119,120,146,149,160,162],special:[2,40,45,46,60,81,98,109,112],special_bond:[2,4,21,22,28,36,38,42,46,57,67,112,125],species1:[71,146],species2:[71,146],species:80,speciesn:71,specif:[1,2,4,13,19,45,58,59,60,62,63,64,65,66,67,72,73,85,86,96,97,99,101,102,112,116,122,123,139,142,150,159,167],specifi:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,32,34,35,36,38,39,40,41,43,44,45,46,47,48,49,50,51,52,53,54,55,57,58,59,60,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,78,79,80,81,82,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],specifii:73,spectral:153,spectrum:[42,78],speed:[1,2,4,19,58,66,73,78,97,102,110,142,156,157,160],speedup:[1,4],spefici:[45,59,125],spellmey:[2,46],spend:61,spent:1,sphere1:73,sphere:[2,41,42,45,58,59,62,73,74,87,108,113,118,122,123,127,136,137,150,165],spheric:0,spheriod:2,spheroid:[2,74],spin:118,spline:[71,96,99,102,125,139],split:[1,2,3,4,19,62,66,69,74,115],splittol:2,spparks:2,spread:[1,2],spring:[2,10,11,21,22,24,25,27,48,56,67,77],sqrt:[33,38,76,108,114,116,121,123,139],squar:[2,8],squares:[19,66],squeez:[68,136,137],sr2:44,src:[0,1,2,3,4,58,81,142,168],srolovitz:116,srp:114,srtio:152,ssao:59,stabil:[2,74,102],stabl:[2,56,73,75,79,102],stabli:72,stack:29,stage:[32,97],stagger:1,stai:78,stall:4,stand:[0,2],standard:[0,1,2,3,4,38,45,51,58,60,73,77,81,86,98,99,101,110,113,118,121,122,127,128,129,130,131,134,138,139,142,143,150,159],starikov:85,start:[0,2,4,19,39,45],start_6:121,stat:[28,76,96],state:[2,3,29,30,32,51,59,67,68,70,71,72,74,75,78,83,84,85,97,102,113,115,118,122,123,139,141,142,150,152,155,156,157],statement:168,stationari:[73,136,137],statist:[2,19,67,72,78,80,81,85,96,97,99,114,123,136,165,167],statu:[28,109],steadi:[2,75,78],stefan:168,stegailov:85,steinhardt:38,stencil:73,step:[1,2,3,4,35,40,43,58,59,60,62,63,64,65,66,67,68,69,76,78,80,81,83,84,85,96,97,99,114,121,125,139,142,152,167],stepwis:32,steve:0,steven:67,stiff:[2,26,77,80,96],stile:111,still:[1,2,3,4,19,36,58,66,85,107,116,122,123,126,136,150,154,168],stilling:[117,141,149,159,163],stochast:115,stoddard:113,stoichiometr:80,stoichiometri:152,stoke:73,stone:113,stop:[2,3,19,28],stopthresh:[19,66],store:[2,3,33,35,36,39,40,43,45,57,58,59,60,61,62,63,64,65,72,73,74,75,76,77,80,81,82,84,85,98,99,102,109,114,115,116,117,118,119,120,122,123,139,140,141,142,145,146,149,152,153,159,160,161,162,163],straatsma:2,straightforward:118,strain:[2,68,74,75,136,137],strang:59,strategi:0,stratford:73,stream:[2,39,43,59,60,72],streiz:110,strength:[42,59,79,86,87,150],stress:[2,35,39,40],stretch:[28,40],strict:153,strictli:[2,19,66,78],strietz:110,string:[2,3,19,45,58,62,63,64,65,66,80,139,149,153,167],strong:99,stronger:2,strongest:[136,137],strongli:[1,2,81,85,142],structur:[0,2,3,29,30,38,41,44,51,79,95,102,109,118,139,142,149,152],strucur:30,stuart:[99,109,152],stuck:68,studi:[2,37,129,152],studio:4,stukowski:116,style:0,style_nam:74,stylecomput:152,sub:[1,2,3,19,32,35,42,57,59,66,68,74,75,78,81,85,87,99,101,109,122,123,125,150,152,166],subbox:[40,59],subdivis:73,subdomain:73,subequ:3,subgroup:58,subject:[2,4,19,66],submit:[0,57,119],subscript:[3,85,88,119,163],subsequ:[2,3,19,66,68,85,116],subset:[2,3,4,19,42,58,66,74,75,97,99,102],substanti:[2,159],substep:74,substitut:[1,58,97,118],substract:110,substrat:[68,74],substyl:135,subsystem:85,subtract:[2,28,35,37,39,43,58,62,69,72,134,167],succeed:63,success:[2,3,58,63,68,96,97],successfulli:[3,58],successulli:3,sudden:18,suddenli:87,sudo:3,suffer:87,suffici:[2,19,66,74,86,126],suffix:[1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,46,47,48,49,50,51,52,53,54,55,58,59,74,75,80,81,88,89,90,92,93,94,95,97,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,139,140,141,144,147,148,149,150,151,154,159,160,161,162,163,164,165,166],suggest:[0,2,78],suit:[73,118],suitabl:[28,32,58,67,102,123,135,139],sum:[2,29,33,34,36,37,38,39,40,42,43,62,63,64,65,72,76,78,84,85,86,87,96,101,110,114,118,119,127,130,139,153,167],summar:[2,119,152],summari:1,summat:[2,29,38,105,110,116,117,127,131,142,152,159,160,161,162,163],sumsq:40,sun:[6,20,47,88,107],sup:[78,109,152],supinski:142,supplementari:[122,150],suppli:85,support:[1,2,3,4,19,32,58,59,62,66,67,68,73,74,75,76,78,79,82,84,86,87,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],suppos:[119,168],suppress:2,sure:[2,3,68,81,116,168],surfac:[2,29,41,42,45,59,73,76,79,85,86,87,97,102,136,137,142,152,165],surface_mov:85,surfact:[111,121],surpris:118,surround:[29,45,68,71,74,76,145,146],suspens:[136,137],sustain:[58,68,123],suzuki:74,svg:2,svn:3,swap:2,swiggl:86,swiler:[42,153],switch7_section_start:121,switchflag:[42,153],swol:27,swope:2,symbol:[2,41,44,102,118,153],symmetr:[2,29,32,39,43,68,74,98,113,116,160,162],symmetri:[2,29,36,38,58,76,88,98],symplect:74,sync:2,synchron:[1,97],syntax:[1,2,3],sysstem:102,syst:152,system:[0,1],system_:77,systemat:[2,142],t_e:85,t_e_min:85,t_equil:[83,84],t_infil:85,t_init:[78,85],t_j:13,t_lb:73,t_oufil:85,t_out:85,t_outfil:85,t_qm:78,t_switch:[83,84],ta06a:153,ta4:142,ta5:44,ta6:142,tabbernor:41,table:71,tabul:[71,80,98,102,103,104,105,106,107,110,116,118,120,127,131,138,145,146,148,149,151,160],tabular:149,tad:2,tag:[60,71,80,120,146],tail:[32,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,116,117,118,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],tait:[156,157],take:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,33,35,39,40,43,46,47,48,49,50,51,52,53,54,55,58,59,61,62,63,64,65,66,68,69,74,75,80,81,82,88,89,90,92,93,94,95,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,142,144,147,148,150,151,152,154,158,159,160,161,162,163,164,165,166,167],taken:[2,45,67,72,73,78,80,85,92,116,118,122,145,146,159,163],talk:2,talli:[2,19,62,64,66,99,118,121,125],tang:142,tangenti:[2,123],tanh:85,tantalum:[142,153],taper:138,tarbal:[0,3],target:[2,3,19,66,68,69,72,74,75,77,78,82,85,114],task:[1,2,4,28,77],taskset:4,tau:[73,74,83,84,85],tau_1:72,tau_k:72,tau_n_k:72,tb3:44,tbp:102,tchain:[74,75],tcsh:3,tdamp:[74,75],technic:[2,73],techniqu:[2,32,68,78],technolog:4,tell:[2,3,57],temeperatur:3,temp:[2,32,35,39,40,43,62,63,64,65,67,68,69,74,75,77,78,85,99,113,121,122,125,150,167],temper:[2,97],temperar:77,temperatur:0,temperature_definit:60,templat:[45,81],templeton2010:60,templeton2011:60,templeton:60,tempor:72,temporarili:79,tend:[13,74,76,80],tensor:[2,33,34,35,39,42,43,68,73,74,75,118,136,137,142,167],term:[0,1,2,5,6,11,21,22,32,33,35,39,43,47,48,56,61,63,64,65,69,72,73,74,75,77,78,79,82,85,88,95,96,98,99,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,122,123,124,127,131,134,135,136,137,139,140,141,142,144,148,150,152,158,159,160,161,162,163,165,167],termin:[41,74,96,97],tersoff:[4,43,110,117,149],tersoff_1:[160,161,162],tersoff_2:[160,161,162],tersoff_mod:161,tertiari:51,test:[0,2],tether:[2,84,121],tetot:152,texas_holdem:79,text:[2,19,58,59,60,62,63,64,65,66,71,85,97,116,119,126,139,145,146,153,168],tfix:79,tflag:59,th4:44,thakkar:4,thakker:4,than:[1,2,3,4,11,19,36,37,38,39,43,48,58,62,64,65,66,67,68,72,73,76,78,79,80,82,85,86,87,96,97,99,101,102,103,104,105,106,116,118,122,123,136,137,139,145,146,150,152,154,158,159,162,165,166],thank:[160,162],thei:[0,1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,32,33,34,35,39,40,42,45,46,47,48,49,50,51,52,53,54,55,57,58,59,61,62,63,64,65,66,67,68,72,73,74,75,79,81,85,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,112,113,114,115,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,144,146,147,148,149,150,151,152,153,154,158,159,160,161,162,163,164,165,166,167,168],them:[1,2,3,19,28,35,40,47,58,59,61,62,63,64,65,66,67,68,74,75,76,79,81,85,88,97,98,102,116,119,122,150,154,168],themselv:[2,3,66,97,98,102,110,116,135,139,140,141,153],theorem:[72,102,115],theoret:[37,78,159],theori:[2,42,60,74,102,142,165],therebi:[136,137],therefor:[2,32,69,73,81,112,159],therein:[2,139],thereof:32,thermal:0,thermo:[0,1],thermo_modifi:[2,40,68,74,158,167],thermo_p:167,thermo_press:[39,68,74,75,167],thermo_styl:[2,31,35,39,40,43,45,58,62,63,65,67,68,74,75,78,86,96,99,121,125],thermo_temp:[39,67,68,74,75,167],thermoberendsen:2,thermochemistri:118,thermodyam:167,thermodyanm:67,thermodynam:0,thermost:2,thermostat:0,thermostatequ:2,thesi:136,thess:103,theta0:[5,6,8,10,11,12,16,17,18,42,48,79,94],theta0max:42,theta10:102,theta1:[47,56,88,102],theta2:[47,56,88,102],theta3:[88,102],theta4:102,theta5:102,theta6:102,theta7:102,theta8:102,theta9:102,theta:[2,10,11,36,38,42,44,45,48,59,79,85,88,94,125,149,161],theta_0:147,theta_:[94,102],theta_c:125,theta_ijk:102,theta_ijl:88,theta_jik:[140,141],theta_pi:102,theta_sigma:102,thi:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],thick:[41,59],thin:59,thing:[2,3,28,68,74,168],think:[2,3,89,93,96],third:[2,13,29,35,42,43,62,63,64,65,72,82,85,109,119,120,139,147,163],thirumalai:51,tho:117,thole:2,thompson:[0,39,42,43,153],those:[1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,35,36,38,39,42,43,45,46,47,48,49,50,51,52,53,54,55,58,59,61,62,63,65,68,69,74,75,81,83,84,88,89,90,92,93,94,95,96,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,139,140,144,147,148,150,151,153,154,159,160,161,162,163,164,165,166,167,168],though:[2,35,45,58,68,97,114,116,118,119,122,123,135,136,163],thought:[86,123,126],thread:[1,4],three:[1,2,28,29,32,35,36,37,40,41,42,44,45,51,67,68,69,74,75,80,83,85,91,92,94,98,99,102,116,117,119,122,123,126,139,140,141,142,147,149,150,152,153,159,160,161,162,163],threebodi:159,thresh:[19,58,59,66],threshhold:[19,59,66],threshold:[19,66,76],through:[2,3,45,58,68,71,73,74,77,80,85,86,87,99,115,117,118,120,123,127,142,146,151,152,154,158],throughout:[2,4,41,142],thru:[2,3,33,34,37,58,64,96],thrust:1,thu:[1,2,3,19,29,30,34,35,36,38,40,42,43,45,46,57,58,59,61,62,63,64,65,66,67,68,69,72,74,75,76,81,82,85,86,87,88,96,97,98,99,101,102,103,104,105,106,107,108,109,110,114,115,116,117,118,119,120,121,122,123,127,131,135,136,137,139,140,141,142,144,145,146,148,149,150,152,153,155,156,157,158,159,160,161,162,163,166,167],thumb:[45,108],ti2:44,ti3:44,ti4:44,tidi:168,tight:[102,152],tij:113,tildeslei:[13,32,113],tile:[2,19,45,66],tilt:[2,58,68,74,76,78,163,167],time:[0,1],time_integr:60,timedelta:63,timeout:167,timer:[1,167],timeremain:167,timescal:[61,62,63,64,65,78,118],timespan:74,timestep:[1,2,3,19,35,40,43,58,59,61,62,63,64,65,66,67,68,69,72,73,74,75,76,79,80,81,83,84,85,86,96,97,102,114,118,125,136,137,154,167],timesteppnig:81,tin:[109,110],tini:[45,96,102],tio2:152,tio:152,tip3p:0,tip4:2,tip4p:0,tip:0,tirrel:86,titl:[62,63,64,65,168],title1:[62,63,64,65],title2:[62,63,64,65],title3:[62,63,64,65],tji:113,tl1:44,tl3:44,tlbr_msw:149,tloop:[74,75],tm3:44,tmp1:[64,65],tmp2:[64,65],tmp:[2,19,34,58,59,62,66],tobia:74,togeth:[2,3,4,19,43,45,58,62,64,66,68,74,121],tol:[81,159],toler:[68,80,81,96,97,159],tolernac:80,too:[1,2,19,29,30,36,38,42,59,66,68,69,74,81,85,97,114],took:154,tool:[0,1,2,3,19,58,59,66,97],toolkit:2,top:[0,3,4,73,97,153,168],topolog:[2,32,57],torqu:[2,13,58,73,96,101,113,122,123,137],torsion:[2,47,57,99],torsion_flag:99,tosi:103,tot:152,total:[2,3,4,19,31,33,34,35,37,40,42,43,58,62,64,66,72,73,74,75,77,78,79,80,83,84,85,86,87,96,97,98,99,101,102,109,116,118,123,139,140,141,142,149,152,153,167],toukmaji:113,toward:[13,59,73,75,76,94,97],toxvaerd:132,tpcpu:167,tptask:4,tqx:58,tqy:58,tqz:58,trace:118,track:[73,85,167],track_displac:60,tractabl:80,trade:[2,110,127,131],tradit:[2,56],trail:[32,40,58,61,62,63,64,65,97,119,139,153,167],trajectori:[2,32,58,74,77,81,114],tran:[50,51],transfer:[1,2,4,60,85,102,142],transform:[2,32,58,122,144],transit:[2,4,97,111,135,141,142,162],translat:[2,62,69,74,77,118,167],transmit:2,transport:[60,85],trap:[2,35,63],trapezoid:63,treat:[2,43,62,63,64,65,85,87,96,101,112,118,119,122,125,140,141,142,150],treatment:112,tree:135,tri:[2,3,59,68,74,75,96],triangl:[2,59],triangul:2,triangular:[2,68],triclin:[0,1],triflag:2,trigger:[3,66,67,96,167],trigon:9,trilinear:73,tringl:59,tripl:[42,102],triplet:[117,147,149,159,160,161,162,163],trivial:3,trott:[42,153],troubl:3,truncat:[2,69,80,86,87,100,110,118,123,127,129,132,152],tscale:78,tsige:105,tstart:[72,74,114],tstat:[2,72],tstop:[72,74,114],tsuzuki:[30,163],ttm_mod:85,tucker:[42,153],tuckerman:[74,77],tune:[2,4],tunnel:77,turkand:38,turn:[2,28,42,44,57,59,67,68,74,96,97,99,112,125,139,158,167],tutein:99,tutori:[2,76],tweak:45,twice:[2,4,46,68,74],twist:[136,137],two:[1,2,3,4,19,28,29,32,36,40,41,42,44,45,56,58,59,61,62,63,64,65,66,67,68,72,73,74,75,76,77,78,84,85,87,95,96,97,98,99,101,102,103,104,105,108,109,110,112,113,114,116,117,118,119,120,122,123,126,127,131,135,136,137,139,142,146,148,149,150,152,153,154,158,159,160,161,162,163,165,166,167],two_temperatur:60,twobodi:[160,162,163],twojmax:[42,153],txt:[58,85,126,152,168],typcial:[19,66],type1:[41,44],type2:[41,44],type:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,20,21,22,23,24,25,26,27,28,32,35,41,42,44,45,46,47,48,49,50,51,52,53,54,55,56,58,59,60,63,73,81,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,168],typen:[41,44],typic:[1,2,3,4,13,19,21,22,29,32,45,56,58,59,60,62,66,67,68,74,79,81,96,97,106,108,110,121,122,125,126,127,131,136,137,139,150,162,168],tzou:85,u_chem:31,u_cond:[31,70],u_f:73,u_i:[70,71],u_ij:149,u_j:71,u_mech:[31,70],u_prom:102,uberuaga:97,ubiquit:[3,102],uchem:[120,146],uloop:[77,97],umbrella:2,umin:[10,11,24,25,48],unabl:[3,19,66],unaffect:[58,68,74],unambigu:163,unbias:118,unchang:[68,74],uncom:1,uncompress:59,uncorrel:72,uncoupl:77,under:[0,2,4,6,42,47,59,74,78,88,115,118,135,153],underflow:59,undergo:[2,32,72,74],undergon:67,underli:[2,29,59,74,85],underpredict:2,underscor:[67,68,74,75],understand:[1,2,142],understood:[58,102],undesir:[68,74],undisturb:[136,137],undump:[58,59],unfix:[2,35,60,62,63,64,65,79,83],unfix_flux:60,unfold:82,uniaxi:75,uniform:[4,19,60,66,73,122,150],uniformli:[73,85,145,146,149],uninterrupt:[74,75,78,84,85],union:[2,87],uniqu:[2,72,75,97,116,118],unit:[2,5,6,16,17,18,29,30,31,32,33,34,35,36,37,39,40,41,42,43,44,45,47,58,59,62,63,67,68,69,70,71,72,73,74,75,76,77,78,79,80,82,84,85,86,87,88,89,93,94,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],uniti:117,unitless:[29,62,74,78,80,96,123,144,148,159,160,161,162,163],univers:[2,32,97,136,141,162],unknown:30,unless:[3,4,41,44,45,58,68,74,96,108],unlik:[33,45,98,102,116,119,139,140,141,153],unlike:[58,74,75,116,125,126,140,141],unlimit:149,unnecessari:4,unoccupi:85,unoptim:59,unpack:[0,3],unperturb:32,unphys:[2,74],unpublish:142,unrel:[46,168],unrestrain:79,unscal:58,unset:118,unshift:113,unsmooth:133,unsolv:106,unstabl:73,unstag:168,until:[2,19,59,66,68,71,83,102,123,145,146],unus:102,unwant:45,unwrap:[33,34,43,58,61,67],unwrapexpand:58,up_intern:59,updat:[0,2,4,58,72,73,74,78,85,102,113,142],upenn:3,upon:[2,80,102],upper:[19,37,63,66,68,73,74,78,86,96,123,152],uppercas:0,upsid:2,upsilon:122,upstream:168,urbana:136,urey_bradlei:5,url:168,usabl:116,usag:[2,76,135],use:[2,58,59,61,62,63,64,65,85,122,139,150,152,168],useful:142,user:[0,1,2,3],user_manifold:168,user_misc:[14,15,17,49,53,55,56,92],usernam:168,using:[0,1],usr:3,usual:[2,8,12,16,17,18,23,32,40,54,56,58,59,62,67,68,75,78,79,85,86,87,93,97,106,108,111,113,122,126,135,136,137,147,153,158,159,167],util:122,v11:2,v22:2,v33:2,v_0:85,v_2:142,v_3:142,v_4:142,v_abc:167,v_delta:32,v_dhug:78,v_drai:78,v_e_hbond:125,v_ij:149,v_jx:35,v_jy:35,v_jz:35,v_k11:35,v_k22:35,v_k33:35,v_ke:58,v_lgr_po:78,v_lgr_vel:78,v_linear:86,v_lj:99,v_mu:136,v_myke:40,v_n:[73,142],v_name:[2,32,40,58,59,61,62,63,64,65,86,167],v_occ:121,v_prefactor:154,v_press:43,v_pxy:2,v_pxz:2,v_pyz:2,v_ramp:86,v_rebo:99,v_t_qm:78,v_torsion:99,v_v11:2,v_v22:2,v_v33:2,v_valu:59,v_wiggl:86,v_x:[45,86],v_xave:2,v_xmax:2,v_xx:45,v_y:45,v_yi:45,vacanc:[83,142],vacf:2,vacuum:[85,111,162,166],valanc:102,valenc:[102,118],valent:102,valid:[2,3,41,44,68,76,116,118,122,142,149],valon:139,value1:[61,62,63,64,65,75],value2:[61,62,63,64,65,75],valuei:63,valuej:63,van:[27,32,108,109,135,139,165],vanadium:142,vanderwa:167,vanilla:2,vanish:81,vapor:[19,66],vare:85,vari:[1,19,32,41,44,60,62,63,66,68,74,79,85,86,106,114,115,124,133,136,154],variabl:0,varianc:[40,114],variant:[1,2,74,75,123,140,141,144,160,162],variat:[19,66],varieti:[1,2,59,139,163],variou:0,varshalovich:42,vashishta1990:163,vashishta2007:163,vbia:2,vcm:2,vdisplac:86,vdw:109,vec1:40,vec2:40,vec:76,vector:1,vel:[2,62,114,115,118,123],veld:[105,131],veloc:[2,35,39,40,43,45,58,59,61,62,64,68,69,73,74,75,76,77,78,79,81,84,85,86,96,97,114,118,123,136,137,167],velocit:[114,115,118,123],velocity_bottom:73,velocity_top:73,verbos:152,veri:[1,2,19,32,40,58,59,61,62,63,64,65,66,68,74,77,81,97,118,123,136,137,145,146,153,154,167,168],verifi:168,verlet:[1,4,60,69,74,77,81,85],versa:[2,67],versu:[2,19,66,81,105,113,123,131,167],vertic:[4,19,59,66],via:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,32,35,39,43,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,61,62,63,64,65,66,67,68,73,74,75,77,79,81,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],vibrat:[2,76,78,94,118],vice:[2,67],video:59,view:[2,58,59,102,118,119,152],viewer:[58,59],viewpoint:59,vij:114,vim:0,virial:[35,39,42,43,68,74,75,81,114,115,118],virtual:[2,159],viscoelast:123,viscos:0,viscosity:2,viscou:[2,72,73,96,97],vision:152,vista:58,visual:0,viz:3,viz_tool:3,vizplotgui_tool:3,vmax:68,vmd:[2,3,58],voigt:[2,42],vol:[2,35,43,139,162,167],volpress:142,volum:[2,19,32,35,39,41,43,44,45,62,66,68,70,73,74,75,78,85,86,87,136,137,142,156,157,166,167],voronoi:43,voter:[140,141],voth:77,vri:124,vstream:2,vtk:[2,41],w_1:42,w_2:42,w_i:42,w_ik:149,waal:[32,108,109,135,165],wadlei:102,wagner:[60,73,139],wai:[1,2,3,29,32,34,35,36,38,42,43,45,58,59,62,64,65,67,68,72,73,74,75,77,85,86,89,90,91,93,94,96,97,98,99,110,111,114,116,117,119,122,125,127,139,140,141,147,149,150,152,153,154,158,159,160,162,163,168],wait:[1,4],walk:[72,74],wall:0,wallhi:86,wang:[139,149],want:[0,1,2,3,31,34,39,43,45,58,59,61,62,66,67,76,79,84,86,87,97,98,99,102,108,109,114,116,119,139,145,146,147,149,152,154,159,160,162,163,167,168],ward:102,warm:[4,118],warmup:4,warn:[0,21,22,30,59,74,75,80,136,137,139,145,146,168],warner:98,warning:139,warp:139,warren:[114,145,146],watanab:[83,84],watch:97,water:0,watkin:54,wave:118,wavefunct:118,wavelength:[41,44],wavepacket:118,weak:36,web:1,webb:60,weber:[117,141,149,159,163],weight:[2,32,42,44,46,57],well:[1,2,3,11,26,36,38,39,43,45,48,59,62,65,66,68,73,74,75,80,84,96,97,101,121,122,125,136,137,139,142,150,154,160,161,162,168],went:3,were:[2,3,4,19,29,38,39,45,58,59,62,64,65,66,99,118,123,126,167,168],westview:165,what:[0,1,2,3,45,58,59,61,62,63,64,65,66,67,71,74,77,79,81,86,96,97,139,145,146,154,158,168],whatev:[40,59,68,74,96,97,107,108,142],whelan:44,when:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,36,37,38,39,40,45,46,47,48,49,50,51,52,53,54,55,57,58,59,61,62,63,64,65,66,67,68,73,74,75,76,78,79,80,81,82,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,103,104,105,106,107,108,109,110,112,113,114,116,117,118,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,144,145,146,147,148,149,150,151,153,154,158,159,160,161,162,163,164,165,166,167,168],whenev:[0,56,61,125],where:[1,2,3,4,6,7,8,9,10,11,12,13,16,17,18,19,20,23,24,25,26,29,30,31,32,33,34,36,39,40,41,43,44,47,48,57,58,59,62,63,66,67,68,69,70,71,72,73,74,75,76,77,78,80,81,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,101,102,103,104,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,127,131,136,137,138,139,140,141,142,146,147,148,149,150,152,153,155,156,157,158,159,160,161,162,163,165,166,167],wherea:[2,3,36,72,74,85],whether:[2,3,28,29,59,62,65,67,68,74,75,81,104,106,109,124,126,136,137,139,152],which:[0,1,2,3,4,5,6,7,8,9,12,13,16,19,21,22,23,26,27,28,29,30,31,32,33,34,35,37,38,39,40,42,43,44,45,46,47,50,51,52,54,57,58,59,61,62,63,64,65,66,67,68,69,71,72,73,74,75,76,77,78,79,81,82,83,84,85,86,87,88,90,93,95,96,97,98,99,101,102,103,104,105,106,108,109,110,111,112,113,114,116,117,118,119,120,121,122,123,124,125,126,127,129,130,131,133,135,136,137,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,158,159,160,161,162,163,165,167,168],white:[72,85],who:[0,2,98,116],whole:80,whose:[2,32,59,71,74,76,79,80,81,87,97,118,120,129,145,146,159,160,162],why:[2,168],wicaksono1:76,wicaksono2:76,wicaksono:76,wide:[1,2,106,108,118],width:[59,121],wiggl:86,wigner:42,wih:2,wikipedia:2,wild:[32,125],wildcard:[40,58,59,61,62,63,64,65,158,167],wildli:74,window:[58,59,62,63,64,65,168],wire:79,wirnsberg:[2,69],wisdom:168,wise:[114,159],wish:[2,3,40,43,46,58,61,62,63,65,73,81,86,97,104,125,139,145,146,167],within:[1,2,3,4,13,19,29,30,36,38,39,40,42,45,59,61,62,64,65,66,67,71,76,80,81,85,86,87,96,97,101,103,104,110,115,116,117,118,120,121,126,127,139,142,146,148,150,151,159,160,161,162,163],without:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,39,46,47,48,49,50,51,52,53,54,55,58,59,62,64,65,68,71,72,74,75,80,81,88,89,90,92,93,94,95,97,98,99,100,103,104,105,106,107,108,109,110,113,114,116,117,118,119,120,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,142,144,145,146,147,148,150,151,154,159,160,161,162,163,164,165,166,167,168],won:137,wong:[60,102],word:[2,13,61,62,63,65,79,108],work:[1,2,3,4,28,40,41,44,58,59,62,67,73,74,79,81,84,109,112,114,136,137,139,142,152],worker:163,workflow:168,world:[42,97],worlei:114,worst:87,worth:[62,63,64,65,78],would:[1,2,3,4,13,19,29,33,35,43,45,46,57,58,59,62,66,67,69,74,76,77,80,88,89,90,91,93,96,97,98,99,102,108,109,110,114,115,116,117,119,139,140,141,142,147,149,153,158,159,160,161,162,163,167,168],wrap:[1,2,3,45,58,61,73,86,87,97],wrapper:[0,2],wright:96,write_atom_weight:60,write_restart:[60,73],written:[2,42,58,59,60,61,62,63,64,65,66,67,68,69,72,73,76,78,79,81,82,83,85,86,87,116,138,142,165,168],wrong:[3,68,74,86,87],www:[0,2,3,98,116,136],x200:4,x86:142,x_ij:149,x_ijkl:88,x_kjli:88,x_ljik:88,xave:2,xavx:4,xcore:4,xdr:58,xeon:[1,4],xhi:[2,58,86,167],xhi_bound:[2,58],xhost:4,xi_ij:149,xiaowang:[119,160,162],xiij:76,xlat:[45,167],xlo:[2,3,58,86,167],xlo_bound:[2,58],xmax:2,xmgrace:0,xmic:4,xmovi:[0,2],xmu:123,xplor:58,xpo:45,xrd:41,xsu:58,xt3:58,xt4:58,xt5:58,xtc:[2,58,59],xyz:[2,45,58,59,68,74,75],xzhou:119,yamada:4,yang:[142,149],yate:142,yb2:44,yb3:44,yellow:59,yet:[4,59,86,96,107,108,109,118,165,168],yhi:[2,58,86,167],yhi_bound:[2,58],yield:[2,35,40,43,63,68,74,80,101,114,123,167],yip:83,ylat:[45,167],ylo:[2,58,86,167],ylo_bound:[2,58],york:77,yoshida:74,you:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,30,31,32,33,34,35,36,38,39,40,42,43,45,46,47,48,49,50,51,52,53,54,55,57,58,59,61,62,63,64,65,66,67,68,69,72,74,75,77,79,81,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,118,119,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,139,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168],young:123,your:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,55,58,59,60,63,64,65,67,68,74,75,81,85,86,87,88,89,90,92,93,94,95,97,98,99,100,102,103,104,105,106,107,108,109,110,113,114,116,117,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,139,140,141,142,144,147,148,149,150,151,154,158,159,160,161,162,163,164,165,166,167,168],yourself:[2,68,168],ypo:45,ysu:58,yukawa:108,z_i:[118,162,166],z_j:[162,166],z_meam:139,zannoni:122,zbl:[139,153],zblcut:162,zblcutinn:153,zblcutout:153,zblexpscal:162,zblz:153,zero:[2,3,10,11,19,24,25,29,32,34,36,37,38,39,40,41,42,43,44,45,46,48,55,57,58,59,61,62,63,64,65,66,68,69,72,73,74,75,77,78,80,81,84,85,86,92,96,97,102,103,104,105,106,108,110,113,114,115,118,122,124,125,127,129,131,132,135,137,138,139,142,144,150,151,152,158,163,166,167],zeta:[73,119],zfactor:59,zhang:123,zhi:[2,58,86,167],zhi_bound:[2,58],zhou:[102,119,149,160,162],zhu:157,ziegler:[139,162,166],zimmerman2004:60,zimmerman2010:60,zimmerman:[29,60,102],zlat:167,zlib:58,zlim:152,zlo:[2,58,86,167],zlo_bound:[2,58],zmax:73,zmin:73,zn2:44,zone:41,zoom:[58,59],zr4:44,zsu:58,zwall:86,zwall_veloc:73},titles:["LAMMPS Documentation","5. Accelerating LAMMPS performance","6. How-to discussions","11. Python interface to LAMMPS","5.USER-INTEL package","angle_style charmm command","angle_style class2 command","angle_style cosine command","angle_style cosine/delta command","angle_style cosine/periodic command","angle_style cosine/shift command","angle_style cosine/shift/exp command","angle_style cosine/squared command","angle_style dipole command","angle_style fourier command","angle_style fourier/simple command","angle_style harmonic command","angle_style quartic command","angle_style sdk command","balance command","bond_style class2 command","bond_style fene command","bond_style fene/expand command","bond_style harmonic command","bond_style harmonic/shift command","bond_style harmonic/shift/cut command","bond_style morse command","bond_style nonlinear command","bond_style quartic command","compute centro/atom command","compute cna/atom command","compute dpd command","compute fep command","compute gyration command","compute gyration/chunk command","compute heat/flux command","compute hexorder/atom command","compute msd/nongauss command","compute orientorder/atom command","compute pressure command","compute reduce command","compute saed command","compute sna/atom command","compute stress/atom command","compute xrd command","create_atoms command","dihedral_style charmm command","dihedral_style class2 command","dihedral_style cosine/shift/exp command","dihedral_style fourier command","dihedral_style harmonic command","dihedral_style helix command","dihedral_style multi/harmonic command","dihedral_style nharmonic command","dihedral_style opls command","dihedral_style quadratic command","dihedral_style spherical command","dihedral_style command","dump command","dump image command","fix atc command","fix ave/atom command","fix ave/chunk command","fix ave/correlate command","fix ave/histo command","fix ave/time command","fix balance command","fix bond/swap command","fix box/relax command","fix ehex command","fix eos/cv command","fix eos/table/rx command","fix gld command","fix lb/fluid command","fix nvt command","fix nphug command","fix orient/fcc command","fix pimd command","fix qbmsst command","fix restrain command","fix rx command","fix shake command","fix spring/rg command","fix ti/rs command","fix ti/spring command","fix ttm command","fix wall/lj93 command","fix wall/region command","improper_style class2 command","improper_style cossq command","improper_style cvff command","improper_style distance command","improper_style fourier command","improper_style harmonic command","improper_style ring command","improper_style umbrella command","minimize command","neb command","pair_style adp command","pair_style airebo command","pair_style beck command","pair_style body command","pair_style bop command","pair_style born command","pair_style buck command","pair_style buck/long/coul/long command","pair_style lj/charmm/coul/charmm command","pair_style lj/class2 command","pair_style colloid command","pair_style comb command","pair_style coul/cut command","pair_style coul/diel command","pair_style born/coul/long/cs command","pair_style lj/cut/dipole/cut command","pair_style dpd command","pair_style dpd/fdt command","pair_style eam command","pair_style edip command","pair_style eff/cut command","pair_style eim command","pair_style exp6/rx command","pair_style gauss command","pair_style gayberne command","pair_style gran/hooke command","pair_style lj/gromacs command","pair_style hbond/dreiding/lj command","pair_style list command","pair_style lj/cut command","pair_style lj96/cut command","pair_style lj/cubic command","pair_style lj/expand command","pair_style lj/long/coul/long command","pair_style lj/sf command","pair_style lj/smooth command","pair_style lj/smooth/linear command","pair_style lj/cut/soft command","pair_style lubricate command","pair_style lubricateU command","pair_style lj/mdf command","pair_style meam command","pair_style meam/spline","pair_style meam/sw/spline","pair_style mgpt command","pair_style mie/cut command","pair_style morse command","pair_style multi/lucy command","pair_style multi/lucy/rx command","pair_style nb3b/harmonic command","pair_style nm/cut command","pair_style polymorphic command","pair_style resquared command","pair_style lj/sdk command","pair_style smtbq command","pair_style snap command","pair_style soft command","pair_style sph/idealgas command","pair_style sph/taitwater command","pair_style sph/taitwater/morris command","pair_style srp command","pair_style sw command","pair_style tersoff command","pair_style tersoff/mod command","pair_style tersoff/zbl command","pair_style vashishta command","pair_style yukawa command","pair_style yukawa/colloid command","pair_style zbl command","thermo_style command","LAMMPS GitHub tutorial"],titleterms:{"default":[29,32,36,37,38,41,42,44,45,57,58,59,60,62,65,68,72,73,74,75,77,78,83,84,86,102,118,136,137,142,158,167],"long":[103,104,105,106,107,110,112,113,127,131,135,148,151],acceler:1,adiabat:2,adp:98,airebo:99,alloi:116,amber:2,angle_styl:[5,6,7,8,9,10,11,12,13,14,15,16,17,18],arrai:2,aspher:2,atc:60,atom:[2,29,30,36,38,42,43,61],balanc:[19,66],barostat:2,bcc:76,beck:100,between:2,bodi:[2,101],bond:67,bond_styl:[20,21,22,23,24,25,26,27,28],bop:102,born:[103,112],box:[2,68],buck:[104,105,112,138],build:3,calcul:2,centro:29,charmm:[2,5,46,106,135],chunk:[2,34,62],class2:[6,20,47,88,107],cna:30,code:2,coeffici:2,colloid:[86,108,165],comb3:109,comb:109,command:[2,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],comparison:1,compos:2,comput:[2,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44],conduct:2,constant:2,core:2,correl:63,cosin:[7,8,9,10,11,12,48],cossq:89,coul:[103,104,105,106,107,110,111,112,124,127,131,135,148,151],coupl:2,create_atom:45,cubic:129,custom:58,cut:[25,104,107,110,113,118,121,127,128,135,143,148],cvff:90,data:2,deby:[110,127],delta:8,descript:[5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],diel:111,diffus:2,dihedral_styl:[46,47,48,49,50,51,52,53,54,55,56,57],dipol:[2,13,113],discuss:2,disp:2,distanc:91,document:0,dpd:[31,114,115],dreid:125,dreiding:2,drude:2,dsf:[110,127],dump:[2,58,59],eam:116,edip:117,eff:118,ehex:69,eim:119,elastic:2,energi:115,exampl:[2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],exp6:120,exp:[11,48],expand:[22,130],extend:3,fcc:76,fdt:115,fene:[21,22],fep:32,field:2,file:2,finit:2,fix:[2,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87],fix_modifi:[60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],flow:2,fluid:73,flux:35,forc:2,fourier:[14,15,49,92],from:[2,3],gauss:121,gaybern:122,gener:[1,2],github:168,gld:72,global:2,gpu:[100,103,104,106,107,108,110,113,114,116,121,122,124,127,128,129,130,143,144,150,151,154,159,160,161,162,164,165,166],gran:123,granular:2,gromac:124,gyrat:[33,34],h5md:58,harmon:[16,23,24,25,50,52,86,93,147],hbond:125,heat:35,helix:51,hertz:123,hexord:36,histo:64,histori:123,hook:123,how:2,idealga:155,imag:[58,59],implicit:106,improper_styl:[88,89,90,91,92,93,94,95],indice:0,induc:2,info:[0,60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],input:2,install:3,integr:2,intel:[4,5,16,21,23,46,50,54,74,90,93,104,106,122,127,159,160],interfac:[2,3],jul:0,kspace_styl:2,lammps:[0,1,2,3,168],lennard:138,librari:[2,3],linear:[134,144],list:126,lj1043:86,lj126:86,lj93:86,lj96:128,local:2,lubric:136,lubricateu:137,luci:[145,146],mdf:138,meam:[139,140,141],measur:1,mgpt:142,mie:143,minim:[60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87,96],mod:[85,161],model:2,molfil:58,morri:157,mors:[26,99,125,144],movi:[58,59],mpi:3,msd:37,msm:[103,104,106,110,127],multi:[2,52,145,146],multipl:2,nb3b:147,neb:97,nemd:2,nharmon:53,non:2,nongauss:37,nonlinear:27,nph:74,nphug:75,npt:74,nvt:74,omp:[5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,46,47,48,49,50,51,52,53,54,55,74,75,88,89,90,92,93,94,95,98,99,100,103,104,105,106,107,108,109,110,111,113,114,116,119,121,122,123,124,125,127,128,129,130,131,132,133,134,135,136,140,141,144,147,148,150,151,154,159,160,161,162,163,164,165,166],opl:54,opt:[106,116,127,131,144],optim:1,option:2,orient:76,orientord:38,orthogon:2,other:2,output:[2,60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],overview:3,packag:[1,4],pair:2,pair_styl:[98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166],parallel:3,paramet:2,particl:2,per:2,perform:1,period:9,pimd:77,polariz:2,poli:[136,137],polymorph:149,potenti:2,pppm:2,pressur:39,process:2,properti:2,python:3,qbmsst:78,quadrat:55,quantiti:2,quartic:[17,28],rattl:81,rebo:99,reduc:40,region:[40,87],relat:[5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,80,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],relax:68,replica:2,resquar:150,restart:[2,60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],restrain:79,restrict:[4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],rigid:2,ring:94,run:[2,3,60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],scalar:2,script:[2,3],sdk:[18,151],serial:3,set:2,shake:81,share:3,shell:2,shift:[10,11,24,25,48],simpl:15,simul:2,size:2,smooth:[133,134,144],smtbq:152,sna:42,snad:42,snap:153,snapshot:2,snav:42,soft:[135,144,154],spc:2,sph:[155,156,157],spheric:[2,56],spline:[140,141],spring:[82,84],squar:12,srp:158,start:[60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],stop:[60,61,62,63,64,65,66,68,69,73,74,75,76,78,79,81,82,83,84,85,86,87],strategi:1,streitz:110,stress:43,style:[1,2],summari:2,swap:67,syntax:[5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167],system:2,tabl:[0,2,71,160],taitwat:[156,157],temperatur:2,tersoff:[160,161,162],test:3,thermal:2,thermo:2,thermo_styl:167,thermodynam:2,thermostat:2,time:[2,65],tip3p:2,tip4p:[2,110,127,131,135],triclin:2,tstat:114,ttm:85,tutori:168,umbrella:95,user:4,using:[2,3],valu:2,variabl:2,variou:1,vashishta:163,vector:2,version:0,viscos:2,visual:2,vtk:58,wall:[2,86,87],water:2,weight:64,wolf:[103,110],wrapper:3,write:2,xrd:44,yukawa:[164,165],zbl:[162,166]}})
\ No newline at end of file
+Search.setIndex({envversion:50,filenames:["Manual","Section_accelerate","Section_howto","Section_python","accelerate_intel","angle_charmm","angle_class2","angle_cosine","angle_cosine_delta","angle_cosine_periodic","angle_cosine_shift","angle_cosine_shift_exp","angle_cosine_squared","angle_dipole","angle_fourier","angle_fourier_simple","angle_harmonic","angle_quartic","angle_sdk","balance","bond_class2","bond_fene","bond_fene_expand","bond_harmonic","bond_harmonic_shift","bond_harmonic_shift_cut","bond_morse","bond_nonlinear","bond_quartic","compute_centro_atom","compute_cna_atom","compute_dpd","compute_fep","compute_gyration","compute_gyration_chunk","compute_heat_flux","compute_hexorder_atom","compute_msd_nongauss","compute_orientorder_atom","compute_pressure","compute_saed","compute_sna_atom","compute_stress_atom","compute_xrd","create_atoms","dihedral_charmm","dihedral_class2","dihedral_cosine_shift_exp","dihedral_fourier","dihedral_harmonic","dihedral_helix","dihedral_multi_harmonic","dihedral_nharmonic","dihedral_opls","dihedral_quadratic","dihedral_spherical","dihedral_style","dump_image","fix_atc","fix_ave_atom","fix_ave_chunk","fix_balance","fix_bond_swap","fix_box_relax","fix_ehex","fix_eos_cv","fix_eos_table_rx","fix_gld","fix_lb_fluid","fix_nh","fix_nphug","fix_orient","fix_pimd","fix_qbmsst","fix_restrain","fix_rx","fix_shake","fix_spring_rg","fix_ti_rs","fix_ti_spring","fix_ttm","fix_wall","fix_wall_region","improper_class2","improper_cossq","improper_cvff","improper_distance","improper_fourier","improper_harmonic","improper_ring","improper_umbrella","minimize","neb","pair_adp","pair_airebo","pair_beck","pair_body","pair_bop","pair_born","pair_buck","pair_buck_long","pair_charmm","pair_class2","pair_colloid","pair_comb","pair_coul","pair_coul_diel","pair_cs","pair_dipole","pair_dpd","pair_dpd_fdt","pair_eam","pair_edip","pair_eff","pair_eim","pair_exp6_rx","pair_gauss","pair_gayberne","pair_gran","pair_gromacs","pair_hbond_dreiding","pair_list","pair_lj","pair_lj96","pair_lj_cubic","pair_lj_expand","pair_lj_long","pair_lj_sf","pair_lj_smooth","pair_lj_smooth_linear","pair_lj_soft","pair_lubricate","pair_lubricateU","pair_mdf","pair_meam","pair_meam_spline","pair_meam_sw_spline","pair_mgpt","pair_mie","pair_morse","pair_multi_lucy","pair_multi_lucy_rx","pair_nb3b_harmonic","pair_nm","pair_polymorphic","pair_resquared","pair_sdk","pair_smtbq","pair_snap","pair_soft","pair_sph_idealgas","pair_sph_taitwater","pair_sph_taitwater_morris","pair_srp","pair_sw","pair_tersoff","pair_tersoff_mod","pair_tersoff_zbl","pair_vashishta","pair_yukawa","pair_yukawa_colloid","pair_zbl","thermo_style","tutorial_github"],objects:{},objnames:{},objtypes:{},terms:{"00a":78,"00b":78,"02214e23":35,"0b1":3,"0e4":118,"0x98b5e0":57,"100k":1,"1024x1024":57,"10e":107,"10x":[91,92,97],"12th":75,"16e":75,"16g":60,"16x":1,"18986e":91,"1_prop":2,"1fluid":[115,141],"1st":[2,5,32,45,60,66,69,75,93,94,97,104,111,113,114,115,128,129,134,135,136,140,141,142,144,148,154,155,156,157,158],"2000k":57,"20x":97,"23899e":91,"2400k":57,"2697v2":4,"2697v4":4,"298k":106,"2k_ss":113,"2nd":[2,3,21,22,60,63,66,69,83,91,92,94,104,113,120,134,140,141,148,154,155,156,157,158],"2theta":43,"2x5":113,"36x":4,"3806504e":[2,35],"3n_k":67,"3nk":73,"3rd":[5,37,60,66,104,113,115,120,140,141,148,154,155,156,157,158],"3x3":35,"4857990943e":113,"49e":75,"4_94":3,"4th":[2,45,75,93,94,97,111,114,115,118,134,140,141,142,144,148,154,155,157,158],"50k":1,"512k":4,"524k":4,"5_1":97,"5th":[91,115],"66e":75,"6x6":2,"7120p":4,"8706e":147,"8706q":147,"8730m":147,"8730n":147,"8x1":2,"8x2":2,"948q":147,"9jan09":118,"9th":92,"break":[28,113],"case":[1,2,3,4,19,21,22,29,30,44,45,57,59,60,61,63,68,69,70,71,73,74,75,80,81,82,91,92,94,101,103,105,107,111,113,117,118,120,130,131,132,134,137,140,141,142,144,149,153,155,157,161,162,163],"catch":1,"char":[2,147],"class":[1,2,3,56,102,158],"default":[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28],"export":[4,57],"final":[2,3,19,32,42,59,60,61,63,69,70,73,75,78,80,91,92,93,94,97,111,114,115,130,134,142,144,154,155,157,158,163],"float":[2,4,60,113],"function":[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,35,39,41,45,46,47,48,49,50,51,52,53,54,55,58,63,66,67,68,69,70,72,74,75,76,78,79,80,81,83,84,85,87,88,89,90,91,93,94,95,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,149,150,151,152,154,155,156,157,158,159,160,161],"import":[1,2,3,37,44,49,63,69,80,130,137],"int":[2,3,80],"long":[1,2,4,18,32,39,42,45,50,57,58,64,69,76,80,91,92,95],"new":[0,2,3,19,32,44,57,60,61,62,63,64,69,70,72,76,91,92,111,134,137,140,141,162,163],"null":[2,35,36,38,39,42,44,59,75,77,93,94,104,111,114,118,134,135,136,142,144,148,154,155,156,157,158],"public":[0,114,140,141,147],"return":[2,3,4,19,44,60,69,118,162],"short":[1,2,4,69,94,97,98,99,100,101,104,105,107,113,122,126,130,133,134,139,143,146,147,163],"static":[2,19,57,61,69,118],"switch":[1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,35,39,41,43,45,46,47,48,49,50,51,52,53,54,57,68,69,70,76,78,79,83,84,85,87,88,89,90,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,137,139,142,143,145,146,149,154,155,156,157,158,159,160,161,163],"true":[2,60,61,69,71,72,113,118,147,154],"try":[1,60,68,78,79,163],"var":[3,44],"void":[2,19,61],"while":[1,3,29,37,41,49,63,67,68,69,73,75,91,97,106,111,155,157,158],_j1m1m1:41,_j2m2m2:41,_manifold_rattl:163,_wirnsberg:64,a12:145,a2m:[2,35],a_0:[68,80,97],a_0_real:68,a_1:80,a_2:80,a_3:80,a_4:80,a_c:103,a_cc:103,a_f:157,a_ij:97,a_pi:97,a_sigma:97,a_ss:103,aat:46,aberdeen:[31,65],abil:[63,69,113],abl:[3,62],ablat:80,about:[0,1,2,3,4,19,40,44,57,58,59,60,61,62,63,64,68,70,71,74,76,77,78,79,80,81,82,91,92,96,101,105,160,163],abov:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,32,33,34,35,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,57,59,60,61,62,63,69,70,72,74,75,83,84,85,86,87,88,89,90,92,95,96,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],abscissa:[140,141],absolut:[75,91,118,122],absorb:80,abstol:75,ac3:43,acceler:0,accelri:2,accept:[32,44,62,75,100,126,163],acceptor:120,access:[0,2,3,4,29,30,31,33,34,35,36,37,38,39,40,41,42,43,58,59,60,61,62,63,64,67,68,69,70,71,73,74,76,77,78,79,80,81,82,94,116,118,120,134,149,162],accident:163,accidenti:89,accomod:69,accomplish:4,accord:[2,31,57,66,68,69,73,78,79,80,81,82,113,118,125,128,144,147,149,150,151,152,153],accordingli:[3,131,132,153],account:[2,32,40,43,56,64,69,71,76,77,80,87,105,110,118,122,126,131,132,134,137,147,163],accumul:[2,31],accur:[1,2,19,61,75,76,82,97,113,117,118,145,155,157],accuraci:[1,2,19,61,64,69,76,94,113,140,141],achiev:[1,2,4,13,19,61,64,69,72,73],ackland1:111,ackland2:111,ackland:111,acknowledg:0,acolor:57,acquir:[2,63,69],across:[1,2,19,60,61,75,80,82,92],act:[2,68,78,79,80,82,91,108,117,118,120,145,153],acta:[40,43,93],actinid:137,action:[2,3,67,79],activ:[3,4,32,67,75,130],actual:[1,2,71,117,119,125,131,132,153,162],adapt:[2,32,75,130,131,149],adapti:71,adaptiv:94,add:[0,1,2,3,4,32,35,44,57,58,59,60,64,68,69,70,71,74,76,79,80,81,82,94,98,99,102,105,113,122,134,139,143,146,163],add_molecul:58,add_speci:58,add_to_nodeset:58,added:163,addforc:91,adding:[74,163],addit:[1,2,4,5,13,19,44,55,56,57,61,63,64,66,68,69,70,71,76,81,82,92,93,94,97,98,99,101,104,105,108,110,111,112,113,114,118,119,121,122,130,132,133,134,135,136,137,140,141,142,143,144,146,147,148,154,155,156,157,158,161,163],addition:[0,2,3,4,57,60,80,92,117,145,163],address:[3,57,163],addtorqu:91,adequ:92,adher:13,adhikari:68,adiabat:0,adiam:57,adjac:[44,64,92,155],adjiman:138,adjust:[2,4,19,40,43,57,60,61,63,69,70,71,73,75,81,91,92,94,131,132,147,157],admiss:70,adof:60,adopt:74,advanc:[4,97],advantag:[1,2,3,19,61,112],advect:2,advis:[75,92],affect:[1,2,42,57,60,62,63,64,77,80,89,91,92,113,131,132],affin:[4,104],afshar:109,after:[2,3,6,19,44,46,55,57,58,60,61,62,63,68,69,73,75,76,78,79,81,83,91,93,94,97,104,111,112,113,114,115,130,131,132,134,135,136,137,140,141,142,144,147,148,154,155,156,157,158,162,163],afterword:19,ag1:43,ag2:43,again:[2,3,41,64,83,92,131,132],against:[3,92],aggreg:[2,77],aggress:64,agre:[91,94],ahd:120,aidan:0,aim:2,aka:57,al2o3:147,al2o3_001:40,al3:43,ala:[68,147],alat:[71,134],albe:[144,155,157],albeit:74,alchem:32,alcu:[93,97],alcu_eam:144,alderton:108,alejandr:69,algebra:137,algorithm:[0,1,2,19,58,61,62,64,68,72,76,80,91,110,113,132,137],alia:4,alias:1,align:[2,13,19,61],alkali:113,all:[0,1,2,3,4,19,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,81,82,83,87,91,92,93,94,96,97,98,99,100,101,102,104,105,108,109,111,112,113,114,115,116,117,118,119,120,121,122,123,124,126,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,160,161,162,163],allen:[13,32,108,117],allentildeslei:32,alloc:[2,3],alloi:[93,97,105],allow:[1,2,3,4,19,36,38,43,44,56,57,58,60,61,62,63,67,68,69,71,73,74,75,76,77,78,79,80,81,82,91,92,94,97,98,99,100,101,105,111,113,118,119,120,122,126,131,132,137,144,145,147,153,160,162,163],almost:[4,73,80,153],alo:105,alon:[2,62],along:[2,13,29,32,40,43,44,57,60,62,64,68,73,76,77,80,82,91,92,105,108,118,122,126,134],alonso:[135,136],alpha:[2,26,68,73,91,93,95,98,105,109,110,111,112,114,115,120,121,122,134,139,156,162],alpha_c:130,alpha_i:148,alpha_lj:130,alphabet:56,alreadi:[44,60,61,73,92,109,119,124,132,153,161],also:[0,1,2,3,4,13,18,19,28,29,30,31,32,33,34,36,37,38,39,41,42,44,45,56,57,59,60,61,62,63,65,66,67,68,69,70,71,72,73,74,75,76,77,80,82,91,92,97,100,101,106,107,108,109,111,112,113,117,118,120,126,130,131,134,137,142,144,145,146,150,151,152,154,155,156,157,158,162,163],alter:[2,3,19,44,57,60,62,63,69,92],altern:[1,2,3,4,35,44,65,69,75,84,88,91,93,94,105,110,111,112,114,122,130,134,135,136,142,144,148,154,155,157,158,162],alternat:91,although:[4,13,69],aluminum:161,alwai:[0,2,3,4,28,60,81,82,83,91,99,102,111,125,137,140,141,147,149,155,157,161],amaz:3,amber2lmp:0,amber:0,ambient:57,amd:137,among:[4,42,68],amorph:[44,156],amount:[1,2,57,63,69,71,75,109],amplitud:89,amzallag:147,analag:2,analalog:2,analog:[2,38,41,118],analysi:[30,137,148],analyt:[1,40,43,76,97,124,137,144],analyz:[2,92,137],andersen:76,anderson:109,andzelm:153,ang:[4,71],angl:[0,1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,28,32,36,38,39,40,41,42,43,44,46,47,48,50,52,54,55,56,57,62,69,74,76,83,84,85,87,88,89,90,91,94,97,105,112,120,122,126,130,135,136,142,158,162],angle1:74,angle2:74,angle:[4,13],angle_coeff:[5,6,7,8,9,10,11,12,13,14,15,16,17,18],angle_cosine_shift:11,angle_cosine_shift_exp:[10,47],angle_cutof:120,angle_cutoff:120,angle_hybrid:13,angle_styl:[0,2],angleangl:83,angleangletors:46,angletors:46,angmom:[2,60],angmomi:60,angmomx:60,angmomz:60,angstrom:[2,40,43,44,57,81,93,94,101,111,130,134,142,157,161],angular:[2,13,41,44,76,93,97,104,118,131,132,134,137,144,155,156],anharmon:[11,27,47],ani:[1,2,3,4,13,19,29,30,32,33,34,35,36,37,38,39,40,41,42,43,44,45,55,57,60,61,62,63,64,66,68,69,70,71,72,75,76,80,81,82,91,92,94,97,100,101,104,105,108,109,111,112,114,117,126,137,140,141,144,145,148,154,155,156,157,158,162,163],anihil:[130,139],anim:[3,57,92],animat:57,anion:[114,147],aniso:[63,69,70],anisotrop:[117,145],ann:138,annoi:163,annot:[154,155,156,157,158],anoth:[2,3,4,13,57,60,62,64,67,69,70,80,91,92,105,109,113,114,117,120,121,122,130,145,149,153,155,156,157,163],another:[1,2,32],ansi:4,anthoni:79,antisymmetri:113,antonelli:[78,79],any:[1,2,57,153],anymor:79,anyth:[3,44,154,155,157,163],anywher:[44,134,148],aparam:32,apart:[96,149],api:3,appear:[2,3,19,32,36,38,41,44,57,60,61,63,83,91,92,103,111,134,140,141,147,158],append:[1,3,4,19,29,32,34,35,36,37,38,39,40,41,42,43,44,57,59,60,61,62,63,64,67,68,69,70,72,73,74,76,79,81,97,113,153,162],appendix:[13,108,147],appl:[63,69,158],appli:[2,13,19,32,37,41,42,43,44,45,56,57,58,60,61,63,64,65,66,67,68,69,70,71,72,73,74,76,79,80,91,92,96,98,99,101,105,108,113,115,118,119,120,122,128,132,137,141,143,146,153,160],applic:[1,2,4,62,71,74,157],applicat:58,appling:63,apply:[32,63,76,77],approach:[2,4,55,58,67,72,79,80,97,105,107,110,117,137,145,153],appropri:[1,2,3,30,35,56,60,62,63,68,69,70,72,73,81,82,92,94,97,100,103,104,105,112,118,126,130,137,154,155,156,157,158],approxim:[2,40,43,68,72,76,91,107,113,115,117,131,132,137,141,145,147,160],april:3,apu:[131,132],aqua:57,ar_thermal:58,ar_ttm:58,arbitrari:[2,57,69,72,75,154],arbitrarili:[3,41,63,69,105],arch:1,architectur:137,archiv:2,archive:3,area:[2,19,35,39,61,68,118],arg:[3,19,32,44,60,61,64,74,79,81,92,98,99,101,102,107,108,110,113,119,122,126,130,131,132,133,139,143,146,162],argument:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,32,35,38,39,41,42,44,45,46,47,48,49,50,51,52,53,54,59,60,61,63,66,69,70,75,76,80,83,84,85,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,107,108,109,110,111,112,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,133,134,135,136,139,140,141,142,143,144,145,146,147,148,149,154,155,156,157,158,159,160,161,162],aris:160,arithmet:[2,101,103,125],arl:[31,65],army:[31,65],around:[1,2,29,30,41,44,45,55,57,63,69,81,82,147],arrang:41,arrheniu:75,arriv:4,articl:[2,147],artifici:[73,150,151],arxiv:[41,148],ascend:19,ascii:[92,111,114,134],ash:[131,132],aside:[44,134],ask:[3,163],asoci:57,aspect:[2,117,145],aspher:0,asphere:[117,145],asq:[131,132],assign:[1,2,3,19,34,40,41,42,43,44,57,60,61,62,63,68,69,70,72,92,97,111,114,117,120,140,141,145,161,162],assignemnt:2,associ:[2,32,33,34,56,57,63,67,68,69,74,75,77,91,92,105,109,110,111,113,120,122,126,140,141,153],assum:[2,3,44,60,63,68,71,80,81,86,92,97,100,103,113,120,121,126,131,132,162,163],assume:92,assumpt:93,astar:134,astart:149,asterisk:[32,59,60,120,153,162],astop:[91,149],asu:111,asub:134,asymmetr:[64,97,111],asynchron:4,atc_fe_output:58,athomp:0,atm2pa:2,atom1:74,atom2:74,atom3:74,atom4:74,atom:[0,1],atom_element_map:58,atom_modifi:[3,92],atom_styl:[2,31,44,57,65,66,69,75,92,96,103,108,110,113,114,117,118,132,145,160],atom_weight:58,atomey:[2,3,57],atomfil:2,atomic:[0,147],atomic_charg:58,atomic_numb:144,atomist:[2,58,137],attach:[2,72],attatch:79,attempt:[2,19,61,62,92,162],attend:58,attrac:134,attract:[0,21,22,94,100,103,126,134,138,147,160],attribut:[2,3,32,57,59,60,62,63,69,70,97,113,162],atw:[131,132],atwater:156,atwt:134,atyp:[105,122,126,130],au1:43,au3:43,aug:3,augment:[63,134],augt1:134,author:[111,112],auto:[2,3,35],autocorrel:35,autom:57,automat:[2,4,18,68,104,111,134,137,161,163],auxiliari:[1,2,3],avail:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,39,41,45,46,47,48,49,50,51,52,53,54,57,60,63,67,69,70,75,76,79,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,134,135,139,142,143,144,145,146,148,149,154,155,156,157,158,159,160,161],availabl:4,avalo:110,ave_chunk:2,aveforc:2,avendano:138,averag:[2,19,31,32,35,36,37,40,43,58,59,60,61,63,69,70,73,75,83,94,110,113,115,134,141,162],avi:57,avoid:[1,2,18,44,57,71,72,82,97,113,130,134,139],avx2:4,avx512:4,avx:4,awai:[2,57,60,62,71,81,105,122,126],awar:112,axel:163,axi:[2,19,29,36,40,43,44,57,60,61,80,87,90],axial:70,azimuth:57,b_k:148,ba2:43,babadi:145,back:[1,2,3,44,69,78,79,92,118],backbon:[62,76,89],background:[32,39,42,61,80,92,103,131,132,134],backtrack:91,backward:92,baczewski:67,bad:92,badli:[63,69],balanc:[1,2,4],ball:[41,131,132],bammann:58,band:[2,41,92,97,137,147],bandwidth:1,bandwith:57,bar:[32,57],barashev:111,barostat:[0,1],barostt:2,barr:104,barrier:[2,90,92,104,116],bartok2010:148,bartok2013:148,bartok:[41,148],base:[2,3,4,5,32,35,40,43,44,57,58,61,72,75,94,95,97,109,113,117,120,122,131,135,136,143,144,147,154,156,157,158,162,163],bashford:[2,5,45,101],basi:[2,41,44,81],basic:[2,19,42,57,58,61,69,71,82,93,137],basin:92,bask:[111,134,144],bath:73,bayli:[2,45],bb13:46,bcc:[29,30],bcolor:57,bdiam:57,be2:43,bead:[21,22,62,72,153],bear:[2,67],becaus:[0,1,2,4,19,36,38,41,44,57,60,61,62,63,67,69,73,80,82,85,91,92,101,105,107,109,113,114,117,118,119,120,121,130,131,132,134,140,141,145,153,163],becker:[93,111],becom:[1,2,4,19,28,57,61,62,64,68,69,81,82,92,94,103,105,111,113,117,122,144,145,154,158,160,163],been:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,39,45,46,47,48,49,50,51,52,53,54,57,59,60,61,62,63,68,69,70,73,76,80,81,83,84,85,87,88,89,90,91,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,135,136,137,139,142,143,145,146,149,153,154,155,156,157,158,159,160,161,162],befor:[1,2,13,19,33,34,37,44,60,61,63,68,69,73,81,91,92,114,115,118,130,134,137,141,162,163],begin:[58,59,60,61,66,75,92,111,115,137,140,141,144,147,149,153,161,162],begun:75,behav:[11,47,91],behavior:[57,62,63,67,69,73,80,97,113,134,161],behaviour:2,behind:73,believ:3,bellott:[2,5,45,101],bellow:87,belong:60,below:[1,2,3,4,19,28,35,39,40,41,42,43,44,45,56,57,58,59,60,61,62,63,66,69,70,71,73,74,75,76,78,79,80,81,91,92,93,94,97,98,101,102,103,105,108,111,113,114,115,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,138,140,141,145,146,148,149,153,158,159,160,161,162,163],bench:[1,2,3],benchmark:[1,3,4,19,61],benedict:137,benefit:[1,4,67],bennet:32,berardi:[117,145],beraun:80,berendsen:[2,69,70,76],bern:[72,104,117,147],bernendsen:2,beryllium:113,best:[1,2,4,69,74,97,105,122,126],beta:[2,73,93,95,111,112,114,134,155,156,157,162],beta_:97,beta_k:148,beta_pi:97,beta_sigma:97,beta_t:156,better:[2,4,11,41,47,61,68,69,92,155,163],betwe:96,between:1,beutler:130,beyond:[2,32,69,116,128,162],bflag1:57,bflag2:57,bgq:137,bi3:43,bi5:43,bia:[2,39,42,60,69],bias:2,biersack:[134,157,161],big:[73,103,163],bin:[2,3,34,60,73],binari:[2,4,56,57,58,59,60,61,62,63,64,67,68,69,70,71,73,74,76,77,78,79,80,81,82,93,94,95,96,97,98,99,100,101,102,103,104,105,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],binary2txt:0,binchunk:60,bind:[97,147],binsiz:4,biolog:2,biologi:50,biomolecul:101,bios:4,bisect:[19,61],bisector:[2,105,122,126],bispectrum:[41,148],bit:[3,163],bitrat:57,bkgd_dyn:134,bks:73,blank:[57,66,75,92,97,112,115,134,140,141,142,148,154,155,156,157,158],blast:80,blend:134,block:[2,35,41,44,82,97,113,144,148,163],blow:[81,82,149],blue:[57,62],bluegen:137,board:108,bodi:0,body:96,bodyforc:68,bodyforcei:68,bodyforcex:68,bodyforcez:68,bogu:63,bohr:[111,113,137,157],boltzmann:[2,32,35,39,60,62,66,68,70,109],bond:[0,1,2,4,6,13,18,20,21,22,23,24,25,26,27,28,32,35,36,38,39,41,42,44,45,46,55,56,57,60],bond_coeff:[2,20,21,22,23,24,25,26,27,28],bond_harmon:[24,25],bond_harmonic_shift:25,bond_interact:58,bond_styl:[0,2],bondangl:6,bondbond13:46,bondbond:6,bonet:110,book:[160,163],bookmark:0,boost:1,border:[4,80],boresch:32,boreschkarplu:32,born:[2,32],boron:113,botero:113,both:[1,2,3,4,11,28,32,44,47,56,57,60,62,63,64,68,69,73,76,78,79,80,81,82,83,91,92,94,97,98,99,100,101,102,103,108,109,111,112,113,117,118,120,122,124,126,127,128,130,131,132,137,138,139,143,145,146,154,155,156,157,158,162],bottleneck:1,bottom:68,bound:[2,10,11,19,47,61,69,81,82,91,113],boundari:[2,33,34,35,37,39,40,42,43,44,57,58,59,63,68,69,71,73,77,80,81,82,119,131,132,137,162],boundary_dynam:58,boundary_faceset:58,boundary_integr:58,bounds:[2,19,61],bount:3,box:[0,1],boxcolor:57,boxxlo:3,bptype:153,br1:43,bracket:[2,19,59,60,61,162],bragg:[40,43],branch:[3,163],branicio2009:158,branicio:[30,158],breakdown:[1,94],brennan:[31,65,110,140,141,153],brenner:94,brick:[19,61],brief:[1,2,69,94,97],briefli:[2,72,104,147,163],brilliantov:118,broadwel:4,broken:[28,29,69,97],brook:2,brown:[4,40,42],brownian:[2,37,131,132],brows:0,browser:57,bryantsev:120,btype:[105,122,126,130,153],buc:99,buck:[2,4,32,98],buckingham:[98,99,100,107,133],buckplusattr:147,buffer:57,bufi:57,bug:0,bui:57,build:[0,1,2],built:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,20,21,22,23,24,25,26,27,28,31,32,37,39,40,41,43,45,46,47,48,49,50,51,52,53,54,55,56,62,64,65,66,67,68,69,70,71,72,73,75,76,78,79,80,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],bulatov:[135,136],bulk:[2,29,68,71,106,134,137,147],bundl:[57,163],button:163,bypass:2,c11:134,c_0:[80,94,151,152],c_1:[40,43,67],c_2:[40,43],c_cluster:2,c_cstherm:2,c_doubl:3,c_e:80,c_flux:35,c_gauss:116,c_hb:120,c_i:66,c_id:[2,32,59,60,162],c_ij:2,c_ijkl:2,c_k:67,c_my_stress:59,c_myang:60,c_mycentro:60,c_mychunk:[2,34],c_mycomput:60,c_mytemp:162,c_n_k:67,c_p:42,c_peratom:42,c_pi:97,c_prop:2,c_sigma:97,c_size:2,ca2:43,cach:4,cacul:76,calcforc:68,calclat:35,calcluat:[37,39,42,105],calcualt:[35,60],calcul:[0,1],caldwel:[2,45],calhoun:72,call:[1,2,3,4,72,94,103,160,163],callabl:3,callback:3,caltech:[2,113],calucl:2,calul:[3,29],can:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],cannot:[1,2,3,4,19,28,57,59,60,61,62,63,67,69,73,80,81,82,91,92,99,100,102,111,117,119,122,126,128,130,143,145,146,153],canon:[69,72,79,137],cao1:72,cao2:72,cao:72,capabl:[3,4,94,102],capac:[65,80,150],capolungo:[40,43],captur:[2,94,100,113,118,126,134],carbid:105,carbon:[57,89,94,104,134],card:[4,32,120],care:[2,44,55,60,68,69,96],carefulli:[3,28],carlo:[2,62],caro:111,carri:[4,80,118],carrillo:4,cartesian:[2,93],cascad:80,cat:[4,57],cate:68,categori:[0,94],cation:[114,147],caus:[1,2,4,44,63,69,71,75,76,81,82,91,92,120,122,128,131,132],caution:1,cautious:94,caveat:94,cbecker:[93,111],cc1:[2,34,60],ccc:[112,154,155,157,158],ccflag:4,ccflags:4,ccm6:111,ccsi:[112,154,155,157,158],ccu:97,cd2:43,cdeam:111,cdll:3,cdof:[2,60],cdte:97,cdte_bop:97,cdtese:97,cdzn:97,cdznte:97,ce3:43,ce4:43,cell:[2,40,43,44,63,69,70,73,80,113,137,162],cella:[2,162],cellalpha:[2,162],cellb:[2,162],cellbeta:[2,162],cellc:[2,162],cellgamma:[2,162],center:[2,9,33,34,37,40,44,57,60,63,67,69,77,79,81,82,83,96,112,113,117,118,131,132,134,135,136,154,155,156,157,158],centr:64,central:[29,36,38,41,71,76,77,86,137,142,158],centro:2,centroid:72,centrosymmetri:29,certain:[1,2,57,59,60,62],cfg:[2,57],cg_type:146,ch2:76,ch2lmp:[0,2],ch3:76,chain:[0,2,13,28,62,69,70,72,76,79,89,108,109,153],challeng:2,champaign:131,chan:137,chandler:[93,111],chandrasekhar:[2,122],chang:[1,2,3,4,19,22,32,44,57,58,61,62,63,68,69,70,71,73,74,75,76,78,79,80,82,91,92,109,113,118,131,132,134,137,147,153,162,163],change_box:2,chapter:72,charact:[2,19,57,61,66,75,113,115,121,140,141,144,147],character:[2,29,38,41,148],characterist:78,charg:[1,2,3,32,40,43,44,98,99,104,105,107,108,111,113,114,122,126,130,143,147,157,158,160,161],charmm:0,cheaper:[117,145],check:[2,3,19,35,61,74,76,79,91,92,121,162],checkout:163,chem:[2,5,6,9,20,21,22,32,38,39,42,45,46,53,64,67,68,69,72,73,78,79,81,83,89,90,92,94,98,101,102,104,105,106,108,109,110,113,116,117,119,120,122,126,127,130,134,138,140,141,143,147,153],chemic:[31,40,43,58,115,141],chemistri:[73,94,97,113],chen:80,cheng:104,chi:[71,114,117],chiral:89,chmod:3,cho:134,choic:[2,4,19,28,29,32,42,55,60,61,62,68,69,72,92,130],choos:[1,2,13,28,32,57,62,63,68,69,70],chose:[155,157],chosen:[2,41,44,50,57,63,67,68,69,70,72,110,113,118,121,124,146,155],chunk:0,chunkid:[34,60],ciccotti:76,cieplak:[2,45],circular:2,circumv:[36,38],citat:[0,68],cite:147,cl1:43,clarendon:[13,108],clarifi:[155,157],clark:143,classic:[0,2,4,72,73,80,90,113],classifi:158,clean:2,cleanli:162,clear:[2,3],clebsch:41,click:[3,44,56,57,92,163],climb:92,clockwis:45,clone:163,close:[2,3,19,42,62,63,68,69,76,82,92,94,97,105,106,134,140,141,157,163],closer:[19,61,63,78,92],closest:[71,117,145,153],cloud:147,cluster:[2,4,42,64,76],cmax:134,cmd:[3,72],cmdarg:3,cmin:134,cmm:[18,146],cna:29,co2:[43,75,76,115],coars:[13,18,28,50,66,75,115,119,141,146],coarsest:41,code:[0,1],coeff:[6,45,46,55,83,121,149],coeffici:0,coefficienct:109,coefficient0:111,coefficient1:111,coeffieci:[2,95],coeffincientn:111,coexist:113,cohes:[2,114,134],coincid:[82,101,131,132],cold:2,coleman:[40,43],collect:[2,34,44,60,103],colliex:43,collis:[68,118,161],colloid:2,color:[19,57,61,67,73],column:[2,29,34,36,38,41,42,43,59,60,73,80,94,116,120,162],colvar:0,com:[2,37,64,96,163],comand:62,combiant:106,combin:[2,3,18,32,55,57,58,64,69,72,82,83,103,105,106,110,113,114,115,129,130,148,154,155,157,158,160],come:[0,2,13,63,69,78,79,154,155,157,158,162,163],comit:163,comm:[0,3,30,92,109],comm_modifi:[2,97,103,109,113,118],comm_styl:[19,61],comm_world:3,command:[0,1],comment:[3,45,66,75,80,92,93,111,112,114,115,121,134,140,141,142,147,148,154,155,156,157,158,163],commit:163,commmand:2,common:[0,1,2,3,4,30,63,72,82,83,118,120,154,155,157],commonli:[2,9,37,38,57,90,119,124,148,155,157],commun:[1,2,3,4,19,57,61,63,68,69,80,110],comp:[76,92,113,145,152,156],compar:[1,2,4,40,43,56,91,92,134,147],comparison:0,compass:[6,20,46,56,83,102],compat:[3,19,49,59,60,61,64,81,137],compens:[2,113],compil:[4,57,137],complain:3,complement:134,complementari:[105,122],complet:[2,3,19,61,72,92,114],complex:[2,3,9,36,38,41,44,68,82,92,113,137],complic:2,compon:[2,29,30,33,34,35,36,37,38,39,41,42,57,59,60,62,63,64,68,69,70,72,76,82,91,92,109,113,118,131,132,147,148,162],componenet:2,composit:[2,68,111],compound:[104,113,114,158],compres:60,compress:[2,57,60,70,73],compris:[82,115,145],compton:[40,43],comput:[0,1],computation:[2,80,97],compute_modifi:[62,63,69,70,162],compute_sa:40,compute_xrd:43,concav:82,concentr:[66,75,111,115,141],concept:[2,60],conceptu:[2,63,92,105,134],concern:[2,30,32,67],concis:3,concurr:4,conden:[80,155,157],condens:[2,80,94,107,111,122,158],condit:[2,39,40,42,43,57,58,68,70,71,73,76,77,80,110,113,119],conducit:2,conduct:0,confer:[4,137],configur:[1,2,4,57,63,72,91,92,94,97,112,134,137,154,155,157,158,162,163],conflict:163,conform:[2,62,63,74,89,92,113],confus:158,conjuct:109,conjug:113,conjunct:[2,32,44,68,92,98,99,105,109,113,120,122,143,146],connect:[2,32,62,76,92,106,118,153,157],conner:94,connor:94,consecut:[3,44,105,122,126],consequ:[1,2,80,121],conserv:[13,62,67,68,69,75,76,92,108,109,110,118,128,147],consid:[2,29,32,59,61,62,80,113,145,147,153,162],consider:2,consist:[2,3,39,44,50,60,67,69,70,73,74,75,92,94,97,103,105,113,117,131,132,134,137,140,141,145,147],consistent_fe_initi:58,constant:0,constantli:64,constitu:[2,81,82,103,145],constrain:[2,60,64,67,76,77,91,113],constraint:[19,39,42,60,61,64,76,77,81,91,132],construct:[2,28,29,30,36,38,40,41,43,63,69,74,75,82,108,137,153,154],constructor:3,consult:4,consum:1,contact:[0,106,112,114,117,118,145],contain:[0,1,2,3,19,32,35,40,41,43,44,45,56,57,58,59,60,61,66,68,71,73,75,80,82,92,93,94,97,104,105,108,111,112,113,115,134,137,140,141,142,144,148,154,155,156,157,158,162,163],content:162,context:[2,4,160],contibut:29,contin:4,continu:[0,2,19,60,61,62,63,64,67,69,70,73,78,79,80,82,97,109,124,127,145,156,162],continuum:[2,58,80],contour_integr:58,contract:[63,69],contrain:76,contrast:[1,2,160],contrib:80,contribut:[2,29,32,33,34,35,39,41,42,59,60,63,68,76,91,92,109,111,113,131,132,137,147,162,163],control:[2,3,4,11,13,19,32,35,41,47,57,58,61,63,69,70,75,80,113,117,137,154,157],control_typ:58,convect:35,conveni:[2,13,148,163],convent:[13,49,54,56,74,111,113],converg:[2,19,57,61,62,63,70,73,74,76,91,92,104,105,122,147],convers:[41,57,105,106,107,113,122,126,130,143],convert:[2,5,6,8,12,16,17,18,35,44,46,57,83,84,88,89,92,93,111,137,155,157,161],convex:82,cool:64,coord1:60,coord2:60,coord3:60,coord:[2,3,36,38,71,81,92],coordb:147,coordbb:147,coordiat:91,coordin:[1,2,3,19,32,33,34,41,44,57,59,60,61,62,63,64,69,71,76,77,79,80,91,92,93,94,96,112,147],coordn:60,coords:147,copi:[0,3,57,80,92,163],copper:161,coprocessor:[1,4],core:[0,1],coreshel:2,coreshell:[2,99,105,107],cornel:[2,45],corner:[2,57,82,163],corpor:4,corr:104,correct:[2,3,32,45,57,64,69,73,81,82,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,111,112,113,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],correction_max_iter:58,correctli:[3,69,76,82,92,107,132,137,163],correl:[2,35,36,41,60,67,72],correpond:66,correspond:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,29,32,39,40,41,43,45,46,47,48,49,50,51,52,53,54,55,57,60,63,64,66,68,69,70,71,72,75,76,81,82,83,84,85,87,88,89,90,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,134,135,137,139,141,142,143,144,145,146,147,148,149,154,155,156,157,158,159,160,161,162],correspondingli:[131,132],cosin:2,cosineshift:11,cost:[1,2,3,19,40,42,43,57,60,61,69,75,80,105,122,126,137,154],costheta0:[154,155,157,158],costheta:144,costli:[3,4],coul:[2,4,18,21,22,32,45,91],could:[2,3,19,32,34,39,57,60,61,73,80,81,82,91,94,116,120],coulomb:[2,42,91,98,99,100,101,102,104,105,106,107,108,113,118,119,122,126,130,133,143,146,147,157,158,160,162],coulommb:2,count:[1,2,3,19,35,45,60,61,69,76,82,91,92,116,120,162],counterbal:64,counterbalanc:13,counterclockwis:45,coupl:0,couple:[2,3],cours:[4,67,74,81,131,149],cov:147,coval:[2,13,113,134,147],cover:[2,58,68,113],cpp:[1,2,3,32,76],cpu:[1,4,162],cpuinfo:4,cpuremain:162,cr2:43,cr3:43,creat:[0,1,2,3,19,35,39,40,44,57,58,59,60,61,62,63,66,69,70,71,72,74,80,92,94,97,104,111,112,130,139,140,141,144,147,154,155,156,157,158,162,163],create_atom:[2,19,35],create_box:[2,19,35,44,63,69,153,162],create_elementset:58,create_faceset:58,create_nodeset:58,createatom:0,creation:44,criteria:[57,62,91],criterion:[19,44,61,62,91,92,104,113,118,147],critic:[2,24,25,80,91],cross:[4,33,57,59,92,101,109,111,119,120,122,124,126,144,146,155,157,161],crossov:1,crozier:0,crucial:73,crystal:[2,4,29,30,38,71,79,162],crystallin:[2,156],crystallogr:[40,43],crystallograph:162,crystallographi:[40,43],cs1:43,cs_chunk:2,csanyi:[41,148],cscl:134,csequ:2,csh:[3,4],cshrc:3,csic:[112,154,155,157,158],csinfo:2,csisi:[112,154,155,157,158],cst:111,cstherm:2,csvr:2,ctcm:[93,111],ctype:3,cu1:43,cu2:43,cu3au:134,cube:[2,82],cubes:[19,61],cubic:[38,68,71,111],cuda:1,cuh:97,cummul:[2,62,120,162],cumul:[2,60,69,70,92],current:[0,1,2,3,4,19,30,32,42,57,58,60,61,62,63,64,69,74,75,76,77,80,81,91,92,97,104,108,111,113,114,118,121,131,132,134,135,136,144,149,155,157,162,163],curv:[2,44],curvatur:[117,145,161],custom:[0,2,3,33,34,35,42,57,59,60,62,63,69,70,73,91,94,116,120,162],cut:[1,2,4,19],cuthi:71,cutinn:[131,132],cutlo:71,cutmax:144,cutoff1:[102,108,122,126,130,133,143,146],cutoff2:[98,99,100,102,107,108,122,126,130,133,143,146],cutoff:[2,4,21,22,28,29,30,32,36,38,41,62,66,71,73,81,82,91,93,94,95,96,97,98,99,100,101,102,103,105,106,107,108,109,110,111,112,113,114,115,116,117,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],cutoffa:112,cutoffc:112,cuu3:111,cval:43,cvff:4,cwiggl:81,cyan:57,cycl:[69,70],cyclic:45,cylind:[57,60,82],cylindr:2,cyrot:97,d3q15:68,d3q19:68,d_e:80,daan:79,damp:[2,69,70,73,91,92,98,99,101,105,108,113,118,122,130,143,146],dampflag:118,danger:[109,162],darden:108,darken:57,dash:118,dat:[2,35,58],data2xmovi:0,data:1,databas:0,date:[0,2],datum:2,davenport:133,davi:81,david:[155,157],daw:[111,144],dcd:[2,57,72],deactiv:130,debug:[2,3,40,43,44,72],decai:[36,105,161],decid:[2,4,163],decod:57,decompos:[32,148],decomposit:[58,72],decoupl:2,decreas:[4,62,64],dedic:4,defect:[2,29,137],defin:[2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,65,66,68,69,70,71,72,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,94,95,96,98,99,100,101,102,103,105,106,108,109,110,112,113,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],definit:[2,41,60,65,70,81,97,103,110,113,144,148],defint:162,deform:[2,42,63,69,131,132],deg2theta:43,degre:[2,5,6,8,12,13,16,17,18,36,38,39,43,44,45,46,48,49,54,55,57,60,62,69,70,72,74,76,79,83,84,88,89,90,91,108,111,120,162],degress:60,delai:[2,162],delet:[28,60,62,69,153,163],delete_atom:44,delete_bond:[20,21,22,23,24,25,26,27,28],delete_el:58,delimit:75,dellago:[2,64],deloc:[113,147],delr:134,delta_1:97,delta_3:97,delta_7:97,delta_ij:[134,144],delta_pi:97,delta_r:144,delta_sigma:97,deltah_f:66,demo:3,demonstr:[73,134],dendrim:120,denniston:68,denot:[40,64,105,119],dens:[62,75,113],densiti:[2,19,41,44,58,60,61,68,80,81,93,94,97,111,134,135,136,140,141,144,145,147,150,151,152,162],depart:0,departur:73,depend:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,36,39,41,44,45,46,47,48,49,50,51,52,53,54,56,57,60,61,63,66,68,69,70,71,75,76,78,80,81,82,83,84,85,87,88,89,90,91,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,134,135,137,138,139,140,141,142,143,144,145,146,147,148,149,154,155,156,157,158,159,160,161,162],dependend:2,deposit:[69,76],deprect:60,depth:[26,57,80,115,117,145],der:[32,103,104,130,160],deriv:[2,32,41,63,64,69,70,71,78,79,80,81,82,94,97,103,108,113,114,119,124,128,129,134,137,160],derjagin:160,derlet:71,descib:57,describ:[0,1,2,3,4,19,29,30,40,41,42,43,44,50,53,60,61,62,63,66,67,68,69,70,71,72,73,75,78,79,81,91,92,94,96,98,99,101,102,103,104,105,108,111,113,114,115,117,118,119,122,123,124,125,126,127,128,129,130,131,132,133,134,137,138,140,141,144,145,146,147,148,149,153,154,155,156,157,158,159,160,161,163],descript:[2,3],descriptor:41,design:[0,2,3,40,43,58,62,69,71,80,95,96,101,105,107,113,130,131,132,135,136,144],desir:[2,3,4,35,39,42,44,60,63,67,69,76,91,92,109,111,120,131,132,154,155,157,162],desktop:[2,57],destabil:97,destre:89,destroi:3,detail:[1,2,3,4,19,34,35,39,41,42,44,56,57,58,60,61,62,63,64,67,68,69,70,73,76,79,80,91,93,94,96,97,100,101,102,103,104,105,108,109,113,114,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,138,140,141,145,147,148,149,159,160,162,163],detect:[36,92,104,120,121],determin:[1,2,4,26,32,39,40,42,43,44,57,59,60,61,63,66,69,71,72,73,74,75,81,82,94,100,104,108,111,115,116,118,126,134,137,141,145,147,153,160],devan:146,devanathan:157,develop:[0,2,3,4,70,73,94,97,113,136,137,147,158],deviat:[70,71,116],devic:1,devin:104,devis:136,dfactor:57,dft:137,dhug:73,dhugoniot:73,dia:134,diag:75,diagnost:[4,62,75],diagon:[2,41,42,63,69],diagonalstyl:148,diagram:[19,40,43,56,61,72],diallo:120,diam:57,diamet:[2,44,57,103,117,118,124,145,160],diamond:[113,134],dick:2,did:[91,109,111,118,155,157],dielectr:[101,105,106,107,122,126,130,143],diff:[2,4],differ:[1,2,3,4,19,28,29,32,36,41,44,56,57,60,61,62,63,64,67,68,69,71,72,73,76,77,78,79,80,81,82,83,92,93,94,97,100,101,103,104,109,110,111,113,115,117,118,119,122,123,125,126,133,134,135,136,138,139,140,141,142,144,145,146,147,148,149,154,155,157,158,160,162],differenti:[1,2,13,75,105,144,156],difficult:[63,72,120],difficulti:[36,38,76],diffract:[40,43],diffraction:[40,43],diffus:0,diffuse:2,digit:137,dihedr:[0,4,28,36,38,39,41,42,44,45,46,47,48,49,50,51,52,53,54,55,56,62,74,84,85,86,88,91,94,97,101,162],dihedral_coeff:[45,46,47,48,49,50,51,52,53,54,55,56],dihedral_cosine_shift_exp:11,dihedral_styl:[0,2,42],dihydrid:113,dij:76,dilat:[63,69,70],dim:[44,134],dimens:[1,2,19,35,42,44,57,60,61,63,68,69,70,73,81,92,162],dimension:[36,39,40,41,43,60,80,92,144],dimensionless:[37,41,80,148,160],dimer:[2,134],dimstr:[19,61],dintel_offload_noaffinity:4,dipol:0,dipolar:13,dipole:108,dir:[1,3,71,73,144],dirac:41,direc:144,direct:[2,4,13,29,38,40,41,43,44,45,57,68,70,71,73,78,79,80,81,82,91,92,109,110,118,132],directli:[2,3,32,41,57,68,75,82,93,94,98,99,100,105,108,111,113,122,126,143,146,153,162],directori:[0,1,2,3,4,78,79,92,93,94,97,104,105,111,112,114,130,134,135,136,137,142,144,147,148,154,155,156,157,158],disabl:[4,80,121],disadvantag:[2,61],disallow:69,discard:[19,61,82],discontinu:[91,128],discourag:134,discret:[2,57,68],discuss:[0,1],disk:[2,36],disloc:[29,137],disord:[29,137],disp:0,dispar:145,disperion:[108,126],dispers:[2,100,108,126,131,158],displac:[2,37,63,69,71,118],displai:[3,56,57],disregard:137,dissip:[2,31,65,67,78,79,109,110,118,131,132],dist:[2,35,72,74,153],distanc:[2,5,6,20,21,22,23,24,25,26,27,28,30,33,34,36,37,38,40,41,44,46,57,60,62,63,64,68,69,70,71,73,74,76,77,79,80,81,82,83],distinct:[2,145],distinguish:[2,41,113],distort:93,distrbut:93,distribut:[0,2,3,19,32,41,56,61,67,68,69,93,97,105,111,112,114,134,135,136,142,144,145,154,155,156,157,158],distro:144,ditto:161,div:4,diverg:[79,94],divid:[2,4,19,35,39,42,56,60,61,71,91,92,114,147,158],divis:[2,55,68,97,130,162],dl_poly:2,dlammps_ffmpeg:57,dlammps_gzip:57,dlammps_jpeg:57,dlammps_memalign:4,dlammps_png:57,dlm:69,dlmp_intel_offload:4,dlopen:2,dlvo:[103,160],dm_lb:68,doc:[0,1,2,3,32,34,37,39,42,44,56,57,59,60,69,82,91,92,93,94,96,104,105,111,112,114,120,134,135,136,142,144,148,154,155,157,158,162,163],docuement:145,doe:[0,1,2,3,19,28,29,32,35,40,43,44,45,56,57,58,60,61,62,63,64,66,67,68,69,80,81,82,84,85,86,88,89,92,93,94,95,96,97,100,101,102,103,104,105,106,108,109,111,112,113,115,116,117,118,119,121,124,125,127,128,129,131,132,134,135,136,137,140,141,144,145,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],doesn:[44,94,104,112,154,155,156,157,158],dof:[39,60],dof_per_atom:60,dof_per_chunk:60,doi:[2,71],domain:[2,19,40,43,57,61,63,68,69,72,80,81,92],domin:[1,113],don:[0,4,82,134,147,163],done:[1,2,19,44,55,57,58,60,61,62,63,66,69,72,76,78,79,91,92,94,100,111,126,132,133,134,140,141,153,162,163],donor:120,dot:42,doti:[97,144],doubl:[1,2,3,4,32,45,82,97,114,119,137],dover:58,down:[2,3,63,113,147],download:3,downsid:2,dpd:2,dpdtheta:[31,110],dpdtheta_i:[65,66],dr_ewald:40,drag:[2,35,69,70,77],dragforc:68,drai:[57,73],drain:91,dramat:[62,63,69,147],drautz:97,draw:57,drawn:[57,67],drayleigh:73,dreid:2,dreiding:0,drfourth:37,drho:[93,111,140,141],drift:[2,37,64,67],drive:[3,63,69,71,92],driven:[2,50],driver:2,drop:109,drsquar:37,drude:0,dt_collis:68,dt_lb:68,dt_md:68,dtqm:73,dudarev:43,due:[1,2,4,28,29,33,34,37,40,41,42,43,44,57,62,63,67,68,69,70,71,74,78,79,80,81,82,91,92,106,109,110,111,116,117,131,132,144,145,146,153,155,157,160,161,162],duffi:80,dullweb:69,dummi:[13,156],dump:[0,1],dump_modifi:[2,57],dunbrack:[2,5,45,101],duplic:[19,61,71],durat:[56,60,80,118],dure:[2,4,19,32,45,58,59,60,61,62,63,64,66,67,68,69,70,71,72,73,74,76,77,78,79,80,81,82,91,92,109,130,137,139,140,141,162],dvlo:160,dvx:2,dx_lb:68,dy3:43,dyanam:2,dynam:[0,2,3,4,19,31,37,44,57,58,61,62,65,67,69,70,72,73,74,78,79,80,91,92,109,110,113,131,132,152],dynamo:[93,111,134],dyre:127,e28637:13,e_1:97,e_2:97,e_a:75,e_b:114,e_ee:113,e_hbond:120,e_i:[2,97,114],e_j:[2,97],e_k:97,e_ke:113,e_kl:2,e_lj:[94,108],e_n:97,e_ne:113,e_nn:113,e_pr:113,e_rebo:94,e_torsion:94,e_tot:137,e_vol:137,eaa:83,eaat:46,each:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,32,33,34,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,66,67,68,69,70,71,72,75,76,77,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,157,158,159,160,161,162],eacn:[19,61],eam:[0,93,105],eangl:162,earli:[19,60,61],earlier:[92,118,134],earth:113,easi:[2,3,32,42,81],easier:[4,57],easili:[3,57,92],eat:46,eaxmpl:2,eba:6,ebb13:46,ebb:6,ebond:162,ebt:46,ec_ii:134,ec_ij:134,ec_jj:134,echo:[3,40,43],ecoul:162,ecp:113,edg:[2,19,40,43,57,81,82],edge:81,edih:162,edit:[4,163],edition:4,edu:[3,111,131],eebt:46,eff:0,effect:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,33,34,37,39,42,45,46,47,48,49,50,51,52,53,54,56,57,58,59,60,62,63,64,67,69,70,71,72,73,74,76,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,137,139,140,141,142,143,145,146,147,149,154,155,156,157,158,159,160,161,162],effici:[0,1,2,4,39,55,57,63,69,72,76,97,103,105,122,126,137,140,141,145],efficienc:4,efield:[76,91],eggebrecht:[105,147],ehex:2,eigenvalu:72,eimp:162,einstein:[2,79],either:[1,2,3,4,19,29,40,41,42,43,44,57,59,61,62,63,64,68,69,70,71,75,76,82,91,97,103,111,115,118,131,132,134,137,141,144,153,155,157],ejtehadi:[103,117,145],elaplong:162,elaps:[81,149,162],elast:[2,21,22,92,118,156],elastic:0,elba:13,electr:[2,58,114,161],electric:4,electrolyt:160,electron:[2,40,58,80,93,104,108,111,113,114,134,137,144,147,157,158,161],electron_integr:58,electron_temperatur:58,electron_unit:113,electroneg:[2,104,114,147],electroneg_compon:147,electrostat:[2,4,103,108,113,122,130,132,147,160],elem1:[114,134,148],elem2:[114,134,148],elem:147,element1:[93,111,147],element2:[93,111,147],element:[2,33,37,39,41,42,57,58,93,94,97,104,111,112,113,114,134,135,136,137,142,144,147,148,154,155,156,157,158,162],elementn:[93,111],elementset:58,elif:41,elig:120,elimin:[2,67,76,78,79],elj:108,ellips:2,ellipsoid:[2,44,91,117,132,145],elong:162,els:[57,59,60,69,80],elsewher:[134,162],elt:134,emac:0,email:[0,3,114],emb:82,emb_lin_neg:134,embed:[3,13,80,93,111,114,130,134,135,136,144],embt:46,emol:162,emphas:118,empir:[58,113],empiric:94,emploi:[64,156],empti:121,enabl:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,31,32,37,39,40,41,43,45,46,47,48,49,50,51,52,53,54,56,62,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],enclos:[2,134,147],encod:57,encompass:2,encount:38,encourag:[75,77],end:[1,2,3,4,19,46,57,62,64,67,69,74,75,80,92,109,111,117,133,137,145,148,149,162],endbondtors:46,energet:[62,94],energi:[0,1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,18,20,21,22,23,24,25,26,27,28,31,32,35,39,42,44,45,46,47,48,49,50,51,52,53,54,55,56,58,59,60,61,62,63,64,65,66,67,68,69,70,71,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109],energy_compon:147,enforc:[2,57,62,69,76,122],enforce2d:[2,91],eng:[3,104,136],engineer:[58,78,111],enginer:135,enhanc:[58,64],enlarg:57,enough:[44,61,73,81,82,105],enpub:111,ensembl:[2,32,35,69,72,73,109,147],ensight:2,ensur:[2,41,63,67,69,97,130,154,158],enter:[114,137,158],enthalpi:[75,111,162],entir:[0,2,3,19,31,39,40,42,43,44,60,61,62,64,67,69,70,71,72,75,77,80,108,126],entiti:2,entri:[40,66,73,97,112,134,140,141,142,148,154,155,156,157,158],entry1:[140,141],enumuer:2,environ:[1,2,3,4,57,71,93,97,104,112,113,144,155],eos:66,epair:[94,116,120,162],epp:108,epq:108,eps0:160,eps14:130,epsilon0:157,epsilon:[2,18,21,22,27,28,32,45,81,82,91,96,101,102,103,105,106,107,108,115,117,119,120,121,122,123,124,125,126,127,128,129,130,133,138,143,145,146,154,159,160],epsilon_0:161,epsilon_14:101,epsilon_:145,epsilon_d:106,epsilon_i:[117,145],epsilon_i_:145,epsilon_i_a:[117,145],epsilon_i_b:[117,145],epsilon_i_c:[117,145],epsilon_j:[117,145],epsilon_j_:145,epsilon_j_a:[117,145],epsilon_j_b:[117,145],epsilon_j_c:[117,145],epsilon_lj:145,eqp:108,eqq:108,equal:[2,3,19,28,32,35,42,44,57,61,63,67,68,70,71,72,73,74,75,78,79,80,81,91,92,94,104,109,110,116,117,120,131,137,138,144,145,147,148,149,158,161,162],equat:[2,35,38,39,40,43,56,63,64,65,66,68,69,70,71,72,73,75,76,80,81,103,108,109,110,113,114,115,118,131,132,134,141,145,150,151,152,161],equation:[71,89],equilibr:[2,35,44,62,63,69,73,78,79,104,105],equilibrium:[1,2,6,8,10,11,12,13,16,17,18,20,23,24,25,26,27,46,47,63,67,68,69,70,73,74,76,79,83,84,88,89,104,134,142,147],equilibrium_start:58,equival:[2,13,59,60,63,69,74,94,109,113,147,155,157,162],equlibrium:2,er3:43,eradiu:113,eras:78,erat:132,erc:105,erfc:[105,122],erhart:[111,155,157],eros:134,erose_form:134,erot:2,errata:[155,157],erratum:81,error:[0,1,2,3,11,47,57,59,60,63,64,66,69,75,80,81,82,91,105,122,145,153,155,157],erta:118,especi:[4,44,61,73,74],essenti:[3,11,47,94,105,122,157,162],essential:70,essex:13,establish:32,estim:[1,2,19,29,35,42,58,61,75,162],esub:134,eta:[2,68,69,73,112,114,117,144,156,158],eta_dot:69,eta_ij:144,eta_ji:114,etail:162,etap:69,etap_dot:69,etc:[1,2,3,4,28,33,34,35,42,44,57,58,59,60,67,69,80,82,91,92,111,112,130,132,137,154,155,157,158,162],etol:[91,92],etot0:73,etot:[2,42,73,162],eu2:43,eu3:43,euler:[75,91,92],eulerian:58,europhi:68,evalu:[3,32,35,41,44,45,57,58,59,60,67,75,81,91,137,140,141,144,147,162],evanseck:[2,5,45,101],evaul:91,evdwl:162,even:[2,4,19,29,55,59,60,61,63,64,69,80,81,82,91,92,96,113,114,118,145,158,162],evenli:[19,42,61,68],event:[2,69,80],eventu:2,ever:28,everaer:[103,117,145],everi:[0,1,2,3,4,19,35,57,58,59,60,61,62,63,64,68,69,70,71,73,75,76,80,92,109,130,147,162,163],everyth:163,everywher:124,eviri:113,evolut:[64,68,72],evolv:[68,72],ewald:[2,40,42,91,98,99,100,105,108,113,122,126,143,146],ewald_disp:108,exact:[19,61,62,67,80],exactli:[2,19,35,44,61,67,73,109,111,118,131,140,141],examin:[2,62,75],exampl:[0,1],exce:[2,4,19,59,60,61,63,69,91],exceed:[19,61,69],excel:113,except:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,33,34,39,42,44,45,46,47,48,49,50,51,52,53,54,56,60,61,63,69,70,72,76,80,83,84,85,87,88,89,90,92,93,94,95,98,99,100,101,102,103,104,105,107,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161,162],excess:113,exchang:[2,58,64,80,113],excit:113,excite:113,exclud:[2,4,39,41,60,91,118,131,132,153],exclus:[1,4,32,45,104,137],excurs:69,execut:[1,2,3,57],exempl:147,exemplari:67,exemplifi:113,exert:[2,82],exhaust:58,exhibit:[36,64,69,113],exist:[2,3,29,44,56,57,63,83,84,85,86,88,110,153,163],exit:[3,19,61,162],expans:[41,55],expect:[1,4,19,61,71,73,134,137],expens:[2,71,80],experi:[2,74,92,109],experienc:[2,4],expir:162,explain:[1,2,3,19,30,57,60,61,63,69,71,92,96,111,147,149,163],explan:[2,41,60,71],explanatori:[59,60],explic:138,explicit:[2,3,32,75,94,97,101,111,113,121,131,163],explicitli:[2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,44,45,46,47,48,49,50,51,52,53,54,67,69,70,73,76,80,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,106,108,109,111,112,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,135,137,139,140,141,142,143,145,146,149,150,151,152,154,155,156,157,158,159,160,161,163],explictli:4,exploit:72,explor:[40,43],expon:[75,111,115,117,120,130,138,146],exponenti:[32,75,115,144,154,158,161],expos:3,exposit:[58,109],express:[2,41,44,63,71,75,80,97,111,113,124,134,147,148],expressiont:97,extend:[0,2],extens:[2,4,21,22,27,32,35,64,69,70,71,74,78,79,80,81,82,117,134,137,145,148,162],extensiv:162,extent:[1,19,21,61,94],exterior:[2,82],extern:[32,57,63,67,68,69,70,80,91,135,136],extra:[2,3,4,19,22,39,40,42,43,44,61,69,73,91,108,118,134],extract:[2,3,18,32,92,105,114,134,148],extract_atom:3,extract_comput:3,extract_fix:3,extract_glob:3,extract_vari:3,extrapol:1,extrem:[1,2,57,63,69,79,113,156],extrema:130,extreme:113,extrins:58,f_1:2,f_a:[155,156,157],f_c:156,f_f:157,f_fix_id:73,f_harm:79,f_i:[13,144],f_id:[2,59,60,162],f_ij:144,f_int:78,f_j:13,f_jj:35,f_k:144,f_langevin:80,f_max:73,f_r:[155,156,157],f_sigma:97,f_solid:79,f_ss:2,face:[2,81,82,117,134,145],facil:0,facilit:2,fact:[2,4,79,118,147],factor:[1,2,8,12,16,17,18,19,22,23,32,35,40,41,43,45,53,57,61,63,64,68,69,70,72,74,75,76,81,82,88,94,97,98,99,101,105,106,107,109,110,113,118,121,122,134,137,140,141,142,143,146,149,154,162],fail:[3,63,91,92,107],fairli:[3,163],faken:30,fall:2,fals:147,famili:158,familiar:[0,3,163],fan:144,far:[2,61,63,69,71,74,81,84,88,92,162],farrel:[155,157],fashion:[2,19,44,61,69,70,73,79,80,81,92,131],fast:[2,4,73,75,131,132,137,162],faster:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,37,39,45,46,47,48,49,50,51,52,53,54,61,69,70,76,78,80,83,84,85,87,88,89,90,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161],fastest:[1,2,80],fault:29,fava:117,favor:62,fcc:[2,29,30,35,38],fcold:64,fdt:[65,66,75],fdti:32,fe2:43,fe3:43,fe_md_boundari:58,featur:[0,2,3,41,57,62,67,72,82,91,163],fecr:111,feel:[71,82,92],fehlberg:75,felling:136,felt:82,fene:[2,4],fennel:[105,122],fep:0,ferguson:[2,45],fermi:[1,157],fermion:113,fernando:133,few:[1,2,3,59,60,64,69,76,91,92,94,147],fewer:[1,3,4],feynman:72,ffield:[104,114,147],fflag1:57,fflag2:57,ffmpeg:57,ffplai:57,fft:[1,3,42],fhot:64,ficiti:153,fictiti:[2,72,74,105,122,126,153],field:0,fifth:[2,115,142],figshar:71,figur:[1,4,73,163],fij:108,file0:71,file1:[3,66,71],file2:[3,66],file:[0,1],filenam:[4,19,57,58,60,61,66,71,75,80,92,93,94,97,105,111,112,114,115,134,135,136,140,141,142,144,147,148,154,155,156,157,158,162],fill:[44,57,80,97,137,163],filter:58,finchham:[2,107],find:[0,2,3,4,30,32,62,63,66,71,74,91,92,105,122,126,134,140,141,147,163],fine:[4,79,163],finer:[41,44],finger:44,finish:[2,3,19,61],finit:0,finni:111,fire:[91,92],first:[0,1,2,3,4,6,19,21,22,28,29,35,37,38,39,42,43,46,57,60,61,62,66,67,68,69,71,72,73,76,77,78,79,80,83,91,92,93,94,96,97,98,99,101,104,105,111,113,114,115,118,119,121,122,126,131,132,134,136,137,140,141,142,144,147,148,153,154,155,156,157,158,161,162,163],fischer:[2,5,45,101],fit:[2,74,94,97,134,140,141,156,163],five:[30,73,97,135],fix:[0,1],fix_flux:58,fix_heat:64,fix_id:[63,69,70,73],fix_manifoldforc:163,fix_modifi:2,fix_nv:163,fix_rattl:76,fix_shak:76,fixedpoint:[63,69],fixid:[57,58],fji:108,flag:[3,4,33,34,40,43,57,62,94,120,121,134,137,153,163],flag_buck:100,flag_coul:[100,108,126],flag_lj:[108,126],flagfld:[131,132],flaghi:[131,132],flaglog:[131,132],flagvf:[131,132],flat:[2,4,80,81],fld:[81,131,132],flexibl:[2,57,60,113,156,162],flip:[2,69],fluctuat:[2,32,63,67,68,69,70,71,79,80,89,110],fluid:[2,63],flux:2,flv:57,fly:[19,57,58,76,97,137,162],fmass:72,fmax:[91,162],fmsec:69,fno:4,fnorm:[91,162],fnve:64,focu:76,foil:[41,71,148],fold:[4,77],follow:[0,1,2,3,4,5,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,35,36,38,41,42,44,45,47,48,49,50,51,52,53,54,55,57,58,59,60,61,65,66,67,68,69,70,72,73,74,75,76,78,79,80,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,163],foo:[3,57,75],foo_species:75,foot:2,forc:[0,1],forcefield:[74,120],forcegroup:68,ford:108,forgiv:69,fork:163,form:[2,28,32,33,34,36,41,42,59,60,67,74,75,80,81,82,83,86,89,92,94,97,110,111,113,116,120,121,133,134,136,137,140,141,142,143,144,145,147,148,149,155,156,157,160,162],formal:[2,35,67,69,72,147],format:[2,19,57,60,61,66,75,80,92,93,94,97,111,114,115,121,134,136,140,141,146,148,158,162],formation:66,former:[2,19,61,80,97],formul:[1,2,42,69,74,76,94,97,111,113,117,134],formula:[2,6,28,29,30,32,33,34,35,39,40,42,43,44,46,56,60,71,77,81,83,85,94,96,97,101,102,103,108,109,111,112,117,118,119,120,121,122,124,125,126,128,129,131,132,134,138,139,145,146,149,154,155,156,157,158,159,160,162],forth:[1,2,3],fortran:[2,3,111,134],forward:[32,92],foster:[97,144],found:[2,30,62,64,68,105,108],four:[2,3,28,41,80,89,92,137],fourier:2,fourth:[2,4,37,74,101,115,142,147],fox:[2,40,45,152],fqq:108,fraction:[1,2,4,19,42,57,62,63,73,75,92,97,115,118,131,132],frame:[41,58,73,117],framer:57,framework:[93,148],frattl:64,free:[2,13,29,32,71,78,79,80,92,113,130,137,139,144,160],freedom:[2,39,60,62,69,70,72,76,79,91,108,162],freeli:[0,2,57],freez:2,frenkel:[2,64,79],frequenc:[2,4,72,73,75,109,113,147],frequent:[29,30,36,38,41,64],fri:73,friction:[2,73,80,118],from:[0,1],front:73,frontend:57,frozen:[2,39,67,116],fs2:[2,35],ftol:[91,92],fuction:105,fudg:76,fulfil:2,full:[1,2,4,35,57,64,68,71,75,97,111,113,114,117],fuller:91,fulli:[2,71,91,92,105,144,163],fulton:111,fumi:98,funcfl:111,fund:0,funrol:137,further:[2,37,57,60,68,72,80,91,92,93,96,104,137,147],furthermor:[11,47,64,75,110,113],futur:[0,2,61,67,92,135,136],g_jik:144,g_p:80,ga3:43,gaa:97,gai:117,gain:4,galindo:138,gamma0:13,gamma:[2,13,68,73,109,110,112,117,134,138,150,151,152,154,155,157,158,162],gamma_:80,gamma_ijk:155,gamma_n:118,gamma_p:80,gamma_t:118,gammaa:138,gammafactor:68,gammar:138,gan:[144,154,155,157,158],gan_sw:144,gan_tersoff:144,gao:[2,5,45,101],gap:[131,132,148],gather:3,gather_atom:3,gathert_atom:3,gauch:50,gauss:106,gaussian:[2,35,37,67,72,74,109,113,116],gavhan:4,gaybern:[2,4,91],gd3:43,gdot:132,ge4:43,gec:[155,157],gen:69,gener:0,gentler:81,gentli:112,geom:2,geometr:[2,44,61,69,82,92,96,102,103,105,108,113,115,117,119,122,123,124,125,126,127,128,129,130,131,132,133,138,141,145,149,159,160,162],geometri:[2,9,19,44,61,63],gerber:130,germann:[70,124],germano:117,get:[0,1,2,3,4,19,35,41,44,57,59,61,63,82,92,105,158,163],get_natom:3,get_rank:3,get_siz:3,gewald:2,gezelt:[105,122],ghost:[2,4,30,63,69,109,110,113,118,121],gif:57,gifsicl:57,gillan:148,gingold:[150,151],git:163,give:[0,1,2,3,4,28,36,38,44,60,63,69,71,91,94,97,113,120,134,137,145,155,156,157],given:[2,3,4,11,38,41,42,47,56,60,63,64,67,68,69,70,71,72,73,74,75,76,77,80,81,82,93,94,97,98,99,100,102,103,104,105,106,109,110,111,113,114,115,117,118,120,122,123,124,126,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,161],glosli:137,glotzer:109,glue:3,gnu:0,gnuplot:3,goddard:[2,9,90,113,120],goe:[28,41,44,64,91,108,112,119,124,127,149,161],gold:29,goldman:73,good:[1,2,4,19,30,40,43,61,69,76,92,93,103,111,137,158,162,163],gordan:41,gordon:2,got:163,gould:[2,45],gov:[0,93,111,114],govern:68,gpa:94,gpl:0,gpt:137,gpu:[1,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,69,70,76,83,84,85,87,88,89,90,93,94],grab:2,grad:2,gradient:[2,63,64,80,92,132,140,141],graft:62,grain:[2,13,18,28,44,50,66,71,75,115,119,137,141,146],gram:[60,111],gran:[2,81,82],granular:0,graph:3,graphic:3,graviti:2,grdient:58,great:[73,163],greater:[1,63,67,69,71,96,98,99,100],greatli:[40,64],green:[2,35,57,72,97,163],green_kubo:2,grest:[21,22,62,100,118,126],grid:[19,40,43,61,68,80],grigera:2,gromac:91,gromacs:[2,91,119],groot:109,ground:[2,31,65,113],group:[2,3,4,19,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,92,147,158,162],group_id:3,grow:[2,69,71,75,118],growth:2,gsmooth_factor:134,guarante:44,guess:163,gui:[3,163],guid:[1,150,151,152],guidelin:1,gullet:134,gulp:2,gunnel:137,gunsteren:130,guo:[2,5,45,50,101],gyrat:2,gzip:[57,92],h12:117,h2o:[115,141],had:[2,3,59,60,62,63,67,69,70,80,109,118,153,162],hafskjold:[2,64],half:[1,2,4,19,57,59,61,69,80,81,82,97,103,113,137],halfwai:[19,57,163],halperin:36,halsei:118,halt:[19,61,64],halv:57,hamak:[81,82,103,145],hamilton:29,hamiltonian:[69,113],han:111,hand:[2,28,29,44,54,57,68,75,105,113],handl:[4,57,113,131,158],happen:2,hara:156,hard:[1,74,147],harden:149,harder:[81,82],hardi:58,hardwar:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,69,70,76,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161],harmon:[2,4],harmonic_fix_wal:132,harrison:94,hartre:[111,113,137],hassl:74,hat:2,have:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,34,35,36,37,38,39,41,42,44,45,46,47,48,49,50,51,52,53,54,57,59,60,61,62,63,67,68,69,70,71,72,73,76,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,108,109,110,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,134,135,136,137,139,140,141,142,143,144,145,146,147,149,154,155,156,157,158,159,160,161,162,163],hbond:2,hcn:75,hcp:[29,30,134],he1:43,head:[2,6,46,83,94,116,120,163],header:[2,57,60,73,80,93,97,111,153],heat:2,heavili:[19,61],heavisid:80,hebenstreit:4,height:[57,92,116],held:[2,75,92,118],helic:50,helium:95,help:[4,63,71,97,139,155,157,163],henc:[1,5,6,10,16,17,18,29,46,60,69,81,82,83,84,88,89,105,116,130,144],henderson:27,henkelman1:92,henkelman2:92,henkelman:92,here:[1,2,3,4,19,29,40,43,49,56,57,60,61,62,67,68,71,73,80,81,91,92,94,97,114,117,120,121,133,144,145,147,161,163],hertzian:[2,118],hertzsch:118,heterogen:37,hex:[44,64],hexagon:[36,134],hexat:36,hey:42,hf4:43,hfo:104,hftn:[91,92],hg1:43,hg2:43,hibb:72,hierarchi:[100,101,122,123,126,133,138],higdon:[131,132],high:[1,2,4,19,38,57,61,63,80,91,94,97,113,117,137,140,141,145,161],higher:[1,4,41,60,64,91,94,113,147],highest:[64,92],highli:[2,4,44,57,69,73,91,113],highlight:2,hight:116,hill:72,histo:[2,43,59,60],histogram:[1,2],histor:114,histori:[0,2],ho3:43,hoc:89,hoh:[2,105,122,126],hold:[2,60,74,91,92,118,130,160],holdem:74,holian:[70,124],holm:71,home:3,homepag:57,hone:72,hood:137,hook:[2,3],hookean:118,hoover:[2,69,70,72,79,109],hop:[62,92,97,147],hope:[19,61],hopefulli:91,horn:2,host:4,hot:2,hove:134,how:[0,1],howev:[1,2,3,4,18,19,35,40,41,43,57,61,62,63,67,68,69,71,72,73,80,92,102,103,111,112,118,134,137,140,141,144,154,157,162,163],howto:[2,69,105,120,122,126],hoyt:58,hpc:1,htm:111,html:[0,3,116,132],htmldoc:0,http:[0,2,3,71,93,111,131,163],https:163,htype:[105,122,126,130],hubbard:106,huge:163,huggin:[98,99],hugh:58,hugoniostat:70,hugoniot:[70,73],hundr:64,hura:2,hybrid:[1,2,4,32,56,69,93,94,104,105,109,111,114,117,118,120,121,130,134,135,136,137,142,144,145,147,148,153,154,155,156,157,158,161],hydrat:116,hydrocarbon:[94,104,113],hydrodynam:[68,131,132],hydrogen:[2,94,97,105,113,120,122,126,130],hydrostat:[63,69,70],hynninen:[106,116],hyoungki:136,hyper:[4,72],hyperbol:106,hyperspher:41,i_0:80,i_1:144,i_csid:2,i_mpi_pin_domain:4,i_mpi_shm_lmt:4,i_n:144,ialloi:134,ibar:134,ibead:72,ibm:137,icc:137,ice:2,icm:163,icms:163,icosohedr:30,id1:[92,121],id2:[92,121],id_press:[63,69,70],id_temp:[62,63,69,70],idea:[1,2,3,19,42,57,61,71,163],ideal:[2,30,71,131,150,163],idealiz:2,ident:[1,4,41,63,67,69,71,72,92,98,99,105,107,111,122,124,130,142,147,148,158,161],identifi:[1,2,29,44,66,120,121,134,140,141],idn:92,ielement:134,ignor:[2,3,4,19,32,57,61,63,69,70,74,80,81,82,92,93,102,103,111,112,114,117,121,134,140,141,142,144,145,154,155,156,157,158],iii:[2,9,90,120],ijj:158,ijk:[87,89,90,97,144,158],ijl:89,ikeshoji:[2,64],ikj:158,ill:60,illinoi:131,illustr:[1,2,3,4,71,72,92],imag:[2,3,33,34,40,44],image2pip:57,image:57,imagemagick:57,imagin:[97,112,135,136,142,144,154,155,156,157,158],imaginari:[2,36,72],imbal:[1,19,61,75],imbalanc:[19,61],img:57,immedi:[0,44,75,76],immers:68,impact:[1,2,94],impart:2,impei:[2,122],implement:[1,2,11,31,32,38,40,43,44,47,56,60,64,65,68,69,72,73,75,76,80,89,91,92,93,97,104,105,107,109,110,111,112,113,122,126,130,134,145,155,157],impli:[2,32,42,57,74],implicit:[2,67,81],implict:106,important:79,impos:[2,39,64,71,78,79,81,82,91,92],imposs:1,improp:[0,4,39,42,44,62,83,84,85,86,87,88,89,90,91,162],improper:[4,89],improper_coeff:[83,84,85,86,87,88,89,90],improper_styl:[0,2],improv:[0,1,4,19,61,64,69,120,122,137,154,156],in3:43,inaccur:[1,2],inaccuraci:82,inact:[120,162],inappropri:44,incid:[40,43],includ:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,32,33,34,35,36,37,38,39,40,41,42,43,45,46,47,48,49,50,51,52,53,54,56,57,58,59,60,62,63,67,68,69,70,71,72,73,74,75,76,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,134,135,136,137,139,142,143,144,145,146,148,149,154,155,156,157,158,159,160,161,162,163],inclus:[0,32,59,60,162],incompat:3,incomplet:3,incompress:113,inconsist:62,incorpor:[55,73,97,106,163],incorrect:134,incorrectli:118,increas:[1,2,4,40,42,57,62,64,66,74,75,92,94,113,117,140,141,156],increasingli:113,increment:[3,61,69,147],incur:[60,80],indefinit:78,indent:91,independ:[2,3,19,35,44,59,60,61,62,63,67,68,69,79,80,118,137],index:[0,2,3,59,60,66,72,80,140,141,162],indic:[2,3,4,6,28,31,33,35,37,39,42,46,57,59,60,63,69,80,83,89,104,114,134,137,142,147,155,157,162,163],indirectli:2,indium:148,individu:[0,1,2,3,4,32,39,42,44,56,57,59,60,63,64,68,69,76,91,98,99,101,102,105,111,113,119,121,122,126,143,146,162],induc:0,ineffici:[2,29,30,36,38,41,57,69],inerti:132,inertia:[2,132],infer:[61,114,162],infin:[91,162],infininti:57,infinit:[68,80,113],infinitesim:2,inflect:[106,124],influenc:[19,155,156,157],inform:[0,1,2,3,4,19,40,43,44,45,57,58,59,60,61,62,63,64,68,71,74,76,77,78,81,82,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],infrequ:[2,69,109],infti:[106,131,132],ingtegr:97,inher:91,inherit:2,inhomogen:80,inidividu:91,init:147,init_fil:80,initi:[2,3,19,32,57,58,61,62,63,66,67,68,69,70,72,73,74,75,78,79,80,81,91,92,94,108,109,137,140,141,147,162],initial:2,initialt:80,inlclud:3,inner2:[101,119],inner:[4,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],inner_distance_cutoff:120,innner:128,inorgan:[2,158],inp:[148,158],input:[0,1],insert:[44,148,153],insid:[2,3,44,59,64,68,81,82],inside:[68,124],insight:2,instabl:[68,108],instal:[1,2,3,4,57,92,100,101,122,126,130,137,163],install:0,instanc:[2,3,116,144],instantan:[2,62,63,67,69,70,73,162],instanti:[2,3,58],instead:[1,2,3,4,19,29,34,45,60,61,63,68,99,100,111,121,123,130,134,137,139],instruct:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,57,69,70,76,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161],instruction:3,insuffici:2,insult:69,insur:[2,3,30,44,57,80,81,82,103,117,145,162],integ:[2,3,29,38,41,44,45,48,49,52,55,57,60,62,67,68,73,75,80,87,109,110,134,148],integral:[72,140,141],intel:1,intel_coprocessor:4,intel_cpu_intelmpi:4,intel_cpu_mpich:4,intel_cpu_openpmi:4,intend:[2,18,67],intens:[1,2,33,34,35,37,39,40,43,60,61,62,69,70,80,162],intensiv:162,inter:[62,92,97],interact:[1,2,3,13,28,32,36,38,39,41,42,45,50,55,56,62,71,72,74,75,80,81,82,84,85,86,88,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,141,143,144,145,146,147,148,149,153,154,155,156,157,158,159,160,161,162],interatom:[44,78,79,93,97,111,113,134,137,147,156],intercept:40,interchang:2,interconvert:113,interesect:82,interest:[1,3,43,72,79,112,132],interf:163,interfac:0,interfer:[69,94],interg:2,interi:132,interior:[2,19,82],interlac:134,interleav:[2,44],intermedi:[2,57,71,89,92],intermolecular:94,intern:[0,2,3,4,5,6,8,12,16,17,18,31,32,42,46,57,58,65,66,69,70,75,83,84,88,89,91,110,115,140,141,150,162],internal:57,internal_element_set:58,internal_quadratur:58,internat:[4,40,43,58],interpenetr:134,interpentr:[150,151],interpol:[2,57,58,66,68,71,92,97,140,141,155],interpret:[2,3,55,57,118,149],interrupt:73,intersect:[2,40,82],intersert:82,interspers:91,interstiti:137,interv:[2,35,69,73,147],intestieti:40,intial:[2,94],intiial:19,intramolecular:13,introduc:[2,36,38,57,64,69,73,89,93,105,113,122,126,130,154],introduct:0,inv:[40,43],invalid:[33,92,131,132],invari:[38,41],invent:76,invers:[2,26,40,43,73,89,90,98,105,122,159,160],invert:[1,2],invis:82,invoc:62,invok:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,33,34,39,44,45,46,47,48,49,50,51,52,53,54,57,58,59,60,61,62,63,64,67,68,69,70,71,76,77,78,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,135,139,142,143,145,146,148,149,154,155,156,157,158,159,160,161,162],involv:[2,68,91,92,96,117,154,155,157],ion:[2,80,97,106,114,116,134,137,147,157,161],ionic:[2,98,99,106,113,114,143,147],ioniz:[104,113],ipp:0,ir3:43,ir4:43,irregular:[2,19,61,63,69],irrelev:142,irrespect:[131,132],irrevers:75,isbn:160,isenthalp:69,ismail:[100,126],isn:[3,64],iso:[63,69,70],isobar:[69,110],isodem:113,isoenerget:110,isoenthalp:110,isol:118,isomorph:72,isotherm:[69,110],isotrop:[2,36,117,131,132],issu:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,30,39,45,46,47,48,49,50,51,52,53,54,57,62,63,64,69,70,72,76,79,83,84,85,87,88,89,90,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,145,146,149,153,154,155,156,157,158,159,160,161,162],issue:58,item:[2,19,61],iter:[2,19,61,63,76,91,92,147,162],iterat:91,ith:[59,60,162],itself:[2,3,35,57,80,92,105,114,117,140,141],ityp:44,izumi:156,j0jt:35,j_m:41,jackson:138,jacs:[2,45],janssen:71,januari:134,jaramillo:113,jcp:81,jeffer:4,jello:69,jeremi:136,jik:97,jmm:41,job:76,jochim:69,join:[2,29,118],joint:120,jon:29,jone:[1,2,21,22,32,45,58,64,81,82,91,94,96,99,100,101,102,103,108,117,119,120,121,122,123,124,126,127,129,130,133,138,144,145,146],jonsson:[30,92,147],jorgensen:[2,53,105,122,126],journal:[50,58,111,137,150,151],jpeg:57,jpg:57,judici:2,jump:[2,18,70],jun:4,just:[2,3,13,35,42,57,60,80,92,94,96,144,163],justo:112,jusufi:[106,116],jut:82,k11:35,k22:35,k33:35,k_2:86,k_4:86,k_sigma:97,k_ub:5,kalia:158,kapfer:38,kappa:[2,35,105,110,122,159,160],kappa_:80,karplu:32,karttunen:68,kate:0,kaufmann:4,kayser:106,kcal2j:35,ke_eta_dot:69,ke_etap_dot:69,ke_omega_dot:69,keblinski:[105,147],keef:40,keep:[54,75,79,91,105,130,148,162,163],kei:[2,158],kelchner:29,kemper:104,kepler:1,kept:[2,70,78,79],kernel:[4,58,67,137,150,151,152],keword:57,keyword:[2,4,19,29,32,34,36,37,38,39,40,41,42,43,44,57,58,59,60,61,62,63,64,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,91,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],keywrod:113,khersonskii:41,khvostov:4,kim:[134,135,136],kind:[1,2,3,19,30,57,60,61,62,76,92,97,113],kinemat:[131,132],kinet:[2,32,35,39,42,60,63,64,69,70,73,75,91,113,115,141,162],kjl:89,klein:[2,58,69,122,146],kmax:40,kmp_affinity:4,knight:4,knl:4,knock:80,know:[3,19,91,112,163],knowledg:57,known:[41,57,64,78],kokko:1,kokkos:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,69,70,76,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161],kollman:[2,45],kone:[78,79],koning00a:78,koning00b:78,koning96:[78,79],koning97:79,koning99:78,kraker:4,kremer:[21,22],kress:[135,136],kspace:[0,1,2,32,39,42,91,98,99,100,101,105,108,122,126,130,132,146,162],kspace_modifi:[2,4],kspace_styl:0,kstart:74,kstop:74,kth:[67,72],kub:5,kubo:[2,35],kumagai:156,kumar:[131,132],kuronen:144,kutta:75,l12:134,l_box:113,l_skin:80,la3:43,label:[64,72,92],laboratori:[0,31,65,73],lack:[4,113],lackmann:97,ladd:79,lafitt:138,lag:80,lagrangian:[2,58,73],lagrangian_posit:73,lagrangian_spe:73,lambda1:[155,156,157,158],lambda2:[155,156,157],lambda3:[155,157],lambda4:158,lambda:[32,40,43,68,78,79,80,93,112,130,139,154],lambda_fin:78,lambda_initi:78,lamda:[27,139],laminar:152,lammp:[0,3,92,134,137,163],lammps2pdb:2,lammps_clos:2,lammps_command:2,lammps_extract_atom:2,lammps_extract_comput:2,lammps_extract_fix:2,lammps_extract_glob:2,lammps_extract_vari:2,lammps_fil:2,lammps_get_coord:2,lammps_get_natom:2,lammps_ns:2,lammps_open:2,lammps_potentials:104,lammps_put_coord:2,lammps_quest:2,lammps_rk4:75,lammps_set_vari:2,lammps_sppark:2,lammps_vers:2,lamms:2,lamoureux:2,land:4,landron:147,lane:1,langevin:[2,67,69,70,73,74,79,80,92,108,109],languag:[2,3],larentzo:[31,65],larg:[0,1,2,4,19,29,42,44,50,57,60,61,62,63,64,68,69,73,74,76,80,81,82,89,91,103,109,113,117,118,121,137,140,141,145],larger:[1,2,3,19,29,44,57,64,68,69,74,80,81,82,91,92,97,103,105,106,113,118,122,126,132,153],largest:[2,44,91,140,141,153],laser:80,last:[1,2,3,42,55,57,60,61,75,91,92,95,96,97,98,103,104,109,110,111,116,117,118,119,120,123,125,127,128,129,132,138,139,145,147,149,153,159,160,162],lat:134,later:[2,3,70,91,94,97,163],latest:60,latitud:41,lattc:134,latter:[2,3,4,19,32,59,60,61,63,69,75,82,97,99,100,101,102,108,122,126,130,137,143,146,147,162],lattic:[2,19,29,30,35,36,40,43,44,60,61,68,71,81,82,93,111,134,162],launch:[1,2,3,4],laupretr:89,law:2,layer:[2,80],layout:1,lb_fluid:68,lbtype:68,ld_library_path:3,lead:[2,9,19,32,59,60,61,68,70,73,75,76,89,92,105,122,126,128,137,162,163],least:[2,40,43,64],leav:[3,6,19,42,46,61,63,69,76,83],lee2:134,lee:[58,134],left:[2,3,19,56,57,62,71,75,163],leftmost:[19,61],legaci:4,leimkuhl:69,leiu:109,lenart:[106,116],length:[2,3,4,6,19,27,28,29,31,32,33,34,35,37,39,40,43,46,57,61,62,63,66,68,69,70,71,76,80,81,82,91,92,94,97,98,99,105,106,113,116,120,122,134,140,141,155,159,160,162],lennard:[1,2,21,22,32,45,64,81,82,91,94,96,99,100,101,102,103,108,117,119,120,121,122,123,124,126,127,129,130],lenoski:[135,136],less:[1,2,4,19,36,38,60,61,62,63,64,69,71,91,97,101,117,118,131,132,145,154,157,160],let:[1,49,66,76,103,140,141],lett:[41,68,78,79,97,111,113,117,130,140,141,148],letter:[19,61,72],level:[3,57,69,71,74,77,81,82,97,100,101,122,123,126,133,137,138],lever:153,levin:118,lgr_po:73,lgr_vel:73,li1:43,liang:104,lib:[1,3,4,104],libdir:3,liblammp:3,liblammps_foo:3,liblammps_g:3,libmpi:3,librari:[0,1],licens:[0,57],lie:[2,29],like:[2,3,4,28,57,63,69,71,73,75,81,82,92,97,103,108,109,110,113,114,118,120,127,128,134,148,157,159,160,162,163],likelihood:[40,43,62],likewis:[1,2,19,58,61,69,70,92,93,96,97,105,111,114,137],limit:[2,4,11,40,41,43,44,47,57,63,64,67,69,73,91,106,113,118,132,146,149],limit_eradiu:113,line:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,39,41,42,45,46,47,48,49,50,51,52,53,54,57,60,61,63,66,69,70,71,73,75,76,80,83,84,85,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,134,135,137,139,140,141,142,143,144,145,146,147,148,149,154,155,156,157,158,159,160,161,162,163],linear:[2,9,11,41,47,58,62,63,66,69,74,76,80,81,84,85,86,88,92,118,128],linearli:[2,81,92],lineflag:2,lineforc:91,lingo:3,link:[2,3,56,57,134],linkflags:4,linux:[3,4,57],liouvil:69,lipid:13,liquid:[2,4,13,19,32,36,42,61,63,69,73,108,137,143,156],lisal:[110,153],list:[0,1,2,3,4,6,19,29,30,32,36,38,39,41,42,46,56,57,58,59,60,61,62,66,69,71,75,76,83,84,85,86,88,89,91,92,93,94,97,98,99,101,102,104,105,107,109,110,111,112,113,114,115,117,119,120],listfil:121,literatur:[2,134,147,154],lithium:113,littl:[1,4,64,69],littmark:[134,157,161],liu:120,lj126:2,lj12_4:146,lj12_6:146,lj93:2,lj9_6:146,lj_flag:94,lmp1:3,lmp2:3,lmp2arc:[0,2],lmp2cfg:[0,2],lmp2vmd:0,lmp:3,lmp_g:[2,3],lmp_linux:2,lmp_machin:[1,4],lmp_mpi:72,lmpptr:3,load:[1,2,3,4,19,57,61,73,75,104],loadabl:3,localized_lambda:58,localtemp:75,locat:[2,3,11,40,43,47,55,64,68,79,82,105,114,115,116,122,124,126],lockstep:[63,69],log:[1,2,4,73,76,92,94,116,120,131,132,162],logfil:[0,2],logic:[3,4,19,44,61],lomdahl:[70,124],longer:[1,2,28,59,60,69,71,73,75,76,81,82,94,118,147],longest:[19,61],look:[1,2,3,28,57,148,163],lookup:[140,141],loop:[2,3,42,57,60,91,92,137,147,162],loopmax:147,lopez:69,lorentz:43,lose:[2,63,69,118],loss:2,lossi:57,lossless:57,low:[1,2,19,57,61,137,140,141,160],lower:[2,3,4,19,57,61,63,68,69,73,81,106,134],lowercas:[0,57],lowest:41,lrt:4,lsurfac:80,ltbbmalloc:4,lu3:43,lubric:2,lubricateu:[81,131],luci:75,lumped_lambda_solv:58,lyulin:89,m4v:57,m_eff:118,m_i:77,m_u:68,m_v:68,machin:[1,2,3,4,57,69,91,137,163],mackai:68,mackerel:[2,5,45,101],macos:57,made:[2,3,19,57,61,79,117,118,145,149,163],madura:[2,122],magazin:111,magda:81,magic:3,magnitud:[2,29,37,44,91,108,118],mai:[0,1,2,3,4,13,19,29,32,33,34,36,37,38,39,40,41,42,43,44,56,57,60,61,63,64,67,68,69,70,72,73,74,75,76,79,80,81,82,91,92,94,96,97,103,109,113,118,128,130,132,134,135,136,137,140,141,146,148,153,158,161,162,163],mail:163,main:[2,3,68,78,79,111,147],mainboard:1,mainli:143,maintain:[4,93,111,163],make:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,31,32,37,39,40,41,43,45,46,47,48,49,50,51,52,53,54,55,56,57,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,82,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,163],makefil:[3,4,137],maks:118,manag:72,manbi:148,mandadapu:58,manh:97,mani:[1,2,4,19,35,44,57,59,60,61,62,63,64,66,67,68,69,70,71,75,76,80,91,92,104,113,116,120,140,141,147,148,155,157],manifold:163,manipul:[19,61,105,144],manner:[2,3,19,42,57,61,69,78,79,81,82,92,111,113,131],manual:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,40,43,45,46,47,48,49,50,51,52,53,54,57,69,70,76,83,84,85,87,88,89,90,92,93,94,95,96,98,99,100,101,102,103,104,105,107,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161,162],manybodi:[42,91],manybody:[93,94,97,104,111,114,142,144,154,155,156,157,158],map:[3,40,41,43,44,57,58,64,74,92,93,94,97,104,111,112,114,134,135,136,142,144,147,148,153,154,155,156,157,158],mara:147,march:134,mark:[119,130,147],maroonmpi:3,marrink:119,marsaglia:67,martin:134,martyna:69,mask:71,mask_direct:58,mass:[2,32,33,34,35,37,44,58,60,64,67,68,69,72,73,76,77,79,80,93,96,97,111,113,114,118,131,132,135,136,137,144,147,150,151,152,162],mass_matrix:58,massdelta:76,massiv:[0,57,68,72],massless:[2,105,122,126,130],master:92,mat:[58,104,156],match:[2,3,19,61,62,66,69,97,120,128,134,140,141],mater:[30,93,136,144,147],materi:[2,29,58,71,80,105,111,112,113,118,134,135,137],material_fil:58,math:[4,69],mathemat:[40,41,43,44,63,67,81,148],mathrm:163,matlab:0,matric:[41,117],matrix:[2,35,63,75,137],matter:[2,80,94,107,111,113,134,146,147,155,157,158,161],mattson:[31,39,42,65],max2theta:43,max:[2,61,63,75,76,91,92,147,162],max_step:75,maxev:91,maxim:92,maximum:[2,9,19,21,27,28,36,38,40,43,61,64,71,75,76,92,97,116,131,132,147,162],maxit:[91,162],maxstep:75,maxx:144,mayer:[98,99,147],mayo:[2,9,90,120],mbt:46,mcdram:4,mcgraw:72,mclachlan:69,mdregion:58,mdump:[19,61],meam:105,meam_sw_splin:136,meamf:134,mean:[2,3,4,19,28,32,35,36,37,38,39,41,42,44,45,56,57,59,60,61,62,63,64,67,69,70,71,72,75,76,80,81,82,84,85,86,88,91,92,98,99,100,101,105,109,111,113,117,118,120,122,123,126,133,134,138,140,141,143,144,145,146,153,154,155,156,157,160,162],meant:2,measur:0,mechan:[2,3,31,58,64,65,72,75,97,113,124,137],meck:38,media:57,medium:160,meet:[57,62],mehl:93,mei:133,melros:[131,132],melt:[62,97,137,156],member:[45,97],membran:[13,160],memori:[2,4,60,67,80,97],mendelev:111,mention:[1,2,3,68,70,81,92,94],menu:57,mep:92,mer:62,mercuri:163,meremianin:41,merg:163,merz:[2,45],mesh:[1,2,19,40,43,58,61,68,137],mesoparticl:[65,66,110],messag:[0,2,3,57,64,131,132,163],met:[19,61,91,92],metal:[44,58,73,81,93,94,97,104,111,112,113,114,134,135,136,137,144,147,154,155,156,157,158,162],methan:73,methin:89,method:[1,2,3,4,19,32,35,42,58,61,66,68,69,72,73,75,76,78,79,91,92,93,97,104,105,111,113,114,134,135,136,140,141,144,147,158],methodolog:[2,30,42,72],metric:162,mezei:32,mg2:43,mgoh:142,mgptfast:137,micel:77,micelle2d:0,michael:136,mickel:38,microscal:131,mid:[137,153],middl:[2,4,19,32,46,59,60,61,74,83,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],middlebondtors:46,midpoint:153,might:[2,4,9,147,163],migrat:[19,61,71],mikami:[2,69],mike:4,mil:111,militz:71,million:[19,61],mimic:[2,28,105,116,122],mimim:[63,92],min2theta:43,min:[2,41,75,147,153],min_modifi:[63,91],min_step:75,min_styl:[91,92],mind:67,minim:[0,2,19,44,57],minima:[50,55,90],minimi:92,minimizaiton:92,minimum:[9,10,11,21,37,43,47,57,63,74,75,81,82,90,91,92,101,113,115,117,119,120,122,124,126,131,132,146,153],minmiz:63,minstep:75,mintmir:105,minu:92,misc:[2,10,11,13,24,25,37,47,67,71,72,78,79,80,84,86,89,106,108,111,112,116,121,127,133,135,136,139,143,153],miscellan:58,mishin:93,mishra:4,miss:[121,162],mitchel:[2,107],mitig:69,mix:[1,2,4,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],mixtur:[2,69,103,115,134,141],mixture_ref_t:134,mjpeg:57,mkv:57,mn2:43,mn3:43,mn4:43,mo3:43,mo5:[43,137],mo6:43,mobil:[2,37,42,57],mode:[1,2,3,4,34,43,57,59,60,69,72,105,113,137,147,162],model:[0,1],modern:4,modest:1,modif:[2,4,32,134,137,145,157,163],modifi:[0,1,2,3,32,57,64,74,76,79,94,108,111,113,130,134,135,136,139,147,156,163],modin:58,modul:3,modulu:[118,134],mol:[44,76,108,117,146],molchunk:[34,60],mole:[111,115],molecul:[2,13,33,34,42,44,60,62,64,66,74,75,76,101,105,117,122,126,145],molecular:[0,2,4,27,44,50,58,64,72,73,74,80,95,97,100,113,162],molecule:[5,7,8,9,12,16,21,22,23,26,27,28,45,49,50,51,53,56,85,88,90,101,122],moltempl:0,molybdenum:137,mom:[2,35,74],moment:[2,44,68,69,77,108,112,147],momenta:[64,113],momentum:[2,13,41,44,58,67,68,69,132],momon:62,monaghan:[150,151],monitor:[2,63,69,73,76,91,92,108,162],mono:[30,131],monodispers:[118,131,132],monom:[28,62],monoton:[66,92],mont:[2,62],month:0,moor:[31,42,65,140,141],more:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,31,32,34,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,163],morgan:4,moriarti:137,moriarty1:137,moriarty2:137,moriarty3:137,mors:2,mosi2:134,moskalev:41,most:[0,1,2,3,4,19,29,56,57,60,61,63,69,72,73,94,113,117,134,157,162,163],mostli:[3,57],motiion:2,motion:[2,64,68,69,70,71,72,74,80,82,92,108,113,131,132],motiv:71,mov:57,move:[1,2,3,37,60,63,68,69,71,73,74,80,81,82,91,92,105,109,131,132,137,162],movement:[2,91,162],mp2:94,mp4:57,mpeg:57,mpg:57,mpi4pi:3,mpi:[0,1,2],mpi_barrier:1,mpi_comm:2,mpicc:3,mpich:4,mpirun:[1,2,3,4,72],mplayer:57,msd:2,msi2lmp:0,msmse:[40,43],msse3:137,msst:[70,73],mtk:[69,70],mu_j:13,muccioli:117,much:[1,2,3,57,63,73,94,117,145,163],muller:[2,35,138],multi:[0,1],multibodi:[140,141],multicent:113,multicor:1,multinod:4,multiphys:3,multipl:[0,1],multipli:[32,35,56,68,71,91,94],multiscal:3,multisect:[19,61],multistag:32,multithread:4,murdick:97,murti:156,must:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,32,39,40,43,44,45,46,47,48,49,50,51,52,53,54,55,57,58,59,60,61,62,63,64,66,67,68,69,70,71,73,74,75,76,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],mutli:2,mux:57,mxn:72,my_stress:59,myang:60,mychunk:[2,34],myflux:35,myhug:70,myke:35,mymol:76,mympi:3,mype:35,myramp:42,myspher:82,mystress:35,mytemp:162,n_f:73,n_hbond:120,n_ij:118,n_ion:80,n_k:67,n_particl:31,na1:43,nabla:80,nacl:[2,134],nacl_cs_x0:2,nakano:[92,158],name:[0,1,2,3,4,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,57,58,59,60,61,62,63,64,65,66,67,68,72,73,74,75,76,77,78,79,81,82,92,93,94,97,99,111,112,114,117,118,121,134,135,136,142,144,147,148,154,155,156,157,158,162,163],namespac:2,nanoindent:29,nanoparticl:61,nanosecond:64,narrow:2,narulkar:[155,157],nation:0,nativ:[1,2],natom:[2,3,162],natur:[2,41,69,71,111,113,114,134,144],navi:111,navier:68,nb3:43,nb3bharmon:142,nb5:43,nbodi:137,nbot:97,nbuild:162,nchunk:[2,34,60],ncoeff:148,ncount:60,nd3:43,ndanger:162,nden:[2,35],ndof:[69,70],nearbi:[82,94,131,132,160],nearest:[29,30,36,38,68,71,82,121,134,140,141,147],nearli:[2,28,61,113,137],neb:2,neb_combin:92,neb_fin:92,necessari:[2,3,4,32,56,61,63,67,75,130,137,147],necessarili:[64,84,85,86,88],need:[1,2,3,19,28,29,30,35,36,38,39,41,42,44,45,55,56,57,58,60,61,63,66,68,69,74,80,81,92,93,94,95,97,98,99,100,101,102,103,104,105,107,108,109,111,112,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,163],needless:2,neg:[2,11,22,33,41,42,47,49,57,63,67,70,71,75,81,114,125,134,162],neglect:[120,132],neglig:[2,3,32,69,154],neigh_modifi:[2,4,61,91,109,162],neighbor:[1,2,4,19,29,30,36,38,41,42,44,57,61,62,71,72,92,103,105,109,111,112,114,115,121,122,126,134,141,144,147,148,153,154,155,156,157,158,162],neighborhood:[10,29,36,148],neighobr:[2,105,122,126],neither:[19,58,62,94,113,131,132],nelem:148,nelement:[93,111],nelson:[36,38],nemd:0,net:[2,3,71,132],netpbm:57,neutral:[105,122,147],never:[63,69,71,76,81,111,134,148,158],neveri:[59,60,62,64,68,92,147],newer:[60,134],newtion:[97,137,144],newton:[4,13,94,104,112,135,136,147,153,154,155,156,157,158],newtonian:67,next:[1,2,3,29,35,57,60,66,67,75,76,80,91,92,97,115,118,131,132,140,141,144,163],nfile:[66,140,141],nfreq:[59,60,61],ngb:71,ngp:37,nguyen:97,nhc:72,ni2:43,ni3:43,ni_000:40,nialh_jea:111,nice:[2,163],nickla:136,nine:[114,147],nissila:[68,147],nist:[93,111],niter:[19,61],nitrid:105,niu3:111,nkb:73,nlocal:3,nlvalu:38,nmpimd:72,nn2:134,nnn:[36,38],no2:[66,75,115],no_affin:4,no_histori:2,noced:91,nocheck:121,nodal:[2,58,66,80,140,141],node:[1,4,19,40,43,61,68,80,121],node_area:68,node_group:58,nodeless:113,nodes:[19,61],nodeset:58,nodeset_to_elementset:58,noforc:[2,132],nois:[2,67,68,73,80],nomenclatur:2,nomin:69,non:[0,1],nonbond:142,none:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,33,34,35,36,38,39,42,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,74,75,76,77,80,81,82,83,84,85,86,87,88,90,91,92,93,94,95,96,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,133,134,135,136,138,139,140,141,142,143,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],nonequilibrium:[78,79,113],nongaussian:37,nonlinear:[21,22],noordhoek:104,nor:[19,58,104],nord:[144,155,157],nordlund:[144,155,157],norm:[2,60,75,91,92,153,162],normal:[2,3,4,19,29,30,35,39,44,45,60,61,63,69,71,72,80,81,82,83,84,85,86,88,91,92,103,104,117,118,137,153,161,162],norman:80,nose:[2,69,70,72,79,109],notat:[2,29,41,69,111,158],note:[1,2,3,4,8,9,12,16,17,18,19,23,28,30,32,33,34,35,37,39,40,41,42,43,44,45,49,53,56,57,58,59,60,61,62,63,65,66,68,69,70,72,73,74,75,77,80,81,82,83,84,85,86,88,91,92,93,94,97,98,99,100,101,103,105,106,108,109,110,111,114,117,118,119,120,121,122,124,126,131,132,134,135,136,137,138,140,141,142,144,145,146,147,148,149,153,154,155,157,158,160,161,162,163],notes:[32,130],noth:163,notic:[0,2,79,80],novemb:134,now:[2,3,4,22,67,82,111,113,118,149,163],np3:43,np4:43,np6:43,nparticl:96,npartit:162,nph:2,nphi:4,nproc:3,npt:[2,4,32,63],nrepeat:[59,60],nreset:[63,69,70],nreset_ref:63,nrho:[93,111],nrl:111,nstat:71,nstep:[63,69],ntabl:[140,141],ntheta:97,ntype:[41,44,113,120,144],nuclear:[73,113,161],nuclei:113,nucleu:157,nudg:[2,92],num_step:75,numa:1,numactl:4,number:[1,2,3,4,11,19,29,30,31,32,34,35,36,38,39,40,41,43,44,47,56,57,59,60,61,62,66,67,68,69,70,71,72,73,75,76,78,79,80,81,91,92,93,94,97,104,109,111,112,113,114,120,134,135,136,137,140,141,142,144,145,147,148,153,154,155,156,157,158,161,162],numer:[1,2,3,19,32,38,55,57,58,59,60,64,67,69,72,76,80,81,91,108,134,140,141,161,162],numpi:3,nvalu:60,nvcc:1,nve:[1,2,4,32,35,44,58,64,67,69,70,74,76,80,108,117,131,132,145,147,149],nvidia:1,nvt:[2,4,32,35,58,64],nvtfe:58,nxnode:80,object:[2,3,57,63,68,91],observ:[4,69,73],obtain:[1,4,13,30,32,38,68,70,72,94,108,134,147,155,157],obviou:161,obvious:57,occ:116,occasion:69,occlus:57,occup:116,occur:[1,2,3,37,55,61,62,63,66,78,113,130,140,141],occurr:89,oct:3,octahedr:9,odd:[19,38,61,69,80],ode:75,off:[1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,41,42,43,45,46,47,48,49,50,51,52,53,54,56,57,62,67,69,70,76,81,82,83,84,85,87,88,89,90,91,92,93,94,95,98,99,100,101,102,103,104,105,107,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,134,135,139,140,141,142,143,145,146,147,149,153,154,155,156,157,158,159,160,161],offer:[2,105,147],offload:[1,4],offset:[2,44,57,105,122,126],often:[1,2,4,56,57,61,63,69,72,91,92,104,109,122,155,157,163],ohio:136,old:[2,63,69,134,149],older:[4,63,69,149],oleinik:97,olfason:[2,9,90,120],ollila:68,olmsted:[58,71],omega0:90,omega:[2,69,81,87,90,108,118,137],omega_dot:69,omega_ij:110,omega_ijk:157,omega_ik:155,omegadd:[140,141],omgea:2,omiss:0,omit:[64,100,108,126],omp:[1,4],omp_num_threads:4,on_the_fli:58,onc:[0,1,2,3,4,19,45,57,61,75,92,117,119,144,145],once:[0,2,19,35,61,163],one:[2,13,35,41,57,69,70,80,97,106,132,147],onli:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,36,37,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,75,76,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],only:[2,4,19,29,57,63,64,71,91,92,93,94,97,101,104,111,112,114,120,131,132,134,135,136,142,144,148,154,155,156,157,158,162],onset:[73,89],onto:[41,62,64,68,153],open:[0,3,57,163],opencl:1,opengl:2,openmp:[1,4],openmpi:4,oper:[1,2,3,4,19,35,44,60,61,62,64,69,70,76,79,80,92,137,163],opl:4,opls:[53,56],oppelstrup:137,oppos:[2,74],opposit:[2,13,29,45,71,92,105,130],opt:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,69,70,76,83,84,85,87,88,89,90,93,94,95,98,99,100],optim:0,optimiz:[4,91,104],option:[0,1],optional:148,options:[4,137],orang:57,orbit:[97,105,113,147],order:[2,3,4,11,13,19,32,33,34,36,38,39,41,42,47,56,57,59,62,63,64,66,68,69,71,73,74,75,76,80,83,84,85,86,88,89,92,93,94,97,104,110,111,113,114,117,118,122,130,134,137,140,141,145,147,154,155,156,157,158],ordinari:[75,120],org:[2,3,71],organ:[0,2,104],organometal:9,orient:[2,13,29,35,36,38,44,69],orientord:36,origid:60,origin:[2,40,44,57,60,64,69,72,79,93,94,95,97,105,108,109,111,120,134,155,157,163],orlikowski:137,orsi:13,orthogon:0,orthograph:57,orthorhomb:73,os4:43,oscil:[2,69,73,81],ose:57,oserror:3,other:[0,1],otherwis:[1,40,45,56,60,69,75,90,91,121,131,132,144],otyp:[105,122,126,130],our:[2,68,76,155,157],out:[1,2,3,6,19,34,35,37,46,57,61,68,80,82,83,84,88,92,113,133,162],outer2:[101,119],outer:[4,91,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],outer_distance_cutoff:120,outermost:[69,71,74,77,81,82],outlin:[2,57],output:[0,1],output_frequ:58,outsid:[44,57,64,82,92,98,99,105,113,122,124,143,146],outut:2,outward:[81,82],over:[1,2,4,11,19,32,33,34,36,37,38,41,42,47,57,59,60,61,67,69,71,73,74,75,81,82,83,92,103,109,111,112,113,114,120,131,134,137,144,148,149,154,155,156,157,158,162],overal:[2,9,63,69,72,76,113,120,148],overhead:[2,3,19,60,61,64],overlai:[2,4,32,80,105,109,120,121,130,148,161],overlap:[4,44,59,60,91,109,113,118,130,149],overli:75,overload:1,overrid:[4,44,57,63,69,120,134],overridden:[2,44,57,70,131,149],overview:[0,1,2],overwrit:[3,60,134],overwritten:120,own:[2,3,19,30,34,58,59,60,61,62,63,67,68,69,70,72,92,94,97,104,112,144,154,155,156,157,158,163],oxford:[13,32,108],oxid:[104,105,147],oxygen:[2,105,122,126,147],p10:118,p_e:80,p_ik:144,p_pi:97,pacakg:4,pack:[97,134],packag:0,packet:[57,113],pad:[57,72],page:[0,1,2,3,32,34,37,39,42,44,56,57,59,60,69,82,91,92,93,94,96,104,105,111,112,114,120,134,135,136,142,144,148,154,155,157,158,162],painless:163,pair:1,pair_:32,pair_charmm:130,pair_coeff:[2,32,35,45,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],pair_dzugatov:163,pair_eam:93,pair_interact:58,pair_list:121,pair_lj:130,pair_lj_soft_coul_soft:32,pair_modifi:[2,32,91,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],pair_sph:[150,151,152],pair_styl:[0,1,2,4,18,28,32,35,41,45,67,81,82,91],pair_writ:128,pairwis:[0,1,2,28,29,36,38,39,41,42,45,56,62,67,81,91,93,96,98,99,100,101,103,105,109,110,111,113,114,118,120,121,122,123,126,131,132,133,134,135,136,138,139,143,146,149,153,157,159,160,162],pakketeretet2:163,pan:57,panagiotopoulo:[106,116],papaconstantopoulo:93,paper:[2,41,50,68,80,92,94,100,105,118,120,124,126,155,157],paquai:163,paraemt:145,paragraph:[81,140,141],parallel:[0,1,2],parallel_studio_xe_2016:4,parallelepip:2,param:115,paramet:0,parameter:[40,43,94,97,104,105,111,112,113,114,134,135,136,144,147,154,155,156,157,158],parameter_fil:58,parameterizaion:105,parametr:[2,18,112,146],paramt:[37,145],paramter:104,paratem:130,parenthes:[66,75,115,118,140,141],parenthesi:[4,60],parinello:2,pariticl:61,park:[58,136],parmin:137,parrinello1981:63,parrinello:[63,69,73],pars:0,part:[0,1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,31,36,37,39,40,41,42,43,45,46,47,48,49,50,51,52,53,54,56,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],partial:[1,2,60,63,68,70,72,134],partic:2,particip:[55,96],particl:0,particular:[1,2,29,41,44,57,61,62,67,68,69,71,74,76,83,96,97,98,99,101,102,103,107,110,112,113,117,119,122,126,130,133,139,142,143,145,146,154,155,156,157,158,162,163],particularli:[2,9,57,63,113],partit:[2,19,61,72,92,100,101,113,122,123,126,133,138,144,162],partner:62,pass:[2,3,33,34,37,57,63,69,81,153],password:163,past:[0,73,109],patch:0,patel:137,path:[2,3,72,80,92,93,94,97,111,112,114,134,135,136,142,144,147,148,154,155,157,158],pathtolammp:147,patrick:156,pattern:30,paul:0,pauli:[113,147],paves:72,payn:[41,148],pb2:43,pb4:43,pbc:81,pchain:[69,70],pcie:1,pd2:43,pd4:43,pdamp:[69,70],pdb:2,pdf:[0,150,151,152],pe_eta:69,pe_etap:69,pe_omega:69,pe_strain:69,peak:116,pearlman:32,pencil:2,peng:43,per:[0,1],peratom:42,perceiv:57,percent:[4,63,154],percentag:[1,63,69],perfect:[2,19,29,30,36,61,71,92],perfectli:[19,61],perfom:[2,92],perform:0,performac:1,pergamon:[134,157,161],peri:[2,44],peridynam:2,perimitt:106,period:2,perioid:81,perl:2,perman:[28,74,120],permit:[2,68,137],permitt:[106,157,160,161],permut:[112,154,155,157,158],perpendicular:[2,57,71,81],perram:117,persepct:57,person:163,persp:57,perspect:57,perturb:[29,32,81],peskin:68,pettifor:97,pettifor_1:97,pettifor_2:97,pettifor_3:97,pfactor:57,phase:[4,69,97,122,156],phenomena:113,phi0:[54,74],phi1:46,phi2:[46,112,154],phi3:[46,112,154],phi:[1,4,36,38,41,55,56,57,74,85,93,97,111,114,134,135,136],phi_ij:[97,114,144],phillip:109,phillpot:[104,105,147],philosoph:111,philosophi:2,phonon:[0,58,80],phophor:148,phosphid:148,phy:[2,5,6,9,20,21,22,29,30,32,36,38,39,41,42,45,46,53,63,64,67,68,69,70,72,73,76,78,79,80,81,83,89,90,92,94,97,98,101,102,103,104,105,106,107,108,109,110,111,112,113,116,117,118,119,120,122,124,126,127,130,131,132,133,134,136,138,140,141,143,144,145,147,148,153,154,155,156,157,158],physic:[2,4,27,55,58,64,68,80,92,94,95,100,103,111,120,137,150,151,152],physica:[131,132],picosecond:162,picosend:113,piec:[3,41,69],pimd:2,pin:4,pipe:[2,57],pipelin:[2,4],pisarev:80,pishevar:109,pitera:2,pixel:57,pizza:[2,3,19,57,61],pka:80,place:[2,3,19,32,44,57,62,64,67,69,80,81,120,162],placehold:[93,94,104,111,114,134,135,136,142,144,148,153,154,155,156,157,158],placement:122,plai:[2,57],plain:130,plan:[2,4],planar:[2,71,89,90],planck:72,plane:[2,19,36,57,58,61,71,80,83,84,85,86,87,88,90,132],planeforc:91,plasma:[80,113],platform:[1,4,57],plath:[2,35],player:57,pleas:[0,3,4,58,68,112,114,147],plimpton:[0,4,29,39,42,62,71,118],ploop:[69,70],plos:13,plot:[3,4,73,128,130],plu:[3,63,70,113],pm3:43,png:57,pni:57,poariz:2,poem:2,poems:2,point:[1,2,3,4,13,19,29,40,41,43,44,49,57,60,61,63,66,68,69,72,73,80,82,91,92,96,104,106,108,110,113,117,124,137,140,141,144,145,147,153,156,160,162],pointer:3,poisson:118,poisson_solv:58,polar:[2,38,41,43,58,104,105,122],polar_off:104,polar_on:104,polariz:0,politano:147,polydispers:[103,118,131,132,160],polyethylen:94,polygon:2,polym:[0,2,21,22,28,62,72,76,77,109,153],polynomi:[111,128,147],poor:[19,61,76,128],poorli:91,popular:112,porou:68,portion:[1,3,19,28,35,42,59,60,61,63,64,68,69,98,99,100,101,102,105,106,108,109,113,115,116,117,119,120,122,126,130,133,143,145,146,157,163],poschel:118,posit:[2,11,19,22,29,33,34,40,41,42,43,44,47,49,55,57,59,60,61,62,63,64,67,68,69,71,72,73,75,76,78,79,80,81,82,83,92,94,96,109,110,113,116,125,140,141,147,153],possibl:[1,2,3,19,29,32,41,42,58,61,62,65,71,75,80,87,91,120,134,147,158,162],post:[0,2,35,58,73],pot:118,potentail:114,potenti:0,potentiel:130,potin:137,pour:[2,76],power:[3,4,37,41,97],pparam:32,ppm:57,ppn:4,pppm:[0,1],pproni:67,pr3:43,pr4:43,practic:[63,69,158,163],prb:[155,157],prd:[2,92],pre:[2,74,81,97,118,140,141,147,149],prec:[4,147],preced:[2,45,59,60,75,92,97,120,162],preceed:[3,81],precis:[1,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,44,45,46,47,48,49,50,51,52,53,54,60,63,64,69,70,76,83,84,85,87,88,89,90,91,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,137,139,142,143,145,146,147,149,154,155,156,157,158,159,160,161,162],predefin:[54,113],predict:[1,2],prefactor:[8,9,12,16,17,18,56,81,84,88,89,91,103,116,142,145,146,149,160],prefer:[74,94,163],prefix:[3,57,75],preliminari:[66,140,141],prematur:91,preprint:[41,148],prescrib:[2,58,60],presenc:[68,131,132,137,160],present:[1,4,57,67,68,82,104,113,121,130,137,145,147],preserv:[63,69,76],press:[2,4,13,32,42,63,69,70,108,134,157,160,162],pressur:[1,2],pressure_with_eviri:113,presum:[30,92],prevent:[2,55,89,91,92,109,150,151,153],previou:[0,2,3,60,61,91,97,118,120,134,140,141,162],previous:[3,44,59,60,76,80,81,118,162],price:[2,108],primari:[0,2,80],prime:[119,137,155,157],primit:[2,82],princip:147,principl:[2,3,113,137,154,163],print:[0,1,2,3,4,19,35,41,57,60,62,63,68,69,70,71,73,75,76,91,92,94,109,116,120,147,162],printfluid:68,prism:2,privileg:3,probab:149,probabl:[55,61,62,69,81,91,140,141],problem:[0,1,2,3,19,35,58,61,63,74,79,82,91,92,105,108,120,163],proc:[1,3,4],proce:[19,28,61,92,137,162],procedur:[2,19,61,69,70,78,79,91,92,94],proceed:137,procesor:19,process:1,processor:[1,2,3,4,19,44,57,58,60,61,62,63,67,68,69,72,76,80,92,109,147],processsor:[19,61],produc:[1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,39,42,45,46,47,48,49,50,51,52,53,54,57,59,60,61,62,67,69,70,73,75,76,80,81,83,84,85,87,88,89,90,91,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,142,143,144,145,146,149,154,155,156,157,158,159,160,161,162],product:[2,4,41,75,113,115,141],profil:[2,60,64,92],program:[2,3,4,57,68,111],progress:[1,19,61,73,91,92,162],project:[2,163],promot:97,prompt:3,proni:67,prop:2,propag:[69,73,113],propens:2,proper:[62,71,134,163],properli:[92,110],properti:0,proport:[2,19,32,61,73,75,118],propos:[2,41,63,69,122,136,156],protein:[4,44,77],proton:[157,161],prove:[31,65,68],provid:[1,2,3,4,13,29,40,43,44,57,59,60,62,63,68,69,73,78,79,92,94,97,104,105,109,112,113,118,120,121,130,131,134,136,137,144,147,148,153,154,155,156,157,158,162,163],pscrozi:0,psec:69,pseudo:113,pseudopotenti:137,psf:2,psi:[114,160],psi_ij:114,pstart:[69,70],pstop:[69,70],pstyle:32,psxevar:4,pt2:43,pt4:43,ptarget:63,pthread:4,ptr:[2,3],pu3:43,pu4:43,pu6:43,publish:[68,105,134,137,155,157],pull:163,puls:80,pump:[131,132],purchas:57,pure:[3,135,136,155,157],purport:3,purpos:[2,40,43,44,62,63,71,72,74,100,126,137],push:[71,91,118,149,163],put:[2,3,44],pxx:[63,69,162],pxy:[2,162],pxz:[2,162],pydir:3,pyi:[63,69,162],pymol:3,pymol_aspher:0,pympi:3,pypar:3,python:[0,2],pythonpath:3,pyz:[2,162],pzz:[63,69,73,162],q_1:147,q_2:147,q_3:147,q_i:[114,130],q_j:130,qdist:[105,122,126,130],qeq:[2,104,105,147],qeqall:147,qeqallparallel:147,qfile:105,qinitmod:147,qoffload:4,qopenmp:4,qoverrid:4,qtb:73,quadrant:4,quadratur:[32,58],quadrupl:93,quadruplet:[56,83,84,85,86,88,89],qualiti:[57,94],quantic:147,quantit:[37,118],quantiti:1,quantum:[2,41,72,73,94,97,113,137,147],quantum_temperatur:73,quartic_spher:58,quartz:73,quasi:72,quaternion:[2,44,117],queri:[3,28],quest:2,question:[71,163],quick:[0,4],quickli:[36,61,91,92,94],quickmin:[91,92],quicktim:57,quit:[68,148,162],quot:134,quotat:147,r10:97,r12:117,r_1:41,r_2:41,r_c:[106,108,116,157],r_cut:[97,133],r_e:114,r_fu:[131,132],r_i:[13,41],r_ii:41,r_ij:[13,97,113,144,161],r_ik:144,r_j:13,r_jik:144,r_m:133,r_me:106,r_mh:116,r_min:107,r_ub:5,ra2:43,rad2theta:43,radial:[41,60,91,113,120,140,141],radian:[5,6,8,12,16,17,18,43,46,54,74,83,84,88,89],radiat:[40,43,80],radii:[41,62,103,111,117,118,131,132,137,160],radit:113,radiu:[2,33,34,40,41,57,68,77,81,82,97,103,113,114,118,122,130,131,132,133,134,147,148,157,160],rahman:[2,63,69,73],rai:43,ram:157,raman:4,ramp:[2,67,69,73,81,101,109,119,130,131,133,149,161],ran:[2,3],random:[2,44,57,62,67,68,69,72,73,80,109,110],randomli:44,rang:[1,2,4,38,39,41,42,43,50,57,58,91,94,95,97,98,99,100,101,102,103,105,106,107,108,109,111,113,115,117,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,137,138,139,143,144,145,146,147,153,157,159,160,161,162],rank:[2,3],rankin:70,rapid:[2,3],rapidli:[62,69,105,109],rare:2,rasmol:2,rasmussen:117,raster3d:2,rate:[2,4,58,73,75,78,79,115,131,132,141,162],rather:[2,19,39,57,61,67,80,113,140,141],ratio:[2,32,41,61,117,118,145,150],rattl:64,rattle:[64,76],rattle_debug:76,ravelo:[70,124],raw:4,rayleigh:73,rb1:43,rbb:147,rcb:[19,61],rcm:[33,34],rcmx:[33,34],rcmy:[33,34],rcold:64,rcutfac:[41,148],rd1:92,rdn:92,rdt:92,reach:[2,19,61,63,70,75,106],reacquaint:163,react:2,reactant:[75,113],reaction:[66,75,77,92,113,115,141],reactiv:94,read:[2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,62,63,66,69,70,72,75,76,79,80,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],read_data:[2,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,33,34,44,45,46,47,48,49,50,51,52,53,54,55,56,57,62,72,74,75,83,84,85,86,87,88,89,90,92,95,96,98,99,100,101,102,103,105,106,108,109,110,113,116,117,119,120,122,123,124,125,126,127,128,129,130,131,132,133,138,139,143,144,145,146,147,149,153,159,160,162],read_dump:92,read_restart:[2,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,44,45,46,47,48,49,50,51,52,53,54,56,58,63,68,69,70,72,80,83,84,85,86,87,88,89,90,92,95,96,98,99,100,101,102,103,105,106,108,109,110,113,116,117,118,119,122,123,124,125,126,127,128,129,130,131,132,133,138,139,143,145,146,149,153,159,160,162],readabl:57,readi:3,readme:[1,2,3,4,137],real:[2,3,11,14,15,35,36,38,41,44,47,72,73,81,87,105,137,157],realli:[1,39,42,163],reamin:[81,82],rearrang:92,reason:[2,3,44,55,60,78,79,92,106,113,114,116,132],reax:[0,73],rebal:[19,61],rebalanc:[19,61],rebuild:[3,4,109,162],rebuilt:57,recalcul:32,receiv:71,recent:[3,4,60,61,134],reciproc:[2,40,43,98,99,100,105,108,113,122,126,143,146],recogn:[30,69,75,111,134],recomend:2,recommed:75,recommend:[4,57,64,73,79,113,131,132,137,145,147,163],recompil:[1,76],reconstruct:147,recov:[63,64,69],rectangl:[19,61],rectangular:[19,61],rectilinear:[40,43],rector:27,recurs:[19,61,97],recust:19,red:[57,62,72],reduc:[1,2,11,19,39,40,42,43,57,60,61,62,71,74,75,91,113,117,144,145,154,155,157,162],reduct:[40,43,73],redund:114,reed:73,ref:[78,79],refactor:2,refer:[2,3,4,13,32,44,58,59,60,62,63,64,69,70,71,72,73,76,83,90,93,117,134,136,137,145,151,152,155,157,162],referenc:[2,105,120,142,145,162],reflect:[2,40,41,43,56,57,81,97],refresh:58,regard:[2,76],regardless:[44,69],regim:[2,106],region:[0,2,19,35,43,44,50,57,58,60,61,64,69,80,81],region_styl:82,regoin:2,regspher:44,regul:2,regular:[1,19,57,61,80,106],reinder:4,reinhardt:[78,79],reject:[44,62],rel:[1,2,11,18,19,36,41,44,47,61,64,71,75,80,91,113,117,118,131,132,134,145,160,162],relat:[1,2],relationship:[2,147,160],relax:2,releas:0,relev:[2,19,44,58,59,60,61,64,67,68,76,77,80,81,91,95,103,105,106,108,109,113,116,117,118,119,120,121,123,124,125,127,128,129,131,132,139,140,141,145,149,153,159,160,161],reli:[113,161],reltol:75,remain:[19,32,55,56,60,63,69,80,97,113,130,137,162,163],remaina:97,remaind:[44,157],remap:[2,44],remedi:2,rememb:163,remot:163,remov:[2,28,36,38,41,44,60,69,75,76,92,108,132,137,163],remove_molecul:58,remove_sourc:58,remove_speci:58,ren:43,renam:163,render:57,rendon:69,reneighbor:[61,109,162],repeat:[2,57,62,63,75,97,155,157],replac:[2,3,19,33,34,57,60,61,62,70,94,105,118,124,140,141,162],replica:0,report:[0,1,4,40,43,73,74,75,80,92,108,113,134],repositori:163,reprens:80,repres:[1,2,19,29,34,50,57,60,63,66,67,68,69,72,75,80,82,92,93,97,117,130,131,132,134,135,136,143,144],represent:[2,67,72,80,97,113,117,137,145],reproduc:[4,69,105,111,118],repul:134,repuls:[2,18,21,22,81,82,94,97,103,105,109,113,115,118,120,130,134,138,147,153,157,158,160,161],request:[2,19,68,163],requir:[1,2,3,4,18,19,28,31,32,40,42,43,44,45,55,57,58,61,62,65,66,67,68,69,75,76,80,81,83,91,92,93,94,96,97,101,103,104,105,109,110,111,112,113,114,117,118,120,128,130,131,132,134,135,136,137,139,140,141,142,144,145,146,147,148,153,154,155,156,157,158,160,161,162],rerun:[36,38,41,57],rescal:[2,64,69,70,78,79],research:[31,65,68,137],resembl:163,resepct:2,reservoir:[35,64,80],reset:[2,3,33,34,63,69,70,76,80,91,132,162],reset_atomic_reference_posit:58,reset_tim:58,reset_timestep:[2,35,162],resist:2,resolut:147,resolv:[63,72,132,163],resourc:[93,111],respa:[4,69,71,74,77,81,82,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],respecifi:137,respect:[1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,29,32,33,39,40,43,45,46,47,48,49,50,51,52,53,54,57,62,63,64,68,69,70,76,80,81,83,84,85,87,88,89,90,91,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,134,135,137,139,142,143,145,146,147,148,149,154,155,156,157,158,159,160,161],respond:[2,113],respons:2,resquar:[2,117],rest:[2,74,97,132,134,162],restart1:72,restart2:72,restart2data:0,restart:[0,1],restor:[44,162],restrain:13,restraint:[74,121],restratin:74,restrict:[1,2],result:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,34,35,39,40,42,43,44,45,46,47,48,49,50,51,52,53,54,57,59,60,61,62,63,64,67,68,69,70,72,75,76,78,79,80,81,83,84,85,87,88,89,90,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,134,135,137,139,140,141,142,143,145,146,149,154,155,156,157,158,159,160,161],retain:[94,97,137],retriev:[2,135,136],rev:[2,29,36,38,41,42,69,70,78,79,97,103,104,105,108,111,112,113,117,118,124,131,132,133,134,136,140,141,144,145,148,154,155,156,157,158],revers:[2,32,49,62,69,71,78,92,130],review:[41,137,148,163],rfac0:[41,148],rg0:77,rh3:43,rh4:43,rheolog:2,rhi:[140,141],rho0:[134,151,152],rho0_meam:134,rho:[68,93,98,99,100,111,133,134,135,136,140,141,145,150],rho_0:[151,152],rho_alpha_beta:111,rho_bkgd:134,rho_colloid:81,rho_e:80,rho_i:[135,136],rho_ref_meam:134,rho_wal:81,rhodopsin:[1,4],rhosum:[150,151,152],rhot:64,rhs:75,rick:[104,147],right:[2,3,19,29,44,54,56,61,62,68,71,75,105,163],rightmost:[19,61],rii:[33,34],rij:[36,38,71,109,110,140,141,153],rin:[120,127,128],ring:[2,45,72],rino:[30,158],rirj:118,risi:[41,148],risk:74,rix:[33,34],rk4:75,rkf45:75,rlo:[140,141],rmin0:[41,148],rmin:124,rms:75,rnemd:2,robust:91,rock:134,rockett:144,role:2,ronchetti:38,root:[3,32,33,34,111],rose:134,ross:134,rosski:72,rot:[2,35,72,74],rotat:[2,41,44,60,82,91,108,117,145,162],rotation:38,rough:[2,44,57],roughli:[19,57,69,92],round:[1,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,69,70,76,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,139,140,141,142,143,145,146,149,154,155,156,157,158,159,160,161],rous:67,rout:[32,120,130],routin:[2,3,4,68,137],roux:2,row:[2,34,43,60,80,113],rozero:134,rrespa:[1,4,69,93,94,95,96,98,99,100,101,102,103,104,105,106,108,109,111,112,113,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,131,132,133,134,135,136,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],rsq:[140,141],rsurfac:80,ru3:43,ru4:43,rub:5,rubia:[135,136],rule:[0,2,13,29,44,62,69,82,93,95,96,102,103,108,120,125,134,138,149,153,154,155,157,161],run1:2,run2:2,run3:2,run4:2,run5:2,run6:2,run7:2,run8:2,run:[0,1],run_styl:[4,69,91,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,116,117,118,119,120,121,122,123,124,125,126,127,128,129,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],rung:75,runtim:57,rutherford:80,rutuparna:[155,157],rxn:75,ryckaert:[76,89],rydberg:137,s0st:2,s2050:1,s2629:111,s319:58,s_i:[2,113],s_ij:2,saddl:92,sadigh:[111,135,136],saed_vtk:40,safe:[57,163],safran:160,sagui:108,sai:[1,163],said:91,sakai:156,sall:147,salt:[106,116,134],salter:147,same:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,33,34,35,36,37,38,39,41,42,44,45,46,47,48,49,50,51,52,53,54,57,58,59,60,61,62,63,64,67,68,69,70,71,72,73,74,76,78,79,80,82,83,84,85,87,88,89,90,92,93,94,95,97,98,99,100,101,102,103,104,105,106,107,108,109,111,112,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,134,135,138,139,142,143,144,145,146,147,149,153,154,155,156,157,158,159,160,161,162,163],sampl:[1,2,3,35,57,60,69,72,77,79,97],sample_frequ:58,sandia:[0,29,114,134],saniti:74,satellit:2,satisfi:[30,40,41,43,63,64,68,70,76,91,118],satur:106,save:[2,57,62,67,75,80,97],sb3:43,sb5:43,sc3:43,scalabl:[0,1,4],scale:[0,1,2,4,35,41,45,57,58,63,68,69,70,72,73,78,79,80,93,94,106,113,115,118,131,132,134,137,162],scalegamma:68,scalexi:[63,69,70],scalexz:[63,69,70],scaleyz:[63,69,70],scatter:[3,40,43],scatter_atom:3,scatter_coord:3,scenario:[2,62,82],schaik:130,schell:156,schemat:62,scheme:[2,67,69,72,76,80],schmid:109,schroding:113,schroeder:38,sci:[30,104,136,144,147],scienc:[58,62,71,78,111,135,147,156],scientif:[41,111],scm:3,scratch:[19,61],screen:[0,1,2,3,4,40,43,57,68,76,92,101,105,122,134,154,157,158,159,160,161,162],screenshot:3,scripe:3,script:[0,1],sea:3,search:[0,36,38,91,92,118],secant:66,second:[1,2,3,4,28,29,35,37,38,39,42,43,55,60,62,64,66,67,72,74,76,77,78,79,80,91,92,96,97,98,99,100,104,105,111,113,114,115,118,119,121,124,134,142,147,154,156,157,158,161,162],second_mo:147,secondari:50,section:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,31,32,33,34,35,37,39,40,41,43,45,46,47,48,49,50,51,52,53,54,55,56,57,58,60,61,62,64,65,66,67,68,69,70,71,72,73,75,76,78,79,80,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],section_acceler:[5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,69,70,76,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,135,139,142,143,145,146,149,154,155,156,157,158,159,160,161],section_accerl:111,section_command:[0,1],section_exampl:2,section_howto:[2,3,29,30,32,33,34,36,38,41,42,60,96,107],section_modifi:[2,57,162],section_python:2,section_start:[2,3,92,162],section_tool:2,see:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],seed:[44,57,62,67,68,72,73,80,109,110],seek:[19,61],seem:[2,63,134],seen:[4,68,82],segment:[2,57,109,153],select:[2,40,43,44,57,81,92,120,121,134,147],self:[2,59,60,73,74,75,77,79,91,104,105,137,144,147],semi:58,semimet:113,semin:4,send:[0,3],sens:[1,2,19,56,60,61,62,67,73,80,92,105,122,126,155,156,157],sensit:[2,30,63],sep:[2,3],separ:[2,4,19,41,44,55,57,58,61,62,63,69,72,76,98,99,105,106,108,110,122,131,132,134,140,141,142,148,154,157,160],seper:106,sequenc:[19,57,61,92,144],sequenti:144,seri:[2,4,41,57,67,94,117,134,137,140,141,145,149,162],serial:1,serv:[2,153],server:1,set:[0,1],set_vari:[2,3],setarea:68,sete:[60,62],setenv:3,setfl:[93,111],setforc:[2,91,92],setgamma:68,settl:63,setup:[2,3,4,32,35,56,58,62],seven:136,sever:[1,2,3,4,32,56,58,63,68,69,91,97,100,111,126,130,134,144,147,162],sexton:137,sfactor:57,shade:57,shake:[2,13,39,42,60,64],shan:104,shape:[2,19,44,57,61,63,69,73,82,96,117,145],shardlow:[65,75,110],share:[0,1,2],sharp:[82,134,157],shear:[2,63,68,69,118,131,132],shell:0,shenderova:94,shift:[1,2],shiga:[2,69],shini:57,shinoda:[2,69,146],shiny:57,shlib:3,shm:4,shock:[70,73,124],shockvel:73,shortcut:[63,69],shorter:71,shortest:57,should:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,32,35,39,42,44,45,46,47,48,49,50,51,52,53,54,57,61,62,63,67,68,69,70,71,72,73,74,75,76,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,96,98,99,100,101,102,103,104,105,107,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,134,135,137,139,140,141,142,143,145,146,147,149,153,154,155,156,157,158,159,160,161,162,163],show:[2,3,92,120,134,137],shown:[1,4,19,40,41,43,56,61,62,64,69,71,72,113,114,117,118,130,137,145,147],shrink:[2,19,57,61,68,71,91,105,122,126],shrunk:75,shut:[2,3],si4:43,sic:[105,134,142,154,155,157,158],sic_tersoff:144,sicc:[112,154,155,157,158],sicg:[155,157],sicsi:[112,154,155,157,158],side:[19,44,59,61,62,68,71,75,81,82,92,105,117,118,145],sige:[155,157],sigma0:97,sigma14:130,sigma1:97,sigma2:97,sigma:[2,21,22,28,32,45,68,71,81,82,94,96,97,98,101,102,103,108,109,110,112,113,117,119,120,121,122,123,124,125,126,127,128,129,130,133,138,145,146,154],sigma_14:101,sigma_:106,sigma_c:103,sigma_cc:[94,103],sigma_h:116,sigma_i:114,sigma_ss:103,sign:[2,49,56,137,163],signifi:[34,115,141],signific:[67,75,113,117,134,137],significantli:[1,2,42,68,69,74,113,154],silbert:118,silicon:[112,134,154],sim:146,similar:[2,3,4,19,22,32,39,42,44,60,61,67,73,74,81,94,96,97,109,111,113,118,130,131,139,144,162],similarli:[2,39,57,59,60,69,76,82,83,92,94,100,118,126,154],simluat:[2,131],simlul:80,simpl:[1,2,3,4],simpler:3,simplest:34,simpli:[1,2,3,34,60,63,69,72,92,100,108,126,134,162],simplif:113,simplifi:[74,137],simplist:3,simul:[0,1],simulatan:4,simulationub:147,simultan:[2,4],sin:[55,81,144],sinc:[0,1,2,3,6,19,28,29,30,33,34,40,45,57,59,60,61,62,63,68,69,70,71,72,75,80,81,82,83,91,92,93,94,97,99,100,101,102,103,104,108,109,111,112,117,118,119,121,122,124,125,126,127,128,129,130,131,132,133,134,135,136,137,140,141,143,144,145,146,147,148,149,154,155,156,157,158,161,162,163],sinclair:[71,111],sine:144,singapor:41,singh:93,singl:[1,2,3,4,19,32,34,44,55,57,59,60,61,62,63,68,69,70,72,74,76,80,81,92,93,94,97,101,104,111,112,113,114,118,119,120,134,135,136,137,142,143,144,145,147,148,149,154,155,156,157,158],singleel:97,singular:[55,130,131,132,139],sinnott:[94,104],sinusoid:[44,81],sio2:158,sio:104,sirk:[42,153],sisic:[112,154,155,157,158],sisisi:[112,154,155,156,157,158],site:[0,1,2,3,29,32,64,68,76,93,97,105,111,115,116,122,126,130,139,141,143],situat:[63,68,69,72,97],sival:43,six:[2,41,142,144],sixth:142,sixthpow:102,size:[0,1],sjplimp:[0,3],skew:[2,57,69],skin:[30,80,162],skip:[4,45,121],slab:2,slater:[105,147],sleight:28,slepoi:134,slice:[2,40,72],slider:3,slight:[64,80],slightli:[1,2,4,57,69,94,105,122,126,155,157,158],sligthli:108,sliozberg:153,sllod:[2,4],slope:[2,79,106],slot:1,slow:[2,67,69,92,147],slower:[1,97],slowest:80,slowli:[61,91,137,149],sm3:43,small:[2,19,29,32,40,42,43,60,61,62,64,67,69,71,73,75,76,89,91,92,94,103,105,106,107,122,131,132,134,145,148,154,157,163],smaller:[1,2,4,57,68,75,79],smallest:29,smd:77,smith:143,smooth:[2,82,97,101,105,119,124,127],smoother:44,smoothli:[28,41,101,119,128,130,133,157,161],smt:4,smtb:147,smulat:137,sn2:43,sn4:43,snap:[41,57],snapcoeff:148,snapparam:148,snapshot:[0,1],snc4:4,soc:120,sodani:4,soderlind:137,soft:[3,32,91,109,115],softer:[81,82],softwar:[1,2,3,4],sole:[92,144],solid:[2,19,29,30,35,42,58,61,63,69,71,79,98,124,137],solut:[2,63,75,76,82],solv:[64,68,75,76,79,80,132],solvat:44,solvent:[61,67,69,101,103,105,106,116,122,131,132,145],solver:[0,1,2,19,42,58,61,66,75,105,107,115,122,130,141],some:[1,2,3,4,19,37,44,49,56,57,59,60,61,62,63,69,75,80,81,91,92,96,97,105,111,113,137,162,163],someon:91,someth:[3,63,69,81,163],sometim:[2,63,69],somewhat:[29,60,69],somewher:113,soon:62,sort:[4,92],sound:[68,151,152],soundspe:[151,152],sourc:[0,3,4,58,63,80,130],source_integr:58,sourceforg:3,south:41,space:[2,3,4,19,40,41,43,44,57,61,68,69,72,81,92,98,99,100,105,108,111,113,122,126,134,137,140,141,143,144,146,160,162],spahn:118,span:[64,93,94,97,104,111,114,134,135,136,142,144,148,154,155,156,157,158],spars:75,spatial:[2,19,29,34,58,60,61,80],spc:0,spce:64,spcpu:162,spearot:[40,43],speci:[41,66,75,111,114,115,141,144,155,157],special:[2,44,45,58,76,93,104,107],special_bond:[2,4,21,22,28,36,38,41,45,56,62,107,120],species1:[66,141],species2:[66,141],species:75,speciesn:66,specif:[1,2,4,13,19,44,57,58,60,61,62,67,68,80,81,91,92,94,96,97,107,111,117,118,134,137,145,154,162],specifi:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,32,34,35,36,38,39,40,42,43,44,45,46,47,48,49,50,51,52,53,54,56,57,58,59,60,61,62,63,64,66,67,68,69,70,71,73,74,75,76,77,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],specifii:68,spectral:148,spectrum:[41,73],speed:[1,2,4,19,61,68,73,92,97,105,137,151,152,155],speedup:[1,4],spefici:[44,57,120],spellmey:[2,45],spend:59,spent:1,sphere1:68,sphere:[2,40,41,44,57,60,68,69,82,103,108,113,117,118,122,131,132,145,160],spheric:0,spheriod:2,spheroid:[2,69],spin:113,spline:[66,91,94,97,120,134],split:[1,2,3,4,19,60,61,64,69,110],splittol:2,spparks:2,spread:[1,2],spring:[2,10,11,21,22,24,25,27,47,55,62,72],sqrt:[33,38,71,103,109,111,116,118,134],squar:[2,8],squares:[19,61],squeez:[63,131,132],sr2:43,src:[0,1,2,3,4,76,137,163],srolovitz:111,srp:109,srtio:147,ssao:57,stabil:[2,69,97],stabl:[2,55,68,70,74,97],stabli:67,stack:29,stage:[32,92],stagger:1,stai:73,stall:4,stand:[0,2],standard:[0,1,2,3,4,38,44,50,58,68,72,76,81,93,94,96,105,108,113,116,117,122,123,124,125,126,129,133,134,137,138,145,154],starikov:80,start:[0,2,4,19,39,44],start_6:116,stat:[28,71,91],state:[2,3,29,30,32,50,57,62,63,65,66,67,69,70,73,78,79,80,92,97,108,110,113,117,118,134,136,137,145,147,150,151,152],statement:163,stationari:[68,131,132],statist:[2,19,62,67,73,75,76,80,91,92,94,109,118,131,160,162],statu:[28,104],steadi:[2,70,73],stefan:163,stegailov:80,steinhardt:38,stencil:68,step:[1,2,3,4,35,42,57,58,60,61,62,63,64,71,73,75,76,78,79,80,91,92,94,109,116,120,134,137,147,162],stepwis:32,steve:0,steven:62,stiff:[2,26,72,75,91],stile:106,still:[1,2,3,4,19,36,61,80,102,111,117,118,121,131,145,149,163],stilling:[112,136,144,154,158],stochast:110,stoddard:108,stoichiometr:75,stoichiometri:147,stoke:68,stone:108,stop:[2,3,19,28],stopthresh:[19,61],store:[2,3,33,35,36,39,42,44,56,57,58,59,60,67,68,69,70,71,72,75,76,77,79,80,93,94,97,104,109,110,111,112,113,114,115,117,118,134,135,136,137,140,141,144,147,148,154,155,156,157,158],straatsma:2,straightforward:113,strain:[2,63,69,70,131,132],strang:57,strategi:0,stratford:68,stream:[2,39,42,57,58,67],streiz:105,strength:[41,57,74,81,82,145],stress:[2,35,39],stretch:28,strict:148,strictli:[2,19,61,73],strietz:105,string:[2,3,19,44,60,61,75,134,144,148,162],strong:94,stronger:2,strongest:[131,132],strongli:[1,2,76,80,137],structur:[0,2,3,29,30,38,40,43,50,74,90,97,104,113,134,137,144,147],strucur:30,stuart:[94,104,147],stuck:63,studi:[2,37,124,147],studio:4,stukowski:111,style:0,style_nam:69,stylecomput:147,sub:[1,2,3,19,32,35,41,56,57,61,63,69,70,73,76,80,82,94,96,104,117,118,120,145,147,161],subbox:57,subdivis:68,subdomain:68,subequ:3,subject:[2,4,19,61],submit:[0,56,114],subscript:[3,80,83,114,158],subsequ:[2,3,19,61,63,80,111],subset:[2,3,4,19,41,61,69,70,92,94,97],substanti:[2,154],substep:69,substitut:[1,92,113],substract:105,substrat:[63,69],substyl:130,subsystem:80,subtract:[2,28,35,37,39,42,60,64,67,129,162],success:[2,3,63,91,92],successfulli:3,successulli:3,sudden:18,suddenli:82,sudo:3,suffer:82,suffici:[2,19,61,69,81,121],suffix:[1,2,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,45,46,47,48,49,50,51,52,53,54,57,69,70,75,76,83,84,85,87,88,89,90,92,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,134,135,136,139,142,143,144,145,146,149,154,155,156,157,158,159,160,161],suggest:[0,2,73],suit:[68,113],suitabl:[28,32,62,97,118,130,134],sum:[2,29,33,34,36,37,38,39,41,42,60,67,71,73,79,80,81,82,91,96,105,109,113,114,122,125,134,148,162],summar:[2,114,147],summari:1,summat:[2,29,38,100,105,111,112,122,126,137,147,154,155,156,157,158],sun:[6,20,46,83,102],sup:[73,104,147],supinski:137,supplementari:[117,145],suppli:80,support:[1,2,3,4,19,32,57,60,61,62,63,68,69,70,71,73,74,77,79,81,82,91,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],suppos:[114,163],suppress:2,sure:[2,3,63,76,111,163],surfac:[2,29,40,41,44,57,68,71,74,80,81,82,92,97,131,132,137,147,160],surface_mov:80,surfact:[106,116],surpris:113,surround:[29,44,63,66,69,71,140,141],suspens:[131,132],sustain:[63,118],suzuki:69,svg:2,svn:3,swap:2,swiggl:81,swiler:[41,148],switch7_section_start:116,switchflag:[41,148],swol:27,swope:2,symbol:[2,40,43,97,113,148],symmetr:[2,29,32,39,42,63,69,93,108,111,155,157],symmetri:[2,29,36,38,71,83,93],symplect:69,sync:2,synchron:[1,92],syntax:[1,2,3],sysstem:97,syst:147,system:[0,1],system_:72,systemat:[2,137],t_e:80,t_e_min:80,t_equil:[78,79],t_infil:80,t_init:[73,80],t_j:13,t_lb:68,t_oufil:80,t_out:80,t_outfil:80,t_qm:73,t_switch:[78,79],ta06a:148,ta4:137,ta5:43,ta6:137,tabbernor:40,table:66,tabul:[66,75,93,97,98,99,100,101,102,105,111,113,115,122,126,133,140,141,143,144,146,155],tabular:144,tad:2,tag:[58,66,75,115,141],tail:[32,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,111,112,113,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],tait:[151,152],take:[1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,32,33,35,39,42,45,46,47,48,49,50,51,52,53,54,57,59,60,61,63,64,69,70,75,76,77,83,84,85,87,88,89,90,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,137,139,142,143,145,146,147,149,153,154,155,156,157,158,159,160,161,162],taken:[2,44,62,67,68,73,75,80,87,111,113,117,140,141,154,158],talk:2,talli:[2,19,60,61,94,113,116,120],tang:137,tangenti:[2,118],tanh:80,tantalum:[137,148],taper:133,tarbal:[0,3],target:[2,3,19,61,63,64,67,69,70,72,73,77,80,109],task:[1,2,4,28,72],taskset:4,tau:[68,69,78,79,80],tau_1:67,tau_k:67,tau_n_k:67,tb3:43,tbp:97,tchain:[69,70],tcsh:3,tdamp:[69,70],technic:[2,68],techniqu:[2,32,63,73],technolog:4,tell:[2,3,56],temeperatur:3,temp:[2,32,35,39,42,60,62,63,64,69,70,72,73,80,94,108,116,117,120,145,162],temper:[2,92],temperar:72,temperatur:0,temperature_definit:58,templat:[44,76],templeton2010:58,templeton2011:58,templeton:58,tempor:67,temporarili:74,tend:[13,69,71,75],tensor:[2,33,34,35,39,41,42,63,68,69,70,113,131,132,137,162],term:[0,1,2,5,6,11,21,22,32,33,35,39,42,46,47,55,59,64,67,68,69,70,72,73,74,77,80,83,90,91,93,94,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,117,118,119,122,126,129,130,131,132,134,135,136,137,139,143,145,147,153,154,155,156,157,158,160,162],termin:[40,69,91,92],tersoff:[4,42,105,112,144],tersoff_1:[155,156,157],tersoff_2:[155,156,157],tersoff_mod:156,tertiari:50,test:[0,2],tether:[2,79,116],tetot:147,texas_holdem:74,text:[2,19,57,58,60,61,66,80,92,111,114,121,134,140,141,148,163],tfix:74,tflag:57,th4:43,thakkar:4,thakker:4,than:[1,2,3,4,11,19,36,37,38,39,42,47,60,61,62,63,67,68,71,73,74,75,77,80,81,82,91,92,94,96,97,98,99,100,101,111,113,117,118,131,132,134,140,141,145,147,149,153,154,157,160,161],thank:[155,157],thei:[0,1,2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,32,33,34,35,39,41,44,45,46,47,48,49,50,51,52,53,54,56,57,59,60,61,62,63,67,68,69,70,74,76,80,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,107,108,109,110,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,139,141,142,143,144,145,146,147,148,149,153,154,155,156,157,158,159,160,161,162,163],them:[1,2,3,19,28,35,46,57,59,60,61,62,63,69,70,71,74,76,80,83,92,93,97,111,114,117,145,149,163],themselv:[2,3,61,92,93,97,105,111,130,134,135,136,148],theorem:[67,97,110],theoret:[37,73,154],theori:[2,41,58,69,97,137,160],therebi:[131,132],therefor:[2,32,64,68,76,107,154],therein:[2,134],thereof:32,thermal:0,thermo:[0,1],thermo_modifi:[2,63,69,153,162],thermo_p:162,thermo_press:[39,63,69,70,162],thermo_styl:[2,31,35,39,42,44,60,62,63,69,70,73,81,91,94,116,120],thermo_temp:[39,62,63,69,70,162],thermoberendsen:2,thermochemistri:113,thermodyam:162,thermodyanm:62,thermodynam:0,thermost:2,thermostat:0,thermostatequ:2,thesi:131,thess:98,theta0:[5,6,8,10,11,12,16,17,18,41,47,74,89],theta0max:41,theta10:97,theta1:[46,55,83,97],theta2:[46,55,83,97],theta3:[83,97],theta4:97,theta5:97,theta6:97,theta7:97,theta8:97,theta9:97,theta:[2,10,11,36,38,41,43,44,47,57,74,80,83,89,120,144,156],theta_0:142,theta_:[89,97],theta_c:120,theta_ijk:97,theta_ijl:83,theta_jik:[135,136],theta_pi:97,theta_sigma:97,thi:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],thick:[40,57],thin:57,thing:[2,3,28,63,69,163],think:[2,3,84,88,91],third:[2,13,29,35,41,42,60,67,77,80,104,114,115,134,142,158],thirumalai:50,tho:112,thole:2,thompson:[0,39,41,42,148],those:[1,2,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,35,36,38,39,41,42,44,45,46,47,48,49,50,51,52,53,54,57,59,60,63,64,69,70,76,78,79,83,84,85,87,88,89,90,91,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,134,135,139,142,143,145,146,148,149,154,155,156,157,158,159,160,161,162,163],though:[2,35,44,63,92,109,111,113,114,117,118,130,131,158],thought:[81,118,121],thread:[1,4],three:[1,2,28,29,32,35,36,37,40,41,43,44,50,62,63,64,69,70,75,78,80,86,87,89,93,94,97,111,112,114,117,118,121,134,135,136,137,142,144,145,147,148,154,155,156,157,158],threebodi:154,thresh:[19,57,61],threshhold:[19,57,61],threshold:[19,61,71],through:[2,3,44,63,66,68,69,72,75,80,81,82,94,110,112,113,115,118,122,137,141,146,147,149,153],throughout:[2,4,40,137],thru:[2,3,33,34,37,91],thrust:1,thu:[1,2,3,19,29,30,34,35,36,38,41,42,44,45,56,57,59,60,61,62,63,64,67,69,70,71,76,77,80,81,82,83,91,92,93,94,96,97,98,99,100,101,102,103,104,105,109,110,111,112,113,114,115,116,117,118,122,126,130,131,132,134,135,136,137,139,140,141,143,144,145,147,148,150,151,152,153,154,155,156,157,158,161,162],thumb:[44,103],ti2:43,ti3:43,ti4:43,tidi:163,tight:[97,147],tij:108,tildeslei:[13,32,108],tile:[2,19,44,61],tilt:[2,63,69,71,73,158,162],time:[0,1],time_integr:58,timeout:162,timer:[1,162],timeremain:162,timescal:[59,60,73,113],timespan:69,timestep:[1,2,3,19,35,42,57,59,60,61,62,63,64,67,68,69,70,71,74,75,76,78,79,80,81,91,92,97,109,113,120,131,132,149,162],timesteppnig:76,tin:[104,105],tini:[44,91,97],tio2:147,tio:147,tip3p:0,tip4:2,tip4p:0,tip:0,tirrel:81,titl:[60,163],title1:60,title2:60,title3:60,tji:108,tl1:43,tl3:43,tlbr_msw:144,tloop:[69,70],tm3:43,tmp:[2,19,34,57,60,61],tobia:69,togeth:[2,3,4,19,42,44,60,61,63,69,116],tol:[76,154],toler:[63,75,76,91,92,154],tolernac:75,too:[1,2,19,29,30,36,38,41,57,61,63,64,69,76,80,92,109],took:149,tool:[0,1,2,3,19,57,61,92],toolkit:2,top:[0,3,4,68,92,148,163],topolog:[2,32,56],torqu:[2,13,68,91,96,108,117,118,132],torsion:[2,46,56,94],torsion_flag:94,tosi:98,tot:147,total:[2,3,4,19,31,33,34,35,37,41,42,60,61,67,68,69,70,72,73,74,75,78,79,80,81,82,91,92,93,94,96,97,104,111,113,118,134,135,136,137,144,147,148,162],toukmaji:108,toward:[13,57,68,70,71,89,92],toxvaerd:127,tpcpu:162,tptask:4,trace:113,track:[68,80,162],track_displac:58,tractabl:75,trade:[2,105,122,126],tradit:[2,55],trail:[32,59,60,92,114,134,148,162],trajectori:[2,32,69,72,76,109],tran:[49,50],transfer:[1,2,4,58,80,97,137],transform:[2,32,117,139],transit:[2,4,92,106,130,136,137,157],translat:[2,60,64,69,72,113,162],transmit:2,transport:[58,80],trap:[2,35],treat:[2,42,60,80,82,91,96,107,113,114,117,120,135,136,137,145],treatment:107,tree:130,tri:[2,3,57,63,69,70,91],triangl:[2,57],triangul:2,triangular:[2,63],triclin:[0,1],triflag:2,trigger:[3,61,62,91,162],trigon:9,trilinear:68,tringl:57,tripl:[41,97],triplet:[112,142,144,154,155,156,157,158],trivial:3,trott:[41,148],troubl:3,truncat:[2,64,75,81,82,95,105,113,118,122,124,127,147],tscale:73,tsige:100,tstart:[67,69,109],tstat:[2,67],tstop:[67,69,109],tsuzuki:[30,158],ttm_mod:80,tucker:[41,148],tuckerman:[69,72],tune:[2,4],tunnel:72,turkand:38,turn:[2,28,41,43,56,57,62,63,69,91,92,94,107,120,134,153,162],tutein:94,tutori:[2,71],tweak:44,twice:[2,4,45,63,69],twist:[131,132],two:[1,2,3,4,19,28,29,32,36,40,41,43,44,55,57,59,60,61,62,63,67,68,69,70,71,72,73,79,80,82,90,91,92,93,94,96,97,98,99,100,103,104,105,107,108,109,111,112,113,114,115,117,118,121,122,126,130,131,132,134,137,141,143,144,145,147,148,149,153,154,155,156,157,158,160,161,162],two_temperatur:58,twobodi:[155,157,158],twojmax:[41,148],txt:[80,121,147,163],typcial:[19,61],type1:[40,43],type2:[40,43],type:[2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,20,21,22,23,24,25,26,27,28,32,35,40,41,43,44,45,46,47,48,49,50,51,52,53,54,55,57,58,68,76,82,83,84,85,86,87,88,89,90,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,108,109,110,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,163],typen:[40,43],typic:[1,2,3,4,13,19,21,22,29,32,44,55,57,58,60,61,62,63,69,74,76,91,92,101,103,105,116,117,120,121,122,126,131,132,134,145,157,163],tzou:80,u_chem:31,u_cond:[31,65],u_f:68,u_i:[65,66],u_ij:144,u_j:66,u_mech:[31,65],u_prom:97,uberuaga:92,ubiquit:[3,97],uchem:[115,141],uloop:[72,92],umbrella:2,umin:[10,11,24,25,47],unabl:[3,19,61],unaffect:[63,69],unambigu:158,unbias:113,unchang:[63,69],uncom:1,uncompress:57,uncorrel:67,uncoupl:72,under:[0,2,4,6,41,46,57,69,73,83,110,113,130,148],underflow:57,undergo:[2,32,67,69],undergon:62,underli:[2,29,57,69,80],underpredict:2,underscor:[62,63,69,70],understand:[1,2,137],understood:97,undesir:[63,69],undisturb:[131,132],undump:57,unfix:[2,35,58,60,74,78],unfix_flux:58,unfold:77,uniaxi:70,uniform:[4,19,58,61,68,117,145],uniformli:[68,80,140,141,144],uninterrupt:[69,70,73,79,80],union:[2,82],uniqu:[2,67,70,92,111,113],unit:[2,5,6,16,17,18,29,30,31,32,33,34,35,36,37,39,40,41,42,43,44,46,57,60,62,63,64,65,66,67,68,69,70,71,72,73,74,75,77,79,80,81,82,83,84,88,89,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],uniti:112,unitless:[29,60,69,73,75,91,118,139,143,154,155,156,157,158],univers:[2,32,92,131,136,157],unknown:30,unless:[3,4,40,43,44,63,69,91,103],unlik:[33,44,93,97,111,114,134,135,136,148],unlike:[69,70,111,120,121,135,136],unlimit:144,unnecessari:4,unoccupi:80,unoptim:57,unpack:[0,3],unperturb:32,unphys:[2,69],unpublish:137,unrel:[45,163],unrestrain:74,unset:113,unshift:108,unsmooth:128,unsolv:101,unstabl:68,unstag:163,until:[2,19,57,61,63,66,78,97,118,140,141],unus:97,unwant:44,unwrap:[33,34,42,59,62],up_intern:57,updat:[0,2,4,67,68,69,73,80,97,108,137],upenn:3,upon:[2,75,97],upper:[19,37,61,63,68,69,73,81,91,118,147],uppercas:0,upsid:2,upsilon:117,upstream:163,urbana:131,urey_bradlei:5,url:163,usabl:111,usag:[2,71,130],use:[2,57,59,60,80,117,134,145,147,163],useful:137,user:[0,1,2,3],user_manifold:163,user_misc:[14,15,17,48,52,54,55,87],usernam:163,using:[0,1],usr:3,usual:[2,8,12,16,17,18,23,32,53,55,57,60,62,63,70,73,74,80,81,82,88,92,101,103,106,108,117,121,130,131,132,142,148,153,154,162],util:117,v11:2,v22:2,v33:2,v_0:80,v_2:137,v_3:137,v_4:137,v_abc:162,v_delta:32,v_dhug:73,v_drai:73,v_e_hbond:120,v_ij:144,v_jx:35,v_jy:35,v_jz:35,v_k11:35,v_k22:35,v_k33:35,v_lgr_po:73,v_lgr_vel:73,v_linear:81,v_lj:94,v_mu:131,v_n:[68,137],v_name:[2,32,57,59,60,81,162],v_occ:116,v_prefactor:149,v_press:42,v_pxy:2,v_pxz:2,v_pyz:2,v_ramp:81,v_rebo:94,v_t_qm:73,v_torsion:94,v_v11:2,v_v22:2,v_v33:2,v_valu:57,v_wiggl:81,v_x:[44,81],v_xave:2,v_xmax:2,v_xx:44,v_y:44,v_yi:44,vacanc:[78,137],vacf:2,vacuum:[80,106,157,161],valanc:97,valenc:[97,113],valent:97,valid:[2,3,40,43,63,71,111,113,117,137,144],valon:134,value1:[59,60,70],value2:[59,60,70],van:[27,32,103,104,130,134,160],vanadium:137,vanderwa:162,vanilla:2,vanish:76,vapor:[19,61],vare:80,vari:[1,19,32,40,43,58,60,61,63,69,74,80,81,101,109,110,119,128,131,149],variabl:0,varianc:109,variant:[1,2,69,70,118,135,136,139,155,157],variat:[19,61],varieti:[1,2,57,134,158],variou:0,varshalovich:41,vashishta1990:158,vashishta2007:158,vbia:2,vcm:2,vdisplac:81,vdw:104,vec:71,vector:1,vel:[2,60,109,110,113,118],veld:[100,126],veloc:[2,35,39,42,44,57,59,60,63,64,68,69,70,71,72,73,74,76,79,80,81,91,92,109,113,118,131,132,162],velocit:[109,110,113,118],velocity_bottom:68,velocity_top:68,verbos:147,veri:[1,2,19,32,57,59,60,61,63,69,72,76,92,113,118,131,132,140,141,148,149,162,163],verifi:163,verlet:[1,4,58,64,69,72,76,80],versa:[2,62],versu:[2,19,61,76,100,108,118,126,162],vertic:[4,19,57,61],via:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,32,35,39,42,44,45,46,47,48,49,50,51,52,53,54,55,56,57,59,60,61,62,63,68,69,70,72,74,76,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,143,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],vibrat:[2,71,73,89,113],vice:[2,62],video:57,view:[2,57,97,113,114,147],viewer:57,viewpoint:57,vij:109,vim:0,virial:[35,39,41,42,63,69,70,76,109,110,113],virtual:[2,154],viscoelast:118,viscos:0,viscosity:2,viscou:[2,67,68,91,92],vision:147,visual:0,viz:3,viz_tool:3,vizplotgui_tool:3,vmax:63,vmd:[2,3],voigt:[2,41],vol:[2,35,42,134,157,162],volpress:137,volum:[2,19,32,35,39,40,42,43,44,60,61,63,65,68,69,70,73,80,81,82,131,132,137,151,152,161,162],voronoi:42,voter:[135,136],voth:72,vri:119,vstream:2,vtk:[2,40],w_1:41,w_2:41,w_i:41,w_ik:144,waal:[32,103,104,130,160],wadlei:97,wagner:[58,68,134],wai:[1,2,3,29,32,34,35,36,38,41,42,44,57,60,62,63,67,68,69,70,72,80,81,84,85,86,88,89,91,92,93,94,105,106,109,111,112,114,117,120,122,134,135,136,142,144,145,147,148,149,153,154,155,157,158,163],wait:[1,4],walk:[67,69],wall:0,wallhi:81,wang:[134,144],want:[0,1,2,3,31,34,39,42,44,57,59,60,61,62,71,74,79,81,82,92,93,94,97,103,104,109,111,114,134,140,141,142,144,147,149,154,155,157,158,162,163],ward:97,warm:[4,113],warmup:4,warn:[0,21,22,30,57,69,70,75,131,132,134,140,141,163],warner:93,warning:134,warp:134,warren:[109,140,141],watanab:[78,79],watch:92,water:0,watkin:53,wave:113,wavefunct:113,wavelength:[40,43],wavepacket:113,weak:36,web:1,webb:58,weber:[112,136,144,154,158],weight:[2,32,41,43,45,56,67,68,75,107,109,110,115,134,140,141,148],well:[1,2,3,11,26,36,38,39,42,44,47,57,60,61,63,68,69,70,75,79,91,92,96,116,117,120,131,132,134,137,145,149,155,156,157,163],went:3,were:[2,3,4,19,29,38,39,44,57,60,61,94,113,118,121,162,163],westview:160,what:[0,1,2,3,44,57,59,60,61,62,66,69,72,74,76,81,91,92,134,140,141,149,153,163],whatev:[57,63,69,91,92,102,103,137],whelan:43,when:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,36,37,38,39,44,45,46,47,48,49,50,51,52,53,54,56,57,59,60,61,62,63,68,69,70,71,73,74,75,76,77,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,98,99,100,101,102,103,104,105,107,108,109,111,112,113,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,132,134,135,136,137,139,140,141,142,143,144,145,146,148,149,153,154,155,156,157,158,159,160,161,162,163],whenev:[0,55,59,120],where:[1,2,3,4,6,7,8,9,10,11,12,13,16,17,18,19,20,23,24,25,26,29,30,31,32,33,34,36,39,40,42,43,46,47,56,57,60,61,62,63,64,65,66,67,68,69,70,71,72,73,75,76,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,96,97,98,99,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,122,126,131,132,133,134,135,136,137,141,142,143,144,145,147,148,150,151,152,153,154,155,156,157,158,160,161,162],wherea:[2,3,36,67,69,80],whether:[2,3,28,29,57,60,62,63,69,70,76,99,101,104,119,121,131,132,134,147],which:[0,1,2,3,4,5,6,7,8,9,12,13,16,19,21,22,23,26,27,28,29,30,31,32,33,34,35,37,38,39,41,42,43,44,45,46,49,50,51,53,56,57,59,60,61,62,63,64,66,67,68,69,70,71,72,73,74,76,77,78,79,80,81,82,83,85,88,90,91,92,93,94,96,97,98,99,100,101,103,104,105,106,107,108,109,111,112,113,114,115,116,117,118,119,120,121,122,124,125,126,128,130,131,132,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,153,154,155,156,157,158,160,162,163],white:[67,80],who:[0,2,93,111],whole:75,whose:[2,32,57,66,69,71,74,75,76,82,92,113,115,124,140,141,154,155,157],why:[2,163],wicaksono1:71,wicaksono2:71,wicaksono:71,wide:[1,2,101,103,113],width:[57,116],wiggl:81,wigner:41,wih:2,wikipedia:2,wild:[32,120],wildcard:[57,59,60,153,162],wildli:69,window:[57,60,163],wire:74,wirnsberg:[2,64],wisdom:163,wise:[109,154],wish:[2,3,42,45,59,60,68,76,81,92,99,120,134,140,141,162],within:[1,2,3,4,13,19,29,30,36,38,39,41,44,57,59,60,61,62,66,71,75,76,80,81,82,91,92,96,98,99,105,110,111,112,113,115,116,121,122,134,137,141,143,145,146,154,155,156,157,158],without:[1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,32,39,45,46,47,48,49,50,51,52,53,54,57,60,63,66,67,69,70,75,76,83,84,85,87,88,89,90,92,93,94,95,98,99,100,101,102,103,104,105,108,109,111,112,113,114,115,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,137,139,140,141,142,143,145,146,149,154,155,156,157,158,159,160,161,162,163],won:132,wong:[58,97],word:[2,13,59,60,74,103],work:[1,2,3,4,28,40,43,57,60,62,68,69,74,76,79,104,107,109,131,132,134,137,147],worker:158,workflow:163,world:[41,92],worlei:109,worst:82,worth:[60,73],would:[1,2,3,4,13,19,29,33,35,42,44,45,56,57,60,61,62,64,69,71,72,75,83,84,85,86,88,91,92,93,94,97,103,104,105,109,110,111,112,114,134,135,136,137,142,144,148,153,154,155,156,157,158,162,163],wrap:[1,2,3,44,59,68,81,82,92],wrapper:[0,2],wright:91,write_atom_weight:58,write_restart:[58,68],written:[2,41,57,58,59,60,61,62,63,64,67,68,71,73,74,76,77,78,80,81,82,111,133,137,160,163],wrong:[3,63,69,81,82],www:[0,2,3,93,111,131],x200:4,x86:137,x_ij:144,x_ijkl:83,x_kjli:83,x_ljik:83,xave:2,xavx:4,xcore:4,xeon:[1,4],xhi:[2,81,162],xhi_bound:2,xhost:4,xi_ij:144,xiaowang:[114,155,157],xiij:71,xlat:[44,162],xlo:[2,3,81,162],xlo_bound:2,xmax:2,xmgrace:0,xmic:4,xmovi:[0,2],xmu:118,xpo:44,xrd:40,xtc:[2,57],xyz:[2,44,57,63,69,70],xzhou:114,yamada:4,yang:[137,144],yate:137,yb2:43,yb3:43,yellow:57,yet:[4,57,81,91,102,103,104,113,160,163],yhi:[2,81,162],yhi_bound:2,yield:[2,35,42,63,69,75,96,109,118,162],yip:78,ylat:[44,162],ylo:[2,81,162],ylo_bound:2,york:72,yoshida:69,you:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,30,31,32,33,34,35,36,38,39,41,42,44,45,46,47,48,49,50,51,52,53,54,56,57,59,60,61,62,63,64,67,69,70,72,74,76,78,79,80,81,82,83,84,85,87,88,89,90,91,92,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,113,114,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,134,135,136,137,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],young:118,your:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,39,44,45,46,47,48,49,50,51,52,53,54,57,58,62,63,69,70,76,80,81,82,83,84,85,87,88,89,90,92,93,94,95,97,98,99,100,101,102,103,104,105,108,109,111,112,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,134,135,136,137,139,142,143,144,145,146,149,153,154,155,156,157,158,159,160,161,162,163],yourself:[2,63,163],ypo:44,yukawa:103,z_i:[113,157,161],z_j:[157,161],z_meam:134,zannoni:117,zbl:[134,148],zblcut:157,zblcutinn:148,zblcutout:148,zblexpscal:157,zblz:148,zero:[2,3,10,11,19,24,25,29,32,34,36,37,38,39,40,41,42,43,44,45,47,54,56,57,59,60,61,63,64,67,68,69,70,72,73,75,76,79,80,81,87,91,92,97,98,99,100,101,103,105,108,109,110,113,117,119,120,122,124,126,127,130,132,133,134,137,139,145,146,147,153,158,161,162],zeta:[68,114],zfactor:57,zhang:118,zhi:[2,81,162],zhi_bound:2,zhou:[97,114,144,155,157],zhu:152,ziegler:[134,157,161],zimmerman2004:58,zimmerman2010:58,zimmerman:[29,58,97],zlat:162,zlim:147,zlo:[2,81,162],zlo_bound:2,zmax:68,zmin:68,zn2:43,zone:40,zoom:57,zr4:43,zwall:81,zwall_veloc:68},titles:["LAMMPS Documentation","5. Accelerating LAMMPS performance","6. How-to discussions","11. Python interface to LAMMPS","5.USER-INTEL package","angle_style charmm command","angle_style class2 command","angle_style cosine command","angle_style cosine/delta command","angle_style cosine/periodic command","angle_style cosine/shift command","angle_style cosine/shift/exp command","angle_style cosine/squared command","angle_style dipole command","angle_style fourier command","angle_style fourier/simple command","angle_style harmonic command","angle_style quartic command","angle_style sdk command","balance command","bond_style class2 command","bond_style fene command","bond_style fene/expand command","bond_style harmonic command","bond_style harmonic/shift command","bond_style harmonic/shift/cut command","bond_style morse command","bond_style nonlinear command","bond_style quartic command","compute centro/atom command","compute cna/atom command","compute dpd command","compute fep command","compute gyration command","compute gyration/chunk command","compute heat/flux command","compute hexorder/atom command","compute msd/nongauss command","compute orientorder/atom command","compute pressure command","compute saed command","compute sna/atom command","compute stress/atom command","compute xrd command","create_atoms command","dihedral_style charmm command","dihedral_style class2 command","dihedral_style cosine/shift/exp command","dihedral_style fourier command","dihedral_style harmonic command","dihedral_style helix command","dihedral_style multi/harmonic command","dihedral_style nharmonic command","dihedral_style opls command","dihedral_style quadratic command","dihedral_style spherical command","dihedral_style command","dump image command","fix atc command","fix ave/atom command","fix ave/chunk command","fix balance command","fix bond/swap command","fix box/relax command","fix ehex command","fix eos/cv command","fix eos/table/rx command","fix gld command","fix lb/fluid command","fix nvt command","fix nphug command","fix orient/fcc command","fix pimd command","fix qbmsst command","fix restrain command","fix rx command","fix shake command","fix spring/rg command","fix ti/rs command","fix ti/spring command","fix ttm command","fix wall/lj93 command","fix wall/region command","improper_style class2 command","improper_style cossq command","improper_style cvff command","improper_style distance command","improper_style fourier command","improper_style harmonic command","improper_style ring command","improper_style umbrella command","minimize command","neb command","pair_style adp command","pair_style airebo command","pair_style beck command","pair_style body command","pair_style bop command","pair_style born command","pair_style buck command","pair_style buck/long/coul/long command","pair_style lj/charmm/coul/charmm command","pair_style lj/class2 command","pair_style colloid command","pair_style comb command","pair_style coul/cut command","pair_style coul/diel command","pair_style born/coul/long/cs command","pair_style lj/cut/dipole/cut command","pair_style dpd command","pair_style dpd/fdt command","pair_style eam command","pair_style edip command","pair_style eff/cut command","pair_style eim command","pair_style exp6/rx command","pair_style gauss command","pair_style gayberne command","pair_style gran/hooke command","pair_style lj/gromacs command","pair_style hbond/dreiding/lj command","pair_style list command","pair_style lj/cut command","pair_style lj96/cut command","pair_style lj/cubic command","pair_style lj/expand command","pair_style lj/long/coul/long command","pair_style lj/sf command","pair_style lj/smooth command","pair_style lj/smooth/linear command","pair_style lj/cut/soft command","pair_style lubricate command","pair_style lubricateU command","pair_style lj/mdf command","pair_style meam command","pair_style meam/spline","pair_style meam/sw/spline","pair_style mgpt command","pair_style mie/cut command","pair_style morse command","pair_style multi/lucy command","pair_style multi/lucy/rx command","pair_style nb3b/harmonic command","pair_style nm/cut command","pair_style polymorphic command","pair_style resquared command","pair_style lj/sdk command","pair_style smtbq command","pair_style snap command","pair_style soft command","pair_style sph/idealgas command","pair_style sph/taitwater command","pair_style sph/taitwater/morris command","pair_style srp command","pair_style sw command","pair_style tersoff command","pair_style tersoff/mod command","pair_style tersoff/zbl command","pair_style vashishta command","pair_style yukawa command","pair_style yukawa/colloid command","pair_style zbl command","thermo_style command","LAMMPS GitHub tutorial"],titleterms:{"default":[29,32,36,37,38,40,41,43,44,56,57,58,60,63,67,68,69,70,72,73,78,79,81,97,113,131,132,137,153,162],"long":[98,99,100,101,102,105,107,108,122,126,130,143,146],acceler:1,adiabat:2,adp:93,airebo:94,alloi:111,amber:2,angle_styl:[5,6,7,8,9,10,11,12,13,14,15,16,17,18],arrai:2,aspher:2,atc:58,atom:[2,29,30,36,38,41,42,59],balanc:[19,61],barostat:2,bcc:71,beck:95,between:2,bodi:[2,96],bond:62,bond_styl:[20,21,22,23,24,25,26,27,28],bop:97,born:[98,107],box:[2,63],buck:[99,100,107,133],build:3,calcul:2,centro:29,charmm:[2,5,45,101,130],chunk:[2,34,60],class2:[6,20,46,83,102],cna:30,code:2,coeffici:2,colloid:[81,103,160],comb3:104,comb:104,command:[2,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],comparison:1,compos:2,comput:[2,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43],conduct:2,constant:2,core:2,cosin:[7,8,9,10,11,12,47],cossq:84,coul:[98,99,100,101,102,105,106,107,119,122,126,130,143,146],coupl:2,create_atom:44,cubic:124,cut:[25,99,102,105,108,113,116,122,123,130,138,143],cvff:85,data:2,deby:[105,122],delta:8,descript:[5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],diel:106,diffus:2,dihedral_styl:[45,46,47,48,49,50,51,52,53,54,55,56],dipol:[2,13,108],discuss:2,disp:2,distanc:86,document:0,dpd:[31,109,110],dreid:120,dreiding:2,drude:2,dsf:[105,122],dump:[2,57],eam:111,edip:112,eff:113,ehex:64,eim:114,elastic:2,energi:110,exampl:[2,3,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],exp6:115,exp:[11,47],expand:[22,125],extend:3,fcc:71,fdt:110,fene:[21,22],fep:32,field:2,file:2,finit:2,fix:[2,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82],fix_modifi:[58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],flow:2,fluid:68,flux:35,forc:2,fourier:[14,15,48,87],from:[2,3],gauss:116,gaybern:117,gener:[1,2],github:163,gld:67,global:2,gpu:[95,98,99,101,102,103,105,108,109,111,116,117,119,122,123,124,125,138,139,145,146,149,154,155,156,157,159,160,161],gran:118,granular:2,gromac:119,gyrat:[33,34],harmon:[16,23,24,25,49,51,81,88,142],hbond:120,heat:35,helix:50,hertz:118,hexord:36,histori:118,hook:118,how:2,idealga:150,imag:57,implicit:101,improper_styl:[83,84,85,86,87,88,89,90],indice:0,induc:2,info:[0,58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],input:2,install:3,integr:2,intel:[4,5,16,21,23,45,49,53,69,85,88,99,101,117,122,154,155],interfac:[2,3],jul:0,kspace_styl:2,lammps:[0,1,2,3,163],lennard:133,librari:[2,3],linear:[129,139],list:121,lj1043:81,lj126:81,lj93:81,lj96:123,local:2,lubric:131,lubricateu:132,luci:[140,141],mdf:133,meam:[134,135,136],measur:1,mgpt:137,mie:138,minim:[58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82,91],mod:[80,156],model:2,morri:152,mors:[26,94,120,139],movi:57,mpi:3,msd:37,msm:[98,99,101,105,122],multi:[2,51,140,141],multipl:2,nb3b:142,neb:92,nemd:2,nharmon:52,non:2,nongauss:37,nonlinear:27,nph:69,nphug:70,npt:69,nvt:69,omp:[5,6,7,8,9,10,11,12,13,14,15,16,17,20,21,22,23,24,25,26,27,28,45,46,47,48,49,50,51,52,53,54,69,70,83,84,85,87,88,89,90,93,94,95,98,99,100,101,102,103,104,105,106,108,109,111,114,116,117,118,119,120,122,123,124,125,126,127,128,129,130,131,135,136,139,142,143,145,146,149,154,155,156,157,158,159,160,161],opl:53,opt:[101,111,122,126,139],optim:1,option:2,orient:71,orientord:38,orthogon:2,other:2,output:[2,58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],overview:3,packag:[1,4],pair:2,pair_styl:[93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161],parallel:3,paramet:2,particl:2,per:2,perform:1,period:9,pimd:72,polariz:2,poli:[131,132],polymorph:144,potenti:2,pppm:2,pressur:39,process:2,properti:2,python:3,qbmsst:73,quadrat:54,quantiti:2,quartic:[17,28],rattl:76,rebo:94,region:82,relat:[5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,73,75,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],relax:63,replica:2,resquar:145,restart:[2,58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],restrain:74,restrict:[4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],rigid:2,ring:89,run:[2,3,58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],scalar:2,script:[2,3],sdk:[18,146],serial:3,set:2,shake:76,share:3,shell:2,shift:[10,11,24,25,47],simpl:15,simul:2,size:2,smooth:[128,129,139],smtbq:147,sna:41,snad:41,snap:148,snapshot:2,snav:41,soft:[130,139,149],spc:2,sph:[150,151,152],spheric:[2,55],spline:[135,136],spring:[77,79],squar:12,srp:153,start:[58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],stop:[58,59,60,61,63,64,68,69,70,71,73,74,76,77,78,79,80,81,82],strategi:1,streitz:105,stress:42,style:[1,2],summari:2,swap:62,syntax:[5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,62,63,64,65,66,67,68,69,70,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,118,119,120,121,122,123,124,125,126,127,128,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],system:2,tabl:[0,2,66,155],taitwat:[151,152],temperatur:2,tersoff:[155,156,157],test:3,thermal:2,thermo:2,thermo_styl:162,thermodynam:2,thermostat:2,time:2,tip3p:2,tip4p:[2,105,122,126,130],triclin:2,tstat:109,ttm:80,tutori:163,umbrella:90,user:4,using:[2,3],valu:2,variabl:2,variou:1,vashishta:158,vector:2,version:0,viscos:2,visual:2,wall:[2,81,82],water:2,wolf:[98,105],wrapper:3,write:2,xrd:43,yukawa:[159,160],zbl:[157,161]}})
\ No newline at end of file
diff --git a/doc/src/fix_ave_chunk.txt b/doc/src/fix_ave_chunk.txt
index 65cd27c2f..796cf5e33 100644
--- a/doc/src/fix_ave_chunk.txt
+++ b/doc/src/fix_ave_chunk.txt
@@ -1,478 +1,478 @@
 "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c
 
 :link(lws,http://lammps.sandia.gov)
 :link(ld,Manual.html)
 :link(lc,Section_commands.html#comm)
 
 :line
 
 fix ave/chunk command :h3
 
 [Syntax:]
 
 fix ID group-ID ave/chunk Nevery Nrepeat Nfreq chunkID value1 value2 ... keyword args ... :pre
 
 ID, group-ID are documented in "fix"_fix.html command :ulb,l
 ave/chunk = style name of this fix command :l
 Nevery = use input values every this many timesteps :l
 Nrepeat = # of times to use input values for calculating averages :l
 Nfreq = calculate averages every this many timesteps :l
 chunkID = ID of "compute chunk/atom"_compute_chunk_atom.html command :l
 one or more input values can be listed :l
 value = vx, vy, vz, fx, fy, fz, density/mass, density/number, temp, c_ID, c_ID\[I\], f_ID, f_ID\[I\], v_name :l
   vx,vy,vz,fx,fy,fz = atom attribute (velocity, force component)
   density/number, density/mass = number or mass density
   temp = temperature
   c_ID = per-atom vector calculated by a compute with ID
   c_ID\[I\] = Ith column of per-atom array calculated by a compute with ID, I can include wildcard (see below)
   f_ID = per-atom vector calculated by a fix with ID
   f_ID\[I\] = Ith column of per-atom array calculated by a fix with ID, I can include wildcard (see below)
   v_name = per-atom vector calculated by an atom-style variable with name :pre
 
 zero or more keyword/arg pairs may be appended :l
 keyword = {norm} or {ave} or {bias} or {adof} or {cdof} or {file} or {overwrite} or {title1} or {title2} or {title3} :l
   {norm} arg = {all} or {sample} or {none} = how output on {Nfreq} steps is normalized
     all = output is sum of atoms across all {Nrepeat} samples, divided by atom count
     sample = output is sum of {Nrepeat} sample averages, divided by {Nrepeat}
     none = output is sum of {Nrepeat} sample sums, divided by {Nrepeat}
   {ave} args = {one} or {running} or {window M}
     one = output new average value every Nfreq steps
     running = output cumulative average of all previous Nfreq steps
     window M = output average of M most recent Nfreq steps
   {bias} arg = bias-ID
     bias-ID = ID of a temperature compute that removes a velocity bias for temperature calculation
   {adof} value = dof_per_atom
     dof_per_atom = define this many degrees-of-freedom per atom for temperature calculation
   {cdof} value = dof_per_chunk
     dof_per_chunk = define this many degrees-of-freedom per chunk for temperature calculation
   {file} arg = filename
     filename = file to write results to
   {overwrite} arg = none = overwrite output file with only latest output
   {format} arg = string
     string = C-style format string
   {title1} arg = string
     string = text to print as 1st line of output file
   {title2} arg = string
     string = text to print as 2nd line of output file
   {title3} arg = string
     string = text to print as 3rd line of output file :pre
 :ule
 
 [Examples:]
 
 fix 1 all ave/chunk 10000 1 10000 binchunk c_myCentro title1 "My output values"
 fix 1 flow ave/chunk 100 10 1000 molchunk vx vz norm sample file vel.profile
 fix 1 flow ave/chunk 100 5 1000 binchunk density/mass ave running
 fix 1 flow ave/chunk 100 5 1000 binchunk density/mass ave running :pre
 
 [NOTE:]
 
 If you are trying to replace a deprectated fix ave/spatial command
 with the newer, more flexible fix ave/chunk and "compute
 chunk/atom"_compute_chunk_atom.html commands, you simply need to split
 the fix ave/spatial arguments across the two new commands.  For
 example, this command:
 
 fix 1 flow ave/spatial 100 10 1000 y 0.0 1.0 vx vz norm sample file vel.profile :pre
 
 could be replaced by:
 
 compute cc1 flow chunk/atom bin/1d y 0.0 1.0 
 fix 1 flow ave/chunk 100 10 1000 cc1 vx vz norm sample file vel.profile :pre
 
 [Description:]
 
 Use one or more per-atom vectors as inputs every few timesteps, sum
 the values over the atoms in each chunk at each timestep, then average
 the per-chunk values over longer timescales.  The resulting chunk
 averages can be used by other "output
 commands"_Section_howto.html#howto_15 such as "thermo_style
 custom"_thermo_style.html, and can also be written to a file.
 
 In LAMMPS, chunks are collections of atoms defined by a "compute
 chunk/atom"_compute_chunk_atom.html command, which assigns each atom
 to a single chunk (or no chunk).  The ID for this command is specified
 as chunkID.  For example, a single chunk could be the atoms in a
 molecule or atoms in a spatial bin.  See the "compute
 chunk/atom"_compute_chunk_atom.html doc page and ""Section_howto
 23"_Section_howto.html#howto_23 for details of how chunks can be
 defined and examples of how they can be used to measure properties of
 a system.
 
 Note that only atoms in the specified group contribute to the summing
 and averaging calculations.  The "compute
 chunk/atom"_compute_chunk_atom.html command defines its own group as
 well as an optional region.  Atoms will have a chunk ID = 0, meaning
 they belong to no chunk, if they are not in that group or region.
 Thus you can specify the "all" group for this command if you simply
 want to use the chunk definitions provided by chunkID.
 
 Each specified per-atom value can be an atom attribute (position,
 velocity, force component), a mass or number density, or the result of
 a "compute"_compute.html or "fix"_fix.html or the evaluation of an
 atom-style "variable"_variable.html.  In the latter cases, the
 compute, fix, or variable must produce a per-atom quantity, not a
 global quantity.  Note that the "compute
 property/atom"_compute_property_atom.html command provides access to
 any attribute defined and stored by atoms.  If you wish to
 time-average global quantities from a compute, fix, or variable, then
 see the "fix ave/time"_fix_ave_time.html command.
 
 The per-atom values of each input vector are summed and averaged
 independently of the per-atom values in other input vectors.
 
 "Computes"_compute.html that produce per-atom quantities are those
 which have the word {atom} in their style name.  See the doc pages for
 individual "fixes"_fix.html to determine which ones produce per-atom
 quantities.  "Variables"_variable.html of style {atom} are the only
 ones that can be used with this fix since all other styles of variable
 produce global quantities.
 
 Note that for values from a compute or fix, the bracketed index I can
 be specified using a wildcard asterisk with the index to effectively
 specify multiple values.  This takes the form "*" or "*n" or "n*" or
 "m*n".  If N = the size of the vector (for {mode} = scalar) or the
 number of columns in the array (for {mode} = vector), then an asterisk
 with no numeric values means all indices from 1 to N.  A leading
 asterisk means all indices from 1 to n (inclusive).  A trailing
 asterisk means all indices from n to N (inclusive).  A middle asterisk
 means all indices from m to n (inclusive).
 
-Using a wildcard is the same as if the individual elements of the
-vector or columns of the array had been listed one by one.  E.g. these
-2 fix ave/chunk commands are equivalent, since the "compute
+Using a wildcard is the same as if the individual columns of the array
+had been listed one by one.  E.g. these 2 fix ave/chunk commands are
+equivalent, since the "compute
 property/atom"_compute_property/atom.html command creates, in this
 case, a per-atom array with 3 columns:
 
-compute myAng all property/atom 50 angmomx angmomy angmomz
+compute myAng all property/atom angmomx angmomy angmomz
 fix 1 all ave/chunk 100 1 100 cc1 c_myAng\[*\] file tmp.angmom
 fix 2 all ave/chunk 100 1 100 cc1 c_myAng\[1\] c_myAng\[2\] c_myAng\[3\] file tmp.angmom :pre
 
 NOTE: This fix works by creating an array of size {Nchunk} by Nvalues
 on each processor.  {Nchunk} is the number of chunks which is defined
 by the "compute chunk/atom"_doc/compute_chunk_atom.html command.
 Nvalues is the number of input values specified.  Each processor loops
 over its atoms, tallying its values to the appropriate chunk.  Then
 the entire array is summed across all processors.  This means that
 using a large number of chunks will incur an overhead in memory and
 computational cost (summing across processors), so be careful to
 define a reasonable number of chunks.
 
 :line
 
 The {Nevery}, {Nrepeat}, and {Nfreq} arguments specify on what
 timesteps the input values will be accessed and contribute to the
 average.  The final averaged quantities are generated on timesteps
 that are a multiples of {Nfreq}.  The average is over {Nrepeat}
 quantities, computed in the preceding portion of the simulation every
 {Nevery} timesteps.  {Nfreq} must be a multiple of {Nevery} and
 {Nevery} must be non-zero even if {Nrepeat} is 1.  Also, the timesteps
 contributing to the average value cannot overlap, i.e. Nrepeat*Nevery
 can not exceed Nfreq.
 
 For example, if Nevery=2, Nrepeat=6, and Nfreq=100, then values on
 timesteps 90,92,94,96,98,100 will be used to compute the final average
 on timestep 100.  Similarly for timesteps 190,192,194,196,198,200 on
 timestep 200, etc.  If Nrepeat=1 and Nfreq = 100, then no time
 averaging is done; values are simply generated on timesteps
 100,200,etc.
 
 Each input value can also be averaged over the atoms in each chunk.
 The way the averaging is done across the {Nrepeat} timesteps to
 produce output on the {Nfreq} timesteps, and across multiple {Nfreq}
 outputs, is determined by the {norm} and {ave} keyword settings, as
 discussed below.
 
 NOTE: To perform per-chunk averaging within a {Nfreq} time window, the
 number of chunks {Nchunk} defined by the "compute
 chunk/atom"_compute_chunk_atom.html command must remain constant.  If
 the {ave} keyword is set to {running} or {window} then {Nchunk} must
 remain constant for the duration of the simulation.  This fix forces
 the chunk/atom compute specified by chunkID to hold {Nchunk} constant
 for the appropriate time windows, by not allowing it to re-calcualte
 {Nchunk}, which can also affect how it assigns chunk IDs to atoms.
 More details are given on the "compute
 chunk/atom"_compute_chunk_atom.html doc page.
 
 :line
 
 The atom attribute values (vx,vy,vz,fx,fy,fz) are self-explanatory.
 As noted above, any other atom attributes can be used as input values
 to this fix by using the "compute
 property/atom"_compute_property_atom.html command and then specifying
 an input value from that compute.
 
 The {density/number} value means the number density is computed for
 each chunk, i.e. number/volume.  The {density/mass} value means the
 mass density is computed for each chunk, i.e. total-mass/volume.  The
 output values are in units of 1/volume or density (mass/volume).  See
 the "units"_units.html command doc page for the definition of density
 for each choice of units, e.g. gram/cm^3.  If the chunks defined by
 the "compute chunk/atom"_compute_chunk_atom.html command are spatial
 bins, the volume is the bin volume.  Otherwise it is the volume of the
 entire simulation box.
 
 The {temp} value means the temperature is computed for each chunk, by
 the formula KE = DOF/2 k T, where KE = total kinetic energy of the
 chunk of atoms (sum of 1/2 m v^2), DOF = the total number of degrees
 of freedom for all atoms in the chunk, k = Boltzmann constant, and T =
 temperature.
 
 The DOF is calculated as N*adof + cdof, where N = number of atoms in
 the chunk, adof = degrees of freedom per atom, and cdof = degrees of
 freedom per chunk.  By default adof = 2 or 3 = dimensionality of
 system, as set via the "dimension"_dimension.html command, and cdof =
 0.0.  This gives the usual formula for temperature.
 
 Note that currently this temperature only includes translational
 degrees of freedom for each atom.  No rotational degrees of freedom
 are included for finite-size particles.  Also no degrees of freedom
 are subtracted for any velocity bias or constraints that are applied,
 such as "compute temp/partial"_compute_temp_partial.html, or "fix
 shake"_fix_shake.html or "fix rigid"_fix_rigid.html.  This is because
 those degrees of freedom (e.g. a constrained bond) could apply to sets
 of atoms that are both included and excluded from a specific chunk,
 and hence the concept is somewhat ill-defined.  In some cases, you can
 use the {adof} and {cdof} keywords to adjust the calculated degress of
 freedom appropriately, as explained below.
 
 Also note that a bias can be subtracted from atom velocities before
 they are used in the above formula for KE, by using the {bias}
 keyword.  This allows, for example, a thermal temperature to be
 computed after removal of a flow velocity profile.
 
 Note that the per-chunk temperature calculated by this fix and the
 "compute temp/chunk"_compute_temp_chunk.html command can be different.
 The compute calculates the temperature for each chunk for a single
 snapshot.  This fix can do that but can also time average those values
 over many snapshots, or it can compute a temperature as if the atoms
 in the chunk on different timesteps were collected together as one set
 of atoms to calculate their temperature.  The compute allows the
 center-of-mass velocity of each chunk to be subtracted before
 calculating the temperature; this fix does not.
 
 If a value begins with "c_", a compute ID must follow which has been
 previously defined in the input script.  If no bracketed integer is
 appended, the per-atom vector calculated by the compute is used.  If a
 bracketed integer is appended, the Ith column of the per-atom array
 calculated by the compute is used.  Users can also write code for
 their own compute styles and "add them to LAMMPS"_Section_modify.html.
 See the discussion above for how I can be specified with a wildcard
 asterisk to effectively specify multiple values.
 
 If a value begins with "f_", a fix ID must follow which has been
 previously defined in the input script.  If no bracketed integer is
 appended, the per-atom vector calculated by the fix is used.  If a
 bracketed integer is appended, the Ith column of the per-atom array
 calculated by the fix is used.  Note that some fixes only produce
 their values on certain timesteps, which must be compatible with
 {Nevery}, else an error results.  Users can also write code for their
 own fix styles and "add them to LAMMPS"_Section_modify.html.  See the
 discussion above for how I can be specified with a wildcard asterisk
 to effectively specify multiple values.
 
 If a value begins with "v_", a variable name must follow which has
 been previously defined in the input script.  Variables of style
 {atom} can reference thermodynamic keywords and various per-atom
 attributes, or invoke other computes, fixes, or variables when they
 are evaluated, so this is a very general means of generating per-atom
 quantities to average within chunks.
 
 :line
 
 Additional optional keywords also affect the operation of this fix
 and its outputs.
 
 The {norm} keyword affects how averaging is done for the per-chunk
 values that are output every {Nfreq} timesteps.
 
 It the {norm} setting is {all}, which is the default, a chunk value is
 summed over all atoms in all {Nrepeat} samples, as is the count of
 atoms in the chunk.  The averaged output value for the chunk on the
 {Nfreq} timesteps is Total-sum / Total-count.  In other words it is an
 average over atoms across the entire {Nfreq} timescale.
 
 If the {norm} setting is {sample}, the chunk value is summed over atoms
 for each sample, as is the count, and an "average sample value" is
 computed for each sample, i.e. Sample-sum / Sample-count.  The output
 value for the chunk on the {Nfreq} timesteps is the average of the
 {Nrepeat} "average sample values", i.e. the sum of {Nrepeat} "average
 sample values" divided by {Nrepeat}.  In other words it is an average
 of an average.
 
 If the {norm} setting is {none}, a similar computation as for the
 {sample} seting is done, except the individual "average sample values"
 are "summed sample values".  A summed sample value is simply the chunk
 value summed over atoms in the sample, without dividing by the number
 of atoms in the sample.  The output value for the chunk on the
 {Nfreq} timesteps is the average of the {Nrepeat} "summed sample
 values", i.e. the sum of {Nrepeat} "summed sample values" divided by
 {Nrepeat}.
 
 The {ave} keyword determines how the per-chunk values produced every
 {Nfreq} steps are averaged with values produced on previous steps that
 were multiples of {Nfreq}, before they are accessed by another output
 command or written to a file.
 
 If the {ave} setting is {one}, which is the default, then the chunk
 values produced on timesteps that are multiples of {Nfreq} are
 independent of each other; they are output as-is without further
 averaging.
 
 If the {ave} setting is {running}, then the chunk values produced on
 timesteps that are multiples of {Nfreq} are summed and averaged in a
 cumulative sense before being output.  Each output chunk value is thus
 the average of the chunk value produced on that timestep with all
 preceding values for the same chunk.  This running average begins when
 the fix is defined; it can only be restarted by deleting the fix via
 the "unfix"_unfix.html command, or re-defining the fix by
 re-specifying it.
 
 If the {ave} setting is {window}, then the chunk values produced on
 timesteps that are multiples of {Nfreq} are summed and averaged within
 a moving "window" of time, so that the last M values for the same
 chunk are used to produce the output.  E.g. if M = 3 and Nfreq = 1000,
 then the output on step 10000 will be the average of the individual
 chunk values on steps 8000,9000,10000.  Outputs on early steps will
 average over less than M values if they are not available.
 
 The {bias} keyword specifies the ID of a temperature compute that
 removes a "bias" velocity from each atom, specified as {bias-ID}.  It
 is only used when the {temp} value is calculated, to compute the
 thermal temperature of each chunk after the translational kinetic
 energy components have been altered in a prescribed way, e.g.  to
 remove a flow velocity profile.  See the doc pages for individual
 computes that calculate a temperature to see which ones implement a
 bias.
 
 The {adof} and {cdof} keywords define the values used in the degree of
 freedom (DOF) formula described above for for temperature calculation
 for each chunk.  They are only used when the {temp} value is
 calculated.  They can be used to calculate a more appropriate
 temperature for some kinds of chunks.  Here are 3 examples:
 
 If spatially binned chunks contain some number of water molecules and
 "fix shake"_fix_shake.html is used to make each molecule rigid, then
 you could calculate a temperature with 6 degrees of freedom (DOF) (3
 translational, 3 rotational) per molecule by setting {adof} to 2.0.
 
 If "compute temp/partial"_compute_temp_partial.html is used with the
 {bias} keyword to only allow the x component of velocity to contribute
 to the temperature, then {adof} = 1.0 would be appropriate.
 
 If each chunk consists of a large molecule, with some number of its
 bonds constrained by "fix shake"_fix_shake.html or the entire molecule
 by "fix rigid/small"_fix_rigid.html, {adof} = 0.0 and {cdof} could be
 set to the remaining degrees of freedom for the entire molecule
 (entire chunk in this case), e.g. 6 for 3d, or 3 for 2d, for a rigid
 molecule.
 
 The {file} keyword allows a filename to be specified.  Every {Nfreq}
 timesteps, a section of chunk info will be written to a text file in
 the following format.  A line with the timestep and number of chunks
 is written.  Then one line per chunk is written, containing the chunk
 ID (1-Nchunk), an optional original ID value, optional coordinate
 values for chunks that represent spatial bins, the number of atoms in
 the chunk, and one or more calculated values.  More explanation of the
 optional values is given below.  The number of values in each line
 corresponds to the number of values specified in the fix ave/chunk
 command.  The number of atoms and the value(s) are summed or average
 quantities, as explained above.
 
 The {overwrite} keyword will continuously overwrite the output file
 with the latest output, so that it only contains one timestep worth of
 output.  This option can only be used with the {ave running} setting.
 
 The {format} keyword sets the numeric format of each value when it is
 printed to a file via the {file} keyword.  Note that all values are
 floating point quantities.  The default format is %g.  You can specify
 a higher precision if desired, e.g. %20.16g.
 
 The {title1} and {title2} and {title3} keywords allow specification of
 the strings that will be printed as the first 3 lines of the output
 file, assuming the {file} keyword was used.  LAMMPS uses default
 values for each of these, so they do not need to be specified.
 
 By default, these header lines are as follows:
 
 # Chunk-averaged data for fix ID and group name
 # Timestep Number-of-chunks
 # Chunk (OrigID) (Coord1) (Coord2) (Coord3) Ncount value1 value2 ... :pre
 
 In the first line, ID and name are replaced with the fix-ID and group
 name.  The second line describes the two values that are printed at
 the first of each section of output.  In the third line the values are
 replaced with the appropriate value names, e.g. fx or c_myCompute[2].
 
 The words in parenthesis only appear with corresponding columns if the
 chunk style specified for the "compute
 chunk/atom"_compute_chunk_atom.html command supports them.  The OrigID
 column is only used if the {compress} keyword was set to {yes} for the
 "compute chunk/atom"_compute_chunk_atom.html command.  This means that
 the original chunk IDs (e.g. molecule IDs) will have been compressed
 to remove chunk IDs with no atoms assigned to them.  Thus a compresed
 chunk ID of 3 may correspond to an original chunk ID or molecule ID of
 415.  The OrigID column will list 415 for the 3rd chunk.
 
 The CoordN columns only appear if a {binning} style was used in the
 "compute chunk/atom"_compute_chunk_atom.html command.  For {bin/1d},
 {bin/2d}, and {bin/3d} styles the column values are the center point
 of the bin in the corresponding dimension.  Just Coord1 is used for
 {bin/1d}, Coord2 is added for {bin/2d}, Coord3 is added for {bin/3d}.
 For {bin/sphere}, just Coord1 is used, and it is the radial
 coordinate.  For {bin/cylinder}, Coord1 and Coord2 are used.  Coord1
 is the radial coordinate (away from the cylinder axis), and coord2 is
 the coordinate along the cylinder axis.
 
 Note that if the value of the {units} keyword used in the "compute
 chunk/atom command"_compute_chunk_atom.html is {box} or {lattice}, the
 coordinate values will be in distance "units"_units.html.  If the
 value of the {units} keyword is {reduced}, the coordinate values will
 be in unitless reduced units (0-1).  This is not true for the Coord1 value
 of style {bin/sphere} or {bin/cylinder} which both represent radial
 dimensions.  Those values are always in distance "units"_units.html.
 
 :line
 
 [Restart, fix_modify, output, run start/stop, minimize info:]
 
 No information about this fix is written to "binary restart
 files"_restart.html.  None of the "fix_modify"_fix_modify.html options
 are relevant to this fix.
 
 This fix computes a global array of values which can be accessed by
 various "output commands"_Section_howto.html#howto_15.  The values can
 only be accessed on timesteps that are multiples of {Nfreq} since that
 is when averaging is performed.  The global array has # of rows =
 the number of chunks {Nchunk} as calculated by the specified "compute
 chunk/atom"_compute_chunk_atom.html command.  The # of columns =
 M+1+Nvalues, where M = 1 to 4, depending on whether the optional
 columns for OrigID and CoordN are used, as explained above.
 Following the optional columns, the next column contains the count of
 atoms in the chunk, and the remaining columns are the Nvalue
 quantities.  When the array is accessed with a row I that exceeds the
 current number of chunks, than a 0.0 is returned by the fix instead of
 an error, since the number of chunks can vary as a simulation runs
 depending on how that value is computed by the compute chunk/atom
 command.
 
 The array values calculated by this fix are treated as "intensive",
 since they are typically already normalized by the count of atoms in
 each chunk.
 
 No parameter of this fix can be used with the {start/stop} keywords of
 the "run"_run.html command.  This fix is not invoked during "energy
 minimization"_minimize.html.
 
 [Restrictions:] none
 
 [Related commands:]
 
 "compute"_compute.html, "fix ave/atom"_fix_ave_atom.html, "fix
 ave/histo"_fix_ave_histo.html, "fix ave/time"_fix_ave_time.html,
 "variable"_variable.html, "fix ave/correlate"_fix_ave_correlate.html
 
 [Default:]
 
 The option defaults are norm = all, ave = one, bias = none, no file output, and
 title 1,2,3 = strings as described above.