diff --git a/doc/Manual.pdf b/doc/Manual.pdf index 3798dcd2e..0f5f3497d 100644 Binary files a/doc/Manual.pdf and b/doc/Manual.pdf differ diff --git a/doc/html/Manual.html b/doc/html/Manual.html index 1480a9f0f..ad381570b 100644 --- a/doc/html/Manual.html +++ b/doc/html/Manual.html @@ -1,440 +1,440 @@ LAMMPS-ICMS Documentation — LAMMPS documentation

LAMMPS-ICMS Documentation

-

28 Jul 2016 version

+

30 Jul 2016 version

Version info:

The LAMMPS “version” is the date when it was released, such as 1 May 2010. LAMMPS is updated continuously. Whenever we fix a bug or add a feature, we release it immediately, and post a notice on this page of the WWW site. Each dated copy of LAMMPS contains all the features and bug-fixes up to and including that version date. The version date is printed to the screen and logfile every time you run LAMMPS. It is also in the file src/version.h and in the LAMMPS directory name created when you unpack a tarball, and at the top of the first page of the manual (this page).

LAMMPS-ICMS is an experimental variant of LAMMPS with additional features made available for testing before they will be submitted for inclusion into the official LAMMPS tree. The source code is based on the official LAMMPS svn repository mirror at the Institute for Computational Molecular Science at Temple University and generally kept up-to-date as much as possible. Sometimes, e.g. when additional development work is needed to adapt the upstream changes into LAMMPS-ICMS it can take longer until synchronization; and occasionally, e.g. in case of the rewrite of the multi-threading support, the development will be halted except for important bugfixes until all features of LAMMPS-ICMS fully compatible with the upstream version or replaced by alternate implementations.

  • If you browse the HTML doc pages on the LAMMPS WWW site, they always describe the most current version of upstream LAMMPS, but may be missing some new features in LAMMPS-ICMS.
  • If you browse the HTML doc pages included in your tarball, they describe the version you have, however, not all new features in LAMMPS-ICMS are documented immediately.
  • The PDF file on the WWW site or in the tarball is updated about once per month. This is because it is large, and we don’t want it to be part of every patch.
  • There is also a Developer.pdf file in the doc directory, which describes the internal structure and algorithms of LAMMPS.

LAMMPS stands for Large-scale Atomic/Molecular Massively Parallel Simulator.

LAMMPS is a classical molecular dynamics simulation code designed to run efficiently on parallel computers. It was developed at Sandia National Laboratories, a US Department of Energy facility, with funding from the DOE. It is an open-source code, distributed freely under the terms of the GNU Public License (GPL).

The primary developers of LAMMPS are Steve Plimpton, Aidan Thompson, and Paul Crozier who can be contacted at sjplimp,athomps,pscrozi at sandia.gov. The LAMMPS WWW Site at http://lammps.sandia.gov has more information about the code and its uses.


The LAMMPS documentation is organized into the following sections. If you find errors or omissions in this manual or have suggestions for useful information to add, please send an email to the developers so we can improve the LAMMPS documentation.

Once you are familiar with LAMMPS, you may want to bookmark this page at Section_commands.html#comm since it gives quick access to documentation for all LAMMPS commands.

PDF file of the entire manual, generated by htmldoc

Indices and tables

\ No newline at end of file diff --git a/doc/html/_sources/Manual.txt b/doc/html/_sources/Manual.txt index d93d66dc2..84beb3023 100644 --- a/doc/html/_sources/Manual.txt +++ b/doc/html/_sources/Manual.txt @@ -1,105 +1,105 @@ .. raw:: html

LAMMPS Documentation ==================== -28 Jul 2016 version +30 Jul 2016 version ------------------- Version info: ------------- The LAMMPS "version" is the date when it was released, such as 1 May 2010. LAMMPS is updated continuously. Whenever we fix a bug or add a feature, we release it immediately, and post a notice on `this page of the WWW site `_. Each dated copy of LAMMPS contains all the features and bug-fixes up to and including that version date. The version date is printed to the screen and logfile every time you run LAMMPS. It is also in the file src/version.h and in the LAMMPS directory name created when you unpack a tarball, and at the top of the first page of the manual (this page). * If you browse the HTML doc pages on the LAMMPS WWW site, they always describe the most current version of LAMMPS. * If you browse the HTML doc pages included in your tarball, they describe the version you have. * The `PDF file `_ on the WWW site or in the tarball is updated about once per month. This is because it is large, and we don't want it to be part of every patch. * There is also a `Developer.pdf `_ file in the doc directory, which describes the internal structure and algorithms of LAMMPS. LAMMPS stands for Large-scale Atomic/Molecular Massively Parallel Simulator. LAMMPS is a classical molecular dynamics simulation code designed to run efficiently on parallel computers. It was developed at Sandia National Laboratories, a US Department of Energy facility, with funding from the DOE. It is an open-source code, distributed freely under the terms of the GNU Public License (GPL). The primary developers of LAMMPS are `Steve Plimpton `_, Aidan Thompson, and Paul Crozier who can be contacted at sjplimp,athomps,pscrozi at sandia.gov. The `LAMMPS WWW Site `_ at http://lammps.sandia.gov has more information about the code and its uses. .. _bug: http://lammps.sandia.gov/bug.html .. _sjp: http://www.sandia.gov/~sjplimp ---------- The LAMMPS documentation is organized into the following sections. If you find errors or omissions in this manual or have suggestions for useful information to add, please send an email to the developers so we can improve the LAMMPS documentation. Once you are familiar with LAMMPS, you may want to bookmark :ref:`this page ` at Section_commands.html#comm since it gives quick access to documentation for all LAMMPS commands. `PDF file `_ of the entire manual, generated by `htmldoc `_ .. toctree:: :maxdepth: 2 :numbered: Section_intro Section_start Section_commands Section_packages Section_accelerate Section_howto Section_example Section_perf Section_tools Section_modify Section_python Section_errors Section_history Indices and tables ================== * :ref:`genindex` * :ref:`search` .. raw:: html .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Section_commands.html#comm diff --git a/doc/html/_sources/compute_rigid_local.txt b/doc/html/_sources/compute_rigid_local.txt index 9c1ba55d4..b8755e5a3 100644 --- a/doc/html/_sources/compute_rigid_local.txt +++ b/doc/html/_sources/compute_rigid_local.txt @@ -1,177 +1,200 @@ .. index:: compute rigid/local compute rigid/local command =========================== Syntax """""" .. parsed-literal:: compute ID group-ID rigid/local rigidID input1 input2 ... * ID, group-ID are documented in :doc:`compute ` command * rigid/local = style name of this compute command * rigidID = ID of fix rigid/small command or one of its variants * input = one or more rigid body attributes +.. parsed-literal:: + + possible attributes = id, mol, mass, + x, y, z, xu, yu, zu, ix, iy, iz + vx, vy, vz, fx, fy, fz, + omegax, omegay, omegaz, + angmomx, angmomy, angmomz, + quatw, quati, quatj, quatk, + tqx, tqy, tqz, + inertiax, inertiay, inertiaz + id = atom ID of atom within body which owns body properties + mol = molecule ID used to define body in :doc:`fix rigid/small ` command + mass = total mass of body + x,y,z = center of mass coords of body + xu,yu,zu = unwrapped center of mass coords of body + ix,iy,iz = box image that the center of mass is in + vx,vy,vz = center of mass velocities + fx,fy,fz = force of center of mass + omegax,omegay,omegaz = angular velocity of body + angmomx,angmomy,angmomz = angular momentum of body + quatw,quati,quatj,quatk = quaternion components for body + tqx,tqy,tqz = torque on body + inertiax,inertiay,inertiaz = diagonalized moments of inertia of body Examples """""""" .. parsed-literal:: compute 1 all rigid/local myRigid mol x y z Description """"""""""" Define a computation that simply stores rigid body attributes for rigid bodies defined by the :doc:`fix rigid/small ` command or one of its NVE, NVT, NPT, NPH variants. The data is stored as local data so it can be accessed by other :ref:`output commands ` that process local data, such as the :doc:`compute reduce ` or :doc:`dump local ` commands. Note that this command only works with the :doc:`fix rigid/small ` command or its variants, not the fix rigid command and its variants. The ID of the :doc:`fix rigid/small ` command used to define rigid bodies must be specified as *rigidID*\ . The :doc:`fix rigid ` command is typically used to define a handful of (potentially very large) rigid bodies. It outputs similar per-body information as this command directly from the fix as global data; see the :doc:`fix rigid ` doc page for details The local data stored by this command is generated by looping over all the atoms owned on a processor. If the atom is not in the specified *group-ID* or is not part of a rigid body it is skipped. If it is not the atom within a body that is assigned to store the body information it is skipped (only one atom per body is so assigned). If it is the assigned atom, then the info for that body is output. This means that information for N bodies is generated. N may be less than the # of bodies defined by the fix rigid command, if the atoms in some bodies are not in the *group-ID*\ . .. note:: Which atom in a body owns the body info is determined internal to LAMMPS; it's the one nearest the geometric center of the body. Typically you should avoid this complication, by defining the group associated with this fix to include/exclude entire bodies. Note that as atoms and bodies migrate from processor to processor, there will be no consistent ordering of the entries within the local vector or array from one timestep to the next. Here is an example of how to use this compute to dump rigid body info to a file: .. parsed-literal:: compute 1 all rigid/local myRigid mol x y z fx fy fz dump 1 all local 1000 tmp.dump index c_1[1] c_1[2] c_1[3] c_1[4] c_1[5] c_1[6] c_1[7] ---------- This section explains the rigid body attributes that can be specified. The *id* attribute is the atomID of the atom which owns the rigid body, which is assigned by the :doc:`fix rigid/small ` command. The *mol* attribute is the molecule ID of the rigid body. It should be the molecule ID which all of the atoms in the body belong to, since that is how the :doc:`fix rigid/small ` command defines its rigid bodies. The *mass* attribute is the total mass of the rigid body. There are two options for outputting the coordinates of the center of mass (COM) of the body. The *x*\ , *y*\ , *z* attributes write the COM "unscaled", in the appropriate distance :doc:`units ` (Angstroms, sigma, etc). Use *xu*\ , *yu*\ , *zu* if you want the COM "unwrapped" by the image flags for each atobody. Unwrapped means that if the body COM has passed thru a periodic boundary one or more times, the value is generated what the COM coordinate would be if it had not been wrapped back into the periodic box. The image flags for the body can be generated directly using the *ix*\ , *iy*\ , *iz* attributes. For periodic dimensions, they specify which image of the simulation box the COM is considered to be in. An image of 0 means it is inside the box as defined. A value of 2 means add 2 box lengths to get the true value. A value of -1 means subtract 1 box length to get the true value. LAMMPS updates these flags as the rigid body COMs cross periodic boundaries during the simulation. The *vx*\ , *vy*\ , *vz*\ , *fx*\ , *fy*\ , *fz* attributes are components of the COM velocity and force on the COM of the body. The *omegax*\ , *omegay*\ , and *omegaz* attributes are the angular velocity componennts of the body around its COM. The *angmomx*\ , *angmomy*\ , and *angmomz* attributes are the angular momentum components of the body around its COM. The *quatw*\ , *quati*\ , *quatj*\ , and *quatk* attributes are the components of the 4-vector quaternion representing the orientation of the rigid body. See the :doc:`set ` command for an explanation of the quaternion vector. The *angmomx*\ , *angmomy*\ , and *angmomz* attributes are the angular momentum components of the body around its COM. The *tqx*\ , *tqy*\ , *tqz* attributes are components of the torque acting on the body around its COM. The *inertiax*\ , *inertiay*\ , *inertiaz* attributes are components of diagonalized inertia tensor for the body, i.e the 3 moments of inertia for the body around its principal axes, as computed internally by LAMMPS. ---------- **Output info:** This compute calculates a local vector or local array depending on the number of keywords. The length of the vector or number of rows in the array is the number of rigid bodies. If a single keyword is specified, a local vector is produced. If two or more keywords are specified, a local array is produced where the number of columns = the number of keywords. The vector or array can be accessed by any command that uses local values from a compute as input. See :ref:`this section ` for an overview of LAMMPS output options. The vector or array values will be in whatever :doc:`units ` the corresponding attribute is in: * id,mol = unitless * mass = mass units * x,y,z and xy,yu,zu = distance units * vx,vy,vz = velocity units * fx,fy,fz = force units * omegax,omegay,omegaz = radians/time units * angmomx,angmomy,angmomz = mass*distance^2/time units * quatw,quati,quatj,quatk = unitless * tqx,tqy,tqz = torque units * inertiax,inertiay,inertiaz = mass*distance^2 units Restrictions """""""""""" This compute is part of the RIGID package. It is only enabled if LAMMPS was built with that package. See the :ref:`Making LAMMPS ` section for more info. Related commands """""""""""""""" :doc:`dump local `, :doc:`compute reduce ` **Default:** none .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Section_commands.html#comm diff --git a/doc/html/_sources/manifolds.txt b/doc/html/_sources/manifolds.txt index 6b2486b8f..19e0a636a 100644 --- a/doc/html/_sources/manifolds.txt +++ b/doc/html/_sources/manifolds.txt @@ -1,45 +1,55 @@ -Description -""""""""""" +Manifolds (surfacse) +==================== -Below is a list of currently supported manifolds, their parameters and a short description of them. -The parameters listed here are in the same order as they should be passed to the relevant fixes. +**Overview:** + +This doc page is not about a LAMMPS input script command, but about +manifolds, which are generalized surfaces, as defined and used by the +USER-MANIFOLD package, to track particle motion on the manifolds. See +the src/USER-MANIFOLD/README file for more details about the package +and its commands. + +Below is a list of currently supported manifolds by the USER-MANIFOLD +package, their parameters and a short description of them. The +parameters listed here are in the same order as they should be passed +to the relevant fixes. +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | *manifold* | *parameters* | *equation* | *description* | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | cylinder | R | x^2 + y^2 - R^2 = 0 | Cylinder along z-axis, axis going through (0,0,0) | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | cylinder_dent | R l a | x^2 + y^2 - r(z)^2 = 0, r(x) = R if |z| > l, r(z) = R - a*(1 + cos(z/l))/2 otherwise | A cylinder with a dent around z = 0 | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | dumbbell | a A B c | -( x^2 + y^2 ) * (a^2 - z^2/c^2) * ( 1 + (A*sin(B*z^2))^4) = 0 | A dumbbell | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | ellipsoid | a b c | (x/a)^2 + (y/b)^2 + (z/c)^2 = 0 | An ellipsoid | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | plane | a b c x0 y0 z0 | a*(x-x0) + b*(y-y0) + c*(z-z0) = 0 | A plane with normal (a,b,c) going through point (x0,y0,z0) | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | plane_wiggle | a w | z - a*sin(w*x) = 0 | A plane with a sinusoidal modulation on z along x. | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | sphere | R | x^2 + y^2 + z^2 - R^2 = 0 | A sphere of radius R | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | supersphere | R q | |x|^q + |y|^q + |z|^q - R^q = 0 | A supersphere of hyperradius R | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | spine | a, A, B, B2, c | -(x^2 + y^2)*(a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^4), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise | An approximation to a dendtritic spine | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | spine_two | a, A, B, B2, c | -(x^2 + y^2)*(a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^2), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise | Another approximation to a dendtritic spine | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | thylakoid | wB LB lB | Various, see :ref:`(Paquay) ` | A model grana thylakoid consisting of two block-like compartments connected by a bridge of width wB, length LB and taper length lB | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ | torus | R r | (R - sqrt( x^2 + y^2 ) )^2 + z^2 - r^2 | A torus with large radius R and small radius r, centered on (0,0,0) | | +---------------+----------------+----------------------------------------------------------------------------------------------------------------------------+------------------------------------------------------------------------------------------------------------------------------------+--+ .. _Paquay: **(Paquay)** Paquay and Kusters, Biophys. J., 110, ???, (2016), to be published, preprint available at `arXiv:1411.3019 `_. .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Section_commands.html#comm diff --git a/doc/html/_sources/pair_modify.txt b/doc/html/_sources/pair_modify.txt index d52065356..7a01f9d57 100644 --- a/doc/html/_sources/pair_modify.txt +++ b/doc/html/_sources/pair_modify.txt @@ -1,292 +1,289 @@ .. index:: pair_modify pair_modify command =================== Syntax """""" .. parsed-literal:: pair_modify keyword values ... * one or more keyword/value pairs may be listed * keyword = *pair* or *shift* or *mix* or *table* or *table/disp* or *tabinner* or *tabinner/disp* or *tail* or *compute* .. parsed-literal:: *pair* values = sub-style N *special* which wt1 wt2 wt3 sub-style = sub-style of :doc:`pair hybrid ` N = which instance of sub-style (only if sub-style is used multiple times) *special* which wt1 wt2 wt3 = override *special_bonds* settings (optional) which = *lj/coul* or *lj* or *coul* w1,w2,w3 = 1-2, 1-3, and 1-4 weights from 0.0 to 1.0 inclusive *mix* value = *geometric* or *arithmetic* or *sixthpower* *shift* value = *yes* or *no* *table* value = N 2^N = # of values in table *table/disp* value = N 2^N = # of values in table *tabinner* value = cutoff cutoff = inner cutoff at which to begin table (distance units) *tabinner/disp* value = cutoff cutoff = inner cutoff at which to begin table (distance units) *tail* value = *yes* or *no* *compute* value = *yes* or *no* Examples """""""" .. parsed-literal:: pair_modify shift yes mix geometric pair_modify tail yes pair_modify table 12 pair_modify pair lj/cut compute no pair_modify pair lj/cut/coul/long 1 special lj/coul 0.0 0.0 0.0 Description """"""""""" Modify the parameters of the currently defined pair style. Not all parameters are relevant to all pair styles. If used, the *pair* keyword must appear first in the list of keywords. It can only be used with the :doc:`hybrid and hybrid/overlay ` pair styles. It means that all the following parameters will only be modified for the specified sub-style. If the sub-style is defined multiple times, then an additional numeric argument *N* must also be specified, which is a number from 1 to M where M is the number of times the sub-style was listed in the :doc:`pair_style hybrid ` command. The extra number indicates which instance of the sub-style the remaining keywords will be applied to. Note that if the *pair* keyword is not used, and the pair style is *hybrid* or *hybrid/overlay*\ , then all the specified keywords will be applied to all sub-styles. The *special* keyword can only be used in conjunction with the *pair* keyword and must directly follow it. It allows to override the :doc:`special_bonds ` settings for the specified sub-style. More details are given below. The *mix* keyword affects pair coefficients for interactions between atoms of type I and J, when I != J and the coefficients are not explicitly set in the input script. Note that coefficients for I = J must be set explicitly, either in the input script via the "pair_coeff" command or in the "Pair Coeffs" section of the :doc:`data file `. For some pair styles it is not necessary to specify coefficients when I != J, since a "mixing" rule will create them from the I,I and J,J settings. The pair_modify *mix* value determines what formulas are used to compute the mixed coefficients. In each case, the cutoff distance is mixed the same way as sigma. Note that not all pair styles support mixing. Also, some mix options are not available for certain pair styles. See the doc page for individual pair styles for those restrictions. Note also that the :doc:`pair_coeff ` command also can be to directly set coefficients for a specific I != J pairing, in which case no mixing is performed. mix *geometric* .. parsed-literal:: epsilon_ij = sqrt(epsilon_i * epsilon_j) sigma_ij = sqrt(sigma_i * sigma_j) mix *arithmetic* .. parsed-literal:: epsilon_ij = sqrt(epsilon_i * epsilon_j) sigma_ij = (sigma_i + sigma_j) / 2 mix *sixthpower* .. parsed-literal:: epsilon_ij = (2 * sqrt(epsilon_i*epsilon_j) * sigma_i^3 * sigma_j^3) / (sigma_i^6 + sigma_j^6) sigma_ij = ((sigma_i**6 + sigma_j**6) / 2) ^ (1/6) The *shift* keyword determines whether a Lennard-Jones potential is shifted at its cutoff to 0.0. If so, this adds an energy term to each pairwise interaction which will be included in the thermodynamic output, but does not affect pair forces or atom trajectories. See the doc page for individual pair styles to see which ones support this option. The *table* and *table/disp* keywords apply to pair styles with a long-range Coulombic term or long-range dispersion term respectively; see the doc page for individual styles to see which potentials support these options. If N is non-zero, a table of length 2^N is pre-computed for forces and energies, which can shrink their computational cost by up to a factor of 2. The table is indexed via a bit-mapping technique :ref:`(Wolff) ` and a linear interpolation is performed between adjacent table values. In our experiments with different table styles (lookup, linear, spline), this method typically gave the best performance in terms of speed and accuracy. The choice of table length is a tradeoff in accuracy versus speed. A larger N yields more accurate force computations, but requires more memory which can slow down the computation due to cache misses. A reasonable value of N is between 8 and 16. The default value of 12 (table of length 4096) gives approximately the same accuracy as the no-table (N = 0) option. For N = 0, forces and energies are computed directly, using a polynomial fit for the needed erfc() function evaluation, which is what earlier versions of LAMMPS did. Values greater than 16 typically slow down the simulation and will not improve accuracy; values from 1 to 8 give unreliable results. The *tabinner* and *tabinner/disp* keywords set an inner cutoff above which the pairwise computation is done by table lookup (if tables are invoked), for the corresponding Coulombic and dispersion tables discussed with the *table* and *table/disp* keywords. The smaller the cutoff is set, the less accurate the table becomes (for a given number of table values), which can require use of larger tables. The default cutoff value is sqrt(2.0) distance units which means nearly all pairwise interactions are computed via table lookup for simulations with "real" units, but some close pairs may be computed directly (non-table) for simulations with "lj" units. When the *tail* keyword is set to *yes*\ , certain pair styles will add a long-range VanderWaals tail "correction" to the energy and pressure. These corrections are bookkeeping terms which do not affect dynamics, unless a constant-pressure simulation is being performed. See the doc page for individual styles to see which support this option. These corrections are included in the calculation and printing of thermodynamic quantities (see the :doc:`thermo_style ` command). Their effect will also be included in constant NPT or NPH simulations where the pressure influences the simulation box dimensions (e.g. the :doc:`fix npt ` and :doc:`fix nph ` commands). The formulas used for the long-range corrections come from equation 5 of :ref:`(Sun) `. .. note:: The tail correction terms are computed at the beginning of each run, using the current atom counts of each atom type. If atoms are deleted (or lost) or created during a simulation, e.g. via the :doc:`fix gcmc ` command, the correction factors are not re-computed. If you expect the counts to change dramatically, you can break a run into a series of shorter runs so that the correction factors are re-computed more frequently. Several additional assumptions are inherent in using tail corrections, including the following: * The simulated system is a 3d bulk homogeneous liquid. This option should not be used for systems that are non-liquid, 2d, have a slab geometry (only 2d periodic), or inhomogeneous. * G(r), the radial distribution function (rdf), is unity beyond the cutoff, so a fairly large cutoff should be used (i.e. 2.5 sigma for an LJ fluid), and it is probably a good idea to verify this assumption by checking the rdf. The rdf is not exactly unity beyond the cutoff for each pair of interaction types, so the tail correction is necessarily an approximation. The tail corrections are computed at the beginning of each simulation run. If the number of atoms changes during the run, e.g. due to atoms leaving the simulation domain, or use of the :doc:`fix gcmc ` command, then the corrections are not updates to relect the changed atom count. If this is a large effect in your simulation, you should break the long run into several short runs, so that the correction factors are re-computed multiple times. * Thermophysical properties obtained from calculations with this option enabled will not be thermodynamically consistent with the truncated force-field that was used. In other words, atoms do not feel any LJ pair interactions beyond the cutoff, but the energy and pressure reported by the simulation include an estimated contribution from those interactions. The *compute* keyword allows pairwise computations to be turned off, even though a :doc:`pair_style ` is defined. This is not useful for running a real simulation, but can be useful for debugging purposes or for performing a :doc:`rerun ` simulation, when you only wish to compute partial forces that do not include the pairwise contribution. Two examples are as follows. First, this option allows you to perform a simulation with :doc:`pair_style hybrid ` with only a subset of the hybrid sub-styles enabled. Second, this option allows you to perform a simulation with only long-range interactions but no short-range pairwise interactions. Doing this by simply not defining a pair style will not work, because the :doc:`kspace_style ` command requires a Kspace-compatible pair style be defined. ---------- -Use of *special* keyword -^^^^^^^^^^^^^^^^^^^^^^^^ - The *special* keyword allows to override the 1-2, 1-3, and 1-4 exclusion settings for individual sub-styles of a :doc:`hybrid pair style `. It requires 4 arguments similar to the :doc:`special_bonds ` command, *which* and wt1,wt2,wt3. The *which* argument can be *lj* to change the Lennard-Jones settings, *coul* to change the Coulombic settings, or *lj/coul* to change both to the same set of 3 values. The wt1,wt2,wt3 values are numeric weights from 0.0 to 1.0 inclusive, for the 1-2, 1-3, and 1-4 bond topology neighbors, respectively. The *special* keyword can only be used in conjunction with the *pair* keyword and has to directly follow it. .. note:: The global settings specified by the :doc:`special_bonds ` command affect the construction of neighbor lists. Weights of 0.0 (for 1-2, 1-3, or 1-4 neighbors) exclude those pairs from the neighbor list entirely. Weights of 1.0 store the neighbor with no weighting applied. Thus only global values different from exactly 0.0 or 1.0 can be overridden and an error is generated if the requested setting is not compatible with the global setting. Substituting 1.0e-10 for 0.0 and 0.9999999999 for 1.0 is usually a sufficient workaround in this case without causing a significant error. ---------- Restrictions """""""""""" none You cannot use *shift* yes with *tail* yes, since those are conflicting options. You cannot use *tail* yes with 2d simulations. Related commands """""""""""""""" :doc:`pair_style `, :doc:`pair_coeff `, :doc:`thermo_style ` Default """"""" The option defaults are mix = geometric, shift = no, table = 12, tabinner = sqrt(2.0), tail = no, and compute = yes. Note that some pair styles perform mixing, but only a certain style of mixing. See the doc pages for individual pair styles for details. ---------- .. _Wolff: **(Wolff)** Wolff and Rudd, Comp Phys Comm, 120, 200-32 (1999). .. _Sun: **(Sun)** Sun, J Phys Chem B, 102, 7338-7364 (1998). .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Section_commands.html#comm diff --git a/doc/html/_sources/tutorial_github.txt b/doc/html/_sources/tutorial_github.txt index 37cb6ffb5..586ac009d 100644 --- a/doc/html/_sources/tutorial_github.txt +++ b/doc/html/_sources/tutorial_github.txt @@ -1,256 +1,248 @@ LAMMPS GitHub tutorial -********************** +====================== -written by Stefan Paquay -======================== +**written by Stefan Paquay** ---------- -This document briefly describes how to use GitHub to merge changes -into LAMMPS using GitHub. It assumes that you are familiar with +This document briefly describes how to use GitHub to merge changes you +make into LAMMPS, using GitHub. It assumes that you are familiar with git. You may want to have a look at the `Git book `_ to reacquaint yourself. ---------- -Making an account -***************** +**Making an account** First of all, you need a GitHub account. This is fairly simple, just go to `GitHub `_ and create an account by clicking the ``Sign up for GitHub'' button. Once your account is created, you can sign in by clicking the button in the top left and filling in your username or e-mail address and password. ---------- -Forking the repository -********************** +**Forking the repository** To get changes into LAMMPS, you need to first fork the repository. At the time of writing, LAMMPS-ICMS is the preferred fork. Go to `LAMMPS on GitHub `_ and make sure branch is set to ``lammps-icms'', see the figure below. .. image:: JPG/tutorial_branch.png :align: center Now, click on fork in the top right corner: .. image:: JPG/tutorial_fork.png :align: center This will create your own fork of the LAMMPS repository. You can make changes in this fork and later file *pull requests* to allow the upstream repository to merge changes from your own fork into the one we just forked from. At the same time, you can set things up, so you can include changes from upstream into your repository. ---------- -Adding changes to your own fork -******************************* +**Adding changes to your own fork** Before adding changes, it is better to first create a new branch that will contain these changes, a so-called feature branch. -Feature branches -================ +**Feature branches** Since LAMMPS is such a big project and most user contributions come in small portions, the most ideal workflow for LAMMPS is the so-called ``Feature branch'' workflow. It is explained in great detail here: `feature branch workflow `_. The idea is that every new feature for LAMMPS gets its own branch. This way, it is fairly painless to incorporate new features into the upstream repository. I will explain briefly here how to do it. In this feature branch, I will add a USER-package. I assume that git is installed on the local machine and you know how to use a command line. First of all, you need to clone your own fork of LAMMPS: .. parsed-literal:: $ git clone https://github.com//lammps.git You can find the proper url to the right of the "HTTPS" block, see figure. .. image:: JPG/tutorial_https_block.png :align: center The above command copies (``clones'') the git repository to your local machine. You can use this local clone to make changes and test them without interfering with the repository on github. First, however, it is recommended to make a new branch for a particular feature you would like added to LAMMPS. In this example, I will try adding a new USER-package called USER-MANIFOLD. To create a new branch, run the following git command in your repository: .. parsed-literal:: $ git checkout -b add-user-manifold The name of this new branch is "add-user-manifold" in my case. Just name it after something that resembles the feature you want added to LAMMPS. Now that you've changed branches, you can edit the files as you see fit, add new files, and commit as much as you would like. Just remember that if halfway you decide to add another, unrelated feature, you should switch branches! After everything is done, add the files to the branch and commit them: .. parsed-literal:: $ git add src/USER-MANIFOLD examples/USER/manifold/ $ git add doc/fix_nv\ *t,e*\ _manifold_rattle.txt $ git add doc/fix_manifoldforce.txt doc/user_manifolds.txt After the files are added, the change should be comitted: .. parsed-literal:: $ git commit -m 'Added user-manifold package' The "-m" switch is used to add a message to the commit. Use this to indicate what type of change was commited. -Wisdom by Axel: ---------------- +**Wisdom by Axel** *"Do not use "git commit -a". the -a flag will automatically include *all* modified or new files. mercurial does that and it find it hugely annoying and often leading to accidental commits of files you don't want. use git add, git rm, git mv for adding, removing, renaming and then git commit to finalize the commit. personally, i find it very convenient to use the bundled gui for commits, i.e. git gui. typically, i will do git add and other operations, but then verify and review them with git gui. git gui also allows to do line-by-line unstaging and other convenient operations."* After the commit, the changes can be pushed to the same branch on GitHub: .. parsed-literal:: $ git push Git will ask you for your user name and password on GitHub if you have not configured anything. If you correctly type your user name and password, the change should be added to your fork on GitHub. If you want to make really sure you push to the right repository (which is good practice), you can provide it explicitly: .. parsed-literal:: $ git push origin or using an explicit URL: .. parsed-literal:: $ git push git@github.com:Pakketeretet2/lammps.git After that, you can file a new pull request based on this branch. GitHub will now look like this: .. image:: JPG/tutorial_pull_request_feature_branch1.png :align: center Make sure that the current branch is set to the correct one, which, in this case, is "add-user-manifold". Now click "New pull request". If done correctly, the only changes you will see are those that were made on this branch, so in my case, I will see nothing related to $\mathrm*pair\_dzugatov*.$ This will open up a new window that lists changes made to the repository. If you are just adding new files, there is not much to do, but I suppose merge conflicts are to be resolved here if there are changes in existing files. If all changes can automatically be merged, green text at the top will say so and you can click the "Create pull request" button, see image. .. image:: JPG/tutorial_pull_request2.png :align: center After this you have to specify a short title and a comment with details about your pull request. I guess here you write what your modifications do and why they should be incorporated upstream. After that, click the "Create pull request" button, see image below. .. image:: JPG/tutorial_pull_request3.png :align: center Now just write some nice comments, click "Comment", and that is it. It is now up to the maintainer(s) of the upstream repository to incorporate the changes into the repository and to close the pull request. .. image:: JPG/tutorial_pull_request4.png :align: center ---------- -Additional changes -****************** +**Additional changes** Before the pull request is accepted, any additional changes you push into your repository will automatically become part of the pull request. ---------- -After a merge -************* +**After a merge** When everything is fine the feature branch is merged into the LAMMPS repositories: .. image:: JPG/tutorial_merged.png :align: center Now one question remains: What to do with the feature branch that got merged into upstream? It is in principle safe to delete them from your own fork. This helps keep it a bit more tidy. Note that you first have to switch to another branch! .. parsed-literal:: $ git checkout lammps-icms $ git pull lammps-icms $ git branch -d add-user-manifold If you do not pull first, it is not really a problem but git will warn you at the next statement that you are deleting a local branch that was not yet fully merged into HEAD. This is because git does not yet know your branch just got merged into lammps-icms upstream. If you first delete and then pull, everything should still be fine. Finally, if you delete the branch locally, you might want to push this to your remote(s) as well: .. parsed-literal:: $ git push origin :add-user-manifold .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Section_commands.html#comm diff --git a/doc/html/compute_rigid_local.html b/doc/html/compute_rigid_local.html index d2ddebee8..154d01a90 100644 --- a/doc/html/compute_rigid_local.html +++ b/doc/html/compute_rigid_local.html @@ -1,327 +1,350 @@ compute rigid/local command — LAMMPS documentation

compute rigid/local command

Syntax

compute ID group-ID rigid/local rigidID input1 input2 ...
 
  • ID, group-ID are documented in compute command
  • rigid/local = style name of this compute command
  • rigidID = ID of fix rigid/small command or one of its variants
  • input = one or more rigid body attributes
+
+possible attributes = id, mol, mass,
+                   x, y, z, xu, yu, zu, ix, iy, iz
+                   vx, vy, vz, fx, fy, fz,
+                      omegax, omegay, omegaz,
+                   angmomx, angmomy, angmomz,
+                   quatw, quati, quatj, quatk,
+                      tqx, tqy, tqz,
+                      inertiax, inertiay, inertiaz
+    id = atom ID of atom within body which owns body properties
+    mol = molecule ID used to define body in fix rigid/small command
+    mass = total mass of body
+    x,y,z = center of mass coords of body
+    xu,yu,zu = unwrapped center of mass coords of body
+    ix,iy,iz = box image that the center of mass is in
+    vx,vy,vz = center of mass velocities
+    fx,fy,fz = force of center of mass
+    omegax,omegay,omegaz = angular velocity of body
+    angmomx,angmomy,angmomz = angular momentum of body
+    quatw,quati,quatj,quatk = quaternion components for body
+    tqx,tqy,tqz = torque on body
+    inertiax,inertiay,inertiaz = diagonalized moments of inertia of body
+

Examples

compute 1 all rigid/local myRigid mol x y z
 

Description

Define a computation that simply stores rigid body attributes for rigid bodies defined by the fix rigid/small command or one of its NVE, NVT, NPT, NPH variants. The data is stored as local data so it can be accessed by other output commands that process local data, such as the compute reduce or dump local commands.

Note that this command only works with the fix rigid/small command or its variants, not the fix rigid command and its variants. The ID of the fix rigid/small command used to define rigid bodies must be specified as rigidID. The fix rigid command is typically used to define a handful of (potentially very large) rigid bodies. It outputs similar per-body information as this command directly from the fix as global data; see the fix rigid doc page for details

The local data stored by this command is generated by looping over all the atoms owned on a processor. If the atom is not in the specified group-ID or is not part of a rigid body it is skipped. If it is not the atom within a body that is assigned to store the body information it is skipped (only one atom per body is so assigned). If it is the assigned atom, then the info for that body is output. This means that information for N bodies is generated. N may be less than the # of bodies defined by the fix rigid command, if the atoms in some bodies are not in the group-ID.

Note

Which atom in a body owns the body info is determined internal to LAMMPS; it’s the one nearest the geometric center of the body. Typically you should avoid this complication, by defining the group associated with this fix to include/exclude entire bodies.

Note that as atoms and bodies migrate from processor to processor, there will be no consistent ordering of the entries within the local vector or array from one timestep to the next.

Here is an example of how to use this compute to dump rigid body info to a file:

compute 1 all rigid/local myRigid mol x y z fx fy fz
 dump 1 all local 1000 tmp.dump index c_1[1] c_1[2] c_1[3] c_1[4] c_1[5] c_1[6] c_1[7]
 

This section explains the rigid body attributes that can be specified.

The id attribute is the atomID of the atom which owns the rigid body, which is assigned by the fix rigid/small command.

The mol attribute is the molecule ID of the rigid body. It should be the molecule ID which all of the atoms in the body belong to, since that is how the fix rigid/small command defines its rigid bodies.

The mass attribute is the total mass of the rigid body.

There are two options for outputting the coordinates of the center of mass (COM) of the body. The x, y, z attributes write the COM “unscaled”, in the appropriate distance units (Angstroms, sigma, etc). Use xu, yu, zu if you want the COM “unwrapped” by the image flags for each atobody. Unwrapped means that if the body COM has passed thru a periodic boundary one or more times, the value is generated what the COM coordinate would be if it had not been wrapped back into the periodic box.

The image flags for the body can be generated directly using the ix, iy, iz attributes. For periodic dimensions, they specify which image of the simulation box the COM is considered to be in. An image of 0 means it is inside the box as defined. A value of 2 means add 2 box lengths to get the true value. A value of -1 means subtract 1 box length to get the true value. LAMMPS updates these flags as the rigid body COMs cross periodic boundaries during the simulation.

The vx, vy, vz, fx, fy, fz attributes are components of the COM velocity and force on the COM of the body.

The omegax, omegay, and omegaz attributes are the angular velocity componennts of the body around its COM.

The angmomx, angmomy, and angmomz attributes are the angular momentum components of the body around its COM.

The quatw, quati, quatj, and quatk attributes are the components of the 4-vector quaternion representing the orientation of the rigid body. See the set command for an explanation of the quaternion vector.

The angmomx, angmomy, and angmomz attributes are the angular momentum components of the body around its COM.

The tqx, tqy, tqz attributes are components of the torque acting on the body around its COM.

The inertiax, inertiay, inertiaz attributes are components of diagonalized inertia tensor for the body, i.e the 3 moments of inertia for the body around its principal axes, as computed internally by LAMMPS.


Output info:

This compute calculates a local vector or local array depending on the number of keywords. The length of the vector or number of rows in the array is the number of rigid bodies. If a single keyword is specified, a local vector is produced. If two or more keywords are specified, a local array is produced where the number of columns = the number of keywords. The vector or array can be accessed by any command that uses local values from a compute as input. See this section for an overview of LAMMPS output options.

The vector or array values will be in whatever units the corresponding attribute is in:

  • id,mol = unitless
  • mass = mass units
  • x,y,z and xy,yu,zu = distance units
  • vx,vy,vz = velocity units
  • fx,fy,fz = force units
  • omegax,omegay,omegaz = radians/time units
  • angmomx,angmomy,angmomz = mass*distance^2/time units
  • quatw,quati,quatj,quatk = unitless
  • tqx,tqy,tqz = torque units
  • inertiax,inertiay,inertiaz = mass*distance^2 units

Restrictions

This compute is part of the RIGID package. It is only enabled if LAMMPS was built with that package. See the Making LAMMPS section for more info.

\ No newline at end of file diff --git a/doc/html/manifolds.html b/doc/html/manifolds.html index aef95c505..73f57ef60 100644 --- a/doc/html/manifolds.html +++ b/doc/html/manifolds.html @@ -1,286 +1,294 @@ - Description — LAMMPS documentation + Manifolds (surfacse) — LAMMPS documentation

-
-

Description

-

Below is a list of currently supported manifolds, their parameters and a short description of them. -The parameters listed here are in the same order as they should be passed to the relevant fixes.

+
+

Manifolds (surfacse)

+

Overview:

+

This doc page is not about a LAMMPS input script command, but about +manifolds, which are generalized surfaces, as defined and used by the +USER-MANIFOLD package, to track particle motion on the manifolds. See +the src/USER-MANIFOLD/README file for more details about the package +and its commands.

+

Below is a list of currently supported manifolds by the USER-MANIFOLD +package, their parameters and a short description of them. The +parameters listed here are in the same order as they should be passed +to the relevant fixes.

manifold parameters equation description  
cylinder R x^2 + y^2 - R^2 = 0 Cylinder along z-axis, axis going through (0,0,0)  
cylinder_dent R l a x^2 + y^2 - r(z)^2 = 0, r(x) = R if |z| > l, r(z) = R - a*(1 + cos(z/l))/2 otherwise A cylinder with a dent around z = 0  
dumbbell a A B c -( x^2 + y^2 ) * (a^2 - z^2/c^2) * ( 1 + (A*sin(B*z^2))^4) = 0 A dumbbell  
ellipsoid a b c (x/a)^2 + (y/b)^2 + (z/c)^2 = 0 An ellipsoid  
plane a b c x0 y0 z0 a*(x-x0) + b*(y-y0) + c*(z-z0) = 0 A plane with normal (a,b,c) going through point (x0,y0,z0)  
plane_wiggle a w z - a*sin(w*x) = 0 A plane with a sinusoidal modulation on z along x.  
sphere R x^2 + y^2 + z^2 - R^2 = 0 A sphere of radius R  
supersphere R q |x|^q + |y|^q + |z|^q - R^q = 0 A supersphere of hyperradius R  
spine a, A, B, B2, c -(x^2 + y^2)*(a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^4), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise An approximation to a dendtritic spine  
spine_two a, A, B, B2, c -(x^2 + y^2)*(a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^2), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise Another approximation to a dendtritic spine  
thylakoid wB LB lB Various, see (Paquay) A model grana thylakoid consisting of two block-like compartments connected by a bridge of width wB, length LB and taper length lB  
torus R r (R - sqrt( x^2 + y^2 ) )^2 + z^2 - r^2 A torus with large radius R and small radius r, centered on (0,0,0)  

(Paquay) Paquay and Kusters, Biophys. J., 110, ???, (2016), to be published, preprint available at arXiv:1411.3019.

\ No newline at end of file diff --git a/doc/html/pair_modify.html b/doc/html/pair_modify.html index fe24147bb..b45eacca3 100644 --- a/doc/html/pair_modify.html +++ b/doc/html/pair_modify.html @@ -1,434 +1,431 @@ pair_modify command — LAMMPS documentation

pair_modify command

Syntax

pair_modify keyword values ...
 
  • one or more keyword/value pairs may be listed
  • keyword = pair or shift or mix or table or table/disp or tabinner or tabinner/disp or tail or compute
 pair values = sub-style N special which wt1 wt2 wt3
   sub-style = sub-style of pair hybrid
   N = which instance of sub-style (only if sub-style is used multiple times)
   special which wt1 wt2 wt3 = override special_bonds settings (optional)
   which = lj/coul or lj or coul
   w1,w2,w3 = 1-2, 1-3, and 1-4 weights from 0.0 to 1.0 inclusive
 mix value = geometric or arithmetic or sixthpower
 shift value = yes or no
 table value = N
   2^N = # of values in table
 table/disp value = N
   2^N = # of values in table
 tabinner value = cutoff
   cutoff = inner cutoff at which to begin table (distance units)
 tabinner/disp value = cutoff
   cutoff = inner cutoff at which to begin table (distance units)
 tail value = yes or no
 compute value = yes or no
 

Examples

pair_modify shift yes mix geometric
 pair_modify tail yes
 pair_modify table 12
 pair_modify pair lj/cut compute no
 pair_modify pair lj/cut/coul/long 1 special lj/coul 0.0 0.0 0.0
 

Description

Modify the parameters of the currently defined pair style. Not all parameters are relevant to all pair styles.

If used, the pair keyword must appear first in the list of keywords. It can only be used with the hybrid and hybrid/overlay pair styles. It means that all the following parameters will only be modified for the specified sub-style. If the sub-style is defined multiple times, then an additional numeric argument N must also be specified, which is a number from 1 to M where M is the number of times the sub-style was listed in the pair_style hybrid command. The extra number indicates which instance of the sub-style the remaining keywords will be applied to. Note that if the pair keyword is not used, and the pair style is hybrid or hybrid/overlay, then all the specified keywords will be applied to all sub-styles.

The special keyword can only be used in conjunction with the pair keyword and must directly follow it. It allows to override the special_bonds settings for the specified sub-style. More details are given below.

The mix keyword affects pair coefficients for interactions between atoms of type I and J, when I != J and the coefficients are not explicitly set in the input script. Note that coefficients for I = J must be set explicitly, either in the input script via the “pair_coeff” command or in the “Pair Coeffs” section of the data file. For some pair styles it is not necessary to specify coefficients when I != J, since a “mixing” rule will create them from the I,I and J,J settings. The pair_modify mix value determines what formulas are used to compute the mixed coefficients. In each case, the cutoff distance is mixed the same way as sigma.

Note that not all pair styles support mixing. Also, some mix options are not available for certain pair styles. See the doc page for individual pair styles for those restrictions. Note also that the pair_coeff command also can be to directly set coefficients for a specific I != J pairing, in which case no mixing is performed.

mix geometric

epsilon_ij = sqrt(epsilon_i * epsilon_j)
 sigma_ij = sqrt(sigma_i * sigma_j)
 

mix arithmetic

epsilon_ij = sqrt(epsilon_i * epsilon_j)
 sigma_ij = (sigma_i + sigma_j) / 2
 

mix sixthpower

epsilon_ij = (2 * sqrt(epsilon_i*epsilon_j) * sigma_i^3 * sigma_j^3) /
              (sigma_i^6 + sigma_j^6)
 sigma_ij = ((sigma_i**6 + sigma_j**6) / 2) ^ (1/6)
 

The shift keyword determines whether a Lennard-Jones potential is shifted at its cutoff to 0.0. If so, this adds an energy term to each pairwise interaction which will be included in the thermodynamic output, but does not affect pair forces or atom trajectories. See the doc page for individual pair styles to see which ones support this option.

The table and table/disp keywords apply to pair styles with a long-range Coulombic term or long-range dispersion term respectively; see the doc page for individual styles to see which potentials support these options. If N is non-zero, a table of length 2^N is pre-computed for forces and energies, which can shrink their computational cost by up to a factor of 2. The table is indexed via a -bit-mapping technique (Wolff) and a linear interpolation is +bit-mapping technique (Wolff) and a linear interpolation is performed between adjacent table values. In our experiments with different table styles (lookup, linear, spline), this method typically gave the best performance in terms of speed and accuracy.

The choice of table length is a tradeoff in accuracy versus speed. A larger N yields more accurate force computations, but requires more memory which can slow down the computation due to cache misses. A reasonable value of N is between 8 and 16. The default value of 12 (table of length 4096) gives approximately the same accuracy as the no-table (N = 0) option. For N = 0, forces and energies are computed directly, using a polynomial fit for the needed erfc() function evaluation, which is what earlier versions of LAMMPS did. Values greater than 16 typically slow down the simulation and will not improve accuracy; values from 1 to 8 give unreliable results.

The tabinner and tabinner/disp keywords set an inner cutoff above which the pairwise computation is done by table lookup (if tables are invoked), for the corresponding Coulombic and dispersion tables discussed with the table and table/disp keywords. The smaller the cutoff is set, the less accurate the table becomes (for a given number of table values), which can require use of larger tables. The default cutoff value is sqrt(2.0) distance units which means nearly all pairwise interactions are computed via table lookup for simulations with “real” units, but some close pairs may be computed directly (non-table) for simulations with “lj” units.

When the tail keyword is set to yes, certain pair styles will add a long-range VanderWaals tail “correction” to the energy and pressure. These corrections are bookkeeping terms which do not affect dynamics, unless a constant-pressure simulation is being performed. See the doc page for individual styles to see which support this option. These corrections are included in the calculation and printing of thermodynamic quantities (see the thermo_style command). Their effect will also be included in constant NPT or NPH simulations where the pressure influences the simulation box dimensions (e.g. the fix npt and fix nph commands). The formulas used for the long-range corrections come from equation 5 of (Sun).

Note

The tail correction terms are computed at the beginning of each run, using the current atom counts of each atom type. If atoms are deleted (or lost) or created during a simulation, e.g. via the fix gcmc command, the correction factors are not re-computed. If you expect the counts to change dramatically, you can break a run into a series of shorter runs so that the correction factors are re-computed more frequently.

Several additional assumptions are inherent in using tail corrections, including the following:

  • The simulated system is a 3d bulk homogeneous liquid. This option should not be used for systems that are non-liquid, 2d, have a slab geometry (only 2d periodic), or inhomogeneous.
  • G(r), the radial distribution function (rdf), is unity beyond the cutoff, so a fairly large cutoff should be used (i.e. 2.5 sigma for an LJ fluid), and it is probably a good idea to verify this assumption by checking the rdf. The rdf is not exactly unity beyond the cutoff for each pair of interaction types, so the tail correction is necessarily an approximation.

The tail corrections are computed at the beginning of each simulation run. If the number of atoms changes during the run, e.g. due to atoms leaving the simulation domain, or use of the fix gcmc command, then the corrections are not updates to relect the changed atom count. If this is a large effect in your simulation, you should break the long run into several short runs, so that the correction factors are re-computed multiple times.

  • Thermophysical properties obtained from calculations with this option enabled will not be thermodynamically consistent with the truncated force-field that was used. In other words, atoms do not feel any LJ pair interactions beyond the cutoff, but the energy and pressure reported by the simulation include an estimated contribution from those interactions.

The compute keyword allows pairwise computations to be turned off, even though a pair_style is defined. This is not useful for running a real simulation, but can be useful for debugging purposes or for performing a rerun simulation, when you only wish to compute partial forces that do not include the pairwise contribution.

Two examples are as follows. First, this option allows you to perform a simulation with pair_style hybrid with only a subset of the hybrid sub-styles enabled. Second, this option allows you to perform a simulation with only long-range interactions but no short-range pairwise interactions. Doing this by simply not defining a pair style will not work, because the kspace_style command requires a Kspace-compatible pair style be defined.


-
-

Use of special keyword

The special keyword allows to override the 1-2, 1-3, and 1-4 exclusion settings for individual sub-styles of a hybrid pair style. It requires 4 arguments similar to the special_bonds command, which and wt1,wt2,wt3. The which argument can be lj to change the Lennard-Jones settings, coul to change the Coulombic settings, or lj/coul to change both to the same set of 3 values. The wt1,wt2,wt3 values are numeric weights from 0.0 to 1.0 inclusive, for the 1-2, 1-3, and 1-4 bond topology neighbors, respectively. The special keyword can only be used in conjunction with the pair keyword and has to directly follow it.

Note

The global settings specified by the special_bonds command affect the construction of neighbor lists. Weights of 0.0 (for 1-2, 1-3, or 1-4 neighbors) exclude those pairs from the neighbor list entirely. Weights of 1.0 store the neighbor with no weighting applied. Thus only global values different from exactly 0.0 or 1.0 can be overridden and an error is generated if the requested setting is not compatible with the global setting. Substituting 1.0e-10 for 0.0 and 0.9999999999 for 1.0 is usually a sufficient workaround in this case without causing a significant error.

-

Restrictions

none

You cannot use shift yes with tail yes, since those are conflicting options. You cannot use tail yes with 2d simulations.

Default

The option defaults are mix = geometric, shift = no, table = 12, tabinner = sqrt(2.0), tail = no, and compute = yes.

Note that some pair styles perform mixing, but only a certain style of mixing. See the doc pages for individual pair styles for details.


(Wolff) Wolff and Rudd, Comp Phys Comm, 120, 200-32 (1999).

(Sun) Sun, J Phys Chem B, 102, 7338-7364 (1998).

\ No newline at end of file diff --git a/doc/html/searchindex.js b/doc/html/searchindex.js index 85be22d26..da2bc9718 100644 --- a/doc/html/searchindex.js +++ b/doc/html/searchindex.js @@ -1 +1 @@ -Search.setIndex({envversion:50,filenames:["Manual","Section_accelerate","Section_commands","Section_errors","Section_example","Section_history","Section_howto","Section_intro","Section_modify","Section_packages","Section_perf","Section_python","Section_start","Section_tools","accelerate_gpu","accelerate_intel","accelerate_kokkos","accelerate_omp","accelerate_opt","angle_charmm","angle_class2","angle_coeff","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_hybrid","angle_none","angle_quartic","angle_sdk","angle_style","angle_table","angle_zero","atom_modify","atom_style","balance","body","bond_class2","bond_coeff","bond_fene","bond_fene_expand","bond_harmonic","bond_harmonic_shift","bond_harmonic_shift_cut","bond_hybrid","bond_morse","bond_none","bond_nonlinear","bond_quartic","bond_style","bond_table","bond_write","bond_zero","boundary","box","change_box","clear","comm_modify","comm_style","compute","compute_ackland_atom","compute_angle","compute_angle_local","compute_angmom_chunk","compute_basal_atom","compute_body_local","compute_bond","compute_bond_local","compute_centro_atom","compute_chunk_atom","compute_cluster_atom","compute_cna_atom","compute_com","compute_com_chunk","compute_contact_atom","compute_coord_atom","compute_damage_atom","compute_dihedral","compute_dihedral_local","compute_dilatation_atom","compute_dipole_chunk","compute_displace_atom","compute_dpd","compute_dpd_atom","compute_erotate_asphere","compute_erotate_rigid","compute_erotate_sphere","compute_erotate_sphere_atom","compute_event_displace","compute_fep","compute_group_group","compute_gyration","compute_gyration_chunk","compute_heat_flux","compute_hexorder_atom","compute_improper","compute_improper_local","compute_inertia_chunk","compute_ke","compute_ke_atom","compute_ke_atom_eff","compute_ke_eff","compute_ke_rigid","compute_meso_e_atom","compute_meso_rho_atom","compute_meso_t_atom","compute_modify","compute_msd","compute_msd_chunk","compute_msd_nongauss","compute_omega_chunk","compute_orientorder_atom","compute_pair","compute_pair_local","compute_pe","compute_pe_atom","compute_plasticity_atom","compute_pressure","compute_property_atom","compute_property_chunk","compute_property_local","compute_rdf","compute_reduce","compute_rigid_local","compute_saed","compute_slice","compute_smd_contact_radius","compute_smd_damage","compute_smd_hourglass_error","compute_smd_internal_energy","compute_smd_plastic_strain","compute_smd_plastic_strain_rate","compute_smd_rho","compute_smd_tlsph_defgrad","compute_smd_tlsph_dt","compute_smd_tlsph_num_neighs","compute_smd_tlsph_shape","compute_smd_tlsph_strain","compute_smd_tlsph_strain_rate","compute_smd_tlsph_stress","compute_smd_triangle_mesh_vertices","compute_smd_ulsph_num_neighs","compute_smd_ulsph_strain","compute_smd_ulsph_strain_rate","compute_smd_ulsph_stress","compute_smd_vol","compute_sna_atom","compute_stress_atom","compute_tally","compute_temp","compute_temp_asphere","compute_temp_body","compute_temp_chunk","compute_temp_com","compute_temp_cs","compute_temp_deform","compute_temp_deform_eff","compute_temp_drude","compute_temp_eff","compute_temp_partial","compute_temp_profile","compute_temp_ramp","compute_temp_region","compute_temp_region_eff","compute_temp_rotate","compute_temp_sphere","compute_ti","compute_torque_chunk","compute_vacf","compute_vcm_chunk","compute_voronoi_atom","compute_xrd","create_atoms","create_bonds","create_box","delete_atoms","delete_bonds","dielectric","dihedral_charmm","dihedral_class2","dihedral_coeff","dihedral_cosine_shift_exp","dihedral_fourier","dihedral_harmonic","dihedral_helix","dihedral_hybrid","dihedral_multi_harmonic","dihedral_nharmonic","dihedral_none","dihedral_opls","dihedral_quadratic","dihedral_spherical","dihedral_style","dihedral_table","dihedral_zero","dimension","displace_atoms","dump","dump_custom_vtk","dump_h5md","dump_image","dump_modify","dump_molfile","echo","fix","fix_adapt","fix_adapt_fep","fix_addforce","fix_addtorque","fix_append_atoms","fix_atc","fix_atom_swap","fix_ave_atom","fix_ave_chunk","fix_ave_correlate","fix_ave_correlate_long","fix_ave_histo","fix_ave_time","fix_aveforce","fix_balance","fix_bond_break","fix_bond_create","fix_bond_swap","fix_box_relax","fix_colvars","fix_deform","fix_deposit","fix_drag","fix_drude","fix_drude_transform","fix_dt_reset","fix_efield","fix_ehex","fix_enforce2d","fix_eos_cv","fix_eos_table","fix_eos_table_rx","fix_evaporate","fix_external","fix_freeze","fix_gcmc","fix_gld","fix_gle","fix_gravity","fix_heat","fix_imd","fix_indent","fix_ipi","fix_langevin","fix_langevin_drude","fix_langevin_eff","fix_lb_fluid","fix_lb_momentum","fix_lb_pc","fix_lb_rigid_pc_sphere","fix_lb_viscous","fix_lineforce","fix_manifoldforce","fix_meso","fix_meso_stationary","fix_modify","fix_momentum","fix_move","fix_msst","fix_neb","fix_nh","fix_nh_eff","fix_nph_asphere","fix_nph_body","fix_nph_sphere","fix_nphug","fix_npt_asphere","fix_npt_body","fix_npt_sphere","fix_nve","fix_nve_asphere","fix_nve_asphere_noforce","fix_nve_body","fix_nve_eff","fix_nve_limit","fix_nve_line","fix_nve_manifold_rattle","fix_nve_noforce","fix_nve_sphere","fix_nve_tri","fix_nvt_asphere","fix_nvt_body","fix_nvt_manifold_rattle","fix_nvt_sllod","fix_nvt_sllod_eff","fix_nvt_sphere","fix_oneway","fix_orient","fix_phonon","fix_pimd","fix_planeforce","fix_poems","fix_pour","fix_press_berendsen","fix_print","fix_property_atom","fix_qbmsst","fix_qeq","fix_qeq_comb","fix_qeq_reax","fix_qmmm","fix_qtb","fix_reax_bonds","fix_reaxc_species","fix_recenter","fix_restrain","fix_rigid","fix_rx","fix_saed_vtk","fix_setforce","fix_shake","fix_shardlow","fix_smd","fix_smd_adjust_dt","fix_smd_integrate_tlsph","fix_smd_integrate_ulsph","fix_smd_move_triangulated_surface","fix_smd_setvel","fix_smd_tlsph_reference_configuration","fix_smd_wall_surface","fix_spring","fix_spring_chunk","fix_spring_rg","fix_spring_self","fix_srd","fix_store_force","fix_store_state","fix_temp_berendsen","fix_temp_csvr","fix_temp_rescale","fix_temp_rescale_eff","fix_tfmc","fix_thermal_conductivity","fix_ti_rs","fix_ti_spring","fix_tmd","fix_ttm","fix_tune_kspace","fix_vector","fix_viscosity","fix_viscous","fix_wall","fix_wall_gran","fix_wall_piston","fix_wall_reflect","fix_wall_region","fix_wall_srd","group","group2ndx","if","improper_class2","improper_coeff","improper_cossq","improper_cvff","improper_distance","improper_fourier","improper_harmonic","improper_hybrid","improper_none","improper_ring","improper_style","improper_umbrella","improper_zero","include","info","jump","kspace_modify","kspace_style","label","lattice","log","manifolds","mass","min_modify","min_style","minimize","molecule","neb","neigh_modify","neighbor","newton","next","package","pair_adp","pair_airebo","pair_awpmd","pair_beck","pair_body","pair_bop","pair_born","pair_brownian","pair_buck","pair_buck_long","pair_charmm","pair_class2","pair_coeff","pair_colloid","pair_comb","pair_coul","pair_coul_diel","pair_cs","pair_dipole","pair_dpd","pair_dpd_fdt","pair_dsmc","pair_eam","pair_edip","pair_eff","pair_eim","pair_exp6_rx","pair_gauss","pair_gayberne","pair_gran","pair_gromacs","pair_hbond_dreiding","pair_hybrid","pair_kim","pair_lcbop","pair_line_lj","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_modify","pair_morse","pair_multi_lucy","pair_multi_lucy_rx","pair_nb3b_harmonic","pair_nm","pair_none","pair_peri","pair_polymorphic","pair_quip","pair_reax","pair_reax_c","pair_resquared","pair_sdk","pair_smd_hertz","pair_smd_tlsph","pair_smd_triangulated_surface","pair_smd_ulsph","pair_smtbq","pair_snap","pair_soft","pair_sph_heatconduction","pair_sph_idealgas","pair_sph_lj","pair_sph_rhosum","pair_sph_taitwater","pair_sph_taitwater_morris","pair_srp","pair_style","pair_sw","pair_table","pair_table_rx","pair_tersoff","pair_tersoff_mod","pair_tersoff_zbl","pair_thole","pair_tri_lj","pair_vashishta","pair_write","pair_yukawa","pair_yukawa_colloid","pair_zbl","pair_zero","partition","prd","print","processors","python","quit","read_data","read_dump","read_restart","region","replicate","rerun","reset_timestep","restart","run","run_style","set","shell","special_bonds","suffix","tad","temper","thermo","thermo_modify","thermo_style","timer","timestep","tutorial_drude","tutorial_github","uncompute","undump","unfix","units","variable","velocity","write_coeff","write_data","write_dump","write_restart"],objects:{},objnames:{},objtypes:{},terms:{"00a":344,"00b":344,"02214e23":99,"03275e":523,"0892e":12,"0b1":11,"0e20":[360,500,524],"0e4":[269,353,423],"0e5":269,"0x98b5e0":206,"100k":1,"1024x1024":206,"10e":411,"10f":3,"10g":524,"10th":[492,498,511],"10x":[3,385,386,388,389,399],"10x10x10":166,"10x20x20":380,"12th":318,"15g":[207,524],"16e":318,"16g":[219,223],"16x":1,"18986e":386,"1_12":380,"1_3":380,"1_6":380,"1_prop":6,"1fluid":[420,451,479],"1st":[2,6,8,12,19,21,37,44,56,59,60,62,75,95,172,184,186,199,211,212,219,220,221,222,223,227,231,241,242,271,305,315,318,346,358,362,383,389,394,395,399,406,408,416,418,419,420,427,428,437,438,443,444,445,450,451,452,456,467,477,478,479,480,481,482,485,491,497,505,506,509,524],"1x2x2":494,"2000k":206,"20x":399,"23899e":386,"2400k":206,"2697v2":15,"2697v4":15,"298k":410,"2_3":380,"2k_ss":418,"2nd":[2,3,6,11,12,14,16,37,45,46,56,59,62,75,81,96,160,167,199,207,219,220,221,222,223,227,229,231,241,242,271,317,323,331,358,361,368,376,386,387,388,389,393,395,408,418,425,426,443,450,451,467,476,477,478,479,480,481,482,485,497,504,506,509,524],"2pi":199,"2theta":177,"2x1x2":494,"2x2x1":494,"2x2x2":494,"2x4x10":494,"2x5":418,"300k":[248,317,512,525],"310k":512,"3419e":269,"36x":15,"3806504e":[6,99],"3n_k":247,"3nk":307,"3nkb":312,"3rd":[4,9,14,16,19,37,56,75,115,125,199,219,220,222,223,227,241,242,317,319,358,387,391,393,408,418,420,425,426,450,451,467,477,478,479,480,481,482,485,497,504,509,524],"3x3":[99,380],"4857990943e":418,"49e":318,"4_94":11,"4th":[6,37,56,87,113,114,127,174,184,199,207,318,331,358,378,392,394,395,399,416,419,420,423,427,443,450,451,452,456,467,477,478,479,480,482,485,497,504,509,512,529],"4x10":376,"4x2x10":494,"4x6x10":494,"50k":1,"512k":15,"524k":15,"53xx":17,"54xx":17,"58i":211,"5_1":399,"5_12":380,"5_6":380,"5kx":[213,237],"5nlog_2":12,"5th":[127,386,420,514],"6021765e":523,"66e":318,"6863e22":455,"6x6":6,"7120p":15,"72360e":269,"7797e":269,"7842e":12,"8032044e":523,"8706e":466,"8706q":466,"8730m":466,"8730n":466,"8e12":221,"8x1":6,"8x2":[6,12],"948q":466,"9e18":[12,39],"9e9":455,"9jan09":[353,423],"9th":388,"abstract":16,"boolean":[3,358,360],"break":[2,3,7,8,9,12,54,55,61,182,210],"byte":[3,12,221,514],"case":[1,2,3,6,8,11,12,13,14,15,16,17,39,40,41,45,46,61,63,65,74,75,77,113,114,119,125,127,128,155,156,157,158,159,161,164,165,166,167,168,170,171,172,176,178,180,181,182,184,202,203,204,205,206,207,213,214,218,219,220,222,223,224,225,227,229,231,235,237,243,246,249,250,252,253,254,255,257,269,271,272,273,274,275,276,277,278,279,287,291,292,294,296,298,299,303,304,306,307,308,309,316,317,318,320,323,325,326,328,331,335,338,339,340,342,343,347,349,350,352,353,355,356,357,358,360,376,377,378,380,383,385,386,387,388,390,392,393,395,404,407,409,411,416,418,422,423,425,426,427,439,440,441,443,446,448,450,451,452,456,459,462,464,468,475,478,479,480,482,489,490,492,495,497,499,500,504,505,507,509,511,513,514,515,516,518,519,523,524,525,528,529],"catch":[1,3,495],"char":[6,8,466],"class":[1,3,5,6,7,8,9,11,12,13,21,36,44,55,186,198,244,306,362,371,405,426,458,459,476,485,495,497],"default":[1,2,3,6,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35],"else":[8,205],"export":[15,206,406],"false":[360,524],"final":[3,5,6,7,8,9,11,12,16,41,61,95,153,207,218,219,220,222,223,225,229,231,246,270,271,276,307,311,317,318,319,323,344,346,347,354,360,386,388,394,395,399,416,419,420,427,439,443,452,456,457,477,478,479,480,482,485,492,505,511,518,519,524,527],"float":[3,6,8,12,15,40,42,75,124,203,207,219,223,251,306,319,337,418,463,465,495,497,507,514,524],"function":[1,3,6,7,8,9,11,12,14,16,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,42,43,45,46,47,48,49,51,53,54,56,57,65,69,75,85,95,99,103,110,116,123,127,128,152,155,165,172,173,174,184,185,187,188,189,190,192,193,195,196,197,199,202,203,207,211,212,213,214,216,220,221,224,227,229,230,231,236,237,239,241,242,244,245,247,249,250,252,254,255,257,268,270,271,273,274,275,276,277,278,279,280,281,288,289,291,292,294,296,299,300,304,309,310,311,312,316,317,318,320,321,328,338,339,340,344,345,347,349,352,355,357,360,361,363,364,366,367,370,372,377,378,386,394,395,396,397,399,400,401,402,403,404,405,407,408,409,410,412,413,414,416,417,418,419,421,422,423,424,425,426,429,430,431,432,433,434,435,436,437,438,439,440,442,443,444,445,446,447,448,449,450,451,452,453,455,456,458,459,460,461,466,468,469,470,471,472,473,474,477,478,479,480,481,482,483,485,486,487,488,489,494,495,500,502,504,506,507,513,518],"import":[1,2,3,6,9,11,16,75,115,178,189,210,229,246,249,250,254,255,271,312,338,339,340,342,347,357,359,439,446,459,495,497,506,514,518],"int":[3,6,8,11,111,244,246,254,256,312,347,514],"long":[1,2,3,6,7,8,9,10,12,14,15,17,35,61,63,76,95,96,119,120,121,123,127,153,172,179,182,183,184,190,202,206,210,211,212,216,217,220],"new":[0,3,5,6,7],"null":[3,6,99,100,117,123,153,178,210,224,230,233,236,268,306,315,318,320,323,327,328,331,333,353,394,395,408,416,419,423,426,427,428,443,444,445,452,456,458,459,467,477,480,481,482,485,497,500,505,507,525],"public":[0,7,8,12,244,253,419,450,451,457,466],"return":[2,3,6,8,11,14,15,16,17,18,41,75,118,119,128,146,147,151,176,178,207,219,231,244,271,360,374,376,423,494,495,496,504,507,513,515,524],"short":[1,3,6,7,9,13,15,176,271,317,335,348,378,382,389,390,393,395,399,400,402,403,404,408,409,411,418,426,429,431,435,439,442,443,448,449,453,461,466,478,483,492,495,505,507,511,518,519],"static":[2,3,5,6,7,8],"switch":[1,3,6,10,12,13,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,43,45,46,47,48,49,51,53,54,56,99,123,152,155,165,177,184,185,187,188,189,190,192,193,195,196,199,206,209,213,217,224,231,239,245,249,253,254,257,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,309,310,317,320,321,344,345,355,361,363,364,366,367,370,372,374,376,378,381,388,392,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,446,449,452,453,455,458,459,460,461,468,477,478,480,481,482,483,485,487,488,489,491,492,494,497,499,500,504,506,510,512,519,524,527,529],"throw":514,"true":[6,12,13,16,119,126,129,203,204,219,225,227,231,271,272,298,299,300,304,317,342,346,358,360,393,418,423,466,477,495,499,507,524],"try":[1,3,8,12,16,18,219,251,257,343,344,345,350,495,519,524],"var":[3,11,12,178,358,376,508,524],"void":[4,6,7,8,41,181,225,244,500],"while":[1,3,9,11,12,13,17,74,75,115,152,161,176,189,203,208,217,229,231,235,247,248,253,254,255,257,263,271,294,307,308,312,314,318,348,378,386,393,399,410,416,458,459,480,482,485,492,495,506,511,518],__main__:495,__pthread_key_cr:12,_boundingbox:204,_compute_group_group:154,_compute_heat_flux:154,_compute_t:8,_j1m1m1:152,_j2m2m2:152,_manifold_rattl:519,_pair_lj:9,_serial:12,_wirnsberg:238,a10:360,a123:360,a12:460,a2m:[6,99],a_0:[257,347,399],a_0_real:257,a_1:347,a_2:347,a_3:347,a_4:347,a_c:407,a_cc:407,a_f:482,a_ij:399,a_pi:399,a_sigma:399,a_ss:407,aat:185,aatom1:[68,126],aatom2:[68,126],aatom3:[68,126],ab_23_cd:360,abbrevi:12,abc:[3,12,360,495,524],aberdeen:[88,89,240,322],abf:230,abf_integr:13,abi:208,abil:[3,229,271,304,317,418],abl:[3,8,9,11,12,39,94,203,208,228,237,245,287,343,350,393,495,524,528],ablat:347,abort:512,about:[0,1,3,6,8,9,11,12,13,15,16,39,41,42,63,65,82,119,126,127,130,172,178,203,204,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,231,232,233,235,236,237,238,239,243,244,245,246,249,250,251,252,254,255,256,257,258,259,260,261,262,263,264,265,267,270,276,280,281,282,283,284,285,286,287,288,289,290,293,297,298,299,301,302,303,304,305,306,308,309,310,311,312,313,314,315,316,317,319,320,321,331,332,333,335,336,338,339,340,341,342,343,344,345,346,347,349,350,351,352,354,355,356,357,358,375,378,385,386,388,393,398,404,409,426,455,459,488,495,498,499,504,505,507,512,516,519,524,527,529],abov:[1,2,6,7,8,10,11,12,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,35,37,40,41,42,43,44,45,46,47,48,49,50,51,53,54,56,59,65,66,71,74,75,76,77,80,81,94,95,97,98,99,103,104,106,107,123,125,127,130,152,153,155,156,157,158,159,160,161,164,165,166,167,168,170,171,172,176,177,178,180,181,184,185,186,187,188,189,190,191,192,193,195,196,197,199,203,204,205,206,207,210,211,212,213,214,219,220,222,223,225,228,229,231,232,237,241,244,246,250,252,254,255,256,260,270,271,276,300,303,305,310,316,317,318,323,331,335,338,339,340,341,358,360,361,362,363,364,365,366,367,368,370,372,378,380,383,387,388,392,393,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,429,431,432,433,434,435,436,437,438,439,440,441,442,443,446,447,448,449,450,451,453,455,456,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,483,484,485,487,488,489,490,491,492,493,494,495,497,498,499,500,501,504,505,506,507,508,511,512,515,518,519,524,525,528,529],abscissa:[450,451,478,479],absenc:214,absent:518,absolut:[3,207,217,230,231,235,318,323,337,377,378,386,423,431,498],absorb:347,absoult:378,abstol:318,ac3:177,academ:246,acc:342,acceler:0,accelri:[6,13],accept:[7,12,95,176,178,207,228,231,246,318,342,403,435,505,512,519],acceptanc:217,acceptor:425,access:[0,3,6,7,8,9,11,12,15,38,40,58,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,93,96,97,98,99,100,101,102,103,105,106,109,110,111,113,114,115,116,117,118,119,121,122,123,124,125,126,128,129,130,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,155,156,157,158,159,160,161,162,163,165,166,167,168,169,170,171,173,174,175,176,177,200,210,211,212,213,214,215,216,217,218,219,220,222,223,224,225,226,227,228,229,230,231,232,233,236,237,238,239,243,244,245,246,247,248,249,250,251,252,254,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,276,280,281,282,283,284,285,286,287,288,289,290,293,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,328,331,332,333,334,335,336,337,338,339,340,341,343,344,345,346,347,349,350,351,352,353,354,355,356,357,373,377,393,395,421,423,425,426,443,458,459,468,494,495,498,503,515,516,524],accident:519,accidenti:370,accler:[9,12],accommod:215,accomod:271,accompani:8,accomplish:[15,231,258,288],accord:[6,66,75,88,133,139,142,160,206,217,226,227,242,257,271,287,299,307,323,325,344,345,347,352,353,355,356,357,389,418,423,434,437,456,463,465,466,468,470,471,473,474,475,511,524],accordingli:[11,112,156,157,171,176,182,389,440,441,475],account:[3,6,95,130,160,176,177,186,198,220,222,236,238,251,252,254,271,277,278,279,291,292,294,296,298,302,308,317,319,321,331,333,334,335,338,339,340,343,347,350,366,387,409,414,423,431,435,440,441,443,446,466,494,511],accuml:[3,317,343,350],accumul:[6,8,14,75,88,154,210,220,221,254,317,323,349,375,393,503,523],accur:[1,3,6,9,14,16,37,41,56,161,225,269,312,317,318,321,335,343,350,356,358,378,399,418,422,423,448,460,476,478,479,480,482,511,516,524],accuraci:[1,3,6,12,41,202,203,207,225,238,248,271,309,321,348,358,377,378,385,395,418,448,450,451,458,459,478,479,486,506,511,516,518,524,528],accuractli:516,ach:377,achiev:[1,3,6,9,10,15,16,17,28,41,225,238,246,248,271,272,287,299,300,307,377,426,506],achiv:17,acid:9,ackland1:416,ackland2:416,ackland:2,acknowledg:0,acml:12,aco:524,acolor:[206,207],acoust:299,acquir:[3,6,60,63,64,181,182,227,229,231,271,454,490,502,518],across:[1,2,3,6,9,12,13,14,41,59,63,68,71,73,75,84,102,119,126,128,166,180,182,219,222,225,236,250,317,318,319,324,343,347,350,356,360,388,393,492,497,500,501,505,514,516],act:[3,6,73,119,129,163,235,249,252,253,254,255,257,260,270,317,328,342,344,345,347,356,357,358,386,401,412,422,423,425,460,475],acta:[130,177,394],actinid:[9,446],action:[2,6,11,12,75,247,252,345,518],activ:[5,8,11,12,13,15,55,61,95,176,230,247,251,254,260,266,270,297,317,318,326,346,375,439,476,506,518,521,524],active:[266,491],actual:[1,3,6,8,12,56,64,134,161,203,204,207,211,212,224,226,227,235,254,255,294,298,303,304,312,315,323,335,338,339,340,342,348,357,358,377,389,422,424,429,434,440,441,475,494,495,506,507,515,524],actualli:337,adam:[377,378],adapt:[2,3,6,9,95,172,210],adapti:298,adaptiv:[9,230,395],add:[0,1,3,5,6,7,8,9,11,12,13,14,15,16,17,18,40,42,75,95,99,112,125,128,129,131,176,178,179,203,204,205,206,210,211,212,213,214,216,218,219,220,222,223,227,230,235,237,238,244,248,249,250,252,254,256,257,261,269,270,271,272,273,274,275,276,277,278,279,291,292,294,295,296,298,306,316,317,320,321,331,332,334,338,340,341,345,346,347,349,351,352,356,358,378,380,385,387,395,400,402,405,409,418,426,431,443,448,449,453,459,461,495,497,498,503,505,507,509,516,518,519],add_molecul:216,add_speci:216,add_to_nodeset:216,added:[498,519],addforc:[2,3,210],adding:[8,213,237,316],addit:[1,2,3,4,6,7,8,9,12,13,14,15,16,17,19,21,28,32,36,37,39,40,41,42,44,50,55,56,65,118,119,124,154,178,179,181,182,186,191,197,198,199,200,201,206,207,208,210,213,221,224,225,229,230,235,237,238,241,242,246,248,249,250,254,257,271,272,273,274,275,276,277,278,279,289,291,292,294,295,296,298,306,317,320,321,322,324,348,351,352,356,362,368,371,373,378,380,388,390,393,394,395,399,400,402,404,406,408,409,412,414,415,416,417,418,419,423,424,426,427,428,430,431,439,441,442,443,444,445,446,448,450,451,452,453,456,458,459,461,466,467,476,477,478,479,480,481,482,485,489,492,497,498,499,504,505,506,509,511,518,519,520,522,524,527,528,529],addition:[0,4,6,8,11],additionali:204,addres:9,address:[7,8,11,206,253,519],addtorqu:2,adequ:[263,335,348,377,388,506],adher:28,adhikari:257,adiabat:0,adiam:[206,207],adjac:[39,176,178,238,388,448,478,479,480,511,512],adjiman:447,adjust:[2,3,6,15,16,41,61,130,140,156,157,158,161,162,165,166,171,172,177,182,203,206,219,225,229,231,251,254,258,262,267,268,271,272,276,294,298,301,303,304,307,308,309,310,315,317,318,326,335,339,343,348,350,351,352,354,355,357,377,378,386,388,393,395,415,440,441,466,482,507,525],adjust_radiu:326,adjust_radius_factor:326,admiss:276,adof:[158,219],adopt:[316,518],adp:[2,3,7],adri:[9,313,458,459],adust:172,advanc:[3,15,251,399,492,503],advantag:[1,6,8,11,17,39,40,41,225,393,417,506,511],advect:[3,6,335],advertis:8,advis:[318,388,457,516],afer:3,affect:[1,6,10,14,16,40,62,63,75,96,128,153,162,176,182,206,207,212,219,220,222,223,226,227,228,229,231,232,238,244,250,252,254,260,266,268,272,273,274,275,277,278,279,285,291,292,294,296,317,319,333,347,357,370,377,384,385,386,388,389,390,393,418,440,441,448,494,495,497,499,500,502,505,507,516],affin:[15,16,17,231,393,408],affiniti:393,afile:248,aforement:17,afresh:[305,505,524],afshar:413,after:[2,3,5,6,8,11,12,14,20,21,32,39,40,41,44,50,59,60,61,63,65,75,156,157,158,159,160,161,162,165,166,167,168,170,171,178,179,181,182,185,186,191,197,202,203,204,205,206,207,208,210,211,212,216,217,219,220,225,226,227,228,229,231,235,246,257,258,259,260,261,267,268,269,271,277,278,279,285,291,292,294,296,299,303,307,315,317,318,321,330,332,336,338,339,340,342,343,344,345,346,350,352,354,358,361,362,368,376,383,384,386,387,389,391,392,393,394,395,399,406,408,416,417,418,419,420,426,427,428,439,440,441,443,444,445,446,450,451,452,456,458,459,466,467,476,477,479,480,481,482,485,492,494,496,497,498,499,500,502,503,505,507,509,511,514,515,516,518],afterrun:505,afterward:3,afterword:41,ag1:177,ag2:177,again:[6,11,12,16,64,152,158,164,172,203,207,231,238,250,303,361,376,388,440,441,492,494,495,497,499,504,511,513,524,527],against:[11,12,13,66,232,388,458,459],aggreg:[6,12,68,71,73,84,102,119,126,250,267,315,317,333,492,525],aggress:[238,250,511],agilio:[9,13],agre:[3,8,199,386,395,428,459],agreement:[5,7],ahd:425,ahead:354,aidan:[0,5,7,9,13,380],aij:13,aim:6,airebo:[2,3,7,226,227,314],ajaramil:[7,9,13],aka:206,akohlmei:[7,9,13,208,251],aktulga:[7,9,310,459],al2o3:466,al2o3_001:[130,319],al3:177,ala:[257,466],alain:9,alat:[298,443],albe:[456,480,482],albeit:316,albert:9,alchem:[95,172],alcohol:350,alcu:[394,399],alcu_eam:456,alderton:412,alejandr:[271,272],alessandro:13,algebra:446,algorithm:[0,1,6,7,8,9,41,63,207,210,216,225,228,231,238,250,257,259,260,285,300,308,317,321,322,342,343,347,350,355,384,385,386,390,393,414,418,441,446,463,465,492,494,511],alia:[9,15],alias:[1,378],aliceblu:207,align:[6,9,12,28,41,75,180,199,225,252,380,497,500,518],alkali:418,all:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,21,32,36,38,39,40,41,42,44,50,54,55,57,58,59,61,62,63,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,166,171,172,173,174,175,176,177,178,179,180,181,182,184,186,191,197,198,199,200,203,204,205,206,207,208,210,211,212,213,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,234,235,236,237,238,239,240,241,242,243,244,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,263,264,266,267,269,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,289,290,291,292,293,294,295,296,297,298,299,300,302,303,304,305,306,307,308,309,310,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,330,331,332,334,335,336,337,338,339,342,343,344,345,346,347,348,349,350,352,353,354,355,356,357,358,359,360,361,362,366,371,373,375,376,377,378,379,380,383,386,387,388,389,390,392,393,394,395,396,398,399,400,402,403,404,405,406,408,409,412,413,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,435,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,488,489,490,491,492,494,495,496,497,498,499,500,501,502,504,505,506,507,508,509,510,511,512,514,515,516,518,519,523,524,525,527,528,529],allen:[28,95,412,422],allentildeslei:95,allign:3,allindex:359,alloc:[3,5,6,8,9,11,12,62,244,349,387,389,393,454,459,497,505],allocat:3,alloi:[2,3,12,13,394,399,409],allosw:75,allow:[1,2,3,6,8,9,11,12,13,14,15,16,17,21,36,38,39,40,41,55,57,58,59,60,61,63,64,65,81,100,117,119,154,156,157,158,171,176,177,178,180,186,198,199,200,202,203,204,206,207,208,210,211,213,214,215,216,217,219,220,221,222,223,224,225,227,228,229,230,231,232,233,236,237,244,246,247,248,249,251,252,254,257,260,261,266,268,271,272,289,298,302,303,304,305,306,307,309,311,316,317,318,319,320,321,323,325,326,330,331,332,333,334,335,342,343,344,345,347,348,349,350,351,352,356,358,360,362,371,373,377,378,380,386,387,388,389,392,393,395,396,399,400,401,402,403,404,409,416,418,423,424,425,426,431,435,440,441,446,448,456,459,460,463,465,466,475,483,486,488,490,492,495,497,499,500,501,502,503,504,507,509,510,511,514,515,519,524,525],almost:[2,3,12,15,62,252,307,347,378,390,393,475],alo:409,alon:[6,7,228,313,458,459,495],alond:13,along:[6,8,12,28,40,74,75,95,130,176,177,178,202,203,206,219,228,238,252,257,258,262,263,268,270,307,317,321,323,327,331,333,342,346,347,353,356,358,380,382,384,385,386,388,409,412,423,426,429,431,435,443,458,459,478,479,497,500,507,508,524],alonso:[444,445],alpha:[6,12,51,211,257,307,308,312,386,394,397,400,409,413,414,416,417,419,420,425,430,431,443,449,455,481,483,515,518],alpha_c:439,alpha_i:467,alpha_lj:439,alphabet:[2,3,21,36,44,55,65,186,198,210,362,371,387,406,476,497],alphanumer:[3,65,210,306,314,360,387,524],alreadi:[3,7,8,9,12,16,17,42,57,178,179,181,205,215,219,225,227,231,261,305,307,335,358,359,387,388,413,424,426,433,441,475,486,489,493,497,498,502,507,523,524],also:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,21,28,35,36,37,39,40,41,42,44,54,55,56,60,61,63,65,69,74,75,76,77,79,81,86,87,88,89,95,97,98,100,103,113,114,115,116,117,118,120,121,123,125,127,128,131,152,153,154,155,156,157,158,159,160,161,162,164,165,166,167,168,170,171,172,173,174,175,178,179,180,181,182,184,186,198,199,201,202,203,204,205,206,207,208,210,211,212,213,215,218,219,220,221,222,223,224,225,226,227,228,229,231,232,237,240,241,242,244,245,246,247,248,250,251,254,255,256,257,266,268,269,271,272,273,274,275,276,277,278,279,284,288,289,291,292,294,295,296,298,299,300,302,303,304,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,327,328,331,333,335,338,339,340,341,342,346,347,348,349,351,353,356,358,359,360,362,368,371,375,377,378,380,381,383,386,387,388,389,390,392,393,399,403,404,406,410,411,412,413,416,417,418,422,423,425,426,427,435,439,440,443,446,448,452,454,455,456,457,459,460,461,463,470,471,473,474,476,477,478,479,480,481,482,483,485,492,494,495,496,497,498,499,500,501,502,504,505,506,507,509,510,511,512,515,516,517,518,519,520,522,523,524,525,527,529],alter:[3,6,8,9,11,12,41,61,155,156,157,158,159,161,164,165,166,167,170,171,178,182,203,204,206,208,211,212,219,226,227,228,229,231,270,271,312,315,317,320,328,335,343,350,357,385,388,426,497,502,504,507,524,525,529],altern:[1,6,8,9,11,12,15,16,17,99,178,203,210,220,231,240,251,255,271,306,317,318,342,343,350,363,367,377,385,386,394,395,409,414,416,417,419,428,431,439,443,444,445,452,456,457,467,477,480,482,485,495,497,498,510,512,515],alternat:[386,518],although:[15,28,42,199,260,271,304,308,317,342,376,504,518,529],aluminum:489,alwai:[0,6,11,12,15,16,17,54,59,65,75,176,207,219,220,221,223,227,230,246,248,252,309,312,317,335,352,356,357,361,377,378,384,386,387,389,390,393,402,405,416,434,446,450,451,458,459,466,468,478,479,480,482,489,492,497,498,500,502,509,511,514,518,524,525],amap:207,amatrix:248,amaz:11,amazingli:13,amber2lmp:0,amber:0,ambient:206,ambigu:[3,65,210,524],amd:[16,393,446],amino:9,amit:9,among:[15,153,217,257],amorph:[178,481],amount:[1,3,6,12,61,96,126,176,180,202,206,217,221,229,230,246,250,254,271,298,304,317,318,326,335,340,343,348,350,358,377,393,413,454,497,500],amplitud:[231,268,327,353,370,500,524],amu:246,amzallag:466,analag:[6,524],analalog:6,analog:[6,117,152,180,199,423],analys:[7,502],analysi:[7,9,13,65,66,77,208,313,314,324,359,446,467,497,507],analyt:[1,3,9,13,130,172,177,321,377,399,427,428,433,446,456,478],analyz:[6,8,9,13,388,446],andersen:[287,293,321],anderson:[302,413],andre:[7,9,13],andrew:13,andzelm:475,ang:[15,298,518],angl:[0,1,2,3,6,7],angle1:316,angle2:316,angle:[3,8,15,21,28,32,36,37,68,387,497],angle_coeff:[2,3,19,20],angle_cosine_shift:26,angle_cosine_shift_exp:[25,187],angle_cutof:425,angle_cutoff:425,angle_hybrid:[28,67],angle_info:459,angle_styl:0,angle_typ:40,angleangl:[3,361,368,497],angleangletors:[3,185,497],anglecoeff:[3,38],angles:207,angletors:[3,185,191,497],angletyp:227,angmom:[2,3,6,65],angmomi:[124,129,203,204,337],angmomx:[124,129,203,204,337],angmomz:[124,129,203,204,337],angstrom:[6,10,61,75,129,130,167,177,178,202,203,204,206,207,215,231,232,246,251,252,268,310,315,352,354,355,357,378,380,384,390,394,395,404,416,439,443,452,457,458,459,482,489,500,506,523,525],angular:[6,28,40,63,65,69,90,91,92,93,116,124,129,152,156,157,170,171,178,203,204,210,254,260,267,268,273,274,275,277,278,279,281,282,283,286,289,290,291,292,296,315,317,321,327,337,394,399,408,423,440,441,443,446,456,476,480,481,497,507,524,525],angularm:282,anharmon:[26,53,187,312,511],ani:[1,3,6,7,8,9,10,11,12,13,15,16,21,28,37,38,39,40,41,42,44,55,56,58,60,61,63,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,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,155,156,157,158,159,160,161,162,163,165,166,167,168,169,170,171,172,173,174,175,176,177,178,179,181,182,184,186,197,199,200,202,203,204,205,206,207,210,213,214,215,217,219,220,223,224,225,226,227,228,229,230,231,232,234,235,237,238,242,243,246,249,250,252,254,257,260,267,268,271,276,298,300,302,303,304,306,308,309,310,312,314,315,317,318,320,321,323,327,328,331,334,335,336,337,346,347,352,353,354,356,358,359,360,362,373,376,377,378,380,383,384,386,387,388,390,391,392,393,395,399,403,404,408,409,412,413,416,417,419,422,426,427,428,435,446,448,450,451,456,458,459,460,467,476,477,478,479,480,481,482,483,484,485,490,491,492,494,495,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,515,516,518,519,520,522,523,524,525,527,528,529],anihil:[439,449],anim:[2,4,7,11,13,206,388],animat:[4,206],anion:[419,466],aniso:[3,229,231,271,272,273,274,275,276,277,278,279,304,317],anisotrop:[254,422,460],ann:447,annoi:519,annot:[7,477,480,481,482,485,497],annual:[492,511],anoth:[3,6,7,8,9,11,12,15,16,28,40,65,75,131,205,206,210,211,217,219,222,223,228,231,232,238,247,250,254,255,260,271,272,276,303,317,319,338,339,340,347,357,360,384,386,388,389,392,409,413,418,419,422,425,426,430,431,439,458,460,468,475,478,480,481,482,491,492,495,498,504,512,518,519,524,529],another:[1,6,12,76,95,127,306,317,382,506],ansi:[9,12,15],answer:[3,4,8,12,317,390,391],anthoni:345,antiquewhit:207,antisymmetr:[9,40,396],antisymmetri:418,antonelli:[344,345],antonio:455,any:[1,3,6,12,14,42,61,68,73,176,202,203,206,207,213,214,224,227,231,233,249,252,268,304,320,328,353,355,357,426,458,475,492,494,495,497,498,500,508,511,525],anymor:345,anyon:7,anyparticl:94,anyth:[8,11,178,231,253,477,480,482,508,519],anywai:[181,393,518,527],anywher:[12,178,406,443,467,524],aoff:[387,497],aparam:[95,211,212],apart:[3,179,260,331,389,398,468,497,506],aperiod:299,api:[9,11,12,208,427,495],appar:3,appear:[2,3,6,11,12,13,39,40,41,76,81,95,100,117,119,126,127,152,161,178,179,181,203,204,206,207,219,225,229,232,235,246,251,303,314,346,358,360,361,377,386,387,388,407,416,443,448,450,451,466,478,479,485,493,494,495,497,498,499,502,504,518,524,529],append:[1,2,3,9,11,12,14,15,16,17,18,39,41,57,60,61,63,68,71,73,74,75,84,95,96,98,99,100,102,113,115,117,119,120,121,123,126,128,130,131,152,153,156,157,158,166,167,171,172,176,177,178,180,181,182,202,204,206,207,210,211,212,213],appendix:[28,412,466],appl:[229,271,272,485],appli:[2,3,4,5,6,8,9,12,16,17,28,32,41,50,59,61,63,65,75,76,95,96,115,127,152,153,158,164,166,168,172,177,178,180,184,186,191,198,202,203,204,206,207,210,211,212,213,214,216,219,225,229,230,231,233,236,237,238,240,241,242,244,245,246,247,248,249,251,252,254,255,256,257,261,271,272,276,277,278,279,285,291,292,296,297,298,300,304,307,315,316,317,320,321,323,324,327,331,332,334,336,338,339,340,341,343,345,346,347,350,358,377,380,386,387,388,398,400,402,404,409,412,418,420,423,424,425,426,428,429,431,437,441,446,448,451,453,458,461,462,463,464,465,475,479,483,488,497,498,500,501,502,506,507,509,514,516,518,524,525,527,528],applic:[1,6,9,12,15,16,208,228,232,233,244,246,248,251,298,303,306,316,323,331,343,350,377,393,482,507,518],applicat:216,appling:229,apply:[95,224,229,233,248,254,255,256,321,331,332,333,334],applyt:3,appopri:[9,16],approach:[6,7,15,197,203,216,247,299,300,312,317,342,343,345,347,350,377,399,409,411,414,415,422,426,446,460,462,464,475,486],appropri:[1,2,3,6,8,9,11,12,13,14,16,32,37,42,50,56,57,63,77,96,99,119,126,127,128,129,156,157,158,186,191,198,199,202,203,204,207,219,220,223,228,229,231,244,245,248,257,266,268,269,271,273,274,275,276,277,278,279,291,292,294,296,300,303,304,307,312,317,322,335,338,339,340,343,350,352,353,355,356,357,368,378,388,395,399,403,407,408,409,417,423,426,428,435,439,446,457,458,459,477,478,479,480,481,482,485,486,497,498,499,501,502,510,511,514,524,525],approri:249,approxim:[6,9,130,134,177,246,248,257,300,319,321,342,377,382,384,385,386,401,411,418,420,422,440,441,446,448,451,457,460,466,479,483,488,511,518],april:11,aprpopri:492,apu:[440,441],aqua:[206,207],aquamarin:207,ar_thermal:216,ar_ttm:216,ara:13,arbitrari:[6,40,60,127,203,204,206,208,230,231,249,271,300,304,308,318,477,495,508,524],arbitrarili:[11,61,127,152,202,229,271,409,524],arcco:3,arch:[1,9,12,14,16],architect:375,architectur:[393,446],archiv:[6,7,9,12,337,406,504],archive:[11,12],arcsin:3,area:[6,41,99,123,127,176,225,231,257,343,350,415,423,455,484,494,507],aren:[127,360,459],arflags:12,arg:[3,11,12,21,40,41,44,55,61,65,75,95,119,126,128,166,172,176,178,181,182,186,202,203,204,205,207,210,211,212,213,215,217,219,220,221,222,223,224,225,226,227,230,231,232,237,238,244,246,249,250,251,252,260,263,268,273,274,275,287,293,303,316,317,319,320,324,327,328,330,342,345,352,353,354,355,357,358,362,375,388,393,400,401,402,404,405,406,411,412,414,418,424,426,431,435,439,440,441,442,449,453,461,463,465,476,483,494,495,497,500,502,504,506,508,510,515,516,524,525,528,529],argon:246,argonn:12,args:495,argument:[2,3,6,8,11,12,15,16,19,20,21,22,23,24,25,26,27,28,29,30,31,34,37,40,41,42,43,44,45,46,47,48,49,51,53,54,56,61,65,74,77,95,99,117,123,127,152,153,155,160,165,166,167,172,176,178,179,180,182,184,185,186,187,188,189,190,192,193,195,196,199,203,204,207,210,211,212,213,215,218,219,220,221,222,223,224,225,229,230,231,239,241,242,244,245,246,248,249,253,254,260,268,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,302,303,305,309,310,314,317,318,319,320,321,335,347,349,353,355,358,360,361,362,363,364,366,367,368,370,372,375,376,378,379,380,383,388,392,393,394,395,397,398,399,400,401,402,403,404,405,406,407,408,409,411,412,413,414,416,417,419,420,421,422,423,424,425,426,427,428,429,431,432,433,434,435,436,437,438,439,440,442,443,444,445,448,449,450,451,452,453,455,456,458,459,460,461,466,467,468,476,477,478,479,480,481,482,483,485,487,488,489,491,492,493,494,495,496,497,498,500,502,505,506,507,508,512,514,515,524,525,528],aris:[12,488],arithmet:[3,6,113,377,404,407,434,448,483,484],arkansa:9,arl:[9,88,89,240,322],armv8:16,army:[88,89,240,322],arnold:377,around:[1,3,4,6,9,12,42,59,60,61,69,74,75,76,77,81,127,129,152,156,173,176,178,180,184,197,202,206,207,214,215,229,231,232,252,268,271,304,306,308,312,317,327,331,335,352,353,356,376,382,387,466,497,500,507,508,518,524],aroung:3,arrai:3,arrang:152,arrheniu:[318,511],arriv:15,art:[9,492,511],artefact:248,articl:[6,466],articul:[7,9,302],artifact:[96,176,518],artifici:[269,307,470,471,473],arun:13,arxiv:[152,205,287,293,382,467],ascend:[41,207,251,260,317,502],asci:7,ascii:[13,204,319,346,388,416,419,443,497],ash:[440,441],asid:[8,393],aside:[178,443],asin:524,ask:[3,11,519],askari:455,askoos:13,asoci:206,aspect:[6,7,61,231,246,422,460,484,497,507,511],aspect_ratio:319,asper:4,aspher:[0,2,3,4],asphere:4,asq:[440,441],assembl:4,assign:[1,2,3,6,7,11,12,14,16,17,32,38,39,40,41,50,58,59,61,63,65,69,75,76,79,86,98,103,114,116,121,124,125,129,130,152,153,158,173,175,177,178,181,191,202,203,204,205,206,207,208,210,211,212,215,219,222,225,227,228,229,232,234,246,251,254,255,256,257,268,271,273,274,275,276,277,278,279,289,291,292,294,295,296,300,303,304,306,308,314,317,319,338,339,340,341,358,368,378,380,383,387,388,392,393,399,416,419,422,425,426,450,451,459,460,489,494,495,497,498,499,500,501,506,507,512,515,524,525],assignemnt:[6,506],assignment:14,assing:306,assingn:478,assist:[7,269],associ:[3,5,6,8,12,21,36,39,40,44,55,61,69,78,79,86,87,95,97,98,103,109,111,113,114,116,129,142,173,186,198,203,204,206,207,211,212,213,217,229,231,237,244,246,247,253,257,268,271,302,312,316,317,318,319,333,335,359,360,362,371,380,386,388,392,393,406,409,413,414,415,416,418,425,426,428,431,435,450,451,462,464,475,476,478,479,495,498,505,517,518,521,524],associd:70,assum:[2,3,4,6,9,11,12,16,17,39,61,70,75,96,106,112,114,155,156,157,158,159,160,161,163,164,165,166,167,168,170,171,176,178,181,207,211,212,217,219,220,222,223,229,231,243,251,253,257,260,273,274,275,277,278,279,281,283,286,289,290,291,292,296,298,299,303,304,305,308,317,320,323,331,343,346,347,352,355,358,365,377,378,387,388,393,399,401,403,406,407,415,418,425,426,430,435,440,441,492,494,495,497,499,502,507,511,514,515,518,519,525],assume:[172,388,484],assumpt:[176,251,394,448],astar:443,astart:468,asterisk:[21,44,63,81,95,127,172,182,186,207,211,212,260,317,362,383,406,425,475,491,494,507,523],astop:[386,468],asu:416,asub:443,asubrama:13,asum:306,asymmetr:[139,238,355,399,416],asynchron:[14,15],atan2:524,atan:524,atc:[2,7],atc_fe_output:216,athomp:[0,7,9,13],atm2pa:6,atmospher:523,atobodi:129,atol:12,atom1:[302,316,387,497],atom2:[302,316,387,497],atom3:[302,316,387,497],atom4:[316,387,497],atom:[0,1,2,3,4,5],atom_element_map:216,atom_forc:459,atom_info:459,atom_modifi:[2,3,11],atom_styl:[2,3,6,9,12,36,39],atom_vec:8,atom_vec_atom:8,atom_vec_electron:8,atom_veloc:459,atom_weight:216,atomey:[6,7,11,13,203,206,207],atomfil:[3,6,75,306,358,392,507,524],atomic:[0,466],atomic_charg:216,atomic_numb:456,atomid:[129,497],atomist:[6,216,342,446],atomperbin:3,atoms:[203,255,518],atomt:207,atomvec:8,attach:[6,300,323,331,497],attatch:345,attempt:[3,6,41,61,75,202,217,225,226,227,228,232,246,303,304,335,355,377,381,388,426,495,512,515,524],attend:216,attent:[14,17],attogram:523,attrac:443,attract:0,attribut:[3,6,7,8,9,11,39,40,42,60,65,75,95,124,125,126,128,129,156,172,203,204,206,207,210,211,212,218,219,222,228,229,271,273,274,275,276,277,278,279,281,282,291,292,294,296,304,317,319,337,338,339,340,380,387,399,418,426,497,498,499,507,515,524],attribute1:126,attribute2:126,atw:[440,441],atwater:481,atwt:443,atyp:[68,126,172,227,409,431,435,439],atype:172,au1:177,au3:177,aug:11,augment:[9,12,124,229,306,443],augt1:443,auo:314,auoh:314,author:[3,8,9,13,205,416,417,518],auto:[3,6,8,9,11,12,99,174,210,220,221,323,349,377,387,393,494],autocorrel:[65,99,254],autom:[9,12,206],automag:7,automat:[3,6,9,12,14,15,16,17,18,35,140,199,215,221,246,248,257,317,323,348,377,393,408,416,426,443,446,459,462,463,464,465,489,497,510,518,519,524],auxiliari:[1,6,9,11,12,13,203,299,317,498,502,527],avail:[1,3,5,6,7,8,9,11,12,13,14,15,16,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,63,65,95,123,124,152,155,165,176,184,185,187,188,189,190,192,193,195,196,199,203,206,210,211,213,219,222,223,224,229,230,231,239,245,247,249,250,251,254,271,272,273,274,275,276,277,278,279,280,281,287,289,291,292,293,294,296,309,310,311,317,318,319,320,321,345,355,361,363,364,366,367,370,372,375,378,382,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,418,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,441,443,444,448,449,452,453,455,456,458,459,460,461,467,468,477,478,480,481,482,483,485,487,488,489,498,500,506,510,524],availabl:15,avalo:[322,414],ave:12,ave_chunk:6,aveforc:[2,3,6,210,213],avendano:447,averag:[3,6,7,12,14,41,65,66,75,88,89,95,99,100,113,115,127,130,154,158,166,174,177,203,204,207,210,212,216,218,219,220,221,222,223,224,225,229,246,248,250,254,260,271,272,276,299,304,307,313,314,317,318,319,323,361,395,414,418,420,443,451,479,483,498,502,515,518,524],averi:335,avesq:128,avg:12,avi:206,avoid:[1,3,6,12,35,39,61,129,178,179,199,206,215,220,222,223,235,246,248,255,298,300,308,312,317,319,349,356,391,399,418,439,443,449,459,478,479,483,499,505,506,518],avx2:15,avx512:15,avx:15,awai:[3,6,63,127,203,206,219,228,232,249,252,270,298,323,331,346,352,389,409,431,435,502],awar:[393,417,494],awpmd:[2,7],axel:[7,9,13,17],axi:[3,6,41,74,75,100,130,142,156,177,178,180,202,206,219,225,246,249,252,268,303,327,331,347,353,366,372,380,382,497,500,507],axial:276,azimuth:[206,249],azur:207,b_k:467,ba2:177,babadi:460,back:[1,6,7,11,12,13,14,16,129,159,160,161,165,166,167,168,170,178,182,203,204,207,208,211,212,230,235,244,251,252,254,255,271,277,278,279,291,292,294,296,306,315,317,338,339,340,344,345,354,355,357,376,377,378,388,423,495,497,498,499,500,501,504,510,511,524,525],backbon:[228,321,370],backcolor:[207,528],backend:16,background:[9,95,96,123,153,207,225,231,254,335,343,347,350,388,407,440,441,443],backtrack:[384,386],backward:[12,208,388,511,524],baczewski:247,bad:[3,12,61,63,252,388,497,502,514],badli:[3,229,271],bal:342,balanc:[1,2,3,4,6,7,12,14,15,17],balasubramanian:295,ball:[152,440,441],ballenegg:377,bammann:216,band:[4,6,7,9,152,210,270,385,388,399,446,466],bandwidth:[1,10,17,40],bandwith:206,bar:[95,206,523],barashev:416,bare:[235,253,255],barost:[235,518],barostat:[0,1,3],barostt:6,barr:408,barrat:312,barrett:70,barrier:[3,4,6,270,372,388,408,421,511],bartel:299,bartok2010:467,bartok2013:467,bartok:[9,152,457,467],bartok_2010:457,bartok_phd:457,bary:523,barycent:330,basal:2,base:[3,4,6,8,9,11,12,13,14,15,19,65,66,75,82,95,99,113,122,130,158,160,177,178,180,203,205,206,207,210,216,225,226,227,231,232,236,246,251,254,258,260,285,293,299,300,303,306,308,310,317,318,319,323,324,335,342,378,393,395,397,399,413,418,422,425,426,427,429,431,440,444,445,453,455,456,466,477,481,482,485,492,494,497,498,499,501,504,507,508,511,512,515,519,523,524,525,529],bash:406,bashford:[6,19,184,404,509],basi:[3,6,12,40,152,158,178,215,254,256,299,335,352,380,429,507,524],basic:[6,7,8,12,16,41,124,153,206,207,216,225,271,272,298,356,394,396,446,491,499,518],basin:[94,388,492,511],bask:[416,443,456],batch:516,bath:[9,307,312],batom1:[73,126,128,203,207],batom2:[73,126,128,203,207],bayli:[6,184,509],bb13:185,bcc:[2,3,4,7,66,74,77,210],bcolor:[3,206,207],bdiam:[3,206,207],be2:177,bead:[5,7,10,13,40,45,46,170,214,228,300,475],beam:232,bear:[6,247],becau:13,becaus:[0,1,3,6,8,12,15,16,17,40,41,42,61,66,75,76,81,100,117,127,140,152,158,163,168,178,179,180,203,204,205,206,207,208,213,219,225,226,227,228,229,231,237,245,246,247,248,253,254,255,256,266,268,271,272,285,287,294,303,307,308,312,317,331,337,342,343,346,347,350,354,355,356,357,358,364,377,384,386,388,389,392,393,404,406,409,411,413,418,419,422,423,424,425,426,430,439,440,441,443,448,450,451,460,475,476,478,483,484,494,495,497,499,500,501,504,506,507,509,511,512,518,519,523,524,525,527,529],beck:[2,3],becker:[394,416],beckman:251,becom:[1,2,3,6,7,8,15,17,39,41,54,59,61,75,180,203,204,206,207,225,226,227,228,231,238,246,248,257,270,271,314,315,338,339,352,353,355,356,357,377,378,384,388,395,407,409,416,418,422,431,448,456,460,477,485,488,497,498,500,507,519,524],been:[1,2,3,6,7,8,9,11,12,13,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,41,42,43,45,46,47,48,49,51,53,54,56,59,61,62,65,68,73,75,95,123,124,125,126,128,129,131,155,156,157,158,159,160,161,165,166,167,168,170,171,179,180,181,182,184,185,187,188,189,190,192,193,195,196,199,202,203,204,206,207,208,213,215,217,218,219,220,222,223,224,225,228,229,230,231,232,239,245,246,249,251,252,254,255,257,258,259,260,261,266,268,269,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,302,303,304,307,309,310,311,314,315,317,320,321,330,336,338,339,340,347,348,349,352,353,354,355,357,358,361,363,364,366,367,370,372,376,377,378,386,389,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,415,416,417,418,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,441,444,445,446,449,452,453,455,458,459,460,461,468,475,477,478,480,481,482,483,484,485,487,488,489,490,492,494,495,497,498,499,500,501,503,507,511,514,515,524,525,527,528],befor:[1,2,3,6,8,12,16,21,28,39,40,41,44,57,61,69,75,78,79,86,87,97,98,103,113,114,115,116,125,158,161,166,167,173,178,179,181,182,186,201,202,207,211,212,213,214,215,217,219,222,223,224,225,229,234,235,245,246,251,253,254,255,257,260,268,271,277,278,279,291,292,296,299,306,307,308,311,312,317,319,320,336,338,339,340,346,352,353,354,358,362,383,384,386,388,393,419,420,423,439,443,446,451,476,479,486,492,494,495,498,499,500,501,502,504,505,507,511,514,515,518,519,524,525,527,528,529],began:[5,12],begin:[3,8,12,37,39,56,75,128,131,179,199,202,203,207,211,212,216,218,219,220,222,223,225,231,241,242,266,285,302,315,318,319,332,335,337,340,349,354,357,358,374,376,377,378,379,381,385,387,388,389,392,416,420,446,448,450,451,456,463,465,466,468,475,478,479,489,492,497,504,511,513,515,523,524,527],begun:318,behalf:3,behav:[3,26,187,385,386],behavior:[3,182,199,203,204,206,208,228,229,232,246,247,248,251,254,255,256,271,303,307,312,335,338,339,347,385,399,418,443,489,491,499,503,523,524,527],behaviour:[6,254],behind:[8,253,269,307,335,377],beig:207,belak:7,believ:11,bellott:[6,19,184,404,509],bellow:366,belong:[2,3,40,75,129,132,181,217,219,246,260,317,358,387,462,497],below:[1,2,3,4,5,6,8,9,10,11,12,14,15,16,21,37,39,40,41,42,44,54,56,61,62,65,68,71,73,75,81,84,99,102,123,124,127,128,130,152,153,158,164,166,172,176,177,178,181,182,184,186,198,199,202,203,204,206,207,210,211,213,214,216,219,220,221,222,224,225,227,228,229,231,232,237,241,242,244,246,249,250,252,254,255,260,268,269,271,276,277,278,279,291,292,296,298,303,306,307,308,315,316,317,318,320,321,328,331,335,336,337,338,339,340,343,344,345,347,350,352,353,358,360,362,375,377,380,382,383,384,386,387,388,390,393,394,395,396,399,400,401,404,405,406,407,409,412,416,418,419,420,422,423,424,425,426,429,431,432,433,434,435,436,437,438,439,440,441,442,443,447,448,450,451,455,458,459,460,461,467,468,475,476,478,479,484,485,487,488,489,490,491,492,495,497,498,499,500,502,504,505,507,509,510,511,513,514,515,517,518,519,524,525,529],bench:[1,6,9,10,11,12],benchmark:[1,7,10,11,12,13,14,15,16,17,41,225,377,510],beneath:232,benedict:446,benefici:[63,390],benefit:[1,15,247,483,506],bennet:95,beowulf:7,berardi:[422,460],beraun:347,berendsen:[2,3,6,7,159,160,161,165,166,167,168,170,210,217,246,248,271,276],berensen:317,berger:9,berkelei:176,berkowitz:377,berlin:[7,9,323],bern:[3,300,308,309,408,422,466,476,506],bernendsen:6,beryllium:418,besid:[8,320,500],best:[1,6,8,14,15,16,17,18,271,294,295,316,317,393,399,409,431,435,448,478,479,498,506,511],beta:[6,307,394,397,416,417,419,443,480,481,482,515,524],beta_:399,beta_k:467,beta_pi:399,beta_sigma:399,beta_t:481,better:[3,6,7,8,12,15,26,152,187,212,225,246,257,271,285,289,308,315,317,335,378,388,393,480,519],betwe:398,between:[1,2,3,4,5],beutler:439,bewteen:[119,220,335,343,350,426,429,494],beyon:506,beyond:[3,5,6,12,16,63,75,95,176,203,207,222,246,271,377,390,421,437,448,511,515,524],bflag1:[42,206],bflag2:[42,206],bgq:[16,446],bi3:177,bi5:177,bia:[3,6,8,123,153,156,157,158,159,160,161,165,166,167,168,170,171,210,219,230,231,246,254,255,271,277,278,279,291,292,293,294,296,312,338,339,340,342,525],bias:[6,9,230,525],biaxial:156,biersack:[443,476,482,489],big:[3,4,12,203,307,312,335,389,407,519],bigbig:[3,12],bigger:3,bigint:[3,244],bilay:[4,10,331],bilayer1:331,bilayer2:331,bill:7,billion:[3,7,10,12,39,246,505],bin2d:75,bin3d:75,bin:[3,6,11,12,39,65,69,75,79,86,98,103,114,116,125,127,158,166,173,175,203,207,219,222,299,307,312,332,335,343,350,389,390,393,415,454,498,528],binari:[3,6,7,9,12,13,15,32,36,50,55,191,198,203,204,205,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,235,236,237,238,239,243,244,245,246,247,248,249,250,251,252,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,319,320,321,323,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357,368,371,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,449,450,451,453,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,487,488,489,490,498,499,504,527,529],binary2txt:0,binchunk:219,bind:[9,16,17,205,399,466],binsiz:[15,39,207,389,393],binstyl:166,bio:[40,389],biolog:[6,7],biologi:190,biomolecul:[302,317,377,378,404],biomolecular:506,biophi:[287,293,382],biophys:251,bios:15,biosym:13,bird:415,bisect:[41,225,484],bisector:[6,409,431,435],bispectrum:[65,152,467],bisqu:207,bit:[3,11,12,16,39,244,255,448,478,479,483,505,518,519],bitmap:[3,478,479,486],bitrat:[206,207],bitzek:385,bkgd_dyn:443,bks:[307,312],black:207,blais:[9,13],blanchedalmond:207,blank:[2,3,12,37,56,118,199,206,241,242,302,317,318,387,388,399,417,420,443,450,451,452,467,477,478,479,480,481,482,485,494,495,497,524],blas:12,blast:347,blend:443,block:[2,3,6,99,152,178,180,181,303,356,380,382,393,399,418,456,467,500,511,518,519],blocksiz:393,blow:[3,285,352,356,468],blown:3,blue:[2,206,207,228],bluegen:[203,377,446],blueviolet:207,bni:75,board:[378,412],bodi:[0,2,3,4,5],body_nparticl:8,bodyflag:497,bodyforc:257,bodyforcei:257,bodyforcex:257,bodyforcez:257,bodystyl:[260,317],boff:[387,497],bogaert:342,bogu:[3,161,229],bogusz:96,bohr:[416,418,446,482,523],boltzmann:[6,7,9,95,99,123,155,158,159,160,161,164,165,166,167,168,170,219,228,242,254,257,258,259,260,261,276,351,413,512,523],bond:[0,1,2,3,6,7],bond_coeff:[2,3,6,43],bond_graph_cutoff:459,bond_harmon:[8,48,49],bond_harmonic_shift:49,bond_info:459,bond_interact:216,bond_styl:0,bond_typ:182,bond_writ:2,bondangl:[3,20,32,497],bondbond13:[3,185,497],bondbond:[3,20,32,497],bondchk:459,bondcoeff:[3,58],bonds:207,bondtyp:[226,227,387],bonet:[322,414],bonu:[3,527],book:[488,519],bookkeep:448,bookmark:0,boost:[1,3,12,66,389],bop:[2,3,9,314,383],border:[3,7,15,63,347,525],boresch:95,boreschkarplu:95,born:[2,3,6,7,9,95,172,211,212],boron:418,borrow:323,bose:312,botero:[7,9,13,418],both:[1,3,4,6,7,8,9,11,12,14,15,16,26,36,39,40,54,55,59,61,63,64,65,71,73,75,91,95,96,119,124,126,127,140,154,156,157,158,163,166,168,171,176,178,180,181,182,187,198,199,203,206,209,210,211,212,217,219,220,222,223,226,227,228,229,230,231,236,238,246,248,250,252,254,255,257,258,267,268,271,272,277,278,279,285,291,292,296,302,303,306,307,314,317,321,323,331,335,339,343,344,345,347,350,352,353,355,356,357,360,361,371,378,383,386,387,388,389,391,393,395,399,400,401,402,403,404,405,407,412,413,416,417,418,422,423,425,426,427,431,433,435,436,437,439,440,441,446,447,448,449,453,458,460,461,477,480,481,482,485,492,494,495,497,498,499,500,504,509,514,515,518,524,527,528,529],bottleneck:[1,3,495,516],bottom:[8,9,161,176,207,231,245,257,294,343,350,380,509],bottomwal:224,bounc:[3,335],bound:[3,6,16,25,26,41,42,59,61,75,167,180,187,202,203,204,207,222,225,231,232,236,246,255,271,303,335,352,353,354,355,356,357,377,386,418,497,500,511,518,524,525],boundar:3,boundari:[2,3,5,6],boundary_dynam:216,boundary_faceset:216,boundary_integr:216,bounds:[6,41,203,225],bount:11,bourgogn:9,box:[0,1,2,3,4],boxcolor:[206,207],boxxlo:11,bpclermont:[9,13],bptype:475,br1:177,bracket:[2,3,6,41,65,75,128,131,210,218,219,220,222,223,225,349,515,524],bragg:[130,177],branch:11,branicio2009:485,branicio:[77,485],breakabl:[7,44,55],breakag:[82,226],breakdown:[1,12,14,96,118,395,458,459,492,511],brennan:[9,88,89,240,322,414,450,451,475],brenner:[395,476],brick:[3,41,63,64,166,180,225,497,499,501,524],bridg:382,brief:[1,5,6,7,8,12,253,271,395,399,459,511],briefli:[6,10,300,408,466,519],brilliantov:423,bristol:[5,7],brittl:455,broader:495,broadli:8,broadwel:15,broken:[2,54,68,73,74,82,113,118,126,182,226,271,399,499,509,516,527],brook:6,brought:202,brown:[7,9,13,14,15,130,153,207],brownian:[2,3,6,7,9,115,254,256,287,317,351],brownw:7,brows:0,browser:[4,206],bryantsev:425,bsd:12,bstyle:[40,42],btype:[57,73,126,179,203,409,431,435,439,475],buc:402,buck:[2,3,6,9,15,95,211,212,348,378,400],buckingham:[7,9,211,212,308,378,400,402,403,411,442,476],buckplusattr:466,buffer:[3,8,204,206,207,514],bufi:206,bug:0,bui:206,build:[0,1,2,3,6,7,8,9,10],builder:[7,13],built:[1,2,3,4,6,8,9,11,12,13,14,15,16,19,20,22,23,24,25,26,27,28,29,30,31,32,34,35,36,37,40,43,45,46,47,48,49,50,51,53,54,55,56,66,70,82,85,88,89,91,94,95,106,107,108,109,110,111,115,122,123,129,130,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,154,155,156,157,162,164,165,169,170,172,176,177,184,185,187,188,189,190,191,192,193,195,196,197,198,199,203,204,205,208,210,213,214,215,217,221,224,226,227,228,230,231,232,237,238,239,240,241,242,243,245,246,247,248,249,251,253,254,256,257,258,259,260,261,263,264,265,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,306,307,308,309,310,311,312,313,314,317,318,320,321,322,323,324,325,326,327,328,330,335,341,342,343,344,345,347,348,350,353,354,355,359,360,361,363,364,365,366,367,368,370,371,372,378,388,389,390,393,394,395,397,398,399,400,401,402,403,404,405,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,449,450,451,452,453,454,455,456,457,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,492,495,498,500,506,510,511,512],bulatov:[444,445],bulk:[4,6,74,257,298,304,410,443,446,448,455,462,464,466,501],bullet:7,bump:254,bunch:8,bundl:[9,206,208,519],burlywood:207,bussi1:339,bussi2:339,bussi:[248,339],button:519,buyl:[9,205],bybe:9,bypass:6,c11:[220,443],c12:220,c13:220,c1n:220,c21:220,c22:220,c23:220,c2n:220,c31:220,c32:220,c33:220,c34:220,c3n:220,c41:220,c42:220,c43:220,c44:220,c_0:[347,395,473,474],c_1:[68,71,73,84,102,119,128,129,130,177,203,207,247,306,319,358],c_2:[68,73,84,102,119,128,130,174,176,177,203,319,349,358],c_3:[128,319],c_6:176,c_cluster:6,c_cstherm:6,c_dist:128,c_doubl:11,c_e:347,c_flux:99,c_foo:524,c_forc:128,c_gauss:421,c_hb:425,c_i:242,c_id:[6,65,75,95,128,131,203,204,218,219,220,221,222,223,319,337,349,515,524],c_ij:6,c_ijkl:6,c_index:128,c_k:247,c_ke:343,c_msdmol:131,c_my_stress:218,c_mycentro:219,c_mychunk1:125,c_mychunk2:125,c_mychunk:[6,69,79,86,98,103,114,116,158,173,175],c_mycom:222,c_mycomput:219,c_myd:204,c_myf:[203,528],c_myrdf:[127,223],c_mytemp:[8,220,221,222,223,349,515,524],c_n_k:247,c_p:153,c_pe:121,c_peratom:[121,153],c_pi:399,c_press:128,c_prop:6,c_radiu:176,c_reax:[458,459],c_saed:319,c_sigma:399,c_size:6,c_stress:203,c_tdrude:[235,255,518],c_thermo_press:[8,220,221,222,223],c_thermo_temp:223,c_xrd:222,ca2:177,cach:[15,16,39,448,510],cacul:321,cadetblu:207,cai:518,calcal:9,calcforc:257,calclat:99,calcluat:[115,121,123,153,409],calcualt:[99,219],calcul:[0,1,3,4],caldwel:[6,184,509],calhoun:300,call:[1,3,6,7,8,11],callabl:[3,11],callback:[3,8,11,154,210,244,495],caller:3,calori:523,caltech:[6,7,9,13,418],calucl:6,calul:[11,12,74,158,378],cambridg:[9,457],campana:299,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,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,53,54,55,56,57,58,59,60,61,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,184,185,186,187,188,189,190,191,192,193,195,196,197,198,199,200,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,236,237,238,239,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,370,371,372,373,374,375,376,377,378,380,381,383,384,386,387,388,389,390,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,504,505,506,507,508,509,510,511,512,513,514,515,516,518,519,523,524,525,526,527,528,529],cancel:[210,317,525],candid:[182,217,246],cannot:[1,2,3,6,9,11,12,13,14,15,16,38,39,40,41,54,58,59,60,61,71,75,90,92,96,128,131,154,156,158,179,181,182,200,203,204,205,206,207,218,219,220,222,223,225,228,229,231,232,246,247,248,254,255,256,260,268,271,273,275,277,279,281,282,283,289,291,296,303,304,307,312,314,317,319,320,324,335,343,347,349,350,352,353,356,357,358,360,373,377,380,386,388,391,392,393,402,403,405,416,422,424,431,435,437,439,448,453,458,460,461,462,464,475,476,478,479,492,494,495,497,498,500,501,503,506,507,509,511,514,523,524],canon:[9,210,217,246,248,271,272,291,292,293,294,295,296,300,339,342,345,446,455],cao1:300,cao2:300,cao:300,capabl:[5,7,9,11,15,16,17,354,360,378,393,395,405],capac:[9,40,111,164,240,312,347,470,497,507],capit:[234,497],capolungo:[130,177,319],captur:[6,348,395,403,418,423,435,443,518],carbid:409,carbon:[7,206,370,395,408,428,443],card:[12,15,21,44,81,95,127,186,211,212,317,362,383,406,425,491,499,504,527,529],care:[3,6,61,75,178,181,197,202,219,226,227,232,248,253,257,271,303,317,342,398,495,497,500,501,506,507],carefulli:[11,12,54,314,358,426,428,502],carlo:[4,6,7,9,210,217,228,246,317,342,415,476],caro:[217,416],carpent:[7,13],carri:[15,264,306,347,423,459],carrillo:15,cart:[3,494],carter:[9,16],cartesian:[3,6,64,394,494],carv:181,cascad:[236,347],cash:7,cast:[248,524],cat:[14,15,206],catastroph:308,cate:257,categori:0,cation:[419,466],cauchi:[145,150],caus:[1,2,3,6,8,12,15,16,178,180,181,182,203,207,215,229,236,246,271,285,298,303,315,317,318,321,352,354,355,356,357,360,376,378,386,388,392,425,431,437,440,441,448,491,495,496,497,498,502,504,505,524,529],caution:[1,378],cautiou:[226,227],cautious:395,caveat:[395,506],cbecker:[394,416],cc1:[6,69,79,86,98,103,114,116,125,158,173,175,219],ccc:[417,477,480,482,485],ccflag:15,ccflags:[9,15,16,17,18,203],ccm6:416,ccsi:[417,477,480,482,485],ccu:399,cd2:177,cdeam:416,cdennist:9,cdll:11,cdof:[6,158,219],cdte:399,cdte_bop:399,cdtese:399,cdzn:399,cdznte:399,ce3:177,ce4:177,ceas:385,ceil:524,cell:[3,6,61,96,127,130,176,177,178,203,215,229,230,246,251,269,271,272,276,299,307,310,322,347,377,378,380,415,418,446,515],cella:[6,515],cellalpha:[6,515],cellb:[6,515],cellbeta:[6,515],cellc:[6,515],cellgamma:[6,515],center:[3,6,24,42,65,69,75,78,79,86,94,97,98,108,113,114,115,125,127,129,130,158,159,160,163,166,170,173,175,178,206,207,210,211,212,214,219,222,229,231,232,233,235,246,247,252,254,255,260,267,271,277,278,279,291,292,294,296,303,308,314,315,317,319,323,331,332,333,335,337,338,339,340,342,343,345,352,356,361,380,382,387,398,417,418,422,423,429,440,441,443,444,445,458,459,477,480,481,482,484,485,500,507,518,524],centimet:523,centr:238,central:[3,63,74,80,81,100,117,127,134,152,176,260,298,321,333,365,387,446,452,458,459,485,497],centro:[2,3,5,6,7,8,65,66,70],centroid:[3,300,484,507],centrosymmetri:74,cerda:377,ceriotti2:248,ceriotti:[13,248,253],certain:[1,2,3,6,8,12,16,39,75,124,128,131,182,203,204,206,218,219,220,222,223,228,244,245,317,320,336,349,360,368,376,389,426,448,459,483,499,503,518,524],certainli:252,cerutti:378,cfg:[3,6,7,9,13,203,205,206,207,208],cfile:459,cfl:[140,324],cfor:323,cg_type:461,ch2:321,ch2lmp:[0,6],ch3:321,ch5md:205,chain3:389,chain:[0,3,4,6,9,10],challeng:[6,323],chalopin:312,champaign:[251,377,378,440],chan:446,chandler:[394,416],chandrasekhar:[6,431],chang:[1,2,3,6,8,9,11,12,14,15,16,39,40,41,46,55,59,61,64,75,85,95,113,127,138,140,160,161,162,178,179,180,182,199,202,203,204,205,206,207,208,210,211,212,213,214,216,217,224,225,226,227,228,229,230,231,232,236,237,243,245,246,248,250,251,252,254,256,257,258,260,267,268,269,271,272,273,274,275,276,277,278,279,285,287,289,291,292,294,295,296,298,299,303,304,306,307,308,311,314,315,316,317,318,320,321,323,335,338,339,340,341,343,344,345,346,347,348,350,353,356,358,378,384,386,388,391,393,413,418,423,426,440,441,443,446,448,458,459,466,475,476,492,493,494,495,497,498,499,500,501,502,503,505,506,507,508,509,512,515],change_box:[2,3,6,59],changeabl:203,channel:[4,213],chapter:[300,378],charact:[2,3,6,12,37,41,56,65,199,203,204,206,207,208,210,225,241,242,306,314,318,360,387,392,418,420,430,450,451,456,458,459,466,478,479,494,495,499,504,505,524,527,528,529],character:[6,70,74,117,127,152,467,492,511],characterist:[255,335,344],charg:[1,3,4,5,6,7,9,11,14,40,86,95,96,124,130,177,178,203,204,208,210,211,212,217,232,237,246,306,308,309,310,314,337,350,377,378,387,400,402,408,409,411,412,416,418,419,426,431,435,439,453,458,459,466,476,482,483,485,486,488,489,497,498,502,507,509,518,523,524],charmm2lammp:13,charmm:[0,2,3,5],chartreus:207,cheap:335,cheaper:[236,422,460],check:[3,6,8,9,11,12,14,16,38,39,41,58,75,99,199,200,217,225,226,227,232,243,246,252,253,303,316,321,335,343,345,350,358,360,373,376,386,387,388,389,390,393,415,427,430,448,459,490,492,494,495,497,505,511,514,515,516,524],checkf:199,checkout:519,checkqeq:459,checku:199,chem:[6,13,19,20,24,39,40,43,45,46,95,96,117,123,153,184,185,195,221,230,235,238,247,248,255,257,270,271,272,289,294,295,300,304,307,309,317,322,323,335,338,339,342,343,344,345,352,361,370,372,377,378,385,388,395,400,404,405,408,409,410,412,413,414,418,421,422,424,425,431,435,436,439,443,447,448,450,451,453,466,475,483,506,509,511,518],chemic:[9,40,88,89,130,172,177,203,204,216,217,246,308,313,314,342,378,420,451,458,459,471,479],chemistri:[307,308,310,395,399,418,458,459],chen:347,cheng:408,chenoweth:[458,459],chenoweth_2008:[458,459],chi:[102,167,202,298,308,310,373,419,422,525],chiefli:457,child:8,chip:[7,9,16,17,393,510],chipot:230,chiral:370,chmod:[11,12],cho:443,chocol:[7,207],choic:[3,6,9,12,14,15,17,40,41,54,74,95,153,156,157,171,182,197,199,219,225,228,231,232,248,254,257,269,271,300,304,308,317,342,353,371,378,384,385,388,390,393,426,439,448,454,459,497,506,507,510,511,517,518,523],choos:[1,3,6,7,8,9,12,16,17,28,39,54,95,128,168,169,206,226,227,228,229,232,243,254,257,269,271,273,274,275,276,277,278,279,303,304,322,335,339,353,377,378,385,486,492,494,506,512],chose:[480,482],chosen:[2,3,6,12,16,152,178,181,190,199,206,212,217,229,232,243,246,247,255,257,269,271,276,300,303,314,335,339,342,343,348,350,351,357,378,379,385,393,414,418,423,430,433,461,480,492,506,511,512,518],chri:176,christian:[7,9,16],christoph:7,chunk:[0,2,3],chunkid:[69,79,86,98,103,114,116,125,158,173,175,219,332],chute:[4,9,10,249],ciccotti:321,cieplak:[6,184,509],cii:220,cij:220,circl:[42,75,330],circular:[3,6,156,201],circumst:17,circumv:[100,117,312],citat:0,cite:[3,7,8,12,254,466],civ:9,cl1:177,clarendon:[28,412],clarifi:[7,480,482],clariti:360,clark:453,class2:[2,3],classic:[0,3,5,6,7,8,9,15,244,300,307,312,347,372,418],classifi:[476,485],claus:495,clean:[6,12,14,16,505],cleanli:[496,515,528],clear:[2,3,6,8,11],clearli:7,clebsch:152,clermont:[9,13],clever:501,click:[2,11,21,36,44,55,178,186,198,206,251,362,371,388,406,476,519],client:[251,253],climb:[270,388,511],clinic:[7,13],clo:[167,202,525],clock:[12,492,511,516],clockwis:[184,353],clone:519,close:[3,6,11,12,13,39,41,70,75,153,181,203,227,228,229,248,255,257,271,287,294,317,321,353,356,376,378,381,384,385,388,393,395,399,409,410,429,443,448,450,451,458,462,464,478,482,501,507,518,519,521],closer:[3,10,41,127,176,202,203,225,229,233,344,388],closest:[227,298,317,350,422,460,475,486],cloud:[466,518],clovertown:17,clsuter:76,clump1:[302,317],clump2:[302,317],clump3:[302,317],clump:317,cluster:[2,3,6,7,12,15,63,65,75],clutter:3,cmap:497,cmatrix:248,cmax:443,cmd:[11,12,300,508],cmdarg:11,cmin:443,cmm:7,cmoput:145,cn1:220,cn2:220,cna:[2,3,7,65,74],cnn:220,cnr:13,cnrs:9,cnt:[426,501],co2:[40,177,318,321,387,420],coars:[7,9,10,28,35,40,54,190,242,302,317,318,335,420,424,451,461,479,506,509],coarser:[378,524],coarsest:152,code:[0,1,3,5],coeff:[3,7,8,12,20,21,32,44,50,184,185,186,191,197,361,362,368,406,426,430,448,463,465,468,497,526],coeffcient:497,coeffici:[0,2,3,4],coefficienct:413,coefficient0:416,coefficient1:416,coeffieci:[6,397,429],coeffincientn:416,coexist:[246,418],cohes:[6,419,443],coincid:[134,356,404,440,441,492],colberg:205,cold:[6,163,246,250,389,518],coldest:343,coleman8:9,coleman:[9,130,177,319],colin:9,collabor:[7,8,14],collect:[3,6,7,8,9,13,40,42,69,79,86,91,98,103,108,114,116,125,158,166,173,175,178,203,204,207,219,230,260,267,302,312,315,317,358,377,387,389,407,497,504,510,516,529],collid:[236,335,357],colliex:177,collinear:[3,302],collis:[3,257,335,353,357,415,423,489],colllis:335,colloid:[2,3,4,6,7],colombo:39,colon:[208,358,498,516],color1:207,color2:207,color:[3,9,41,203,206,207,225,247,307,312],column:[3,6,9,12,13,42,65,68,69,70,71,73,74,75,79,81,84,86,87,89,98,100,102,103,114,116,117,119,121,124,125,126,127,128,129,131,152,153,158,166,173,175,176,177,199,203,204,207,210,218,219,220,222,223,260,268,269,307,317,336,337,347,357,395,421,425,458,459,498,512,514,524],columnar:176,colvar:[0,2,9,12],colvarmodul:12,com:[2,3,6,7,9,13,14,42,65,75],comamnd:231,comand:228,comannd:393,comb3:[2,3],comb:[2,3,4,7,9,210,308],comb_1:309,comb_2:309,combiant:410,combin:[3,6,7,9,11,13,35,40,65,68,73,84,95,102,113,119,126,156,157,171,197,203,206,216,222,238,246,251,260,263,271,287,293,300,306,322,339,348,356,359,361,377,378,380,385,393,407,409,410,414,418,419,420,426,438,439,467,477,480,482,483,485,488,500,505,510,518,524,526],come:[0,2,3],comfort:[12,13],comid:332,comit:519,comm:[0,3,11,12,63,77,205,251,253,254,378,388,393,413,448,455,478,479,499],comm_modifi:[2,3,6,39],comm_modift:63,comm_styl:[2,3,41,63],comm_world:11,command:[0,1],comment:[2,4,7,11,12,37,56,184,199,203,241,242,255,317,318,347,387,388,394,416,417,419,420,430,443,450,451,452,459,466,467,477,478,479,480,481,482,485,494,495,497,518,519,524],commerci:7,commit:[9,519],commmand:[3,6,12,61,118,295,429,491,492,494,511,528],common:[0,1],commonli:[3,6,9,12,16,24,59,61,115,117,180,203,206,208,372,424,433,467,480,482,497,500,509],commun:[1,3,6,7,8,9,10,11,12,14,15,17,40,41,60,63,64,75,176,181,182,206,207,225,226,227,229,230,231,251,253,257,259,260,261,271,299,306,308,309,310,317,322,335,347,358,375,377,389,390,391,393,414,415,454,490,494,495,506,507,524,527,529],communc:377,comp:[7,205,253,254,287,293,321,378,388,418,448,455,460,474,478,479,481],compact:[65,210,406,476],compani:[5,7],compar:[1,3,4,6,8,12,15,16,39,94,121,130,161,177,186,198,207,235,308,358,360,377,378,386,388,443,466,492,511,512,518,523],comparison:0,compart:382,compass:[7,9,20,21,36,43,44,55,185,186,198,361,362,371,405,476],compat:[3,5,7,8,9,11,12,13,16,17,41,75,128,131,189,203,208,212,218,219,220,222,223,225,238,299,311,339,342,349,352,355,377,393,427,446,448,478,494,495,524],compens:[6,226,227,315,389,418],compet:346,competit:378,compil:[3,7,8,9,12,13,14,15,16,17,18,176,203,205,206,208,251,346,378,393,446,497,498,502,518,524],compl:16,complain:[11,12,16],complement:443,complementari:[7,409,431],complet:[3,6,9,11,12,14,41,61,75,207,225,230,260,300,303,306,335,346,348,359,360,376,388,393,419,463,465,484,492,497,502,505,509,511,514,518,524],complex:[4,6,8,11,12,13,24,40,42,64,100,117,152,154,166,178,179,257,287,330,356,375,388,418,446,478,479,495,497,500,524],compli:[342,346],complic:[6,7,9,12,13,129,217,246,495],complier:12,compon:[3,6,8,12,63,65,69,70,74,77,86,87,96,97,98,99,100,103,104,107,112,114,115,116,117,118,119,120,121,123,124,128,129,139,142,143,144,145,148,149,150,152,153,155,156,157,158,159,160,161,162,163,164,165,166,167,168,170,171,173,174,175,202,203,204,206,207,213,214,218,219,220,221,222,223,224,228,229,231,232,237,238,244,249,253,254,257,260,262,263,267,268,270,271,272,276,277,278,279,291,292,294,296,297,299,300,301,304,315,317,320,321,323,327,328,331,335,338,339,340,342,349,350,355,356,357,377,380,385,386,387,388,393,413,418,423,440,441,463,465,466,467,497,498,507,515,524,525],componenet:6,componennt:129,composit:[6,217,257,416],compound:[408,418,419,485],compres:[75,125,219],compress:[3,6],compris:[40,356,420,460,484],compton:[130,177],comptu:3,compuat:378,comput:[0,1],computation:[3,6,226,227,347,399],computational:518,compute_arrai:8,compute_inn:8,compute_ke_atom:8,compute_loc:8,compute_modifi:[2,3,65],compute_peratom:8,compute_sa:[130,319],compute_scalar:8,compute_temp:8,compute_vector:8,compute_xrd:177,concaten:[2,3,528],concav:356,concentr:[75,242,318,416,420,451,479],concept:[6,158,168,219,506],conceptu:[3,6,75,166,229,231,388,409,426,443,502],concern:[6,77,95,205,247],concetr:75,concis:[11,346],conclud:12,concret:8,concurr:[15,378,524],conden:[347,480,482],condens:[6,160,347,395,411,416,431,485],condit:[2,3,5,6],conducit:6,conduct:[0,2,3,4],cone:500,confer:[15,446],confid:[3,511],config:[12,203,494],configfil:230,configur:[1,2,6,12,14,15,16,37,61,134,180,199,202,203,206,210,229,230,231,232,236,246,253,254,285,300,308,346,375,386,388,395,399,417,443,446,477,480,482,485,492,497,499,500,511,515,519],confin:[497,511],confirm:516,conflict:[3,12,40,204,448,495,519],conform:[3,6,13,61,228,229,270,316,323,346,370,388,418,509],confus:[3,485],conjuct:[9,413],conjug:[7,8,254,385,418,458,459],conjunct:[6,7,75,94,95,125,161,166,172,178,182,207,211,212,254,257,261,285,303,304,308,309,310,312,317,322,335,343,350,355,377,378,388,400,402,406,409,413,418,425,431,448,453,461,483,497,500,504,518,529],connect:[3,6,9,95,163,181,228,251,302,317,321,331,382,388,410,423,458,459,475,482,494,495,497,501,518],conner:395,connor:395,conput:3,consecut:[3,11,12,39,75,178,207,211,212,232,251,252,409,431,435,492,498,500],consequ:[1,6,217,347,430,511],conserv:[3,9,28,210,217,228,235,236,247,250,254,256,257,261,267,269,271,285,287,289,317,318,321,322,338,339,343,350,351,355,388,412,413,414,423,437,466,506,511],consid:[6,74,75,82,95,126,129,160,163,164,181,203,204,207,211,212,218,220,225,227,228,232,258,272,299,317,342,343,346,347,350,378,406,418,426,459,460,466,475,492,493,495,498,499,500,502,505,507,515,518,524],consider:[6,8,254,255,338,339,340,393,459,506],consist:[3,6,8,9,11,12,40,42,68,73,84,102,114,119,122,123,126,129,158,161,163,178,190,202,208,213,214,219,231,232,235,237,244,247,254,255,256,268,271,273,274,275,276,277,278,279,280,281,283,284,285,286,289,290,291,292,294,295,296,304,307,312,314,315,316,317,318,338,339,340,341,351,377,378,380,382,387,388,393,395,399,401,407,409,418,422,426,429,440,441,443,446,448,450,451,460,463,465,466,478,479,486,495,497,498,499,500,501,502,509,518,524],consistent_fe_initi:216,consit:317,constant:[0,3,4],constantli:238,constitu:[3,6,260,317,352,356,407,460],constitut:[463,465],constrain:[3,6,8,9,155,156,157,158,159,161,164,165,166,167,168,170,171,210,219,232,238,246,247,252,260,263,265,287,293,302,303,315,317,321,333,343,350,386,387,418,502,509,518],constraint:[3,5],construct:[6,8,12,37,54,56,63,66,70,74,76,77,81,100,117,130,152,177,229,271,299,316,318,356,389,393,412,446,448,475,477,478,479,500,501,516,524],constructor:[8,11],consult:[15,459],consum:[1,312,454,524],consumpt:375,contact:[0,2,3,4,5,8,9,12,13,40,42,65],contact_stiff:[462,464],contain:[0,1,2,3,4,6,8,9,11,12,13,16,17,18,37,40,41,56,65,95,99,127,130,152,154,158,166,176,177,178,180,184,186,198,199,203,204,206,207,208,210,211,212,216,218,219,220,222,223,225,230,232,237,241,242,248,252,253,254,257,269,285,298,299,302,303,305,306,307,310,314,317,318,319,324,335,342,346,347,356,357,360,376,378,387,388,391,392,394,395,396,399,408,409,412,416,417,418,420,426,427,443,446,450,451,452,456,457,458,459,467,477,478,479,480,481,482,483,485,492,493,494,495,497,498,499,500,502,504,506,509,511,512,514,515,518,519,524,527,529],content:[4,8,9,12,17,459,513,515],context:[3,6,8,12,15,16,127,128,207,226,227,232,302,314,351,385,488,497,504,513,523,524,525],contibut:74,contigu:494,contin:15,continu:[0,2,3,5,6,9,12,13,41,75,87,113,114,174,207,210,211,212,217,219,220,221,222,223,225,228,229,230,231,232,238,246,247,248,250,251,252,254,255,256,262,268,269,271,273,274,275,276,277,278,279,291,292,294,295,296,301,303,306,307,317,319,323,334,335,337,344,345,347,353,356,360,376,392,393,399,413,415,433,436,458,459,460,463,465,481,492,495,497,499,500,505,511,512,514,515,524,527],continuum:[6,7,9,216,347,463,465],contour_integr:216,contract:[61,229,231,271,304,317],contradictori:3,contrain:321,contraint:285,contrari:[248,255],contrast:[1,6,42,55,66,160,163,204,231,358,463,465,488,528],contrib:347,contribut:[3,4,5,6,7,8,9,12,13,16,65,67,69,71,72,74,75,78,79,81,83,85,86,92,95,96,97,98,99,101,103,112,114,116,118,119,120,121,123,125,128,152,153,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,172,173,174,175,212,217,218,219,220,222,223,229,246,254,257,260,261,266,272,294,295,302,303,311,314,317,319,321,349,377,386,388,396,413,415,416,418,426,440,441,446,448,458,459,466,509,515,518,519],contributor:12,control:[3,5,6,7,8,9,11,13,15,26,28,41,95,99,134,152,187,203,204,206,210,216,217,225,229,230,231,250,251,254,255,271,273,274,275,276,277,278,279,304,309,317,318,325,326,338,339,340,347,351,375,377,390,418,422,446,458,459,462,464,477,482,492,494,506,512,513],control_typ:216,controlfil:459,convect:99,conveni:[6,12,28,203,208,223,319,380,467,483,516,519,524],convent:[3,8,28,189,196,198,204,207,316,331,359,416,418,524],converg:[3,6,41,96,203,204,206,208,213,225,228,229,237,244,276,287,293,307,309,312,316,321,384,385,386,388,408,409,431,466,492,504,511,516],convers:[3,8,152,206,207,217,220,304,377,409,410,411,418,431,435,439,453,495,511,523],convert:[2,3,4,5,6,7,8,12,13,19,20,23,27,31,34,35,61,65,75,99,178,185,203,206,207,220,223,269,303,306,358,361,363,367,370,380,388,394,416,446,480,482,489,495,497,498,499,504,514,518,523,524,527,529],convex:[42,356],convinc:[7,12],cook:9,cooki:7,cool:[7,168,238,250,315],cooordin:[203,204],cooper:[5,7],coord123:125,coord1:[3,125,219],coord2:[3,125,219],coord3:[3,125,219],coord:[2,3,6,7,11,61,65,75,76,80],coordb:466,coordbb:466,coordiat:386,coordin:[1,3,4,6,7,8,11,13,14,16,40,41,42,61,63,64,65,69,71,75,78,79,81,86,87,95,97,98,103,113,114,116,124,125,127,129,146,152,161,167,173,175,176,178,182,202,203,204,205,206,207,208,210,213,218,219,222,225,226,227,228,229,230,231,232,235,237,238,239,244,246,249,250,251,252,253,254,255,268,270,271,273,274,275,277,278,279,294,297,298,299,302,303,304,314,315,317,320,321,323,328,331,332,333,334,335,337,345,346,347,354,355,357,358,380,386,387,388,393,394,395,398,417,466,492,497,498,499,500,502,505,507,511,518,524,525],coordn:[125,219],coords:466,copi:[0,3,4,8,9,11,12,14,16,40,131,206,347,388,406,458,495,519],copper:489,coprocessor:[1,7,9,15,16,393,510],coproprocessor:16,copy_arrai:8,copyright:[7,8,302],coral:207,core:[0,1,3,4],core_shel:160,cores:518,coreshel:[4,6,9],coreshell:[4,6],cornel:[6,184,509],corner123i:124,corner123x:124,corner123z:124,corner1i:124,corner1x:124,corner1z:124,corner2i:124,corner2x:124,corner2z:124,corner3i:124,corner3x:124,corner3z:124,corner:[3,6,40,124,206,356,357,380,484,497,519],cornflowerblu:207,cornsilk:207,corp:9,corpor:15,corr:408,correct:[3,6,9,11,12,16,61,86,95,96,112,113,118,121,127,160,165,172,184,204,206,231,238,246,248,254,271,272,294,302,304,307,346,352,356,377,388,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,411,412,413,415,416,417,418,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,484,485,487,488,489,490,497,512,515,518,519],correction_max_iter:216,correctli:[3,8,11,16,75,87,112,113,114,155,156,157,159,161,163,164,165,166,167,170,171,174,203,207,213,232,237,244,255,265,271,272,310,317,321,331,334,353,356,388,389,393,411,441,446,494,495,497,507,519,523,525],correl:[2,3,6,99,100,152,174,210,219],correpond:[241,242],correspond:[1,2,4,6,8,9,10,11,12,19,20,21,22,23,24,25,26,27,28,29,30,31,34,37,40,42,43,44,45,46,47,48,49,51,53,54,56,74,75,95,106,107,123,124,125,126,129,130,131,139,142,143,144,145,146,148,149,150,152,155,156,165,172,176,177,184,185,186,187,188,189,190,192,193,195,196,197,199,202,203,204,206,207,211,212,213,219,221,222,224,227,229,231,238,239,242,244,245,249,254,257,258,267,268,269,271,273,274,275,276,277,278,279,280,281,285,289,291,292,294,296,298,299,300,304,309,310,317,318,320,321,342,352,353,355,356,357,359,361,362,363,364,366,367,370,372,378,383,385,387,388,394,395,397,400,401,402,403,404,405,406,407,408,409,412,413,416,417,418,419,420,421,422,423,424,425,426,429,431,432,433,434,435,436,437,438,439,440,443,444,446,448,449,451,452,453,455,456,458,459,460,461,466,467,468,477,478,479,480,481,482,483,485,487,488,489,492,494,495,497,498,500,510,511,512,514,515,518,524],correspondingli:[440,441,506],corrupt:3,cosin:[2,6,7,21],cosineshift:26,cosmo:[248,253],cossq:2,cost:[1,6,10,11,12,16,39,41,75,120,130,153,177,206,207,219,225,226,227,243,271,289,309,318,347,377,378,391,409,431,435,446,448,477,494,506],costheta0:[477,480,482,485],costheta:456,costli:[11,15,96,248,389],couett:4,coul:[2,3,6,9,15,35,45,46,76,95,118,127,172,184,211,212,348,378,386],could:[2,3,6,9,11,12,16,32,41,50,61,69,75,79,86,95,98,103,114,116,120,123,125,158,168,173,175,191,203,204,206,207,211,212,219,220,225,231,244,253,306,307,308,312,315,317,320,335,336,342,346,347,348,352,356,358,360,368,374,376,384,386,389,393,395,396,421,425,426,429,458,459,493,494,495,497,499,501,504,505,512,513,518,524,525],coulomb:[3,5,6,7,8,9,10,12,14,17,76,96,118,119,127,153,179,183,308,310,348,377,378,386,393,400,402,403,404,405,408,409,410,411,412,418,423,424,426,431,435,439,442,448,453,458,459,461,466,476,482,483,485,488,502,509,515,518,523],coulommb:6,cound:3,count:[1,3,6,8,11,12,41,65,71,81,99,125,127,128,166,176,182,184,213,214,217,219,222,224,225,232,237,243,246,252,271,285,303,320,321,338,339,356,378,386,387,388,390,393,421,425,448,515,516,524],counter:[3,353,492,503,505,511],counteract:246,counterbal:[238,250],counterbalanc:28,counterclockwis:184,counterpart:[203,492],counterproduct:17,coupl:[0,3,4],couple:[4,6,11,12],courant:324,cours:[3,8,15,138,140,172,203,211,212,247,316,331,346,352,354,355,357,358,378,440,468,494,497,510,518,524,527],courtesi:380,cov:466,coval:[6,9,28,418,443,466,518],covari:248,cover:[6,12,75,199,207,216,257,418,484],coverag:75,cpc:253,cpp:[1,3,6,8,9,11,12,13,95,203,211,212,244,321],cpu:[1,3,9,10,12,14,15,16,17,65,75,207,221,235,255,348,375,378,393,406,476,492,510,511,514,515,516,524],cpuinfo:15,cpuremain:515,cpus:12,cr2:177,cr3:177,crack:[4,389],crada:[5,7],crai:[5,7,13,17,203],crash:[3,12,389,518],craympi:393,creat:[0,1,2,3,4,6,7,8,9,11,12,13,14,16,37,39,41,42,56,60,61,64,65,75,87,99,113,114,119,120,123,126,130,146,155,161,162,174,176,178,179,180,181,199,203,204,205,206,207,210,215,216,219,222,223,225,226],create_atom:[2,3,6,7,8,40,41,61,99],create_bond:[2,3],create_box:[2,3,6,21,40,41,44,59,60,61,64,75,99,176,178,179],create_elementset:216,create_faceset:216,create_group:205,create_nodeset:216,createatom:0,creation:[3,5],crimson:207,critchlei:302,criteria:[3,127,179,206,207,226,227,228,266,386,455,484,499,502,524],criterion:[12,41,133,178,181,217,225,228,246,285,309,324,353,358,386,388,408,418,423,466,502,511,512],criterioni:511,critic:[6,48,49,269,342,347,386],crmax:75,crmin:75,cross:[3,12,15,21,75,97,129,156,176,186,203,204,206,218,227,231,268,270,294,317,327,331,334,343,350,362,380,388,404,413,415,416,424,425,426,431,433,435,456,461,463,465,480,482,489,497,501,507,527],crossov:1,crossterm:497,crozier:[0,7,13],crucial:307,crystal:[3,4,6,13,15,74,77,117,298,299,345,380,389,497,501,515,518],crystallin:[6,113,299,380,481,518],crystallis:342,crystallogr:[130,177],crystallograph:[380,515],crystallographi:[130,177,380],cs1:177,cs_chunk:6,cs_im:[40,497],cs_re:[40,497],csanyi:[152,457,467],cscl:443,csequ:6,csh:[11,12,15,406],cshrc:[11,12],csic:[417,477,480,482,485],csinfo:6,csisi:[417,477,480,482,485],csld:[2,3,210],cst:416,cstherm:6,cstyle:494,csvr:[2,3,6,210],ctcm:[394,416],ctemp_core:235,cterm:323,ctr:9,ctype:11,cu1:177,cu2:177,cu3au:443,cube:[6,176,181,235,356,380,518],cubes:[41,225],cubic:[2,3,37,56,117,199,241,257,298,335,378,380,416],cuda:[1,3,7,9,12,14,16,393,510,524],cuda_arch:[9,14],cuda_get:14,cuda_home:[9,14],cuda_prec:[9,14],cuh:399,cummul:[3,6,223,226,227,228,230,243,248,254,256,335,338,339,340,341,343,350,425,515],cumul:[6,217,219,222,236,246,254,269,271,276,285,317,319,388],curli:2,current:[0,1,3,5,6,7,8,9,10,11,12,13,14,15,16,17,40,41,42,57,61,63,65,75,77,87,95,113,119,127,128,142,153,158,166,168,174,176,179,182,202,203,204,205,206,207,208,211,212,216,219,223,225,226,227,228,229,230,231,232,236,237,238,244,246,248,251,252,254,260,266,268,271,272,277,278,279,285,287,291,292,293,294,296,302,303,308,309,311,314,315,316,317,318,321,322,323,324,325,326,327,328,330,332,333,334,335,338,339,340,346,347,350,351,352,353,354,355,357,358,360,375,376,377,378,381,382,383,385,386,387,388,393,399,406,408,412,416,418,419,423,426,427,430,440,441,443,444,445,448,456,458,459,462,463,464,465,468,480,482,483,486,492,493,494,495,497,498,499,500,501,503,504,505,507,509,511,512,514,515,519,524,525,526,527,528,529],curv:[6,178,246,287,293,299],curvatur:[422,460,489],custom:[0,2,3,6],cut0:495,cut1:506,cut2:506,cut:[1,2,3,6,9,12,14,15,16,17,18,41],cuthi:[298,310],cutinn:[401,440,441],cutlo:[298,310],cutmax:456,cutoff1:[405,412,431,435,439,442,453,461],cutoff2:[400,402,403,405,411,412,431,435,439,442,453,461,483],cutoff:[3,6,8,10,15,17,39,45,46,54,55,63,74,76,77,81,95,100,117,119,126,127,152,176,179,181,182,227,228,233,241,242,298,307,308,310,312,314,317,322,335,348,352,356,358,375,377,378,386,389,390,391,393,394,395,396,397,398,399,400,401,402,403,404,405,407,409,410,411,412,413,414,415,416,417,418,419,420,421,422,424,425,426,427,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,458,459,460,461,466,467,468,469,470,471,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,495,499,502,506,518,524],cutoffa:417,cutoffc:417,cuu3:416,cval:177,cvd:342,cvel:323,cvff:[2,7,15,362],cwiggl:[3,268,352,355,357,524],cyan:[2,206,207],cycl:[3,246,269,271,272,276],cyclic:[3,184,199],cygwin:12,cylind:[3,4,75,206,219,252,293,303,353,356,382,500],cylinder_d:382,cylindr:[6,252,331,353],cypress:393,cyrot:399,cyrstal:299,d3q15:257,d3q19:257,d_double_double:14,d_e:347,d_flag2:306,d_flag:306,d_name:[124,203,306,337,507],d_single_double:14,d_single_single:14,d_sx:306,d_sy:306,d_sz:306,daan:345,dai:12,daili:12,daivi:294,damag:[2,3,9,65],dammak:312,damp:[3,6,210,215,254,255,256,261,271,272,276,293,304,307,308,312,317,338,339,351,353,354,385,386,388,400,402,404,409,412,418,423,431,439,453,461,476,483,511,518],damp_com:255,damp_drud:255,dampen:[317,518],dampflag:[353,423],dan:16,danger:[3,12,246,358,413,515],dangl:181,daniel:9,darden:[378,412],darkblu:207,darkcyan:207,darken:206,darkgoldenrod:207,darkgrai:207,darkgreen:207,darkkhaki:207,darkmagenta:207,darkolivegreen:207,darkorang:207,darkorchid:207,darkr:207,darksalmon:207,darkseagreen:207,darkslateblu:207,darkslategrai:207,darkturquois:207,darkviolet:207,dasgupta:308,dash:[423,514],dat:[6,99,199,216,493],data2xmovi:0,data:[1,2,3,4],data_atom:8,data_atom_hybrid:8,data_bodi:8,data_vel:8,data_vel_hybrid:8,databas:0,datafil:[12,13,319],dataset:319,datatyp:3,date:[0,4,6,12,13,202,458,459,524],datom1:[84,126],datom2:[84,126],datom3:[84,126],datom4:[84,126],datum:[3,6,42,68,71,73,84,102,119,126,203,220],davenport:442,davi:352,david:[9,18,377,378,480,482],daw:[416,456],dcd:[3,6,7,203,205,206,207,208,300,498,502],dcs:9,ddim:202,deactiv:439,dealt:253,debug:[6,7,11,12,13,16,57,130,134,177,178,300,305,375,377,427,448,486,495,496,504,507,514,524],deby:[2,3,7,211,212,312],decai:[100,409,489],decid:[3,6,12,15,75,268,306,317,348,512,519],decipher:380,deck:306,declar:205,declin:335,decod:206,decompos:[95,467],decomposit:[3,5,7,17,64,216,300,322],decoupl:[6,518],decreas:[3,15,203,204,213,214,221,228,231,237,238,244,246,254,346,377],decrement:323,dedic:[15,393],deepli:374,deeppink:207,deepskyblu:207,def:[12,13,495],defaul:63,defect:[6,74,176,446],defgrad:2,defin:[2,3,5,6,7,8,11,12,16,19,20,21,22,23,24,25,26,27,28,29,30,31,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,51,53,54,55,56,57,58,59,60,61,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,184,185,186,187,188,189,190,192,193,195,196,197,198,199,200,201,202,203,204,205,206,207,210,211,212,213,214,215,216,217,218,219,220,222,223,224,225,226,227,228,229,231,232,235,236,237,240,242,244,245,246,249,252,253,254,255,256,257,266,268,270,271,272,273,274,275,276,277,278,279,281,282,283,286,289,290,291,292,294,295,296,298,299,300,302,303,304,306,308,310,315,317,318,319,320,321,324,328,332,333,335,337,338,339,340,341,343,344,345,347,349,350,352,353,354,355,356,357,358,360,361,362,363,364,365,366,367,370,371,372,373,375,377,378,380,383,385,386,387,388,389,390,391,392,393,395,396,397,398,400,401,402,403,404,405,406,407,409,410,412,413,414,415,417,418,420,421,422,423,424,425,426,427,429,431,432,433,434,435,436,437,438,439,440,441,442,446,447,448,449,450,451,452,453,455,456,458,459,460,461,462,463,464,465,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,494,495,497,498,500,501,502,503,506,507,508,509,511,512,514,515,518,520,521,522,523,524,525,526],definit:[2,3,6,8,12,13,82,85,127,152,207,219,220,221,222,223,231,240,252,276,319,337,349,352,355,357,359,371,375,387,396,399,407,414,418,429,456,463,465,467,484,495,497,499,506,508,523,524],defint:515,deform:[2,3,6,7,8,40,42,59,61,63,65,85,122,134,138,139,153],deg2theta:177,deg:518,degener:[3,302],degrad:[8,17,299,378,506],degre:[3,6,8,19,20,23,27,28,31,34,35,37,68,84,100,102,104,106,107,109,111,112,117,123,155,156,157,158,159,160,161,162,163,164,165,166,167,168,170,171,177,178,184,185,188,189,196,197,199,202,206,219,228,235,246,248,249,254,255,260,271,272,276,277,278,279,291,292,294,296,300,302,316,317,321,338,339,340,345,361,363,367,370,372,386,412,416,425,507,515,518,525],degrees:199,degress:[158,219],del:511,delai:[3,6,12,389,415,515],deleg:426,delet:[2,3,7,8,12,54,59,62,65,176,181,182,210,219,220,222,223,226,228,243,246,271,319,338,339,358,360,376,387,389,392,448,475,497,498,499,500,508,509,514,519,520,522,524,525],delete_atom:[2,3,7,178],delete_bond:[2,3,43,45,46,47,48,49,50,51,53,54,55,56,68,73,126,179],delete_el:216,deli:202,delimit:[318,495,524],dellago:[6,238],deloc:[272,418,466],delr:443,delt_lo:511,delta:[2,21],delta_1:399,delta_3:399,delta_7:399,delta_conf:3,delta_ij:[443,456],delta_pi:399,delta_r:456,delta_sigma:399,deltah_f:242,delx:202,delz:202,demand:312,demo:11,demon:297,demonstr:[307,443],den:303,dendrim:425,dendtrit:382,denniston:[9,257,259,260,261,299],denomin:[7,183],denot:[130,235,238,255,299,310,312,409,424,426,459,463,465],dens:[75,228,318,418],densiti:[3,6,7,9,17,40,41,61,110,127,138,152,164,176,178,211,212,216,219,225,231,244,257,260,264,265,299,303,304,306,308,347,352,380,383,387,394,395,399,416,443,444,445,450,451,456,460,466,470,472,473,474,497,506,507,515,523],density_continuity:465,density_summation:465,dent:382,depart:[0,7],departur:[269,307],deped:8,depend:[1,2,3,6,8,9,11,12,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,31,34,37,39,40,41,43,44,45,46,47,48,49,51,53,54,56,63,65,68,71,73,74,75,84,100,102,113,119,123,124,125,126,129,131,152,154,155,161,165,166,172,178,179,184,185,186,187,188,189,190,192,193,195,196,198,199,202,203,204,206,207,210,211,212,213,214,217,219,221,222,223,224,225,227,229,231,237,239,242,245,248,249,250,252,254,255,257,259,260,268,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,298,309,310,312,314,317,318,320,321,322,328,335,338,339,340,342,344,346,347,349,352,355,356,357,358,360,361,362,363,364,366,367,370,372,378,380,386,387,389,390,391,393,394,395,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,416,417,418,419,420,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,443,444,446,447,449,450,451,452,453,455,456,458,459,460,461,466,467,468,476,477,478,480,481,482,483,485,487,488,489,492,494,497,499,500,503,507,509,511,514,515,517,524,525],dependend:6,depflags:12,dephas:[492,511],depos:232,deposit:[2,3,4,112,180,210,217],deprec:[3,308,458],deprect:219,depth:[51,156,206,347,420,422,460],dequidt:9,der:[95,118,407,408,439,458,459,488],deriv:[6,7,8,9,37,56,65,95,152,172,199,220,229,231,238,246,254,268,271,273,274,275,276,277,278,279,298,304,308,312,344,345,347,352,353,356,385,387,395,399,407,412,418,419,424,433,437,438,443,446,458,459,476,478,479,488,518],derjagin:488,derlet:298,descend:207,descent:[7,385],descib:[40,206,308],describ:[0,1,2,3,4,6,7,8,9,10,11,12,13,14,15,16,17,18,37,39,40,41,42,56,64,65,71,74,75,77,96,121,124,127,130,142,152,153,156,157,158,162,163,166,169,171,172,176,177,178,180,181,190,195,199,203,204,205,210,211,212,219,220,221,222,223,225,228,229,230,231,232,234,235,241,242,247,248,251,252,253,254,255,256,257,259,260,261,266,270,271,272,276,284,295,298,300,305,306,307,308,309,310,317,318,323,331,335,336,337,338,339,340,341,342,343,344,345,350,352,353,355,360,377,378,380,384,385,386,387,388,392,395,396,398,400,401,402,404,405,406,407,408,409,412,416,418,419,420,422,423,424,426,429,431,432,433,434,435,436,437,438,439,440,441,442,443,446,447,450,451,455,456,457,458,459,460,461,466,467,468,475,476,477,478,479,480,481,482,483,485,487,488,489,490,492,494,495,497,498,499,500,501,507,510,511,514,519,524,525,527],descript:[2,3,6,8,9,11,12,13,17],descriptor:[152,203,427],deserno:378,design:[0,3,6,7,8,11,13,14,16,130,160,163,177,216,228,234,235,271,272,298,299,319,342,347,396,397,398,401,404,409,411,418,439,440,441,444,445,456,459,478],desir:[2,3,6,7,9,11,12,14,15,32,40,50,61,75,96,99,123,128,153,160,178,191,202,219,223,229,231,244,246,247,254,255,256,260,271,294,302,303,304,305,308,312,317,320,321,335,338,339,340,341,346,353,368,374,377,378,380,384,386,387,388,413,416,425,440,441,477,480,482,493,494,495,497,501,506,511,512,514,515,516,524,525,527],desk:7,desktop:[4,6,7,10,12,206],despit:518,destabil:399,destre:370,destroi:[9,11,39,226,227],detail:[1,2,3,4,6,7,8,9,11,12,13,14,15,16,17,18,21,36,40,41,42,55,65,69,70,71,75,79,82,86,98,99,103,114,116,118,120,121,122,123,125,128,129,131,152,153,155,156,157,158,161,171,172,173,175,178,179,182,183,186,198,202,203,204,206,207,210,211,212,216,219,220,221,222,223,225,227,228,229,230,231,232,238,244,246,247,248,249,251,252,254,256,257,261,268,269,270,271,272,273,274,275,276,277,278,279,283,285,291,292,294,295,296,299,302,303,304,306,307,309,310,311,317,321,322,335,338,339,340,341,342,343,345,346,347,348,349,350,351,358,360,362,371,377,378,381,386,387,389,390,393,394,395,396,398,399,401,403,404,405,406,407,408,409,412,413,418,419,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,441,442,443,447,448,450,451,455,458,459,460,466,467,468,476,484,487,488,490,495,497,498,499,500,502,503,506,507,509,512,515,516,519,524,525,529],detect:[2,3,12,42,63,65,94,100,245,303,346,388,408,425,430,492,494,497,508,511,524],determin:[1,3,6,8,9,12,14,15,39,40,42,51,59,60,61,63,64,71,75,95,112,118,119,123,126,129,130,131,139,153,166,167,176,177,178,202,203,204,206,207,208,209,213,214,215,218,219,220,221,222,223,224,225,229,231,232,235,237,242,246,249,250,252,254,255,260,266,268,269,271,277,278,279,291,292,294,296,298,300,303,304,307,314,315,316,317,318,319,320,324,326,328,335,338,339,340,342,348,349,352,353,354,355,356,357,358,371,377,378,380,387,389,390,393,395,396,403,408,412,415,416,420,421,423,426,427,435,443,446,448,451,459,460,466,475,478,479,483,488,494,497,498,500,502,504,507,511,513,514,516,523,524,525],determinist:322,detil:119,devan:[9,461],devanathan:482,develop:[0,3,5,6,7,8,9,11,12,14,15,16,17,18,42,251,276,302,307,308,311,395,399,418,445,446,466,485,499],devemi:9,deviat:[269,276,298,421],deviator:9,devic:[1,3,12,14,16,251,393],device_typ:393,devin:[309,408],devis:445,dfactor:206,dff:518,dfft_fftw2:12,dfft_fftw3:12,dfft_fftw:12,dfft_none:12,dfft_single:[3,12,378],dfft_xxx:12,dfftw:12,dfftw_size:12,dft:[9,311,446],dhi:[61,202,231,303],dhug:[269,307],dhugoniot:[269,307],dia:443,diag:318,diagnost:[2,5],diagon:[3,6,91,129,152,153,154,229,271,304,317,350,463,465],diagonalstyl:467,diagram:[41,84,130,177,198,225,300],diallo:425,diam:[206,207,303,387],diamet:[3,6,40,42,124,178,203,204,206,207,211,212,254,303,306,317,335,337,351,353,387,407,422,423,433,460,484,488,497,498,507],diamond:[380,418,443],diamter:[40,303],dick:6,dicsuss:268,dictat:[217,269],did:[3,12,386,413,415,416,423,448,480,482,505],didn:3,die:17,diel:2,dielectr:2,diff:[3,6,12,15,174,349,377],differ:[1,2,3,4,6,7,8,9,11,12,14,15,16,17,21,36,37,39,41,42,54,55,56,63,66,71,74,75,95,100,104,106,107,132,152,154,155,156,157,158,159,161,164,165,166,167,168,170,171,172,178,179,181,186,198,199,202,203,206,207,210,212,215,217,219,222,225,226,227,228,229,230,231,235,238,241,245,246,247,248,249,250,251,254,255,257,268,271,272,273,274,275,277,278,279,281,283,286,289,290,291,292,296,298,300,302,304,307,308,309,312,315,317,321,323,331,333,335,338,339,340,343,344,345,347,350,351,352,353,356,360,361,371,374,376,377,378,380,381,384,385,387,388,390,391,392,393,394,395,399,403,404,406,407,408,413,414,416,418,420,422,423,424,426,429,431,432,434,435,442,443,444,445,447,448,449,450,451,452,456,458,459,460,461,462,463,465,466,467,468,476,477,478,479,480,482,484,485,488,491,492,494,495,497,499,500,501,502,505,506,507,509,511,512,514,515,516,518,523,524,525,527],differenti:[1,3,6,28,199,318,377,409,456,481],difficult:[229,300,393,425,506,516],difficulti:[100,117,321,458],diffract:[7,9,130,177,319],diffus:[0,4],diffuse:[4,6],digit:[2,3,207,360,446,524],dih_table1:199,dih_table2:199,dihedr:[0,2,3,7],dihedral_coeff:[2,3,184,185],dihedral_cosine_shift_exp:26,dihedral_styl:0,dihedralcoeff:[3,200],dihedraltyp:227,dihydrid:418,dij:321,dilat:[2,3,61,63,65,82],dim1:3,dim2:3,dim:[3,61,75,155,159,160,161,164,165,166,167,168,170,178,202,231,252,353,380,443,500,523,524,525],dimdim:524,dimems:299,dimens:[1,2,3,6,7,12,41,59,60,61,63,65,75,99,125,129,153,158,165,166,167,178,180],dimensinon:75,dimension:[3,39,100,123,130,152,155,158,159,160,161,164,165,166,167,168,170,177,201,219,270,299,347,380,384,388,456,497,507],dimensionless:[115,133,134,136,139,141,143,148,152,347,378,467,488],dimensions:319,diment:3,dimentionless:147,dimer:[6,317,443],dimgrai:207,dimstr:[41,225],dinola:[304,338],dintel_offload_noaffinity:15,dipol:[0,2,3,4],dipolar:[4,28,40,203,204,337,518],dir1:508,dir2:508,dir:[1,3,4,8,10,11,12,269,298,307,334,456,458,459,495,508,524],dirac:152,direc:456,direct:[2,3,6,7,12,13,15,28,59,74,75,117,130,152,176,177,178,184,202,203,206,210,213,214,215,231,232],directli:[3,6,8,9,11,12,95,124,129,152,154,203,204,205,206,213,237,248,252,257,299,318,319,339,351,353,354,355,356,380,385,393,394,395,400,402,403,409,412,416,418,431,435,448,453,461,475,495,507,508,509,515,524],directori:[0,1,2,3],disabl:[3,12,15,347,393,430,495,510,524],disadvantag:[6,225],disallow:[203,231,271],disappear:499,discard:[2,3,41,75,221,225,348,356,494,499,500],discontinu:[199,386,437],discourag:443,discov:[13,348],discret:[6,8,40,42,206,207,254,257,293],discuss:[0,1,2,3],disk:[6,92,93,100,171,201,232,246,303,495],disloc:[74,446],disord:[39,74,446],disp:[0,2,3],dispar:460,disperion:[412,435],dispers:[3,6,7,9,176,299,377,378,403,412,435,440,448,459,478,485],displac:[2,3,6,7,12,42,61,65],displace_atom:[2,3,7,113],displace_box:61,displacemet:500,displai:[11,13,21,36,44,55,186,198,203,206,362,371,406,476],dispters:3,disregard:446,dissip:[6,9,40,88,89,240,247,254,299,322,344,345,401,413,414,423,440,441,476],dissolut:226,dist:[6,73,99,119,128,203,300,316,415,475,492,525],distanc:[2,3,6,7,8,9,12,19,20,39,43,45,46,47,48,49,51,53,54,55,56,57,58,60,61,63,65,66,69,73,75,76,77,78,79,80,81,86,87,94,97,98,100,103,113,114,115,116,117,119,125,126,127,128,129,130,132,146,152,167,173,176,178,179,180,181,185,202,203,204,206,207,215,219,226,227,228,229,231,232,233,236,238,246,252,257,268,269,270,271,276,285,298,299,303,307,308,315,316,317,321,323,327,331,332,333,334,335,342,343,345,346,347,350,352,353,354,355,356,357,361],distinct:[6,235,314,377,460],distinguish:[6,94,152,260,418,496,524],distort:[176,394],distrbut:394,distribut:[0,2,4,5,6],distro:[122,406,455,456],ditto:[8,12,14,16,17,42,126,227,317,489,495],div:[8,15],divd:128,diverg:[3,12,39,317,345,395,499,518,527],divid:[3,6,15,41,99,123,128,138,140,153,175,176,186,198,207,219,220,222,225,231,298,343,350,355,377,386,388,419,459,466,485,506,514,524],divis:[6,197,257,399,429,439,494,515,524],dl_poly:[6,7],dlambda:172,dlammps_async_imd:251,dlammps_bigbig:[12,39],dlammps_ffmpeg:[3,12,206],dlammps_gzip:[3,12,203,206,346,497,498,502],dlammps_jpeg:[3,12,206],dlammps_longlong_to_long:12,dlammps_memalign:[9,12,15],dlammps_png:[3,12,206],dlammps_smallbig:12,dlammps_smallsmall:12,dlammps_xdr:[12,203],dlen:507,dlm:[271,289],dlmp_intel_offload:[9,15],dlo:[61,202,231,303],dlopen:6,dlvo:[7,407,488],dm_lb:257,dmax:[335,384],dmpvtk:204,dmpvtp:204,dna:7,doc:[0,1,2,3,4,6,7,8,9,10,11,12,13,14,16,17,21,36,40,42,55,59,61,65,69,71,79,84,86,95,98,102,103,114,115,116,118,120,121,122,123,125,128,129,131,153,156,157,158,171,173,175,178,179,180,186,198,202,203,204,205,206,207,208,210,211,212,217,218,219,220,221,222,223,232,246,254,255,266,271,272,277,278,279,283,291,292,294,295,296,303,306,317,331,335,338,339,340,349,353,356,358,360,362,371,376,386,387,388,393,394,395,398,406,408,409,416,417,419,425,426,428,429,443,444,445,448,452,455,456,457,467,476,477,480,482,484,485,495,497,498,499,500,502,505,506,507,514,515,519,524,525,527,528],docuement:460,dodd:42,dodgerblu:207,doe:[0,1,2,3,5,6,7,8,9,11,12,14,16,17,32,37,39,41,42,50,54,56,61,64,65,70,74,75,76,95,96,99,114,118,121,127,128,130,154,156,158,160,161,166,168,172,177,178,179,180,182,184,186,191,198,199,202,203,204,205,206,207,210,216,217,219,224,225,227,228,229,231,235,237,238,241,242,243,246,247,250,252,254,255,257,260,267,271,272,273,274,275,277,278,279,291,292,293,294,295,296,304,305,306,310,312,315,317,335,338,340,342,343,347,350,351,352,355,356,357,358,363,364,365,367,368,370,376,377,378,379,380,387,388,389,394,395,396,397,398,399,401,403,404,405,407,408,409,410,412,413,415,416,417,418,420,421,422,423,424,426,427,428,429,430,433,434,436,437,438,440,441,443,444,445,446,448,450,451,456,457,458,459,460,462,463,464,465,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,483,484,485,487,488,489,490,492,493,494,495,497,498,499,500,501,504,505,507,508,509,510,511,514,515,518,519,524,529],doegenomestolif:7,doesn:[3,7,8,12,178,203,204,217,331,387,389,393,395,408,417,428,458,459,477,480,481,482,485,497,499],dof:[3,8,123,156,157,158,171,219,317,525],dof_per_atom:[158,219],dof_per_chunk:[158,219],doff:[387,497],doi:[6,230,298],domain:[3,6,7,12,13,17,39,41,42,60,63,64,75,130,167,177,180,202,205,206,207,210,217,225,229,231,232,250,253,257,271,272,300,312,317,322,347,352,353,377,378,388,393,415,448,492,494,497,501,514],domin:[1,418,511],don:[0,8,9,12,13,15,127,181,213,237,255,356,443,466,495,497,519],donadio:339,done:[1,3,6,7,8,12,14,16,17,37,39,41,56,61,64,75,172,175,178,181,197,199,203,206,207,216,217,219,221,222,223,225,226,227,228,229,231,232,241,242,244,246,251,252,254,255,262,271,277,278,279,291,292,294,296,297,299,300,301,303,306,314,317,319,321,335,338,339,340,342,344,345,358,360,376,377,378,386,388,389,392,393,395,403,416,426,427,428,435,441,442,443,448,450,451,458,475,478,479,484,492,493,494,495,498,501,502,505,515,516,518,519,524,525],donor:425,dot:[153,174,213,237,249,270],doti:[399,456],doubl:[1,2,3,6,8,9,11,12,14,15,16,39,95,184,231,244,305,356,360,376,378,392,393,399,419,424,446,458,459,493,497,501,505,510,524,525],dover:216,down:[3,6,7,8,11,39,75,229,246,254,335,351,418,448,466,496,516],downhil:[384,385],download:[5,7,8,9,11,12,13,16,251,427,457],downsid:6,downward:314,dozen:[8,9,12,118,210,458,459],dpack_array:12,dpack_memcpy:12,dpack_pointer:12,dpd:[2,3,6,7],dpde:264,dpdtheta:[40,88,89,414],dpdtheta_i:[240,241,242],dproduct:396,dr_ewald:[130,319],drag:[2,6,99,210],dragforc:257,drai:[206,269,307],drain:[250,351,386],dramat:[9,61,202,226,227,228,229,231,271,335,338,339,378,448,466,494],drautz:399,draw:206,drawback:306,drawn:[42,203,206,207,247,492],drayleigh:[269,307],dreid:[2,3,4,6,9],dreiding:0,drfourth:115,drho:[124,394,416,450,451],drift:[6,113,115,238,247,248,250,254,255,267,315,335,506,514,518],drive:[11,12,214,229,231,249,271,298,304,317,354,388],driven:[6,190],driver:[6,12,14,210,244,251],drop:[3,207,413],droplet:426,drsquar:115,drude:[0,2],drudes:[255,518],dry:243,dsecriptor:427,dsf:[2,3],dsmc:[2,3,9],dstyle:303,dt_collis:257,dt_lb:257,dt_md:257,dt_srd:335,dtilt:[61,231],dtneb:511,dtqm:307,dtype:[84,126,227],dual:[16,335,393],dudarev:177,due:[1,3,6,9,12,15,16,18,40,54,57,59,60,63,69,74,75,78,79,86,87,94,96,97,98,103,112,113,114,115,116,121,127,130,138,152,153,155,156,157,159,161,164,165,166,167,168,170,171,173,177,178,181,182,203,204,206,210,213,214,222,224,226,227,228,229,230,231,232,237,239,243,244,247,248,251,252,254,255,256,257,260,261,262,267,268,269,270,271,276,285,298,301,303,315,316,317,320,331,332,334,335,336,338,339,340,341,342,344,345,347,351,352,354,355,356,358,377,378,384,386,388,389,390,410,413,414,416,421,422,426,440,441,448,456,458,460,461,475,478,480,482,486,488,489,492,494,497,498,499,506,511,514,515,516,518,524,525],duffi:347,duin:[9,308,313,458,459],duke:378,dullweb:[271,289],dumbbel:382,dummi:[12,28,481],dump0:204,dump10000:204,dump1:502,dump20000:204,dump2:502,dump2vtk_tri:146,dump:[0,1,2,3,4],dump_0:204,dump_1:204,dump_atom:8,dump_custom:8,dump_h5md:205,dump_modifi:[2,3,6,203,204,205,206],dump_p:204,dumpcustom:8,dumptimestep:502,dunbrack:[6,19,184,404,509],dunweg:[254,256],duplic:[2,3,14,16,41,42,179,204,225,248,298,497,523],dupont:[5,7,13],durat:[36,55,155,156,157,159,160,161,163,164,165,166,167,170,171,198,207,219,246,312,347,371,423,476],dure:[2,3,6,8,9,12,15,16,37,39,41,56,75,95,129,138,140,154,160,179,182,184,199,203,204,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,231,232,233,236,237,238,239,241,242,243,244,245,246,247,248,249,250,251,252,254,255,256,257,258,259,260,261,262,263,264,265,267,268,270,271,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,319,320,321,323,327,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,378,386,388,392,413,439,446,448,449,450,451,459,478,479,492,493,495,497,500,502,504,505,507,509,511,512,515,516,524,528,529],dvector:8,dvlo:488,dvx:6,dx_lb:257,dy3:177,dyamic:12,dyanam:6,dyanmic:511,dynam:[0,2,3,4,5,6,7,9,11,12,13,14,15,39,40,41,61,63,75,88,89,112,115,127,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,155,156,157,158,159,161,163,164,165,166,167,168,170,171,176,178,182,203,206,207,210,213,216,225,228,230,231,232,237,240,243,246,247,248,253,254,255,256,261,269,271,272,276,282,285,287,299,300,303,306,307],dynamo:[5,394,416,443],dyne:523,dyre:436,dysam:500,e28637:28,e_1:399,e_2:399,e_a:318,e_b:419,e_data:204,e_ee:418,e_hbond:425,e_i:[6,399,419],e_j:[6,399],e_k:399,e_ke:418,e_kl:6,e_lj:[395,412],e_n:399,e_ne:418,e_nn:418,e_pr:418,e_rebo:395,e_torsion:395,e_tot:446,e_vol:446,eaa:361,eaat:185,each:[0,1,2,3,4,6,7,8,9,10,11,12,13,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,32,34,35,36,37,39,40,41,42,43,45,46,47,48,49,50,51,53,54,55,56,57,59,61,63,64,65,66,67,69,70,71,72,74,75,76,77,78,79,80,81,82,83,85,86,87,89,91,93,95,97,98,100,101,103,104,105,106,107,108,109,110,111,112,113,114,115,116,117,120,121,122,123,124,125,126,127,128,129,130,131,132,146,152,153,154,156,157,158,159,160,161,162,165,166,167,168,170,171,172,173,174,175,176,177,178,181,182,184,185,186,187,188,189,190,191,192,193,195,196,197,198,199,202,203,204,205,206,207,208,209,210,211,212,213,214,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,239,241,242,243,244,246,247,248,249,250,251,252,253,254,255,256,257,258,260,261,262,263,264,265,267,268,269,270,271,273,274,275,276,277,278,279,280,281,282,283,285,286,287,288,289,290,291,292,294,295,296,298,299,300,301,302,303,304,305,306,308,309,310,312,314,317,318,319,320,321,322,323,327,328,330,331,332,333,334,335,336,337,338,339,340,342,345,346,347,348,349,350,351,352,353,355,356,357,358,360,361,363,364,365,366,367,368,370,371,372,376,377,378,380,385,386,387,388,389,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,418,419,420,421,422,423,424,425,426,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,446,447,448,449,450,451,452,453,455,456,458,459,460,461,462,466,467,468,469,470,471,472,473,474,475,476,477,478,479,482,483,484,485,486,487,488,489,490,491,492,494,495,497,498,499,500,501,502,504,505,506,507,509,511,512,514,515,516,517,518,523,524,525,527,529],eacn:[41,225],eam0d:299,eam3d:299,eam:[0,2,3,5,7,8,9,10,12],eam_databas:13,eam_gener:13,eangl:515,earli:[41,219,222,223,225,311,319],earlier:[7,8,12,61,207,388,423,443,448,511],earliest:511,earth:418,easi:[6,7,8,9,10,11,13,95,153,203,211,212,213,214,224,237,249,250,252,254,255,320,328,338,339,340,352,355,357,387,497,500,505,507,525],easier:[8,9,13,15,203,204,206,299],easili:[8,11,206,207,351,388,494,504,513,524],eastwood:[377,378],eat:185,eatom:358,eaxmpl:6,eba:20,ebb13:185,ebb:20,ebond:[235,255,514,515,524],ebt:185,ec_ii:443,ec_ij:443,ec_jj:443,echo:[2,3,11,12,62,130,177],eco:[458,459],ecoa:[458,459],ecoul:[118,154,235,255,458,459,515],ecp:[418,497],edg:[3,6,41,42,61,75,130,176,177,180,181,203,205,206,215,252,320,352,355,356,357,358,380,497,500,507],edge:[2,3,352,355,357,500],edge_histo:176,edge_threshold:176,edih:515,edim:343,edip:[2,7],edit:[3,8,9,12,13,14,15,16,17,18,518,519],edition:15,editor:13,edu:[7,9,11,13,416,440,455,458,459],edward:[9,16],eebt:185,eff:[0,2,7,8],effect:[1,2,3,6,8,9,11,12,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,43,45,46,47,48,49,51,53,54,56,69,75,78,79,86,87,97,98,103,113,114,115,116,123,153,155,160,165,166,173,176,182,184,185,187,188,189,190,192,193,195,196,198,199,202,203,204,206,207,211,212,213,216,217,220,223,224,226,227,228,229,231,232,238,239,241,245,246,247,248,249,250,251,252,254,255,270,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,297,298,300,303,304,306,307,308,309,310,312,315,316,317,320,321,334,335,338,339,340,342,343,345,347,350,351,352,353,354,355,356,357,358,361,363,364,366,367,370,372,377,378,380,385,386,387,388,389,394,395,397,399,400,401,402,403,404,405,407,408,409,412,413,416,417,418,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,446,448,449,450,451,452,453,455,459,460,461,462,464,466,468,476,477,478,479,480,481,482,483,484,485,487,488,489,492,494,495,499,500,502,506,507,509,515,516,523,524,527],effectiv:[254,380],efffect:501,efficaci:39,effici:[0,1,3,6,7,8,9,10,12,14,15,16,17,39,60,63,70,123,154,197,203,204,205,206,207,220,221,229,231,235,248,271,300,302,303,312,317,321,335,377,378,384,389,393,399,407,409,426,431,435,446,450,451,460,478,504,529],efficienc:15,efficient:[9,302],effort:[5,7,498],efftemp:[106,107,164],efi:[458,459],efield:[2,3,210,217],eflux:250,eforc:204,eggebrecht:[409,466],ehanc:210,ehb:[458,459],ehex:[2,6,210],eigensolv:3,eigenvalu:[299,300,377],eigtol:3,eike:172,eim:[2,3,4,7,9],eimp:515,eindhoven:9,einstein:[6,312,345],either:[1,2,3,6,8,9,10,11,12,14,15,16,21,32,41,44,50,61,65,74,75,113,118,124,127,130,152,153,158,160,161,176,177,178,181,186,191,199,203,204,205,206,207,210,218,220,222,223,225,228,229,230,231,232,238,246,252,253,257,261,268,269,271,272,276,294,298,306,314,318,320,321,323,331,335,342,349,353,356,360,362,375,377,378,380,385,386,390,393,399,401,407,416,420,423,426,427,429,440,441,443,446,448,451,454,456,459,475,479,480,482,484,492,495,497,499,500,504,506,509,512,514,524],ejtehadi:[407,422,460],elaplong:[211,212,252,500,515,524],elaps:[3,202,211,212,213,214,224,231,237,249,250,252,254,255,268,303,320,328,338,339,340,352,353,355,357,468,492,500,502,503,507,511,515,516,524],elast:[4,6,7,9,44,45,46,55,122,210,270,299,353,385,388,423,455,481],elastic:[0,4],elastic_t:4,elba:28,electr:[6,210,216,237,255,377,378,419,458,459,489,518,523],electric:15,electrolyt:[9,488],electron:[3,6,7,9,13,40,106,107,124,130,162,164,169,204,210,216,234,235,255,256,272,284,295,310,341,347,385,387,394,396,408,412,416,418,419,443,446,456,457,466,482,485,489,497,517,518,523],electron_integr:216,electron_temperatur:216,electron_unit:418,electroneg:[6,308,309,310,408,419,466],electroneg_compon:466,electronic_dens:3,electronic_specific_heat:3,electronic_thermal_conduct:3,electrostat:[6,9,15,17,217,246,308,310,311,348,377,378,407,412,418,431,439,441,459,466,488],eleftheri:317,elem1:[419,443,467],elem2:[419,443,467],elem:466,element1:[314,394,416,466],element2:[314,394,416,466],element:[3,6,7,8,9,12,13,42,65,87,97,113,115,123,128,131,146,152,153,154,155,156,157,158,159,160,161,165,166,167,168,170,171,174,203,204,205,206,207,208,210,211,216,220,222,223,299,314,342,349,394,395,399,408,416,417,418,419,426,427,428,443,444,445,446,452,456,457,458,459,466,467,477,480,481,482,485,515,518,524,528],elementn:[394,416],elementset:216,elev:511,elif:[152,360],elig:[3,217,226,227,243,246,425],elimin:[3,6,75,176,247,254,255,317,321,344,345,492],elj:412,ellad:9,elliot:9,elliott:9,ellips:[4,6,9,75,90,156,201],ellipsoid:[3,4,6,7,9,13,40,42,75,90,124,142,156,178,201,202,203,204,254,268,273,277,281,282,287,291,317,335,382,383,386,422,441,460,476,497,507,527],ellipsoidflag:497,elong:[235,255,515],elp:[458,459],els:[3,7,8,12,75,118,127,128,131,206,218,219,220,222,223,246,271,317,335,347,348,349,358,360,377,426,496,508,524,528],elsewher:[8,268,335,443,457,458,459,509,515,524],elt:443,emac:0,email:[0,3,5,7,8,9,11,419],emb:[3,9,356],emb_lin_neg:443,embed:[3,4,5,7,9,11,12,13,28,96,154,176,347,394,416,419,439,443,444,445,456,476,486,495],embt:185,emi:[7,9],emile:9,emol:[458,459,515],emphas:423,empir:[9,216,339,418],empiric:395,emploi:[238,299,308,312,481],empti:[3,59,75,176,180,317,377,389,430,497,508,509,524],empty:3,enabl:[3,6,8,9,11,12,13,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,32,34,36,37,39,40,43,45,46,47,48,49,50,51,53,54,55,56,62,63,64,66,70,82,85,88,89,91,95,96,106,107,108,109,110,111,115,118,122,123,129,130,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,154,155,156,157,160,162,164,165,169,170,172,176,177,184,185,187,188,189,190,191,192,193,195,196,198,199,203,204,205,207,208,210,211,212,213,214,215,217,221,224,226,227,228,230,231,232,237,238,239,240,241,242,243,244,245,246,247,248,249,251,252,253,254,255,256,257,258,259,260,261,263,264,265,266,267,269,271,272,273,274,275,276,277,278,279,280,281,282,283,284,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,307,308,309,310,311,312,313,314,316,317,318,320,321,322,323,324,325,326,327,328,330,331,332,334,335,341,342,343,344,345,347,348,350,352,353,354,355,356,359,361,363,364,366,367,368,370,371,372,378,386,388,392,393,394,395,397,398,399,400,401,402,403,404,405,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,443,444,445,446,448,449,450,451,452,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,495,498,499,500,504,506,516,524,529],enclos:[2,6,12,180,203,305,360,443,466,493,495,505,524],encod:[13,39,42,203,206,207,306,426],encompass:[3,6,40,42,59,61,127,179,330,349,476,500],encount:[3,8,12,61,117,222,392,502,524],encourag:[7,8,311,318,333],end12i:124,end12x:124,end12z:124,end1i:124,end1x:124,end1z:124,end2i:124,end2x:124,end2z:124,end:[1,2,3,5,6,8,11,12,14,15,16,17,18,37,40,41,42,57,59,61,75,124,181,182,185,202,203,204,206,207,208,211,212,220,222,223,228,231,238,247,252,254,256,270,271,272,285,293,304,316,317,318,323,335,338,339,340,341,343,346,347,350,354,357,358,376,377,387,388,392,393,413,416,422,429,442,446,460,463,465,467,468,486,492,495,497,498,499,500,502,504,505,509,513,515,518,524,529],end_of_step:8,endbondtors:[3,185,191,497],endif:8,energet:[228,395,459],energi:[0,1,2,3,4,5,6,7,8,9,12,13,19,20,22,23,24,25,26,27,28,29,30,31,33,34,35,37,38,40,43,45,46,47,48,49,51,52,53,54,56,57,58,65,67,68,72,73,83,88,89,90,91,92,93,94,95,96,99,101,104,105,106,107,108,109,111,118,119,120,121,123],energy_compon:466,energy_update_freq:459,enforc:[6,9,59,60,114,202,203,204,205,206,208,210,217,228,231,271,297,299,309,317,321,360,377,431,494,524,525],enforce2d:[2,3,6,201,210],eng:[11,68,73,119,203,244,358,360,408,445],eng_previ:360,engiliti:9,engilitycorp:9,engin:231,engineer:[216,302,323,344,416],enginer:444,enhanc:[212,216,238,492],enlarg:[61,206],enough:[3,40,63,94,178,179,181,182,225,255,303,307,312,317,348,352,353,356,389,393,409,454,497,501,502],enpub:416,ensembl:6,ensight:6,ensur:[3,6,152,203,204,217,221,229,246,247,271,324,346,378,399,415,439,477,485],enter:[59,168,419,446,485,511],enthalpi:[135,273,274,275,318,416,514,515,524],entir:[0,2,3,6,11,14,41,42,65,88,89,96,120,121,123,127,129,130,153,158,177,178,207,210,211,212,219,225,228,230,238,243,246,247,250,254,255,267,271,273,274,275,276,277,278,279,298,300,302,315,317,318,333,347,349,360,393,412,435,448,478,479,497,505,506],entireti:484,entiti:[6,8,40,42,203,317],entri:[3,8,12,37,42,56,68,73,84,102,119,126,129,130,139,142,143,144,145,146,148,149,150,176,199,204,207,211,222,230,241,242,307,358,387,399,417,443,450,451,452,459,467,477,478,479,480,481,482,485,524],entries:207,entropi:511,entry1:[37,56,207,406,450,451,478,479],entry2:207,entryn:207,enumer:[179,203,490],enumuer:6,env:393,environ:[1,3,6,11,12,15,16,17,206,248,253,298,393,394,399,406,408,417,418,456,480,494,508,524],eos:[9,241,242],epair:[118,207,395,421,425,458,459,515],epen:[458,459],epfl:[248,253],epp:412,epq:412,eps0:488,eps14:439,eps:[455,476],epsilon0:482,epsilon:[3,6,35,45,46,50,53,54,95,184,211,212,246,317,335,352,356,384,386,398,404,405,407,409,410,411,412,420,422,424,425,426,429,430,431,432,433,434,435,436,437,438,439,442,447,453,460,461,471,477,483,484,487,488,506,518,523],epsilon_0:489,epsilon_14:404,epsilon_:460,epsilon_d:410,epsilon_i:[422,448,460],epsilon_i_:460,epsilon_i_a:[422,460],epsilon_i_b:[422,460],epsilon_i_c:[422,460],epsilon_ij:448,epsilon_j:[422,448,460],epsilon_j_:460,epsilon_j_a:[422,460],epsilon_j_b:[422,460],epsilon_j_c:[422,460],epsilon_lj:460,epton:455,eqch:173,eqeq:[458,459],eqp:412,eqq:412,equal:[2,3,6,8,11,12,16,39,41,54,65,68,71,73,75,80,84,94,95,99,102,119,121,126,128,131,153,156,172,174,176,178,202,206,207,210,211,212,213,214,217,220,221,222,223,224,225,229,231,232,237,246,247,249,250,252,254,255,257,260,261,268,269,276,287,288,298,300,303,305,307,308,309,312,314,316,317,318,320,323,328,330,338,339,340,343,344,345,347,349,350,352,355,357,358,360,376,380,386,388,389,390,392,393,395,408,413,414,421,422,425,429,440,446,447,456,458,459,460,462,463,464,466,467,468,478,479,484,485,489,493,494,495,497,499,500,504,505,508,511,513,515,524,525],equat:[3,6,7,8,9,99,117,123,130,177,186,198,210,229,235,236,238,240,241,242,248,254,255,257,260,269,270,271,272,276,294,298,300,307,308,312,318,321,322,335,343,347,350,352,353,355,357,377,378,382,407,412,413,414,418,419,420,423,428,440,441,443,448,451,460,463,465,470,471,473,474,479,489,518],equation:[248,298,370],equi:272,equidist:270,equil:[3,308,381,504,529],equilater:507,equilibr:[3,4,5,6,7,9,61,99,178,210,217,220,228,229,246,269,271,272,294,295,304,307,308,309,310,343,344,345,350,408,409,458,459,493,507],equilibria:350,equilibribum:[226,227],equilibrium:[1,3,4,6,7,20,23,25,26,27,28,31,34,35,37,38,43,47,48,49,51,53,56,58,61,161,162,185,187,229,231,246,247,248,255,257,271,276,294,307,308,312,316,321,323,331,335,342,343,345,350,361,363,367,370,408,443,452,466,518],equilibrium_angl:8,equilibrium_dist:8,equilibrium_start:216,equival:[6,12,13,28,61,63,136,137,145,150,176,180,207,222,223,229,231,246,254,271,294,304,316,317,355,395,413,418,466,480,482,483,497,500,505,506,515,518],equlibrium:6,equliibr:[308,310],er3:177,eradiu:[40,124,204,418,497],eras:[320,344],erat:[231,441],erc:409,erfc:[409,431,448],erforc:[124,204],erg:523,erhart:[217,416,480,482],ermscal:396,ernst:9,eror:3,eros:443,erose_form:443,erot:[2,3,6,9,65],errata:[480,482],erratum:352,erron:3,error:[0,1,2],erta:423,ervel:[124,204,497],escap:[232,518],especi:[8,15,166,178,210,217,225,246,307,312,315,316,393,494,516],espresso:[9,311],essenti:[11,12,26,96,140,159,160,161,164,165,166,167,168,170,187,220,299,351,378,395,409,431,482,502,515],essential:[8,276],essex:28,establish:[95,250],estim:[1,3,6,10,12,37,41,56,74,99,153,216,225,236,269,318,335,342,377,378,384,448,459,478,479,511,515],estimat:3,esu:523,esub:443,eta:[6,257,271,307,308,310,351,417,419,422,456,481,485,523],eta_dot:271,eta_ij:456,eta_ji:419,etag:[40,497],etail:515,etap:271,etap_dot:271,etc:[1,2,3,4,6,7,8,9,10,11,12,13,14,15,39,40,42,54,63,71,97,98,99,104,120,121,124,126,129,153,155,158,159,160,161,162,164,165,166,167,168,170,172,178,180,181,182,191,203,204,206,207,210,211,216,217,218,219,222,223,226,227,231,232,244,246,247,254,271,303,314,319,347,348,356,360,376,377,386,387,388,389,391,416,417,426,439,441,446,454,458,459,477,480,482,485,492,495,497,498,499,504,506,507,511,512,513,514,515,516,518,523,524,527,529],ethernet:17,etol:[386,388,492,511],etot0:307,etot:[6,104,106,107,121,153,164,207,235,255,269,307,514,515],eu2:177,eu3:177,euler:[318,386,388],eulerian:216,euqat:469,europhi:257,ev_tal:8,evalu:[2,3,9,11,12,37,56,75,95,96,99,118,128,131,152,154,158,168,176,178,184,202,203,204,206,207,211,212,213,214,216,218,219,220,221,222,223,224,231,237,247,249,250,252,253,254,255,299,305,308,318,320,324,328,338,339,340,349,352,355,357,358,360,384,386,446,448,450,451,456,462,464,466,478,479,492,493,495,499,500,502,504,505,506,507,511,513,515,524,525],evaluat:[377,378,524],evalut:[360,495],evan:[166,294],evanseck:[6,19,184,404,509],evapor:[2,3,9,59,112,210,217],evaul:[8,386],evdwl:[118,154,458,459,515],even:[3,6,8,12,14,15,16,17,33,39,41,52,57,59,61,63,65,74,75,96,118,131,176,179,180,194,197,199,203,204,207,210,211,212,217,218,219,222,223,225,226,227,229,231,232,235,238,252,255,269,271,272,299,303,312,314,317,319,330,335,343,347,350,352,356,358,369,377,384,386,388,393,398,418,419,423,426,429,448,460,485,486,490,497,498,500,502,503,504,506,507,509,512,514,515,516,518,529],evenli:[3,41,57,153,199,225,257,429,486],event:[2,3,6,8,65],eventu:[3,6,12,14,180,511],eventual:308,ever:[9,54,56,253,335],everaer:[407,422,460,476],everi:[0,1,2,3,6,8,9,11,12,14,15,39,41,75,76,99,124,131,140,166,181,203,204,205,206,207,208,210,211,212,213,216,217,218,219,220,221,222,223,224,225,226,227,228,229,231,232,236,238,243,244,246,248,250,251,252,257,258,267,271,272,276,287,293,297,298,299,303,304,305,306,307,308,309,310,312,314,315,317,318,319,321,323,332,335,337,338,339,340,341,342,343,346,347,348,349,350,358,360,376,378,388,389,390,393,413,415,426,439,458,459,466,472,491,492,493,497,499,501,502,504,505,506,511,512,513,515,516,519,524,529],everyth:[8,118,519],everywher:[127,433],eviri:418,evolut:[238,248,257,300,492],evolv:[257,300,348],ewald:[2,3,5,6,7,8,9,12,96,121,130,153,348,377,378,386,400,402,403,409,412,418,431,435,453,461,476,478,483],ewald_disp:412,ewalddisp:3,exact:[21,41,44,75,134,172,181,186,225,228,247,248,254,255,256,303,312,313,335,347,362,377,406,499,504,511,524,527,529],exactli:[3,6,12,16,37,41,42,56,61,75,76,99,127,156,162,169,178,199,211,212,222,225,231,236,241,247,254,255,256,272,284,285,295,299,306,307,335,340,341,354,393,406,413,416,423,426,440,448,450,451,478,479,499,500,507,511,524],exager:518,examin:[6,8,16,228,299,318],examp:[495,524],exampl:[0,1,2,3],exce:[3,6,15,16,17,41,60,75,180,218,219,222,223,225,229,231,236,243,271,299,314,319,325,326,335,386,393,497,524],exceed:[3,41,61,225,231,271,335,459,505],excel:418,except:[1,2,5,6,8,10,11,15,19,20,21,22,23,24,25,26,27,28,29,30,31,34,36,37,40,41,43,44,45,46,47,48,49,51,53,54,55,56,61,62,65,75,97,98,119,123,128,153,155,156,157,158,159,160,161,162,164,165,166,167,168,169,170,171,178,182,184,185,186,187,188,189,190,192,193,195,196,198,199,202,203,204,207,210,213,219,220,222,224,225,229,231,239,245,246,249,252,254,256,271,272,273,274,275,276,277,278,279,280,281,284,285,289,291,292,294,295,296,300,309,310,317,320,321,331,335,341,347,355,358,359,360,361,362,363,364,366,367,370,371,372,377,378,380,383,387,388,389,391,392,393,394,395,397,400,401,402,403,404,405,406,407,408,409,411,412,413,416,417,418,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,441,444,449,452,453,455,458,459,460,461,468,476,477,478,480,481,482,483,485,487,488,489,492,494,495,497,499,500,502,505,506,507,508,509,511,515,518,523,524,525,528],exception:495,excess:[221,418],exchang:[2,3,6,8,63,64,210,216,217,238,246,250,254,309,317,343,347,350,377,393,418,512],exchange:377,excit:418,excite:418,exclud:[3,6,9,12,15,16,65,75,112,123,129,152,158,165,166,182,203,219,226,227,258,267,302,315,317,342,353,358,386,387,389,401,423,426,429,440,441,448,475,509],exclude:389,exclus:[1,3,12,15,95,184,408,446,448,506,516],excurs:[271,492],exectubl:12,execut:[1,2,3,4,6,8,9,11,12,16,62,179,206,251,311,360,376,379,392,493,495,505,508,511,524],exempl:466,exemplari:247,exemplifi:418,exert:[6,252,255,287,312,354,355,356,378],exhaust:[216,392,524],exhibit:[100,238,250,271,385,418,506],exist:[3,6,7,8,11,12,13,36,55,57,61,71,74,134,178,179,198,205,206,207,210,215,224,227,229,232,246,302,303,305,306,358,359,361,363,364,365,367,371,381,387,414,426,458,475,486,493,495,497,498,499,508,509,510,519,524,525,527],exit:[2,3,11,12,41,59,203,225,376,392,495,496,505,514,515,516,524],exlanatori:3,exp6:2,exp:2,expand:[2,3,44],expans:[12,152,197,203,508,524],expect:[1,3,8,12,13,14,15,16,17,18,41,42,75,112,159,170,176,199,225,237,246,248,268,298,304,306,307,312,317,358,378,389,406,443,446,448,492,495,497,499,502,506,511,524],expens:[6,75,207,298,302,317,347,358,377,378,389,393,495],experi:[6,13,14,224,232,251,260,270,304,316,317,384,388,413,448,506,511],experienc:[6,12,15,259,260],experiment:[16,246,377,393,511],expert:12,expertis:7,expir:[515,516],explain:[1,3,6,8,9,11,12,17,41,61,65,68,71,73,75,76,77,80,81,84,94,102,129,158,166,199,203,204,206,207,210,219,220,223,225,227,229,231,271,287,298,306,317,331,358,360,376,377,380,387,388,392,398,416,429,466,468,484,495,498,499,502,504,507,518,519,524,529],explan:[3,6,61,124,129,152,203,204,219,270,298,426,491,494,495,497,506],explanatori:[3,8,128,203,204,218,219,222,317,387,494,524],explantori:[3,313],explic:447,explicit:[6,9,11,21,44,81,95,124,127,172,186,211,212,231,318,325,326,362,377,383,395,396,399,404,406,416,418,430,440,483,491,494,498,501,519],explicitli:[3,6,8,12,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,75,123,155,165,168,176,178,184,185,187,188,189,190,192,193,195,196,199,203,204,207,213,224,231,239,245,247,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,306,307,309,310,317,320,321,340,341,347,355,361,363,364,366,367,370,372,387,393,394,395,397,400,401,402,403,404,405,406,407,408,409,410,412,413,415,416,417,419,420,421,422,423,424,425,426,430,431,432,433,434,435,436,437,438,439,440,444,446,448,449,450,451,452,453,455,459,460,461,468,469,470,471,472,473,474,476,477,478,479,480,481,482,483,485,487,488,489,497,499,500,506,507,509,510,516,518,519],explictli:[15,510],exploit:[14,16,300],explor:[130,177],expon:[3,308,310,318,416,420,422,425,439,447,461],exponenti:[95,318,420,456,477,485,489,511,524],expos:11,exposit:[216,413,415],express:[6,152,164,178,211,212,229,268,298,308,318,347,353,360,399,416,418,433,443,466,467,476,524],expression:360,expressiont:399,extend:[0,3,6,7],extens:[3,6,9,15,16,44,45,46,53,55,65,67,72,83,90,91,92,95,96,99,101,104,107,108,118,120,128,131,154,155,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,172,204,210,213,214,217,223,224,230,233,237,238,244,245,246,248,249,250,252,254,256,269,271,276,285,298,299,315,316,317,320,323,328,331,332,334,338,339,340,341,342,344,345,347,349,352,356,357,422,443,446,459,460,467,514,515,523],extensiv:[65,210,515],extent:[1,3,41,42,45,59,75,176,180,203,215,225,252,354,357,377,380,395,462,464,478,479,494,497,500],exterior:[3,6,176,356],extern:[2,3,9,94,95,176,206,210,224,229,237],extra:[3,6,8,11,12,15,16,40,41,46,63,75,112,120,121,123,130,153,155,156,157,159,161,164,165,166,167,168,170,171,177,178,179,180,207,222,225,227,271,305,306,307,317,335,386,387,390,391,393,412,423,426,429,443,448,494,495,497,500,509,518,524],extract:[3,6,11,13,35,65,67,72,83,95,101,118,126,128,131,211,212,310,388,409,419,443,467,495,502,514],extract_atom:11,extract_comput:[11,495],extract_fix:11,extract_glob:11,extract_vari:11,extramake:[12,14],extrapol:1,extrem:[1,3,6,16,60,206,221,229,231,271,345,418,481,518],extrema:439,extreme:418,extrins:216,f77:[5,7,12],f90:[5,7,12],f_1:6,f_5:[174,349],f_a:[480,481,482],f_ave:128,f_c:481,f_f:482,f_fix_id:307,f_foo:524,f_harm:345,f_i:[28,456],f_id:[6,75,128,131,203,204,210,218,219,220,221,222,223,266,337,349,515,524],f_ij:456,f_indent:223,f_int:344,f_j:28,f_jj:99,f_k:456,f_langevin:347,f_max:[307,312],f_msst:269,f_r:[255,480,481,482],f_sigma:399,f_solid:345,f_ss:6,face:[3,6,59,61,75,166,176,180,215,352,354,355,356,357,380,422,443,460,497,500],face_threshold:176,facet:176,facil:[0,12],facilit:[6,13,42],fact:[6,8,15,248,303,335,345,423,458,466,509],factor:[1,3,6,12,17,23,27,31,34,35,39,41,46,47,59,60,61,76,95,99,112,119,126,127,130,152,172,177,180,184,195,202,203,206,207,211,212,220,225,229,231,232,238,246,251,254,256,257,269,271,272,276,300,304,308,316,318,321,324,326,335,339,343,350,351,352,356,367,378,380,387,393,395,396,399,400,402,404,409,410,411,413,414,418,423,426,430,431,443,446,448,450,451,452,453,459,461,468,477,483,494,497,500,501,506,509,511,512,515,518,523,524],factori:[3,495],factoriz:377,fail:[3,9,11,12,61,182,229,232,377,386,388,411,459,495],failur:[133,463,496,524],fairli:[11,448,506,511,519],faken:77,falcon:251,fall:[3,6,207,222,303,495,524],fals:[94,358,466,524],fame:8,famili:[485,494],familiar:[0,11,519],fan:456,far:[3,6,12,16,59,61,63,94,203,204,207,208,225,226,227,229,232,271,298,316,317,335,352,363,367,384,388,389,484,495,497,502,515],farago:254,farrel:[480,482],farther:203,fashion:[6,8,41,75,178,207,210,211,212,217,225,227,232,246,248,252,268,269,271,273,274,275,276,277,278,279,288,291,292,294,295,296,306,307,309,317,323,327,334,337,345,347,351,352,353,355,357,388,426,440,500,509,524,528],fasolino:428,fast:[6,7,9,12,13,15,16,39,203,204,282,307,318,348,377,378,401,440,441,446,476,478,479,499,504,506,515,525,529],faster:[1,6,9,11,12,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,41,43,45,46,47,48,49,51,53,54,56,63,65,115,123,155,165,184,185,187,188,189,190,192,193,195,196,199,203,204,207,213,224,225,231,239,245,249,253,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,304,308,309,310,317,320,321,335,342,344,347,351,355,361,363,364,366,367,370,372,377,378,390,391,393,394,395,397,399,400,401,402,403,404,405,406,407,408,409,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,449,452,453,455,459,460,461,468,476,477,478,480,481,482,483,485,487,488,489,492,500,506,510,518],fastest:[1,6,16,166,347,348,393,494],fatal:[3,514],fault:[74,459],faulti:12,fava:422,favor:228,favorit:7,fbmc:342,fcc:[2,3,6,7,66,74,77,99,117,210],fcm:[288,524],fcold:238,fdirect:235,fdotr:427,fdt:[2,9,240,241,242,318,322],fdti:95,fe2:177,fe3:177,fe_md_boundari:216,featu:8,featur:[0,3,5,6],fecr:416,feedback:[7,251],feel:[7,251,252,260,298,356,358,388,448],fehlberg:318,felling:445,felt:356,femtosecond:523,fene:[2,3,6,7,10,15,44],fennel:[409,431],fep:[0,2],ferguson:[6,184,509],fermi:[1,9,10,12,14,164,393,482],fermion:418,fernando:442,ferrand:[9,13],few:[1,3,4,5,6,7,9,10,11,12,13,17,39,65,208,218,219,220,222,223,238,255,271,303,306,308,321,349,377,386,387,388,395,466,494,497,502,506,508,516,527],fewer:[1,3,11,14,15,63,260,506],fewest:3,fextern:244,feynman:300,fff:495,ffield:[408,419,458,459,466],fflag1:206,fflag2:206,ffmpeg:[3,12,206],ffplai:206,fft:[1,3,7,9,11,12,14,96,120,121,153,299,377,378,506],fft_inc:[12,378],fft_lib:12,fft_path:12,fftbench:[377,516],fftw2:12,fftw3:12,fftw:[9,12],fhg:[7,9],fhot:238,ficiti:475,fictiti:[6,213,214,237,244,248,300,316,409,431,435,475],field1:[498,502],field2:498,field:[0,2,3,5],fifth:[6,331,420,452],figshar:298,figur:[1,3,8,12,15,307,494,495,519],fij:412,file0:298,file1:[11,13,242,298,346,360,387,502,504,508],file2:[11,13,242,346,360,387,502,504,508],file:[0,1,2,3,4],file_from:205,filen:387,filenam:[3,12,13,15,37,41,56,199,203,204,206,207,208,216,219,220,221,222,223,225,230,241,242,298,302,305,308,309,310,313,314,317,318,319,346,347,374,375,376,387,388,394,395,399,409,416,417,419,420,428,443,444,445,450,451,452,456,457,458,459,466,467,477,478,479,480,481,482,485,493,494,495,498,499,504,508,515,524,527,528,529],filennam:504,filep:[3,203,204,207,499,504,529],filepo:314,fill:[7,9,178,206,303,347,380,389,399,446,459,500,519],filter:[207,216],final_integr:8,final_integrate_respa:8,finchham:[6,160,411],find:[0,3,4,6,7,8,9,11,12,13,15,37,39,56,63,75,77,95,128,181,199,208,217,228,229,241,242,243,246,270,298,303,304,312,316,384,386,388,389,409,426,431,435,443,450,451,466,476,478,479,518,519,524],find_custom:8,fine:[15,16,182,213,237,345,389,393,519,524],finer:[152,178,524],finest:377,finger:[178,202,268,500],finish:[6,11,41,225,360,374,376,377,390,392,393,484,502,524,525],finit:[0,3,4],finni:[7,416,476],finverse:235,fiorin:[9,230],fire:[2,3,210],firebrick:207,first:[0,1,2,3,5,6,8,9,10,11,12,14,15,16,20,37,39,41,42,45,46,54,56,59,61,63,64,74,75,87,96,99,113,114,115,117,123,127,128,139,142,145,146,150,153,163,166,172,174,176,177,179,180,181,185,199,203,204,205,206,207,208,210,211,219,220,222,223,225,228,231,241,242,246,247,252,257,268,269,270,271,298,300,305,306,307,309,314,317,321,323,331,332,333,335,336,337,344,345,346,347,349,358,360,361,368,380,386,387,388,389,392,393,394,395,398,399,400,402,404,406,408,409,416,418,419,420,423,424,426,427,428,429,430,431,435,440,441,443,445,446,448,450,451,452,456,458,459,466,467,475,477,478,479,480,481,482,485,489,492,493,494,495,497,498,499,502,504,506,509,510,511,514,515,518,519,524,525,526,527,529],fischer:[6,9,18,19,184,404,509],fit:[3,6,9,12,37,56,199,241,316,335,395,399,428,443,448,450,451,471,478,479,481,505,519,524],five:[77,164,307,387,399,444,497,511],fix:[0,1],fix_deposit:3,fix_flux:216,fix_heat:238,fix_id:[3,229,269,271,273,274,275,276,277,278,279,304,307],fix_manifoldforc:519,fix_modifi:[2,3,6,8,120,121,160,163,210],fix_nh:8,fix_nv:519,fix_poem:3,fix_pour:3,fix_qeq:3,fix_rattl:321,fix_reax_bond:458,fix_saed_vtk:319,fix_setforc:8,fix_shak:321,fix_srd:3,fixedpoint:[229,271],fixextern:244,fixid:[206,216],fji:412,flag1:[234,391],flag2:[234,391],flag:[3,8,9,11,12,14,15,16,38,40,58,69,78,79,86,87,94,97,98,103,113,114,116,129,130,173,177,181,200,203,204,206,207,208,223,228,230,234,251,254,258,260,267,268,299,306,317,331,334,335,342,346,355,358,373,375,378,387,391,392,393,395,425,430,443,446,475,490,492,494,495,497,498,499,501,502,503,507,519,524],flag_buck:403,flag_coul:[403,412,435],flag_lj:[412,435],flagfld:[401,440,441],flaghi:[3,401,440,441],flaglog:[401,440,441],flagn:234,flagvf:[401,440,441],flat:[6,15,347,352,353,357],flavor:[2,7,12],fld:[352,440,441],flen:396,flex_press:396,flexibl:[3,6,8,179,206,219,230,248,272,343,350,418,481,515],flip:[3,6,231,271,354,355],floor:524,flop:12,floralwhit:207,flow:[4,5],fluctuat:[6,66,95,229,246,247,254,257,271,276,298,299,304,322,345,347,370,414],fluid:[2,6,7,9,10,40,69,79,86,96,103,116,127,128,158,173,175,229,231,249],fluid_veloc:261,flush:[3,207,514],flux:[2,3,6,65],flv:206,fly:[7,9,12,41,206,210,216,221,232,235,317,321,348,399,446,515,518],fmackai:9,fmag:233,fmass:300,fmax:[386,515],fmomentum:235,fmsec:[2,207,254,255,268,271,304,317,338,339,506,517,523,525],fname:376,fno:[9,15],fnorm:[386,515],fnpt:235,fnve:238,fnvt:235,foce:426,fock:396,focu:321,fogarti:[9,310,459],foil:[152,298,467],fold:[15,333,506],folk:7,follow:[0,1,2,3,6,7,8,9,10,11,12,13,14,15,16,17,18,19,22,23,24,25,26,27,28,29,30,31,34,35,37,40,41,42,43,45,46,47,48,49,51,53,54,56,61,65,66,74,75,77,88,99,100,106,107,117,124,127,128,131,152,153,156,157,158,164,166,171,174,176,178,179,184,187,188,189,190,192,193,195,196,197,199,203,205,206,207,210,216,217,218,219,220,221,222,223,225,230,231,232,235,236,240,241,242,244,246,247,248,251,253,254,255,257,260,269,271,276,277,278,279,291,292,294,296,299,300,302,305,306,307,308,310,312,314,316,317,318,319,321,337,338,339,340,343,344,345,346,347,349,350,358,359,363,364,365,366,367,370,372,375,380,383,386,387,388,393,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,411,412,413,414,415,416,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,447,448,449,450,451,452,453,455,456,457,458,459,460,461,463,465,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,483,484,485,487,488,489,490,492,494,495,497,498,500,502,504,505,506,509,511,512,513,518,519,524,525,528],foo:[4,8,11,12,203,206,244,318,495,508,524],foo_species:318,foot:6,footprint:[12,393],fopenmp:[9,17],forc:[0,1,2,3,5],force_uvm:16,forceatom:260,forcefield:[316,425],forcegroup:257,forcezero:384,ford:412,forestgreen:207,forev:75,forget:[255,518],forgiv:271,fork:[12,203],form:[2,3,6,8,12,18,21,44,54,57,65,69,78,79,81,86,87,95,97,98,100,103,113,114,116,127,152,153,172,173,182,186,207,210,211,212,227,247,248,254,256,260,268,294,299,310,312,316,317,318,347,352,356,361,362,365,370,383,385,387,388,395,396,399,406,414,416,418,421,425,426,430,442,443,445,446,450,451,452,453,456,458,459,460,466,467,468,476,478,480,481,482,488,491,494,495,497,502,507,514,518,524],formal:[6,82,85,99,247,248,254,271,300,335,343,466],format:[2,3,6,7,8,9,12,13,21,37,41,44,56,57,71,81,186,199,203,204,205,206,207,208,219,222,223,225,227,241,242,299,302,306,308,310,313,317,318,319,330,346,347,358,359,362,383,387,388,394,395,399,406,416,419,420,430,443,445,450,451,457,458,459,461,467,478,479,485,486,494,495,497,498,499,502,513,514,515,524,526,527],formation:242,former:[6,12,39,41,207,225,347,351,399,401,503,509,524],formerli:[7,13],formul:[1,6,9,40,66,153,213,237,254,271,294,308,310,316,321,346,377,395,399,416,418,422,443,455],formula:[2,3,6,7,13,20,21,36,44,54,55,74,77,95,97,98,99,104,106,107,116,123,130,131,153,155,156,157,158,159,160,161,162,164,165,166,167,168,169,170,171,177,178,183,185,186,198,202,203,211,212,213,214,219,220,221,222,223,224,231,237,249,250,252,254,255,268,298,299,305,314,320,328,333,335,338,339,340,349,352,353,355,357,358,360,361,362,364,371,380,387,395,396,398,399,404,405,406,407,412,413,416,417,422,423,424,425,427,430,431,433,434,435,437,438,440,441,443,447,448,449,460,461,468,476,477,478,480,481,482,485,487,488,493,497,500,507,514,515,523,524,525],forth:[1,6,11,12,13,14,392,495,500,504],fortran:[3,6,9,11,12,13,244,416,426,443,458,459],fortun:8,forward:[3,8,95,376,388,393],foster:[399,455,456],foul:181,found:[3,6,9,12,77,172,203,228,230,238,246,251,257,263,299,342,348,360,376,389,406,409,412,492,498,499,514],four:[6,11,54,87,113,114,152,174,269,347,370,387,388,446,492],fourier:[2,6,12],fourth:[6,15,115,316,331,342,404,420,452,466],fox:[6,130,184,474,509],fphi:[37,56,478,479],fpic:12,fplo:[37,56,478,479],fprime:[478,479],fqdn:253,fqq:412,fraction:[1,3,6,8,12,15,39,41,85,120,153,181,202,206,207,217,226,227,228,229,269,303,307,314,315,318,335,340,341,380,388,393,399,401,420,423,440,441,502,507],fragment:[42,251,314],fraig:42,frame:[91,152,207,216,269,307,354,422],framer:[206,207],framework:[5,248,394,467],franc:9,frattl:238,fraunhof:9,free:[5,6,7,9,13,28,62,65,74,95,172,211,212,298,335,344,345,346,347,385,388,396,418,439,446,449,456,488,494],freedom:[3,6,8,104,106,107,109,111,112,123,155,156,157,158,159,160,161,162,163,164,165,166,167,168,170,171,219,228,235,246,248,254,255,260,271,272,276,277,278,279,291,292,294,296,300,302,317,321,338,339,340,345,386,412,515,518,525],freeli:[0,6,7,12,156,157,171,176,206],freez:[2,3,6,210,215],frenkel:[6,238,246,345],freq:215,frequenc:[3,6,15,39,113,207,221,285,299,300,307,312,318,375,413,418,459,466,492,506,511,524,528],frequent:[3,66,70,74,76,77,81,96,100,117,152,207,226,227,238,243,343,350,448,483,504,516],fri:[269,307],friction:[4,5,6,9,10,42,210,248,254,307,312,317,347,351,353,423,507],friedrich:324,from:[0,1,2,3,5],front:[269,307,354],frontend:[206,311],frozen:[6,123,182,245,247,255,389,421],fs2:[6,99],fscale:251,fstr:524,fstring:495,fstyle:353,ftol:[386,388,492,511],fuchsia:207,fuction:409,fudg:321,fugac:246,fugacity_coeff:246,fulfil:6,full:[1,2,3,6,9,12,15,16,37,39,40,99,206,220,221,230,238,257,298,318,377,378,393,399,416,418,419,422,459,483,497,499,504,505,509,511,516,518,528],full_energi:[3,246],fuller:386,fulli:[3,6,82,248,253,298,386,388,409,456,457,497,519,526,527],fulton:416,fumi:400,func:[495,524],funcfl:416,functionaliri:230,fund:[0,7],fundament:[335,523],funnel_flow:330,funrol:446,further:[3,4,6,8,12,13,63,65,67,72,75,83,94,101,115,118,127,206,207,210,219,222,223,226,232,236,257,261,300,308,319,322,324,335,347,349,358,378,384,386,387,388,389,394,398,408,446,466,492,511,512,524],furthermor:[26,187,238,318,414,418],furthest:63,futher:3,futur:0,g_ewald:3,g_ewald_6:3,g_ewald_disp:3,g_jik:456,g_p:347,ga3:177,gaa:399,gahler:385,gai:[3,422,476],gain:[15,342],gainsboro:207,galindo:447,game:251,gamma0:28,gamma:[3,6,28,254,257,261,299,307,308,310,312,351,413,414,417,422,443,447,470,473,474,477,480,482,485,515],gamma_:[3,347,353],gamma_ijk:480,gamma_n:[353,423],gamma_p:[3,347],gamma_t:[353,423],gammaa:447,gammafactor:257,gammar:447,gan:[456,477,480,482,485],gan_sw:456,gan_tersoff:456,ganzenmuel:[7,9],ganzenmul:9,gao:[6,19,184,404,509],gap:[199,440,441,457,467],gap_2014_5_8_60_17_10_38_466:457,gap_exampl:457,gaseou:7,gass:246,gather:[11,505],gather_atom:11,gather_scatter_loop_unrol:9,gathert_atom:11,gauch:190,gaug:12,gauss:[2,3,118,172,211,212,410],gaussian:[6,40,65,99,113,115,232,247,248,254,300,316,335,339,357,377,413,415,418,421,457,476,492,524,525],gave:[3,448],gavhan:15,gaybern:[2,3,6,7,9,15,156,386],gcc:16,gcmc:[2,3,7,9,210,217],gcores:235,gd3:177,gdot:441,gdrudes:235,ge4:177,gec:[480,482],gen:[271,272],gener:0,genom:7,gentler:[352,355,357],gentli:417,geom:[6,377,415,492,525],geometr:[3,6,7,8,42,59,61,75,86,129,168,169,178,180,203,207,213,224,225,232,237,250,271,277,278,279,291,292,294,296,317,320,328,338,339,340,356,358,377,380,388,398,401,405,407,409,412,418,420,422,424,431,432,433,434,435,436,437,438,439,440,441,442,447,448,451,460,468,479,483,484,487,488,490,497,500,507,515,524],geometri:[3,6,7,9,13,24,38,41,58,75,86,166,178,200,225,226,227,229,232,252,322,373,380,448,497,500],georg:[7,9],georgia:13,gerar:524,gerber:439,germani:9,germann:[276,433,492,511],germano:422,gerolf:13,get:[0,1,3,6,8,9,11],get_natom:[11,495],get_rank:11,get_siz:11,getenv:524,gettimeofdai:12,gewald:[6,377],gezelt:[409,431],gflop:12,gflp:12,gfortran:9,ghost:[3,6,7,12,15,60,63,64,77,176,181,182,229,231,255,271,306,317,319,375,377,389,393,413,414,415,418,423,430,490,502,507,518],ghostwhit:207,giacomo:9,gif:[4,206],gifsicl:206,gigabit:17,giko:2,gikot:2,gillan:467,gingold:[470,471,473],gio:2,git:[7,12,519],github:[8,13,16,230,248,253,457],give:[0,1,2,3,4,5,6,7,8,9,10,11,12,14,15,16,17,54,75,100,117,124,158,161,165,178,203,204,207,213,215,219,220,222,223,229,231,248,271,289,294,298,299,304,312,314,317,349,377,378,386,389,390,393,395,399,415,418,425,426,443,446,448,460,480,481,482,492,494,495,497,507,511,518,525],given:[3,4,5,6,7,9,11,12,15,16,21,26,36,44,55,63,65,66,70,75,117,124,135,136,137,139,140,143,144,145,146,147,148,149,150,151,152,153,172,176,180,186,187,198,199,203,204,205,207,210,217,219,221,226,227,229,231,232,236,238,246,247,248,249,251,257,263,265,268,270,271,276,297,298,299,300,307,308,314,316,318,321,330,331,333,335,337,342,347,348,351,352,353,356,362,371,377,378,393,394,395,399,400,402,403,405,406,407,408,409,410,413,414,415,416,418,419,420,422,423,425,431,432,433,435,443,444,445,446,447,448,449,450,451,452,453,456,460,461,463,465,466,467,476,489,492,495,497,499,500,506,507,511,523,528,529],gjf:254,gjwagn:7,gkio:2,gko:2,gkot:2,gld:[2,3,210],gle4md:[248,253],gle:2,glitch:3,glob:508,global:3,glosli:[378,446],glotzer:[317,413],glue:11,gmail:[7,9,13],gmake:[12,16],gmask:[3,524],gnu:[0,7,9,12,16],gnuplot:[11,13],goal:[5,12,39],goddard:[6,9,24,308,309,310,372,418,425,458,459,509],goe:[12,54,152,178,202,238,268,327,386,389,412,417,424,433,436,468,489,500,504],gold:[74,207],goldenrod:207,goldman:307,gone:3,good:[1,3,6,10,12,15,16,41,77,130,176,177,225,254,269,271,304,308,314,321,342,377,388,389,394,407,415,416,446,448,478,479,485,492,506,511,515,519],googl:251,gordan:152,gordon:6,got:[2,519],gould:[6,184,509],gov:[0,7,9,13,394,416,419,523],govern:257,gpa:395,gpl:[0,7,8,12],gpt:[9,446],gpu:[1,2,3,4,7],gpuid:393,grab:[3,6],gracefulli:3,grad:[6,9,213,237,270],gradient:[6,7,8,12,13,134,139,229,237,238,249,250,270,294,309,343,347,384,385,388,441,450,451,459,478,479],gradient_correction:465,graduat:302,graft:228,grai:207,grain:[5,6,7,9,10,28,35,40,54,70,178,181,190,210,242,298,302,317,318,335,420,424,446,451,461,479,506,509],gram:[219,416,523],grama:[9,310,459],gran:[2,3,6,9,210,352],grana:382,grand:[3,9,210,217,246],granflow:5,granular:[0,3,4,5],graph:11,graphen:501,graphic:11,grasp:5,gravit:249,graviti:[2,3,6,210,217,246],grdient:216,great:[3,13,307,519],greater:[1,3,10,63,75,94,176,207,229,247,271,298,340,354,393,398,400,402,403,429,448,492,494,497,500,506,511,524,525],greathous:13,greatli:[130,238,511],green:[2,6,99,142,143,206,207,299,300,343,399,519],green_kubo:6,greenyellow:207,greffet:312,greg:[7,9],grest:[45,46,228,335,378,403,423,435,509],grew:75,grid:[3,12,41,64,130,166,177,180,204,225,257,312,335,347,348,375,377,378,491,494,497,499,501,506],grigera:6,grime:40,grmask:[3,524],gromac:[2,3,359,386],gromacs:[6,7,203,386,424,476],gronbech:[254,377],groot:413,ground:[6,88,89,240,322,418],group1:[160,181,389],group2:[96,154,160,179,181,389],group2ndx:2,group:[2,3,5,6,7,8,9,11,12,13,15,39,41,61,63,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],group_id:11,groupbig:335,groupid1:[260,317],groupid2:[260,317],groupid:497,groupnam:389,grouptyp:246,grow:[3,6,8,215,231,232,252,254,271,298,318,349,423,497,509],grow_arrai:8,grow_reset:8,growth:[6,342],grueneisen:9,gsmooth_factor:443,gstyle:[3,494],gtl:7,guarante:[68,73,84,102,119,126,178,181,203,236,308,376,380,507],guess:[3,203,304,498,519],gui:[7,11,519],guid:[1,16,40,82,85,109,110,111,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,210,264,265,324,325,326,327,330,348,455,463,465,469,470,471,472,473,474,507],guidelin:[1,8,14,16,17,18,377,478,479],guidlin:16,gullet:443,gulp:6,gumbsch:385,gunnel:446,gunsteren:[304,338,439],gunzenmul:7,gunzip:12,guo:[6,19,184,190,404,509],gwald:3,gyrat:[2,3,6,65],gzip:[3,12,203,204,206,207,346,388,497,498,502],h12:422,h2o:[40,387,420,451,479],h5cc:205,h5md1:205,haak:[304,338],had:[3,6,11,13,61,65,129,203,204,207,208,222,223,228,229,247,248,250,254,255,256,269,271,273,274,275,276,277,278,279,291,292,294,296,303,304,335,338,339,340,347,413,415,423,475,499,503,506,512,515],hafskjold:[6,238],half:[1,3,6,8,9,15,16,39,41,60,61,180,206,218,225,231,254,271,347,352,356,389,393,396,399,407,418,446,459,462,464,497,499,500,507,518],halfwai:[41,206,207,429,519],halperin:100,halsei:423,halt:[41,207,225,238,250,360,514],halv:206,ham:[37,56],hamak:[352,356,407,460],hamilton:74,hamiltonian:[210,248,271,272,339,418,506],hammond:[377,378],han:416,hand:[3,6,9,18,54,74,129,154,178,196,202,206,257,268,318,380,409,418,497,500,507,510],handl:[3,15,206,230,287,310,393,396,418,440,459,485,495,511,518],hang:[3,12,494,495],happen:[3,6,8,12,14,17,63,127,182,207,217,220,389,393,495,498,505],happi:8,haptic:251,hara:481,hard:[1,260,310,316,317,415,458,466,500],harden:[9,468],harder:[352,356,518],hardi:[216,255,377,378,518],hardwar:[1,9,10,12,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,123,155,165,184,185,187,188,189,190,192,193,195,196,199,213,224,231,239,245,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,309,310,317,320,321,355,361,363,364,366,367,370,372,377,378,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,449,452,453,455,459,460,461,468,477,478,480,481,482,483,485,487,488,489,500,510],hardwir:[3,16,353],hardy2:378,harm:396,harmon:[2,3,4,6,7,8,15,21],harmonic_1:57,harmonic_fix_wal:441,harpertown:17,harrison:395,hart:335,hartre:[396,416,418,446,523],hasan:9,hash:[39,497],hassl:316,hat:[6,270],have:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,41,42,43,45,46,47,48,49,51,53,54,56,59,61,65,66,68,69,70,73,74,75,76,77,79,81,86,87,94,98,99,100,103,113,114,115,116,117,123,124,125,126,127,142,152,153,154,155,156,157,158,159,161,165,167,170,171,173,174,175,176,178,179,180,181,182,184,185,187,188,189,190,192,193,195,196,199,202,203,204,205,206,207,208,213,215,217,218,219,220,223,224,225,226,227,228,229,231,232,237,239,243,245,246,247,248,249,250,251,252,254,255,256,257,260,263,266,268,269,271,273,274,275,276,277,278,279,280,281,285,289,291,292,294,295,296,298,300,302,303,304,306,307,308,309,310,312,315,317,320,321,328,330,335,336,338,339,340,341,342,346,347,348,349,351,352,353,354,355,356,357,358,359,360,361,363,364,366,367,368,370,372,377,378,380,384,385,386,387,388,389,390,393,394,395,396,397,399,400,401,402,403,404,405,407,408,409,412,413,414,415,416,417,419,421,422,423,424,425,426,427,431,432,433,434,435,436,437,438,439,440,441,443,444,445,446,448,449,450,451,452,453,455,456,458,459,460,461,465,466,468,477,478,479,480,481,482,483,484,485,487,488,489,491,492,494,495,497,498,499,500,501,502,503,504,505,506,507,509,511,512,514,515,516,518,519,523,524,525,527,528,529],haven:495,hayoun:312,hayr:254,hbcut:458,hbnewflag:458,hbond:[2,3,6,9],hbond_cutoff:459,hcn:318,hcp:[66,70,74,77,380,443],hdf5:[9,205],he1:177,head:[6,20,185,361,395,421,425,458,459,512,519],header:[3,6,7,8,12,179,203,206,207,208,219,220,222,223,269,307,314,319,347,387,394,399,416,475,494,497,507,514],heal:506,heat:[2,3,6,9,40,65],heatconduct:2,heavi:[306,335],heavili:[41,225],heavisid:347,hebenstreit:15,hecht:335,heenen:9,height:[206,232,303,388,421],held:[6,75,318,335,388,423],helic:190,helium:397,helix:[2,7,186],hello:495,help:[3,8,12,14,15,16,17,18,203,229,231,269,298,375,399,449,480,482,519,527],henc:[1,3,13,19,20,25,31,34,35,74,75,119,158,160,168,185,219,271,310,335,351,352,356,358,361,363,367,370,378,409,421,439,456],henderson:53,hendrik:9,henin:[9,230],henkelman1:[270,388],henkelman2:[270,388],henkelman:[270,385,388],here:[1,2,3,4,5,6,7,8,9,11,12,13,14,15,16,17,18,21,36,40,41,44,55,65,68,71,73,74,75,84,102,119,129,130,158,176,177,186,189,198,203,206,207,210,219,225,228,231,246,247,255,257,298,307,310,312,319,347,352,355,357,358,360,362,371,376,382,386,388,392,393,395,396,399,406,419,422,425,426,430,442,456,460,463,465,466,476,478,479,489,495,499,502,518,519,524],herist:348,herrmann:335,hertizian:353,hertz:[2,9,132,353],hertzian:[6,353,423,476],hertzsch:423,hess:377,hessian:[5,385],heterogen:115,heurist:[348,498],hex:[3,178,238,250,380],hexagon:[70,100,443],hexahedron:204,hexat:100,hexord:[2,3,65],hey:[121,153],hf4:177,hfo:408,hftn:[263,287,293,385,386,388],hg1:177,hg2:177,hgrid:335,hibb:300,hidden:[16,495],hienergi:358,hierarch:[7,506],hierarchi:[378,403,404,431,432,435,442,447,506],higdon:[9,440,441],high:[1,3,6,7,9,12,15,18,41,117,199,203,206,225,229,236,255,269,343,347,350,378,385,386,393,395,399,418,422,446,450,451,460,478,479,489,494,506,511,518],higher:[1,15,152,181,207,219,223,226,227,232,238,252,303,312,342,355,357,386,395,418,427,466,524],highest:[232,238,360,387,388,524],highli:[3,6,7,15,178,206,231,254,271,285,307,317,384,386,418,492,511],highlight:[4,6,7,13],hight:421,hilger:[377,378],hill:300,hill_height:13,him:9,hing:9,hint:12,histo:[2,3,6,65,124,177,210,218,219,220],histogram:[1,3,6,12,65,127,176,210,220,222,223],histor:419,histori:[0,2,3],hit:[3,335,354],hmaktulga:[7,9],ho3:177,hoc:370,hocknei:[377,378],hofl:205,hoh:[6,409,431,435],hold:[6,32,61,75,191,219,231,262,301,316,317,331,386,388,423,439,488,508],holdem:316,holder2:378,holder:[377,378],hole:331,holian:[276,433],holm:[298,378],holonom:346,home:[11,12,208],homebrew:12,homepag:[204,206,251],homogen:[294,448],hone:300,honeydew:207,honor:208,hood:446,hook:[2,6,9,11,251,353],hookean:423,hoomd:208,hoover:[6,7,8,168,210,235,254,255,271,272,273,274,275,276,277,278,279,291,292,293,294,295,296,300,304,312,317,338,339,340,345,413,518],hop:[228,388,399,466],hope:[5,13,16,41,42,225,505],hopefulli:[8,386],horizon:455,horn:6,host:[3,12,15,16,230,393],hot:[6,250,272],hotpink:207,hottest:343,hour:[12,516],hourglass:[2,9],hove:443,how:[0,1,2,3,4],howev:[1,2,3,6,7,9,11,12,14,15,16,35,39,41,75,96,99,114,130,152,177,199,203,206,207,220,221,223,225,228,229,232,235,246,247,248,253,254,255,256,257,260,271,298,300,303,304,306,307,312,317,319,335,336,338,339,342,343,347,348,349,350,351,378,380,383,384,388,393,405,407,416,417,423,426,443,446,450,451,454,456,465,477,478,479,482,492,494,495,498,499,505,511,514,515,518,519,524,525],howto:[6,9,65,75,155,156,157,159,161,164,165,166,167,168,170,171,203,210,254,255,271,304,338,339,340,409,425,431,435,525],hoyt:216,hpc:[1,14],hsw:16,htm:416,html:[0,8,9,11,12,14,67,154,253,421,441,506,507],htmldoc:0,htst:511,http:[0,6,7,9,11,13,14,230,248,251,253,298,394,416,440,457,458,459,519],https:519,htype:[409,431,435,439],hubbard:410,huge:[10,12,180,285,335,497,502,514,519],huggin:[7,400,402,476],hugh:216,hugoniostat:[4,9,210,276],hugoniot:[269,276,307],hull:176,hummer:377,hundr:[7,238],hura:6,hwat:306,hwloc:[12,16],hybrid:[1,2,3,6,7,12,15,17,21],hydrat:421,hydrocarbon:[395,408,418],hydrodyanm:40,hydrodynam:[7,9,40,109,111,257,259,260,261,401,440,441,463,465,476,507],hydrogen:[3,6,7,9,243,306,312,395,399,409,418,425,431,435,439,458,459,476,497,506,518],hydrostat:[3,9,229,271,276,304,317],hynninen:[410,421],hyoungki:445,hyper:[15,300],hyperbol:410,hyperradiu:382,hyperspher:152,hyperthread:[16,393],i_0:347,i_1:456,i_csid:6,i_flag1:306,i_mpi_pin_domain:15,i_mpi_shm_lmt:15,i_myflag1:306,i_myflag2:306,i_n:456,i_nam:[124,203,306,337,507],ialloi:443,iatom1:[102,126],iatom2:[102,126],iatom3:[102,126],iatom4:[102,126],ibar:443,ibead:300,ibm:[203,377,446],icc:[9,12,446],ice:6,icm:[251,519],icms:[9,251,519],ico:66,icosohedr:77,ictp:13,id1:[317,388,430,497,500],id2:[317,323,331,388,430,497,500],id_press:[229,269,271,273,274,275,276,277,278,279,304],id_temp:[228,229,269,271,273,274,275,276,277,278,279,291,292,294,296,304,338,339,340],idea:[1,3,6,11,12,41,153,206,207,225,252,298,323,335,343,378,448,505,518,519],ideal:[6,9,40,77,127,246,298,380,440,470,519],idealga:2,idealiz:6,idealli:[12,134,235,518],ident:[1,3,9,12,15,39,40,75,152,203,207,222,229,230,247,248,254,255,268,271,298,300,304,312,314,317,378,387,388,393,400,402,409,411,416,431,433,439,452,458,459,466,467,485,489,492,495,498,511,523,524,525,528],identi:393,identif:70,identifi:[1,3,6,12,37,40,56,74,154,176,178,199,241,242,306,314,335,358,425,430,443,450,451,478,479,492,494,497,500,511,512,514,516],idflag:303,idl:[17,511],idn:[317,388],idr:524,ids:[12,498],ielement:443,ieni:13,ifdef:[8,12],iff:255,iffp:495,ifort:9,ignor:[3,6,11,15,38,41,42,58,63,67,72,75,83,91,95,101,108,118,131,182,200,203,204,206,207,211,212,220,221,222,223,225,229,230,231,232,246,249,253,254,268,271,276,282,288,303,304,305,306,316,317,319,335,338,339,340,346,347,349,352,356,357,358,368,373,379,383,387,388,393,394,405,406,407,416,417,419,422,429,430,443,450,451,452,456,460,477,478,479,480,481,482,484,485,490,492,494,497,498,502,507,509,511,514,524],ignore:3,ihle:335,iii:[6,9,24,308,310,372,425,509],ijj:485,ijk:[366,370,372,399,456,485,494],ijl:370,ikeshoji:[6,238],ikj:485,iko:2,ill:[158,168,219,308],illeg:3,illegal:3,illinoi:[251,377,378,440],illog:495,illustr:[1,4,6,8,9,11,12,15,16,17,18,298,300,388,426,495,518,524],ilmenau:7,ilya:[7,9],imag:[2,3,4,6,11,12,42,69,75,78,79,86,87,97,98,103,113,114,116,124,129,130,173,178],image2pip:206,image:[3,12,203,206,319],imageint:3,imagemagick:[4,206],imagin:[331,346,399,417,426,427,429,444,445,452,456,477,480,481,482,485,509],imaginari:[6,100,246,300,497],imbal:[1,12,41,225,318,393,516],imbalanc:[41,225],imbu:335,imd:2,img:206,immedi:[0,2,3,8,12,178,226,227,232,318,321,336,337,354,494,495,497,499,511,524,528],immediat:[330,524],immens:3,immers:[257,317],impact:[1,4,6,8,9,236,342,395,516],impart:[3,6,249,335,357],impei:[6,431],implement:[1,3,6,8,9,12,16,17,26,82,88,89,95,117,130,160,166,177,178,186,187,198,219,230,234,238,240,248,250,251,254,257,259,260,261,269,271,294,297,299,300,306,307,310,311,312,318,321,322,323,335,342,347,351,370,376,377,378,386,388,393,394,396,399,408,409,411,413,414,416,417,418,426,431,435,439,443,455,458,459,460,480,482,494,495,506,511,518,524,526,527],impli:[3,6,40,61,95,153,202,206,211,212,213,231,237,254,316,338,340,341,377,380,406,495],implicit:[2,3,6,7,247,248,254,282,317,351,352],implicitli:8,implict:410,imporop:387,important:345,impos:[2,6,75,123,167,202,210,213,214,224,237,238,239,244,249,252,261,262,270,285,298,301,320,328,331,332,334,335,342,343,344,345,350,351,352,355,356,357,386,388,390,491,505,516],impose:249,imposs:[1,3,306,497],improp:[0,2,3,7],improper:[3,8,15,362,368,370,371,387,497],improper_coeff:[2,3,361],improper_styl:0,impropercoeff:[3,373],impropertyp:227,imprortant:107,improtant:[211,212],improv:[0,1,9,15,39,41,207,225,238,250,271,299,393,425,431,446,448,459,477,481],imrop:369,in3:177,inaccur:[1,3,6,181,269,377],inaccuraci:356,inact:[425,515,516],inappropri:178,incid:[130,177,232],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,30,31,34,35,36,37,39,40,41,43,44,45,46,47,48,49,51,53,54,55,56,57,61,63,65,68,69,71,73,74,76,78,79,81,84,86,87,91,95,96,97,98,99,100,102,103,104,107,108,113,114,115,116,117,118,119,120,121,122,123,125,126,127,129,130,152,153,154,155,156,157,158,159,160,161,162,164,165,166,167,168,169,170,171,172,173,175,176,177,181,182,184,185,186,187,188,189,190,192,193,195,196,198,199,202,203,204,206,207,208,210,211,212,213,214,216,217,219,220,221,222,223,224,228,229,231,232,233,235,237,239,244,245,246,247,249,250,251,252,254,255,257,258,260,261,266,267,271,272,273,274,275,276,277,278,279,280,281,289,291,292,294,295,296,298,299,300,302,303,306,307,309,310,312,313,314,316,317,318,319,320,321,323,328,331,332,334,335,336,338,339,340,342,345,346,347,348,349,351,352,353,355,356,357,358,360,361,362,363,364,366,367,370,371,372],include:[12,374],includelink:9,includig:[360,376],inclus:[0,3],inclusion:12,incom:251,incompat:[3,11,263,287,293,427],incomplet:[3,11,497],incompress:[272,418],inconsist:[3,182,228,498],inconveni:380,incorpor:[197,307,399,410,519],incorrect:[3,161,254,443],incorrectli:[3,380,423,524],increas:[1,3,6,15,17,37,56,59,61,120,130,153,199,203,204,206,207,221,226,227,228,231,238,241,242,246,254,304,315,316,317,318,343,346,350,377,378,388,393,395,418,422,450,451,459,478,479,481,495,506,511,524],increasingli:418,increment:[3,11,140,213,214,224,225,232,237,243,271,303,323,324,358,376,392,429,466,492,495,509,511,524],incur:[16,219,243,347,494],inde:161,indefatig:7,indefinit:344,indent:[2,3,4,210,223],independ:[4,6,9,11,12,16,41,61,65,86,99,128,131,164,178,202,210,218,219,220,222,223,225,228,229,230,231,232,247,249,254,255,257,260,271,299,304,308,312,317,319,323,334,345,347,380,423,446,492,495,514,525],indetermin:[203,204,207],index:[0,3,6,8,11,12,37,39,40,56,57,68,71,73,84,102,119,128,129,131,176,199,203,207,218,220,241,242,251,253,300,319,347,358,359,360,383,392,448,450,451,458,459,478,479,486,497,512,524],indianr:207,indic:[2,3,6,8,11,12,15,20,40,42,54,67,70,72,78,83,87,88,89,96,97,99,101,113,115,123,126,128,153,155,156,157,158,159,160,161,162,163,165,166,167,168,169,170,171,174,185,199,203,206,211,212,229,271,299,317,347,358,361,370,377,387,389,408,415,419,426,443,446,448,452,458,459,466,480,482,494,496,497,499,515,519,524],indigo:207,indirectli:[6,306,524],indistinguish:254,indium:467,individu:[0,1],induc:[0,3],industri:7,ineffici:[3,6,40,66,70,74,76,77,81,100,117,152,166,206,231,271,299,377,390],inelig:217,inerti:441,inertia:[2,3,6,40,42,65,90,91,92,93],inertiai:129,inertiax:129,inertiaz:129,inexpens:[248,506],inf:[2,3,12,350,500],infer:[3,104,106,107,172,213,214,225,226,227,237,251,302,335,343,350,380,406,419,497,509,515],infil:[3,13,317,494],infin:[3,386,502,515],infininti:206,infinit:[3,232,245,252,254,257,299,335,347,353,354,378,380,418,497,501,523],infinitesim:6,inflect:[410,433,476],influenc:[3,9,41,85,160,268,303,377,378,448,480,481,482],inform:[0,1,2,3,6,7,8,9,11,12,13,14,15,16,39,41,42,61,63,64,65,71,96,126,128,129,130,177,178,184,203,204,205,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,235,236,237,238,239,243,244,245,246,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,270,280,281,282,283,284,285,286,287,288,289,290,293,297,298,299,301,302,303,304,305,306,308,309,310,311,312,313,314,315,316,317,319,320,321,324,331,332,333,335,336,338,339,340,341,342,343,344,346,349,350,351,352,354,355,356,357,359,375,377,378,381,385,386,387,388,389,391,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,412,413,415,416,417,418,419,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,449,450,451,453,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,484,485,487,488,489,490,494,495,497,498,499,501,502,504,509,511,512,514,516,524,526,527,528,529],informat:[8,12,498],infrequ:[6,271,413,492,511,516],infti:[410,440,441],ingtegr:399,inher:[377,386,448],inherit:[6,483],inhomogen:[17,347,448],inidividu:386,init:[3,8,315,466],init_fil:347,init_list:8,init_on:8,init_styl:8,initi:[2,3,4,6,7,8,11,12,13,37,39,40,41,56,59,61,64,75,85,87,94,95,113,114,142,174,179,180,199,202,203,204,206,207,208,211,212,215,216,220,225,227,228,229,231,239,241,242,246,247,251,252,253,254,255,257,262,267,268,269,270,271,276,285,287,299,300,301,306,307,312,315,316,317,318,320,322,332,334,335,337,342,344,345,346,347,348,349,352,353,354,355,357,358,360,377,381,385,386,388,395,396,412,413,415,446,450,451,457,458,459,466,478,479,492,494,495,497,499,500,502,504,505,507,511,512,515,518,524,525,527,529],initial:[2,3,6,87,113,180,524],initial_integr:8,initial_integrate_respa:8,initialis:457,initialt:347,inlclud:11,inlin:495,inner2:[404,424],inner:[3,8,15,57,203,252,360,376,384,385,386,388,392,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,453,455,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,486,487,488,489,490,506,511,524],inner_distance_cutoff:425,innergroup:260,innermost:[37,56,75,391,478,479,506],innernod:260,innner:437,inordin:348,inorgan:[6,485],inp:[230,360,467,485],input1:[71,124,125,128,129,131,337],input2:[71,124,125,128,129,131,337],input:[0,1],input_doubl:3,inquir:324,insensit:12,insert:[3,5,7,8,9,12,61,178,210,232,246,252,303,377,467,475,495,501,518],insertion:[3,232,246,303],insid:[2,3,6,8,11,75,129,141,147,178,203,204,207,218,232,233,238,243,246,252,257,260,303,317,335,352,354,355,356,357,358,375,380,495,496,497,499,500,507,524],inside:[257,433,495,511],insight:[6,13],instabl:[257,412,465],instal:[1,3,6,8,9,11,12,14,15,16,176,203,205,206,208,378,388,403,404,427,431,435,439,446,492,498,499,504,512,519,529],install:[0,8],instanc:[6,9,11,211,230,248,354,421,426,448,456,495,518],instantan:[6,65,228,229,247,248,271,276,299,304,307,312,314,317,342,503,515],instanti:[6,11,12,216,426,494],instead:[1,3,6,8,11,12,13,15,16,17,40,41,61,63,65,74,75,98,113,128,156,160,182,184,199,203,204,212,219,222,223,225,229,230,246,254,257,260,261,299,305,306,315,317,337,355,375,377,378,381,389,393,402,403,416,430,432,439,443,446,449,459,476,483,492,500,504,511,513,518,524],institut:[9,251,302],instruct:[3,4,6,8,9,10,11,12,13,15,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,123,155,165,176,184,185,187,188,189,190,192,193,195,196,199,201,206,213,224,231,239,245,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,309,310,317,320,321,355,361,363,364,366,367,370,372,378,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,449,452,453,455,459,460,461,468,477,478,480,481,482,483,485,487,488,489,500,506,518],instruction:11,insuffici:[3,6,12],insult:271,insur:[3,6,11,12,16,39,40,63,77,112,114,178,179,199,203,204,206,207,213,226,227,232,237,239,243,244,246,249,254,267,305,306,315,317,335,347,352,356,357,358,360,376,387,389,393,407,422,426,454,460,478,490,494,495,497,498,502,505,506,514,515,524,525],insure:16,int_max:3,inteatom:10,integ:[3,6,8,11,12,39,40,42,66,71,74,75,117,124,126,128,131,152,176,178,181,182,184,188,189,193,197,199,202,203,206,207,217,219,226,227,228,232,234,244,246,247,248,251,254,255,256,257,299,302,303,306,307,312,317,318,335,337,339,342,346,347,366,377,380,401,413,414,415,429,443,458,459,463,465,467,492,494,495,496,497,505,506,507,511,514,524,525],integer:[3,497],integr:[2,3,5],integral:[300,450,451],integrate_ulsph:325,intel:[1,2,3,7],intel_coprocessor:15,intel_cpu:12,intel_cpu_intelmpi:15,intel_cpu_mpich:15,intel_cpu_openpmi:15,intel_phi:12,intend:[3,6,8,12,13,35,221,247,457,497],intens:[1,3,6,9,65,69,78,79,86,94,97,98,99,103,113,114,115,116,123,125,127,128,130,131,155,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,173,174,175,177,210,219,220,222,223,225,226,227,228,236,243,250,260,269,271,276,314,317,319,335,343,347,349,350,514,515,523],intensiv:[65,210,515],intepol:524,inter:[17,42,63,64,158,181,182,203,228,254,256,270,309,317,377,388,399,507,518,524,527,529],interact:[1,3,6,7,8,9,10,11,12,14,16,21,28,32,33,36,39,40,42,44,50,52,54,55,57,59,63,65,68,73,76,81,84,95,96,100,102,117,118,119,121,123,126,127,134,135,136,137,139,140,141,142,143,144,145,147,148,149,150,152,153,154,156,157,171,172,176,179,180,181,182,183,184,186,190,191,194,197,198,203,204,210,211,212,226,227,228,245,246,251,252,254,256,260,285,298,300,302,303,308,310,316,317,318,325,326,335,336,342,347,351,352,353,356,357,362,363,364,365,367,369,371,377,378,386,387,388,389,390,391,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,451,453,454,455,456,459,460,461,463,465,466,467,468,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,492,495,497,499,501,502,506,507,509,514,515,518,527],interatom:[3,4,7,9,10,178,203,270,344,345,394,399,416,418,427,443,446,466,481,524],intercept:130,interchang:6,interconnect:17,interconvert:418,intereract:39,interesect:356,interest:[1,5,7,8,9,11,13,75,177,300,342,345,378,417,441,458,459,495,524],interf:[393,519],interfac:[0,3],interfer:[12,271,395],interg:[6,518],intergr:506,interi:441,interior:[3,6,41,356,500],interlac:443,interleav:[6,178,505],intermedi:[6,12,61,206,270,298,370,388,495,496,505,509],intermix:492,intermolecular:[154,395],intern:[0,2,3,5,6,9,11,15,19,20,23,27,31,34,35,39,40,42,65,88,89,95,109,111,129],internal:[3,206,212,303,524],internal_element_set:216,internal_quadratur:216,internat:[15,130,177,216],internet:253,interpenetr:443,interpentr:[470,471,473],interpol:[6,14,37,56,110,199,206,207,216,241,242,257,298,377,378,388,399,448,450,451,459,472,478,479,480],interpret:[2,6,11,197,206,222,423,468,492,495,511,524],interrupt:307,intersect:[3,6,130,207,356,358,500],intersert:356,interspers:386,interstiti:[176,446],intertia:[3,103],interv:[3,6,99,205,220,254,271,307,312,313,326,466,472,492,511,524],intestieti:130,intial:[6,393,395],intiial:[41,502],intiti:[3,334],intra:317,intra_energi:246,intramolecular:[28,154,246],introduc:[6,9,100,117,206,238,271,307,312,317,370,377,394,409,418,431,435,439,477,511,524],introduct:0,intuit:380,inv:[130,177,319],invalid:[3,12,75,97,181,285,388,440,441,499],invari:[117,145,150,152],invent:321,invers:[3,6,51,130,177,207],inverse:518,invert:[1,6,182,299],invis:356,invoc:[176,228,393,463,465,495],invok:[1,3,6,7,8,9,11,12,13,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,41,43,45,46,47,48,49,51,53,54,56,57,61,65,69,75,78,79,86,87,95,96,97,98,103,113,114,116,121,122,123,128,131,155,165,172,173,176,178,179,181,182,184,185,187,188,189,190,192,193,195,196,199,203,204,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,231,232,233,234,236,237,238,239,243,244,245,246,247,249,250,251,252,254,255,256,257,258,259,260,261,262,263,264,265,267,268,270,271,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,308,309,310,311,312,313,314,315,317,319,320,321,323,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,361,363,364,366,367,370,372,376,377,378,379,380,386,388,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,426,427,431,432,433,434,435,436,437,438,439,440,441,444,448,449,452,453,455,459,460,461,463,465,467,468,477,478,480,481,482,483,485,486,487,488,489,491,494,495,496,498,500,502,505,506,508,509,511,514,515,518,524,525],invokd:3,invoke:[3,12,16],involv:[3,6,7,8,12,65,119,126,127,128,158,182,210,217,226,246,257,302,305,310,335,377,385,386,388,398,415,422,429,477,480,482,493,494,500,502,506,511,512],ioff:[387,497],ion:[6,7,9,160,297,331,347,378,399,410,419,421,443,446,466,476,482,489,497,518],ionic:[6,9,400,402,410,418,419,453,466,518],ioniz:[408,418],ionocoval:9,iparam:[3,227],ipi:[2,13],ipp:0,ir3:177,ir4:177,irregular:[6,41,60,225,229,231,271,317],irrelev:452,irrespect:[440,441],irrevers:[235,318],is_act:[3,524],is_avail:[3,524],is_defin:[3,524],isbn:488,isele:[377,378],isenthalp:[9,271,272,273,274,275],ismail:[377,378,403,435],isn:[3,8,11,12,238,250],iso:[3,229,235,255,271,272,273,274,275,276,277,278,279,304,312,317,518],isobar:[9,271,272,277,278,279,322,414],isodem:418,isoenerget:[9,322,414],isoenthalp:[322,414],isol:[3,181,358,423],isomorph:300,isotherm:[9,246,271,272,277,278,279,304,322,414],isotop:306,isotrop:[6,100,254,304,377,378,401,422,440,441],isovolum:319,isralewitz:323,issu:[1,3,6,9,11,12,13,14,16,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,61,75,77,87,113,123,155,165,184,185,187,188,189,190,192,193,195,196,199,206,213,224,228,229,231,232,237,238,239,245,246,249,254,269,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,300,304,306,309,310,317,320,321,334,338,339,340,345,355,357,360,361,363,364,366,367,370,372,378,387,388,391,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,431,432,433,434,435,436,437,438,439,440,444,449,452,453,455,459,460,461,468,475,477,478,480,481,482,483,485,487,488,489,497,499,500,506,509,514,515,516,524,525],issue:216,ital:[458,459],itali:13,item:[6,7,8,41,203,207,225],iter:[3,6,12,39,41,65,205,213,214,224,225,229,235,237,244,252,287,293,299,308,309,317,321,332,342,358,360,376,384,385,386,388,392,466,492,502,506,511,515,516,524],iterat:[12,386],ith:[75,128,131,218,219,220,221,222,223,337,349,515,524],itself:[2,3,6,7,8,9,11,12,13,17,42,61,99,118,169,203,205,206,207,208,220,221,230,235,255,270,311,317,347,358,360,387,388,409,419,422,426,427,450,451,478,479,495,501,504,505,509,524,529],itset:507,ityp:[3,57,102,126,127,178,215,227,310,486],itype1:127,itype2:127,itypen:127,ivector:8,ivori:207,ixcm:317,ixi:[42,317,387],ixx:[42,103,317,387,524],ixy:[103,387,524],ixz:[42,103,317,387,524],iycm:317,iyi:[42,103,317,387,524],iyz:[42,103,317,387,524],izcm:317,izrailev:323,izumi:481,izz:[42,103,317,387,524],j0jt:99,j20:220,j_m:152,jackson:447,jacobi:3,jacobsen:385,jacs:[6,184,509],jagreat:13,jame:[9,18],janssen:298,januari:443,jaramillo:[7,9,13,418],jarzynski:323,jatempl:9,jcc:9,jcp:352,jec:13,jeff:13,jeffer:15,jello:271,jensen:[254,377],jeremi:[9,445],jerom:9,jewett:13,jiang:[255,518],jiao:[9,13],jiht:[7,9],jik:399,jim:7,jku:[7,9],jmake:12,jmm:152,joannopoulo:269,job:[12,62,321,505,516],jochim:[271,272],john:[7,9,13,205],johnson:[9,13],join:[6,74,423,500],joint:[3,302,425],jon:[9,74],jonathan:9,jone:[1,3,6,7,9,10,12,13,45,46,66,95,118,121,184,210,216,238,304,335,352,356,378,380,386,395,398,402,403,404,405,407,412,422,424,425,426,429,430,431,432,433,435,436,438,439,442,447,448,456,460,461,471,476,484,509,518],jonsson:[77,270,385,388,466],jorgensen:[6,195,409,431,435],joul:523,journal:[172,190,216,310,378,416,446,458,459,470,471,473],jparam:[3,227],jpeg:[3,12,206],jpeglib:12,jpg:[4,8,12,203,206,207,528],jpg_inc:12,jpg_lib:12,jpg_path:12,jpl:[7,9],jth:524,jtype1:127,jtype2:127,jtype:[3,57,127,227,486],jtypen:127,judg:511,judici:6,julien:9,jump:[2,6,35,276,360,374],jun:15,june:208,just:[3,6,8,11,12,13,16,18,21,28,42,44,61,63,99,118,121,127,153,156,157,171,182,186,203,206,219,231,235,243,260,268,304,306,317,342,347,358,360,362,387,388,393,395,398,406,426,456,484,495,499,501,502,504,505,516,518,519,524,528,529],justo:417,jusufi:[410,421],jut:356,jzimmer:9,k11:99,k22:99,k33:99,k_2:365,k_4:365,k_d:518,k_sigma:399,k_ub:19,kadiri:70,kalia:485,kamberaj:317,kapfer:117,kappa:[4,6,99,322,343,409,414,431,487,488],kappa_:347,karplu:95,karttunen:257,kate:0,kaufmann:15,kayser:410,kbit:207,kboltz:335,kbp:207,kbt:312,kcal2j:99,kcal:[251,506,518,523],kde:13,ke_eta_dot:271,ke_etap_dot:271,ke_omega_dot:271,keblinski:[409,466],kecom:158,keef:130,keep:[3,7,12,61,75,196,227,231,252,263,299,315,318,345,350,377,386,409,439,467,492,497,503,505,511,515,519,524],keflag:3,kei:[6,16,61,335,485,511,516],keir:13,kelchner:74,kelkar:350,kelvin:523,kemper:[309,408],kepler30:16,kepler32:16,kepler35:16,kepler37:16,kepler:[1,9,10,12,14,16,393],kept:[6,210,276,344,345,518],kernel:[7,13,15,16,40,110,141,147,216,247,248,326,446,469,470,471,472,473,474,497,507],keword:206,keyboard:12,keyword:[3,6,8,12,15,16,37,39,41,42,56,57,60,61,63,68,71,73,74,75,81,84,95,96,98,100,102,104,106,107,112,113,115,117,118,119,120,121,123,125,126,128,129,130,131,152,153,156,157,158,166,167,171,172,176,177,178,180,181,182,199,202,203,204,205,206,207,208,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,235,236,237,238,239,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,323,325,326,327,328,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,360,375,377,378,380,381,383,384,386,387,389,393,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,440,441,442,443,444,445,446,447],keywrod:418,kforc:518,khaki:207,khersonskii:152,khvostov:15,kick:[213,214,215,237,354],kilogram:523,kim:[2,3,4,7],kimvirial:[3,427],kind:[1,2,3,4,6,7,8,9,10,11,12,16,39,40,41,42,57,63,64,65,77,128,158,203,204,206,210,217,219,220,222,225,228,230,234,246,249,268,317,321,335,342,357,388,390,392,399,418,458,459,486,492,496,497,502,503,510,511,518,524],kinemat:[9,440,441],kinet:[3,6,8,65,90,91,92,93,95,99,104,105,106,107,108,123,153,155,156,157,158,159,160,161,163,164,165,166,167,168,170,171,210,217,219,229,235,238,246,250,254,267,269,271,272,273,274,275,276,277,278,279,304,307,318,335,343,350,351,386,418,420,451,479,492,507,511,515,518],kio:2,kiss:[9,12],kjl:370,klahn:346,klapp:377,klein:[6,9,216,230,271,272,295,317,431,461],kloss:7,kmax:[3,130,319,377],kmp_affinity:15,knc:16,knight:15,knl:15,knock:347,know:[3,9,11,12,41,65,67,72,83,101,118,127,210,235,253,255,285,335,386,417,427,483,495,498,501,506,518,519],knowledg:[4,8,9,206,427],known:[3,12,152,206,238,250,299,308,317,344,494,511,525],kohlmey:[7,9,13,17,377,378],kokko:[1,3,9,12,16,320,393,459,500,510,524],kokkos:[1,2,3],kokkos_arch:[9,16],kokkos_cuda:[9,12,16],kokkos_cuda_options:16,kokkos_debug:16,kokkos_device:16,kokkos_devices:16,kokkos_omp:[9,12,16],kokkos_pg:16,kokkos_phi:[9,12,16],kokkos_use_tpls:16,kolafa:378,kollman:[6,184,509],kondor:457,kone:[344,345],kong2011:299,kong:[9,13,299],konglt:9,koning00a:344,koning00b:344,koning96:[344,345],koning97:345,koning99:344,kooser:13,koskinen:385,kosztin:323,kraker:15,krau:13,kremer:[45,46,509],kress:[444,445],kspace:[0,1],kspace_modifi:[2,3,6,15,348],kspace_styl:[0,2,3],kspce:12,kspring:270,kstart:316,kstop:316,kth:[247,300],kub:19,kubo:[6,99,343],kumagai:481,kumar:[9,440,441],kuronen:456,kurt:302,kuster:[287,293,382],kutta:318,l12:443,l_box:418,l_skin:347,la3:177,laa:9,laas:9,lab:[5,7,9,12,122,455],label:[2,3,12,76,203,207,211,212,226,227,230,238,299,300,314,360,376],laboratori:[0,88,89,240,269,307,322],lack:[3,15,269,418],lackmann:399,ladd:[294,345],lafitt:447,lag:347,lagrang:[142,143],lagrangian:[6,134,135,136,137,139,140,141,142,143,144,145,147,148,149,150,216,269,307,308,325,326,463,465,518],lagrangian_posit:[269,307],lagrangian_spe:[269,307],lai:491,lambda1:[480,481,482,485],lambda2:[480,481,482],lambda3:[480,482],lambda4:485,lambda:[95,122,130,172,177,257,319,344,345,347,394,417,439,449,477],lambda_fin:344,lambda_initi:344,lamda:[3,53,335,449],laminar:474,lammp:[0,3,4,7,8,9,11,12,13,14,16,204,299,381,388,392,406,443,446,492,495,506,508,511,512,519,524],lammps2pdb:[6,13],lammps_clos:6,lammps_command:6,lammps_extract_atom:6,lammps_extract_comput:6,lammps_extract_fix:6,lammps_extract_glob:6,lammps_extract_vari:6,lammps_fil:6,lammps_gather_atom:3,lammps_get_coord:6,lammps_get_natom:6,lammps_ns:[6,12],lammps_open:6,lammps_potentials:[406,408,508],lammps_put_coord:6,lammps_quest:[6,244],lammps_rk4:318,lammps_scatter_atom:3,lammps_set_vari:6,lammps_sppark:6,lammps_vers:6,lammpsplot:13,lammpstrj:[498,502,518],lammpsvirial:[3,427],lamms:6,lamoureux:[6,235,483,518],land:15,landron:466,lane:1,lang:518,langevin:[2,3,6,39,159,160,161,163,165,166,167,168,170,210,215,217,234,235,246,247,248,250],langston:42,languag:[6,11,12,16,495,524],lanl:9,lapack:12,laps:348,laptop:7,larentzo:[9,88,89,240,322],larg:[0,1,3,4,5,6,7,8,9,10,12,13,15,16,17,39,40,41,60,61,74,75,120,127,129,153,158,161,166,178,179,180,190,199,202,203,204,206,207,219,225,228,229,231,232,236,238,246,257,271,285,294,299,302,303,304,306,307,312,314,315,316,317,321,331,335,343,347,348,350,352,356,370,377,378,382,384,386,389,393,407,413,418,422,423,430,446,448,450,451,454,460,478,479,492,495,497,499,500,504,506,511,514,516,518,525,529],larger:[1,2,3,6,11,12,13,39,41,56,61,74,75,127,178,180,206,220,222,223,232,238,250,257,266,271,294,295,303,308,312,316,317,319,322,330,335,342,347,351,352,353,356,377,378,384,385,386,388,389,390,393,399,407,409,410,418,423,431,435,441,448,454,475,476,484,497,501,502,505,506,511,524],largest:[3,6,12,39,75,176,178,236,377,386,390,450,451,475,478,479,497,499,505,506,517,524],laroch:312,laser:347,last:[1,2,3,5,6,11,12,14,37,42,56,61,63,75,121,128,153,176,197,199,203,204,206,207,208,209,219,220,222,223,225,236,270,315,318,319,331,335,360,375,386,387,388,389,393,397,398,399,400,407,408,413,414,416,421,422,423,424,425,429,432,434,436,437,438,441,447,449,460,466,468,475,478,479,483,484,487,488,492,493,495,498,502,504,505,509,511,512,515,516,524],lat:443,late:5,latenc:[10,251],later:[6,9,11,12,16,40,61,75,114,180,182,220,232,276,294,302,323,342,358,360,377,386,387,392,393,395,399,495,497,499,501,511,514,516,519,524,527],latest:[7,219,220,221,222,223,319,499],latex:8,latgen:299,latitud:152,lattc:443,latter:[2,6,9,11,14,15,16,41,42,95,156,207,211,212,218,219,220,225,229,252,261,271,273,274,275,277,278,279,302,304,306,310,317,318,335,349,351,356,376,387,399,401,402,403,404,405,412,429,431,435,439,446,453,461,466,483,492,494,495,500,503,514,515,524,528],lattic:[2,3,5,6,7,9,41,61,66,70,74,75,77,99,100,125,130,167,176,177,178,179,202,215,219,225,231,232,236,252,257,258,259,260,261,268,298,299,315,352,354,355,356,357],launch:[1,3,6,11,12,15,16,17,393,494,495,516],laupretr:370,lavend:207,lavenderblush:207,lavgevin:231,law:[6,269,391,463,465],lawngreen:207,lawrenc:9,layer:[6,75,343,347,350],layout:[1,3,16,180,375,494,497,506],lb_fluid:257,lbl:[7,9,176],lbnl:9,lbtype:257,lcbop:[2,3],ld_library_path:[11,12],ldfftw:12,ldrd:7,lead:[2,3,6,12,21,24,39,41,44,61,63,81,95,127,172,176,182,186,207,211,212,222,225,232,248,257,276,307,317,318,321,335,342,343,350,362,370,377,383,388,393,406,409,431,435,437,446,465,491,497,507,518,519,524,525],least:[3,6,12,17,75,130,177,205,217,238,248,302,351,389,393,426,478,479,484,495,524],leav:[3,7,11,12,16,20,41,59,153,168,185,225,229,232,271,273,274,275,277,278,279,303,304,317,321,361,448,497,501,509],lechman:335,lectur:323,led:[3,5],lee2:443,lee:[216,443],left:[6,11,12,41,118,154,198,206,207,228,252,297,298,318,335,358,360,380,497,499,504,519,524,529],leftmost:[41,225],legaci:[12,15,204],legal:7,lehoucq:455,leimkuhl:[271,289,355],leiu:413,lemonchiffon:207,len:507,lenart:[410,421],length:[3,6,8,11,12,15,17,20,37,39,40,41,42,44,53,54,55,56,57,60,61,63,67,68,71,72,73,74,75,78,83,84,85,88,90,95,96,97,98,99,101,102,113,115,118,119,123,125,126,128,129,130,131,140,142,155,156,157,158,159,160,161,162,163,165,166,167,168,169,170,171,174,176,177,180,185,199,203,204,206,207,210,217,221,222,223,225,226,227,228,229,231,241,242,246,249,257,269,270,271,272,276,285,293,298,304,314,317,319,321,322,331,335,342,346,347,349,352,356,378,380,382,384,386,388,389,391,395,396,399,400,402,409,410,415,418,421,425,429,431,443,448,450,451,458,459,469,478,479,480,483,487,488,490,497,500,505,507,514,515,518,524],lengthi:246,lennard:[1,2,3,6,7,9,10,12,45,46,95,118,121,184,210,238,304,335,352,356,378,380,386,395,398,402,403,404,405,407,412,422,424,425,426,429,430,431,432,433,435,436,438,439],lennardjones612_universal__mo_826355984548_001:211,lenoski:[444,445],less:[1,3,6,13,14,15,16,17,37,41,56,59,60,61,75,80,100,117,119,126,127,129,156,157,171,199,207,219,222,223,225,227,228,229,231,232,238,243,252,269,271,298,310,312,319,335,354,355,357,378,380,386,390,393,399,404,422,423,429,440,441,448,460,477,478,479,482,488,497,516,524,525],let:[1,12,37,56,161,189,199,220,241,242,321,335,353,393,407,450,451,478,479,506,510,518,527],lett:[152,166,248,255,257,269,312,323,344,345,385,399,416,418,422,439,450,451,467,518],letter:[2,12,41,59,61,207,225,234,235,255,300,360,392,457],leuven:9,level:[2,3,8,11,12,16,203,206,211,212,213,214,221,224,233,237,249,251,252,266,268,270,271,298,309,316,320,323,331,332,333,334,351,352,356,360,375,378,392,399,403,404,431,432,435,442,446,447,458,459,494,506,511,516,524],lever:475,levin:423,lewi:324,lexicon:7,lgr_po:[269,307],lgr_vel:[269,307],lgvdw:459,li1:177,liang:408,lib:[1,3,9,11,12,14,15,16,204,311,393,408,427,495,498],libatom:[9,457],libcolvar:12,libdir:11,libfftw3:12,libgpu:[9,14],libjpeg:12,liblammp:[11,12],liblammps_foo:[11,12],liblammps_g:[11,12],liblink:9,libmeam:9,libmpi:11,libmpi_stub:12,libmpich:12,libpackag:12,libpng:12,libpoem:9,librar:9,librari:[0,1,3,4],libreax:9,librt:16,licens:[0,7,8,12,206],license:[7,12],lie:[6,74,319],lieu:377,life:7,lifo:8,ligand:331,liggghts:7,light:306,lightblu:207,lightcor:207,lightcyan:207,lightest:342,lightgoldenrodyellow:207,lightgreen:207,lightgrei:207,lightli:331,lightpink:207,lightsalmon:207,lightseagreen:207,lightskyblu:207,lightslategrai:207,lightsteelblu:207,lightweight:335,lightyellow:207,like:[3,4,6,7,8,9,11,12,15,16,17,39,42,54,61,162,169,206,208,213,229,230,232,235,237,251,254,255,256,269,271,272,277,278,279,284,285,287,291,292,294,295,296,298,304,306,307,308,312,317,318,319,322,335,337,338,339,340,341,342,343,350,351,352,355,356,357,360,377,380,382,385,388,393,399,407,412,413,414,418,419,423,425,426,436,437,443,467,478,479,482,483,487,488,494,495,497,498,499,500,502,507,512,515,516,518,519,524,525],likelihood:[130,177,228],likewis:[1,6,12,14,17,39,41,75,96,126,216,225,226,227,246,254,255,271,272,276,295,312,335,338,339,340,378,388,394,398,399,409,416,419,446,476,495,497,499,509,524],likhtman:221,lime:207,limegreen:207,limit:[2,3,6,7,9,12,15,16,17,26,39,60,61,63,75,130,152,154,177,178,179,180,187,205,206,210,227,229,230,231,238,247,254,271],limit_eradiu:418,limit_veloc:[325,326],lindahl:377,line:[0,1,2,3,4,6,7,8,9,10,11],linear:[2,3,6,24,26,37,44,55,56,112,152,187,199,210,211,212,216,228,229,235,241,242,258,262,267,268,271,302,315,316,321,324,327,339,343,347,350,352,354,355,357,363,364,365,367,380,388,423,437],linearli:[6,10,128,207,231,299,352,354,355,357,387,388,390,497,524],lineflag:[6,497],lineforc:[2,210],linen:207,linesearch:[8,12,384],ling:[9,13],lingo:[11,427],link:[5,6,7,8,9,11,12,13,14,16,21,36,44,55,65,186,198,204,206,210,227,251,255,302,311,313,323,331,362,371,396,406,443,457,458,459,476,483,495],linker:12,linkflags:[9,15,17],linux:[9,10,11,12,14,15,206,208,251],linuxamd64:498,liouvil:271,lip:13,lipid:[4,9,10,13,28,317],lipton:302,liquid:[6,7,9,15,28,39,40,41,61,95,100,153,164,176,225,229,231,246,271,304,307,312,342,412,446,448,453,481,506],lisal:[322,414,475],lism:9,list:[0,1],listen:[251,253],listfil:430,liter:[497,508],literatur:[6,8,443,466,477],lithium:418,littl:[1,3,12,15,66,238,271,389,492,500],littmark:[443,476,482,489],liu:[425,459],livermor:9,lj1043:[2,210],lj126:[2,6,210],lj12_4:461,lj12_6:461,lj1d:299,lj6:3,lj93:[2,6,210],lj96:[2,3],lj9_6:461,lj_flag:395,llnl:[5,7,9],lmp1:11,lmp2:11,lmp2arc:[0,6],lmp2cfg:[0,6],lmp2vmd:0,lmp:[11,495,518],lmp_auto:12,lmp_cuda:16,lmp_foo:12,lmp_g:[6,11,12,13,16,376],lmp_gpu:14,lmp_ibm:[12,376],lmp_inc:12,lmp_kokkos_cuda:16,lmp_kokkos_omp:16,lmp_kokkos_phi:16,lmp_linux:[4,6,12],lmp_mac:12,lmp_machin:[1,12,14,15,393],lmp_mpi:[12,16,17,18,300],lmp_mvapich:16,lmp_openmpi:16,lmp_win_mpi:12,lmp_win_no:12,lmpptr:[11,495],lmpqst:244,lmpsdata:13,lmptype:[3,12,244],load:[1,3,4,6,7,9,11,12,15,16,17,41,206,208,210,225,251,307,318,393,408,494,495,516],loadabl:11,loca:207,local:[2,3],localhost:251,localized_lambda:216,localonli:12,localtemp:318,localvector:65,locat:[3,6,8,11,12,26,63,127,130,176,177,187,197,199,203,232,233,238,257,334,345,356,384,406,409,419,420,421,431,433,435,483,494,497,498,500,507,509],lock:[3,392,524],lockstep:[229,271,304,317],log:[1,2,3,4,6,7,8,10,12,13,14,15,62,209,269,299,307,321,335,375,377],logarithm:[148,149,524],logfil:[0,3,6,12,305,381,493],logfreq2:524,logfreq:[207,504,513,524],logic:[7,10,11,12,15,16,41,178,225,358,360,492,494,495,498,506,511,524],lomdahl:[276,433],london:[13,246,459],lone:[458,459],longer:[1,3,4,6,8,12,13,54,127,203,207,218,219,220,221,222,223,226,246,254,271,289,298,302,307,317,318,321,342,352,356,358,384,393,395,423,466,494,502,506,511,521],longest:[41,225,226,389,484],longitudin:331,look:[1,3,6,8,11,12,17,54,63,203,206,209,406,467,478,479,518,519,524],lookup:[3,39,199,448,450,451,478,479],lookup_table:319,loop:[3,4,6,7,11,12,17,39,42,68,71,73,84,96,102,119,126,127,129,153,206,219,226,227,236,342,358,360,376,379,386,388,389,391,392,415,446,466,492,493,495,501,502,505,506,511,515,516,517,524,525],loopa:[360,376,392],loopb:[360,376,392],loopmax:466,loopvar:524,lopez:[271,272],lorant:308,lorentz:177,lose:[6,60,61,180,229,231,255,271,423,497],loss:[6,523],lossi:206,lossless:206,lost:[3,12,13,59,112,232,315,324,335,448,497,498,499,506,514],lot:[17,323,377],low:[1,3,6,7,12,41,161,176,203,206,225,235,255,294,312,317,343,350,378,446,450,451,459,478,479,488,511,518],lower:[2,3,6,9,11,12,15,41,59,61,75,96,154,167,202,206,207,220,221,222,225,229,235,251,254,255,257,271,307,312,343,350,352,353,358,359,377,380,392,410,443,511,520,522,525],lowercas:0,lowest:[56,152,360,387,507,511,512,524],lps:[455,476],lrt:[15,393],ls_:146,lsfftw:12,lsurfac:347,ltbbmalloc:15,lu3:177,lubric:[2,3,6,7,9,211,212,282,401],lubricateu:[2,3,9,352,401,440],lubricuteu:282,luci:[2,318],lucki:12,luigi:13,lumped_lambda_solv:216,lussetti:343,lustig:[7,13],lybrand:378,lyulin:370,m4v:206,m_d:518,m_eff:[353,423],m_fill:3,m_i:333,m_lambdai:455,m_taubi:455,m_u:257,m_v:257,m_yield_stress:455,mac:12,mac_mpi:12,mach:[9,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,324,325,326,327,330,507],machin:[1,3,4,6,7,9,10,11,12,14,15,16,17,18,203,204,206,251,271,348,377,384,386,391,446,494,499,504,505,506,519,525,529],machines:12,mackai:[9,257,259,260,261],mackerel:[6,19,184,255,404,509,518],macos:206,macro:16,macroparticl:415,macroscop:[7,249,269,455],made:[3,6,9,11,12,14,32,41,42,50,66,67,72,83,86,101,179,191,203,206,208,210,211,212,217,225,232,236,251,260,303,311,315,317,345,358,368,389,393,422,423,426,458,460,468,494,501,507,510,519,520,522,525,527],madura:[6,431],magazin:416,magda:352,magenta:207,magic:[3,11],maginn:[172,350],magnitu:337,magnitud:[6,74,115,119,124,154,178,202,203,204,207,232,233,249,250,252,254,323,331,332,334,335,342,353,378,386,412,423,507],mai:[0,1,2,3,6,7,8,11,12,13,14,15,16,17,28,37,39,40,41,56,60,61,63,65,68,71,73,74,75,84,94,95,96,97,98,100,102,112,113,115,117,118,119,120,121,123,124,125,126,128,129,130,152,153,156,157,158,166,167,171,172,176,177,178,179,180,181,182,198,199,202,203,204,205,206,207,208,210,211,212,213,215,217,219,220,221,222,223,224,225,226,227,229,231,232,235,236,237,238,241,243,246,247,248,250,251,252,254,255,256,257,258,260,266,267,268,269,271,272,276,285,287,289,293,299,300,303,304,305,306,307,308,309,312,314,315,316,317,318,319,320,321,323,325,326,328,335,337,338,339,342,343,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,375,376,377,378,380,384,385,386,387,388,389,390,391,393,395,396,398,399,407,413,418,423,426,427,429,437,439,441,443,444,445,446,448,450,451,458,459,461,467,475,478,479,485,489,492,493,494,495,497,498,499,500,501,502,503,504,505,506,507,509,511,512,514,515,516,518,519,524,525,527,529],mail:[3,7,9,12,358,519],main:[3,6,8,11,12,204,251,257,317,344,345,416,466,483,495,512],mainboard:1,mainli:453,maintain:[8,9,13,15,39,163,227,231,294,335,348,385,394,416,506,509,519],major:12,make:[0,1,2,3,6,7,8,9,11],makefil:[3,7,9,11,12,13,14,15,16,17,18,203,204,378,393,446,495],makelist:12,maks:423,malloc:[3,12],manag:[5,8,12,203,251,300,337,506],manbi:467,mandadapu:216,mandatori:[8,203,230],manh:399,mani:[1,2,3,4,5,6,7,8,9,10,12,13,14,15,16,17,37,39,40,41,42,56,63,65,71,75,96,99,112,113,127,154,158,178,179,199,202,203,204,205,206,207,208,210,211,212,213,217,218,219,220,221,222,223,225,226,227,228,229,231,232,238,241,242,243,246,247,250,251,257,258,267,269,271,272,276,285,297,298,299,303,304,306,308,309,310,312,314,317,318,319,321,335,346,347,349,358,360,377,386,388,389,391,393,406,408,415,418,421,425,426,450,451,466,467,476,478,479,480,482,495,497,499,501,502,504,505,506,507,509,510,511,512,516,524,525,529],manifold:2,manifoldforc:[2,9],manipul:[12,41,225,251,409,456,508],manner:[2,3,6,9,11,12,16,41,153,174,206,211,212,213,214,222,225,231,236,237,244,250,254,255,271,277,278,279,291,292,294,296,311,338,339,340,343,344,345,350,352,356,360,378,387,388,392,393,416,418,426,429,440,484,492,494,497,498,499,500,502,506,511,512],manolopoulo:253,mantissa:3,manual:[0,1,3,6,7,8,9,11,12,13,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,43,45,46,47,48,49,51,53,54,56,60,65,71,75,123,130,155,156,157,159,160,161,164,165,166,167,168,170,171,177,184,185,187,188,189,190,192,193,195,196,199,203,204,206,208,213,224,231,239,245,249,253,254,255,270,271,273,274,275,276,277,278,279,280,281,283,286,289,290,291,292,294,296,304,306,309,310,317,319,320,321,338,339,340,350,355,360,361,363,364,366,367,370,372,378,388,392,393,394,395,397,398,400,401,402,403,404,405,407,408,409,411,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,449,452,453,455,459,460,461,468,477,478,480,481,482,483,485,487,488,489,492,500,506,510,511,512,515,524],manybodi:[3,7,8,9,12,153,154,386,426,509,524],map:[2,3,11,12,16,17,39,61,66,75,130,134,152,166,177,178,202,206,207,216,238,299,316,377,378,380,388,394,395,399,408,416,417,419,426,427,428,443,444,445,448,452,456,457,458,459,466,467,475,477,478,479,480,481,482,485,494,497,499,511,524],map_fil:299,mapflag:12,mara:[9,466],march:[9,443],margin:511,mari:13,mark:[424,439,463,465,466],marker:305,maroon:207,maroonmpi:11,marrink:424,marsaglia:[3,247,248,254,255,312],marseil:9,martin:[299,443],martinez:217,martyna:[271,272,317,506],mashayak:16,mask:[3,298,524],mask_direct:216,mass:[2,3,6,8,13,40,42,65,69,78,79,86,94,95,97,98,99,103,104,105,106,107,108,110,113,114,115,124,129,138,158,159,160,163,166,170,173,175,178,181,182,203,204,208,210,211,212,214,216,217,219,231,235,238,245,246,247,249,254,255,257,260,267,269,271,277,278,279,291,292,294,296,299,300,303,306,307,312,314,315,317,321,323,331,332,333,335,337,338,339,340,342,343,345,347,350,351,353,354],mass_matrix:216,massdelta:321,massiv:[0,206,257,300,343,350],massless:[6,255,378,409,431,435,439,518],masstot:317,master:[3,388,492,511],mat:[70,216,408,481],match:[3,6,9,11,12,16,37,41,56,61,75,127,161,199,207,208,225,228,231,241,242,251,271,272,294,314,319,335,342,377,378,399,425,437,443,450,451,457,458,459,478,479,491,495,497,498,499,502,506,511,518,524],matchett:42,mater:[77,394,445,456,466],materi:[6,7,9,61,74,136,137,181,215,216,231,246,252,269,298,304,312,343,347,353,409,416,417,418,423,427,443,444,446,455,458,459,462,463,464,465,492,497,511,518,523],material_fil:216,math:[3,8,15,207,255,271,272,504,513],mathemat:[130,152,177,178,202,211,212,213,214,224,229,237,247,249,250,252,254,255,305,320,328,338,339,340,352,355,357,467,493,500,507,525],mathrm:519,matlab:0,matric:[9,152,248,299,422],matrix:[3,6,9,99,176,220,229,248,299,308,318,377,380,446],matter:[6,12,39,59,61,75,160,347,389,395,411,416,418,443,461,466,480,482,485,489],mattox:9,mattson:[88,89,123,153,240,322],max2theta:177,max:[3,6,8,12,14,17,75,128,207,222,225,227,229,232,266,303,318,321,335,360,380,384,386,388,389,393,466,492,497,511,515,524],max_alpha:8,max_cell_s:415,max_group:3,max_nn:326,max_step:318,max_travel:327,max_vel:[325,326],max_veloc:326,maxangl:246,maxbody:3,maxbond:[3,227],maxedg:176,maxev:[386,492,511],maxfoo:8,maxim:[342,388,516],maximum:[3,6,8,12,14,16,24,41,42,45,53,54,59,61,63,100,117,127,128,130,133,176,177,179,180,202,203,215,220,221,222,225,227,231,232,236,238,246,266,285,287,293,298,303,308,318,321,324,325,326,335,348,377,378,384,388,389,393,396,399,415,421,440,441,466,497,500,505,515,524,525],maxit:[287,293,308,386,492,511,515],maxsize_restart:8,maxspeci:3,maxstep:318,maxwel:[16,297],maxwell50:16,maxwell52:16,maxwell53:16,maxx:456,mayb:13,mayer:[7,400,402,466,476],mayo:[6,7,13,24,372,425,509],mbt:185,mbyte:[12,312],mcc:[458,459],mcdlt:[168,250],mcdram:15,mcgraw:300,mclachlan:[271,289],mdatom:246,mdf:2,mdnvt:246,mdregion:216,mdtemp:246,mdump:[41,225],meam:[2,3,4,7],meam_sw_splin:445,meamf:443,mean:[2,3,4,6,7,8,11,12,15,16,21,33,36,37,38,39,41,42,44,52,54,55,56,58,59,61,63,65,71,75,76,80,81,90,92,93,95,99,100,113,114,115,117,123,124,125,126,127,128,129,131,152,153,155,156,157,159,160,161,164,165,166,167,168,170,171,172,178,179,181,182,184,186,194,198,199,200,201,202,203,204,206,207,208,210,211,212,215,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,237,238,241,244,246,247,248,249,250,252,254,255,256,260,268,271,273,274,275,276,277,278,279,285,287,291,292,293,294,296,298,300,302,303,304,306,312,314,315,317,318,320,321,323,328,331,335,337,338,339,340,342,343,346,347,349,350,351,352,353,354,355,356,357,358,362,363,364,365,367,369,371,373,377,378,380,383,384,386,387,388,389,391,393,396,400,402,403,404,406,409,413,415,416,418,422,423,425,426,429,431,432,435,442,443,447,448,450,451,453,454,456,458,459,460,461,475,477,478,479,480,481,482,484,488,491,492,494,495,497,498,499,500,501,502,503,504,505,506,507,508,509,511,512,514,515,518,523,524,525,526,527,529],meaning:[127,136,137,139,142,146,426],meaningless:[70,342],meant:[6,317,483,501],measur:0,meaur:516,mech:455,mechan:[6,8,9,11,12,16,40,88,89,138,154,216,238,240,250,300,311,318,399,418,427,433,446,463,465,491,495,497],mechanic:311,mechanim:134,meck:117,media:206,medium:488,mediumaquamarin:207,mediumblu:207,mediumorchid:207,mediumpurpl:207,mediumseagreen:207,mediumslateblu:207,mediumspringgreen:207,mediumturquois:207,mediumvioletr:207,mee:342,meet:[3,12,179,206,207,227,228,348,502],mehl:394,mei:442,meloni:39,melros:[440,441],melt1:208,melt2:208,melt3:208,melt:[4,10,228,299,399,446,481],mem:14,member:[181,184,302,399],membran:[28,297,488],memori:[3,5,6,7,8,9,12,14,15,16,17,39,40,62,75,207,219,221,247,248,312,347,375,389,393,399,448,454,459,494,497],memory_usag:8,mendelev:416,mention:[1,6,7,11,40,42,231,250,257,276,352,380,388,395,458,459,499,524],menu:[206,251],mep:[270,388],mer:[4,10,228],mercuri:519,meremianin:152,merg:[5,497],merz:[6,184,509],mescscop:455,mesh:[1,2,3,6,7,8,9,10,12,40,41,42,130],meshless:9,meso:[2,3,40],mesocop:40,mesoparticl:[240,241,242,414],mesoscal:7,mesoscop:[7,109,110,111,264],mess:[3,507],messag:[0,2],met:[8,41,127,225,360,376,378,386,388,392,484,505],metadynam:[9,13,230],metal:[3,5,7,9,10,40,61,75,167,178,215,216,231,232,250,252,307,308,312,351,352,354,355,357,378,380,390,394,395,399,408,416,417,418,419,426,428,443,444,445,446,456,457,466,477,480,481,482,485,500,514,515,517,523],meter:[390,523],methan:[307,312],methanol:4,methin:370,method:[1,3,4,5,6,7,8,9,11,12,13,15,16,18,37,39,40,41,56,66,95,99,121,153,199,210,211,212,216,220,221,225,230,241,242,244,254,257,261,266,269,271,299,300,307,308,309,310,312,317,318,321,322,323,342,343,344,345,350,377,378,384,385,386,388,393,394,396,399,408,409,416,418,419,443,444,445,448,450,451,456,466,476,478,479,485,492,494,495,497,498,500,511,518],methodolog:[6,77,153,300,377],metin:[7,9],metric:[3,10,66,500,515],metropoli:[217,246,512],mezei:95,mf1:208,mf2:208,mf3:208,mg2:177,mglob_default_function_attr:9,mgoh:452,mgpt:2,mgptfast:446,miai:312,mic:[9,16],micel:[4,9,13,333],micelle2d:0,michael:[9,13,445],michel:13,mickel:117,micro:[3,517,523],microcanon:[280,281,283,284,286,289,290],microelast:455,micromet:523,micropor:246,microscal:440,microsec:523,microsecond:523,mid:[5,9,61,231,446,475],middl:[3,6,8,15,21,41,44,81,95,127,167,172,182,185,186,207,211,212,218,225,303,315,316,317,343,350,361,362,383,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,440,441,442,443,444,445,446,447,449,450,451,453,455,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,487,488,489,490,491,495,505,506,507,524],middlebondtors:[3,185,497],midnightblu:207,midpoint:475,mie:[2,3,9],might:[3,6,7,8,12,15,24,75,160,244,246,248,250,287,317,466,495,505,519,524],migrat:[3,8,16,41,42,61,63,68,73,84,102,119,126,129,203,210,225,298,306,312,335,377,390,393,505,527,529],mikami:[6,271,272],mike:[7,9,13,14,15],mil:[9,416],militz:298,mill:385,miller:317,million:[3,7,39,41,75,225],mimic:[6,42,54,255,269,303,409,421,431],mimim:[229,388],min2theta:177,min:[3,4,6,8,12,128,152,207,222,318,377,380,466,475,492,511,524],min_cap:3,min_cg:8,min_clearstor:8,min_dof:8,min_modifi:[2,229],min_nn:326,min_popstor:8,min_post_forc:8,min_pre_forc:8,min_pushstor:8,min_setup:8,min_setup_pre_forc:8,min_step:[8,318],min_stor:8,min_styl:[2,3,261,263,287,293,351,384],minarea:176,mincap:459,mind:[7,247,299],mine:[12,96,168,169,210,358,521],minim:[0,2,3,4,5,6,7],minima:[190,197,372],minimi:[388,484],minimizaiton:388,minimizi:312,minimum:[3,12,24,25,26,42,45,59,61,75,94,115,128,176,177,179,181,187,202,203,206,215,222,229,230,236,253,270,314,316,318,319,324,326,330,335,352,356,360,372,377,380,384,385,386,388,389,404,418,420,422,424,425,431,433,435,440,441,459,461,475,492,505,511,524,525],minlength:176,minmiz:[8,229],minn:9,minord:[3,377],minstep:318,mintcream:207,mintmir:[4,7,308,409,476],minu:[12,61,158,231,360,388,524],minut:[4,8,516],mirror:[63,354],misc:[6,8],miscellan:[2,216],mise:[145,150],mishin:[394,476],mishra:15,mismatch:3,miss:[3,5,12,181,222,246,285,312,335,430,448,514,515],mistak:[3,524],mistakenli:3,mistyp:3,mistyros:207,mitchel:[6,122,160,377,378,411,455],mitchell2011:455,mitchell2011a:455,mitig:271,mivi2:312,mix:[1,3,6,9,14,15,75,126,160,222,348,377,378,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,415,416,417,418,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,490,495,497,510,518,527],mixtur:[6,40,271,306,317,335,357,407,420,443,451,479,497],mixture_ref_t:443,mjpeg:206,mkdir:508,mkl:12,mkv:206,mldivide3:3,mlpark:7,mlutipl:223,mn2:177,mn3:177,mn4:177,mo3:177,mo5:[177,446],mo6:177,mobil:[6,115,153,155,156,157,159,164,171,206,317,358,359],moccasin:207,mod:2,mode:[1,3,4,6,9,10,11,12,13,14,15,16,17,63,69,79,86,96,98,103,114,116,125,127,128,154,158,173,175,176,177,203,204,206,207,222,223,230,231,244,248,271,300,312,323,335,375,377,390,393,409,418,446,466,494,499,504,506,515,523,524,529],model:[0,1,3,4],model_ar_p_mors:427,modern:[12,15,254,256],modest:[1,391],modif:[6,13,15,95,443,446,460,482,518,519],modifi:[0,1,2,3,6,7],modify_param:8,modin:216,modul:[3,9,11,12,13,230,312,382,495],modular:8,modulo:[3,524],modulu:[304,423,443,455,462,464],moementum:268,mofil:498,mol1:524,mol:[2,3,9,75,124,129],molchunk:[69,79,86,98,103,114,116,158,173,175,219],mole:[217,416,420,523],moleclu:[226,227,232,243],molecul:[2,3,4,6,7,8,9,12,13,28,40,69,75,79,86,97,98,103,114,116,124,125,129,153,154,158,160,173,175,178,179,180,181,203,204,207,210,217,219,226,227,228,232,233,238,242,243,246,254,255,260,302,303,306,314,315,316,317,318,321,330,331,332,337,343,350,358,378],molecular:[0,2,3,5,6,7,8,9,12,13,15,39,40,53,75,119,124,126,155,156,157,159,161,164,165,166,167,170,171,178,179,180,181,182,190,203,204,205,208,216,227,230,238,246,253,299,300,307,311,312,316,323,346,347,378,387,396,397,399,403,415,418,426,476,497,498,499,501,502,506,507,509,515,517,518,524],molfil:9,molfrac:[232,303],molnar:323,molpe:120,moltempl:0,molybdenum:446,mom:[6,99,316,525],momementum:[156,157,273,274,277,278,281,282,283,291,292],momemtum:69,moment:[3,6,9,40,42,86,90,92,93,116,124,129,156,171,178,201,203,204,254,257,260,271,289,303,317,333,337,387,412,417,466,497,507,518,523],momenta:[238,248,282,350,418],momentum:[2,3,6,28,40,63,65,69,90,94,112,116,124,129,152,156,157,178,203,204,210,216,235,247,250,254,255,257],momon:228,monaghan:[9,470,471,473],monitor:[3,6,9,12,106,107,161,229,231,232,243,251,254,269,271,303,305,307,317,321,335,386,388,412,515],mono:[77,440],monodispers:[3,353,401,423,440,441],monom:[13,54,228],monoton:[3,241,242,323,346,388,511],monoval:378,mont:[4,6,7,9,210,217,228,246,317,342,415,476],montalenti:[492,511],month:0,moor:[9,16,88,89,153,240,322,450,451],more:[0,1,2,3,4,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,35,36,37,39,40,41,42,43,44,45,46,47,48,49,50,51,53,54,55,56,60,61,63,64,65,66,67,68,70,71,72,73,74,75,76,81,82,83,84,85,88,89,91,94,95,96,98,100,101,102,106,107,108,109,110,111,112,113,115,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,160,161,162,164,165,166,167,169,170,171,172,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,195,196,197,198,199,202,203,204,205,206,207,208,210,211,212,213,214,215,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,235,236,237,238,239,240,241,242,243,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,320,321,322,323,324,325,326,327,328,330,335,337,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,370,371,372,375,377,378,380,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,448,449,450,451,452,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,492,493,494,495,497,498,500,501,502,503,504,505,506,507,508,509,510,511,512,514,516,518,519,524,525,527,528,529],morefoo:8,moreov:[226,227,483],morgan:15,moriarti:[9,446],moriarty1:446,moriarty2:[9,446],moriarty3:446,morri:2,morriss:[166,294],mors:[2,3,6,7,9,44],morse_fe:[478,479],mosel:385,mosi2:443,moskalev:152,most:[0,1,2,3,4,5,6,7,8,10,11,12,14,15,16,17,18,36,39,41,55,74,75,113,119,166,198,203,204,206,207,219,222,223,225,226,227,229,250,271,272,300,304,305,306,307,308,317,319,348,350,358,360,371,378,385,389,391,393,395,418,422,443,457,458,459,482,492,493,494,506,511,512,515,516,519,524,527],mostli:[8,9,11,13,75,180,206,389,497,506,509,524,528],motiion:6,motion:[3,6,7,9,42,94,107,113,155,156,157,159,161,163,164,165,166,167,168,170,171,231,235,238,248,257,260,261,268,271,272,276,287,294,298,300,302,312,316,317,322,343,347,353,356,388,412,418,440,441,500,506,518],motiv:298,mous:251,mov:206,move:[1,2,3,6,8,9,11,12,14,59,61,63,75,94,115,146,158,161,176,202,210,211,213,214,217,219,222,223,226,227,229,231,232,236,237,239,244,245,246,250,251,252,253,257,262],movement:[3,6,12,268,342,386,515],movi:[2,3,4,7,9,12],mp2:395,mp4:206,mpeg:206,mpg:206,mpi4pi:11,mpi:[0,1,3,5,6,7,9,10],mpi_allreduc:[317,495],mpi_barrier:1,mpi_cart:494,mpi_cart_creat:494,mpi_cart_get:494,mpi_cart_rank:494,mpi_cart_shift:494,mpi_comm:6,mpi_get_processor_nam:494,mpi_inc:12,mpi_lib:12,mpi_lmp_bigint:3,mpi_lmp_tagint:3,mpi_path:12,mpi_wtime:12,mpicc:11,mpich2:12,mpich:[12,14,15,16,17,393],mpicxx:[12,16],mpiexec:[12,14,16,17,393],mpiio:3,mpirun:[1,6,11,12,14,15,16,17,18,300,376,393],mplayer:206,mri:[458,459],msd:[2,3,6,12,65,75,87],msi2lmp:0,msi:13,msm:[2,3,9,12,76,127,348,377,378],msmse:[130,177,319],msse3:446,msst:[2,3,4,9,210],mtchell2011:455,mtchell2011a:455,mtd:230,mth:[8,131,207,514],mtk:[271,272,276],mtotal:387,mu_j:28,muccioli:422,much:[1,3,6,11,12,39,154,203,204,206,221,229,307,342,389,390,393,395,422,460,492,495,511,516,518,519,524],mui:[124,203,204,237,337,497],mukherje:[7,9,302],mulder:346,muller:[6,99,210,343,350,447],mult:8,multi:[0,1,2,3],multibodi:[3,9,63,302,450,451],multicent:418,multicor:[1,9,494,510],multidimension:13,multielectron:396,multilevel:[9,377,378],multinod:15,multiphys:11,multipl:[0,1,2,3],multipli:[3,95,99,127,186,198,211,212,220,254,257,298,304,380,386,395,497,524],multiscal:11,multisect:[41,225],multistag:95,multithread:[15,393,459],multitud:7,mundi:295,munich:9,murdick:399,murti:481,murtola:377,muser:299,must:[1,2,3,6,7,8,9,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,35,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,53,54,56,57,58,59,61,63,64,75,90,92,94,95,114,118,120,121,123,126,127,128,129,130,131,156,160,167,171,176,177,178,179,180,181,182,184,185,186,187,188,189,190,191,192,193,195,196,197,199,200,201,202,203,204,205,206,207,208,211,212,213,215,216,217,218,219,220,222,223,224,225,226,227,228,229,231,232,235,237,238,241,242,244,246,247,248,250,251,252,253,254,255,257,258,259,260,261,266,267,268,269,270,271,272,273,275,276,277,279,281,282,283,285,287,289,291,293,296,298,302,303,304,305,306,307,308,310,312,314,315,316,317,318,319,320,321,322,328,330,331,332,334,335,338,339,340,342,343,345,346,347,349,350,352,353,354,355,356,357,358,360,361,362,363,364,365,366,367,368,370,372,373,377,378,380,383,386,387,388,389,390,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,463,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,492,493,494,495,497,498,499,500,502,504,505,506,507,508,511,512,514,515,518,523,524,525,527,529],mutli:6,mutlipl:497,mutual:[3,380,516],mutut:506,muvt:246,mux:[124,203,204,206,237,337,497],muz:[124,203,204,237,337,497],mv2_comm_world_local_rank:12,mvapich2:[16,393],mvapich:12,mxn:[12,300],my_ga:246,my_one_wat:246,my_post_process:508,my_qeq:308,my_setup:508,my_swap_region:217,myblock:[232,303],mybox:180,mychunk1:125,mychunk2:125,mychunk:[6,69,79,86,98,103,114,116,158,173,175],mycmap:497,mycom:222,mydump:[203,207],myer:[5,7],myfil:[494,524],myfix:[217,512],myflux:99,myforc:[203,204,528],myhug:276,myke:99,mymol:[40,321,387],mympi:11,mymultipli:[495,524],myn:495,mype:99,mypi:524,mypress:266,myramp:153,myrdf:[127,223],myreg:380,myregion:358,myrigid:[91,108,129,303],mysocket:253,myspher:[207,356],mystr:360,mystress:99,mytemp:[2,112,155,156,157,159,161,162,164,166,171,266,360,376,392,514,525],myvec:524,myz:497,n_dephas:492,n_element:205,n_f:[307,312],n_hbond:425,n_ij:423,n_ion:347,n_k:247,n_particl:88,na1:177,nabla:347,nacl:[4,6,443],nacl_cs_x0:6,nakano:[308,310,388,485],namd:[7,203,251],name1:[172,231],name2:[172,231],name:[0,1,2,3,4,5,6,8,9,11,12,13,15,32,42,50,57,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,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,155,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,172,173,174,175,176,177,178,191,202,203,204,205,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,273,274,275,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,299,300,301,302,303,304,305,306,307,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,348,349,350,351,352,353,354,355,356,357,358,359,360,368,375,376,378,379,381,387,388,392,394,395,399,402,416,417,419,422,423,426,427,428,430,443,444,445,452,456,458,459,466,467,477,480,481,482,483,485,486,490,494,495,497,498,499,500,504,507,510,512,513,515,518,519,524,525,526,527,528,529],namespac:[6,8,12],nan:3,nangl:[3,497],nangletyp:[387,497,507],nano:[317,517,523],nanoindent:74,nanolett:317,nanomet:[203,207,523],nanoparticl:[225,317],nanosec:523,nanosecond:[238,523],nappli:244,narea:3,narrow:[6,199],narulkar:[480,482],nasa:7,nasr:299,natdef:3,nation:[0,7,9,12,122,455],nativ:[1,6,7,9,12,16,203,208,498],natoli:[9,18],natom1:126,natom2:126,natom:[3,6,11,39,387,495,497,514,515,524],nattempt:303,natur:[6,9,152,231,271,298,312,353,416,418,419,443,456,494,524],navajowhit:207,navi:[207,416],navier:257,nb3:177,nb3b:[2,3,4],nb3bharmon:452,nb3d:9,nb5:177,nbin:[127,222,343,350],nbodi:[260,317,446],nbond:[3,124,497],nbondtyp:[207,387,497,507],nbot:399,nbounc:335,nbrhood_cutoff:459,nbtype:126,nbuild:515,ncall:244,ncbin:75,nchar:207,ncheck:516,nchunk:[3,6,69,75,79,86,98,103,114,116,125,158,173,175,219],ncoeff:467,ncorr:221,ncorrel:221,ncount:[219,220,221],nd3:177,ndanger:515,nden:[6,99],ndihedr:[3,497],ndihedraltyp:[387,497],ndirango:317,ndof:[271,276],ndoubl:497,ndp:518,ndx2group:2,ndx:359,neal:317,nearbi:[7,64,179,232,268,309,335,356,389,395,440,441,476,488,518],nearest:[3,74,75,77,100,117,129,176,179,257,270,298,342,356,377,430,443,450,451,466,478,479,524],nearli:[4,6,9,17,54,61,225,254,335,418,446,448,492,495,501,509],neb:[2,3,4,6,9,13,210],neb_combin:388,neb_fin:388,neb_log:511,neb_step:511,neb_styl:511,necessari:[6,11,12,13,14,15,16,32,63,95,186,191,198,208,225,229,230,246,247,311,318,322,335,348,358,377,439,446,448,466,497,498,502,505,506,507,511,518,528],necessarili:[12,238,312,342,363,364,365,367,380,448,525],necessit:306,need:[1,2,3,5,6,7,8,9,10,11,12,13,14,16,17,32,36,37,39,40,41,42,50,54,55,56,60,63,65,66,70,74,76,77,81,90,99,100,112,114,117,120,123,140,152,153,155,156,157,158,159,161,164,165,166,167,168,170,171,178,180,182,184,186,191,197,198,199,202,203,205,206,207,211,212,213,214,216,217,219,220,221,222,223,225,226,227,229,230,231,235,237,241,242,244,245,246,250,251,253,254,255,257,264,265,271,285,299,303,304,306,312,316,317,323,330,335,343,346,347,349,350,351,352,358,368,371,377,378,387,388,389,390,393,394,395,396,397,399,400,401,402,403,404,405,407,408,409,411,412,413,415,416,417,418,419,421,422,423,424,425,426,427,428,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,487,488,490,492,495,497,498,499,500,502,504,505,507,509,510,511,512,518,519,524,526,527,528,529],needless:[6,389],neelov:378,neg:[3,6,12,26,46,68,73,97,112,119,126,152,153,180,182,187,189,199,206,229,231,232,247,276,298,318,323,331,346,350,352,357,377,385,419,434,443,476,497,500,515,516],neglect:[425,441],neglig:[6,11,95,271,477],neigh:[2,3,12,14],neigh_modifi:[2,3,6,12,15,39,63,182,225,246,285,302,317,335,348,386],neighbor:[1,2,3,6,7,8,9,10,12,14,15,16,39,41,42,63,64,65,66,70,74,76,77,80,81,82,85,96,100,117,119,126,127,147,152,153,176,178,179,180,181,182,203,204,205,206,208,217,225,226,227,228,230,232,243,246,251,270,285,298,300,303,306,308,310,317,326,335,342,358,377,387,388,389],neighborhood:[25,74,100,134,467],neighbour:255,neighobr:[6,409,431,435],neither:[2,3,12,41,65,204,216,228,231,232,395,401,418,440,441,502],nelem:467,nelement:[394,416],nelson:[100,117],nemd:[0,4],nest:[2,360,374,392,524],net:[3,6,11,39,86,94,96,159,170,250,298,308,317,441,459],netherland:9,netpbm:206,network:[12,203,226,227,251,494],neumann:377,neutral:[3,96,246,377,409,431,466],never:[7,12,65,75,210,220,229,246,271,298,321,337,348,352,355,357,377,389,416,443,467,485,494,497,511,514,524],neveri:[3,8,75,213,218,219,220,221,222,223,226,227,228,238,257,258,299,308,309,310,313,314,319,343,349,350,388,466,502,511],newatom:232,newer:[12,219,443,524],newfil:[374,376],newli:[232,303,518,525],newlin:207,newn:317,newt:165,newtemp:[65,112],newtion:[399,446,456],newton:[2,3,5,7,14,15,16,28,63,124,287,293,294,385],newtonian:247,newtyp:[3,227],next:[1,2,3,6,11,12,17,37,56,59,68,73,74,75,84,99,102,119,126,129,142,199,206,207,217,219,232,236,241,242,246,247,285,303,317,318,321,347,360,376,377,386,387,388,389],neyt:342,nfile:[3,37,56,199,203,204,207,241,242,450,451,478,479,499,504,529],nfirst:502,nfirt:502,nfreak:319,nfreq:[39,75,218,219,220,221,222,223,225,314,319,502],nfs:203,ngb:298,nghost:[3,12],ngp:115,ngpu:393,nguyen:[14,399],nharmon:2,nhc:300,nht:317,ni2:177,ni3:177,ni_000:[130,319],nialh_jea:416,nialhjea:[406,426],nice:[6,8,519],nickla:445,nicola:9,nimprop:[3,497],nimpropertyp:[387,497],nine:[139,146,419,466],ninteg:497,nissila:[257,466],nist:[394,416,523],niter:[41,225],nitrid:409,niu3:[406,416,426],nkb:307,nlast:502,nlen:221,nline:387,nlocal:[3,8,11,12,244],nlog:378,nlvalu:117,nmax:42,nmin:42,nmol:497,nmpimd:300,nn2:443,nneighmaxdef:3,nnn:[100,117],no2:[242,318,420,479],no_affin:[15,393],no_gradient_correction:465,no_histori:6,no_velocity_gradient:465,noced:386,nocheck:430,nocit:12,nocoeff:[38,58,200,373,490,497,526,527],nodal:[6,37,56,199,216,241,242,347,450,451,478,479],node:[1,3,10,12,14,15,16,17,41,130,134,177,205,225,251,257,347,393,430,494,510],node_area:257,node_group:216,nodeless:418,nodes:[41,225],nodeset:216,nodeset_to_elementset:216,nof:199,noforc:[2,3,6,210],nois:[6,247,248,254,255,256,257,307,312,317,339,347],nomenclatur:[6,75,380],nomin:[203,271],non:[0,1,2,3,4],nonbond:[4,12,452,476],none:[2,3,6,11,12,14,15,16,17,18,19,20,21,22,23,24,25,26,27,28,29,30,31,32],noneq:248,nonequilibrium:[344,345,418],nonetheless:254,nongauss:[2,65,113],nongaussian:115,nonlinear:[2,7,44,45,46],nonloc:[455,507],nonperiod:3,nonzero:3,noordhoek:408,nopreliminari:199,nor:[2,3,41,61,204,216,324,325,326,327,328,330,408,462,463,464,465,497,500],nord:[456,480,482],norder:494,nordlund:[456,480,482],norm:[6,12,65,128,210,219,318,319,325,326,386,388,475,514,515,523],normal:[3,6,9,11,12,15,39,41,60,63,65,70,74,75,77,96,99,112,113,123,127,128,163,166,176,178,179,180,184,199,207,210,219,220,222,225,229,231,232,245,246,250,254,255,263,268,271,285,298,300,301,306,308,312,314,315,323,335,336,338,339,340,347,352,353,356,357,361,363,364,365,367,382,383,385,386,388,393,407,408,422,423,426,446,475,489,491,492,495,497,499,500,502,503,507,511,514,515,516,518,523,524,528],norman:347,nornal:3,nose:[6,7,8,168,210,235,254,255,271,272,273,274,275,276,277,278,279,291,292,293,294,295,296,300,304,312,317,338,339,340,345,413,518],noskov:[483,518],noslip:[335,357],nosync:516,notabl:[5,39],notat:[6,63,65,74,152,172,210,268,271,416,485,524],note:[1,2,3,6,7,8,9,11,12,13,14,15,16,17,18,21,23,24,27,31,32,34,35,36,37,38,39,40,41,42,44,47,54,55,56,58,60,61,62,63,64,65,68,69,71,73,75,77,79,84,86,95,97,98,99,102,103,107,113,114,115,116,119,121,123,124,125,126,127,128,129,130,131,152,153,158,160,161,162,166,168,172,173,175,176,177,178,179,180,181,182,184,186,189,191,195,198,199,200,202,203,204,205,206,207,208,210,211,212,213,216,217,218,219,220,221,222,223,224,225,226,227,228,229,231,232,235,236,237,240,241,242,243,244,246,248,249,250,252,253,254,255,256,257,267,268,269,271,273,274,275,276,277,278,279,285,287,291,292,294,296,300,302,303,304,306,307,308,310,315,316,317,318,319,322,323,331,332,333,335,338,339,340,343,346,347,349,350,351,352,353,356,357,358,360,361,362,363,364,365,367,371,373,376,377,378,380,383,386,387,388,389,393,394,395,399,400,402,403,404,406,407,409,410,412,413,414,415,416,419,422,423,424,425,426,430,431,433,435,440,441,443,444,445,446,447,448,450,451,452,456,458,459,460,461,463,465,466,467,468,471,475,477,478,479,480,482,484,485,488,489,490,492,494,495,497,498,499,500,501,502,504,505,507,509,511,512,514,515,518,519,523,524,525,528,529],notes:[95,439],noth:[217,253,379,393,495,508,519],notic:[0,6,7,8,12,345,347,518],noutcol:8,noutput:299,noutrow:8,novemb:443,novik:13,novint:251,now:[2,3,6,10,11,12,13,15,46,63,64,75,203,211,212,227,247,251,252,306,317,353,356,378,380,416,418,423,458,459,468,493,498,518,519,525],nowait:251,nozforc:377,np3:177,np4:177,np6:177,npair:[127,220],nparticl:[3,40,42,398],npartit:515,npernod:[14,16,17,393],nph:[2,3,5,6,7,9,42,129,168,210,231,255],nphi:[15,393],nphug:[2,3,9,210,269],npoli:303,nproc:[3,11,203],npt:[2,3,5,6,7,8,10,15,42,59,61,95,129,155,159,160,161,162,164,165,166,167,168,170,210,229,231,235,248,255],npt_aspher:[273,279,291],npt_bodi:[274,292],npt_sphere:[275,296],nrecomput:415,nrepeat:[75,218,219,220,221,222,223,314,319,502],nreset:[229,271,272,276],nreset_ref:229,nrho:[394,416],nrl:416,nsall:9,nsampl:415,nsbin:75,nsbmax_most:3,nsec:517,nskip:[131,502],nsq:[3,390,454],nstart:[131,220,221,222,223,319,497,502],nstat:298,nstep:[3,13,229,271,358,472,495,498],nsteplast:495,nstop:[131,502],nswap:[343,350],nswaptyp:3,ntabl:[37,56,199,241,450,451,478,479],nterm:323,nth:[12,81,127,128,203,204,207,222,231,502,512],ntheta:399,nthread:[3,393],ntpc:393,ntptask:393,ntype1:126,ntype2:126,ntype:[3,152,178,203,207,308,310,418,425,456,497,507],nuclear:[9,106,107,164,248,272,307,312,387,418,489],nuclei:[106,107,162,164,169,204,256,272,284,295,341,396,418,497],nucleu:[106,107,308,482,518],nudg:[4,6,7,9,210,270,385,388],nulcear:9,num:2,num_of_collis:3,num_step:318,numa:[1,3,12,393,494],numactl:15,number:[1,3,4,6,7,8,9,10,11,12,13,14,15,16,17,21,26,37,38,39,40,41,42,44,56,57,58,65,66,67,68,69,71,72,73,74,75,76,77,79,80,81,82,83,84,85,86,88,95,98,99,100,101,102,103,112,113,114,116,117,119,122,123,124,125,126,127,128,129,130,131,141,147,152,155,156,157,158,159,160,161,163,164,165,166,167,168,170,171,172,173,175,176,177,178,179,180,181,182,186,187,198,199,200,202,203,204,205,206,207,208,210,211,212,215,217,219,220,221,222,223,225,226,227,228,230,231,232,241,242,243,244,246,247,248,250,251,252,253,254,255,256,257,260,266,268,271,272,276,285,287,293,298,299,300,302,303,306,307,308,312,314,317,318,321,322,326,332,335,336,337,339,342,343,344,345,347,348,349,350,352,354,355,357,358,360,362,373,375,377,378,380,383,384,386,387,388,389,390,393,394,395,399,401,406,408,413,415,416,417,418,419,425,426,427,428,429,443,444,445,446,448,450,451,452,456,457,458,459,460,463,465,466,467,475,477,478,479,480,481,482,484,485,486,489,490,491,492,494,495,497,498,499,500,501,503,504,505,506,507,509,511,512,514,515,516,518,523,524,525,529],number_of_a:3,number_of_b:3,numbond:3,numer:[1,2,3,6,9,11,12,21,37,41,42,44,56,75,81,95,117,127,172,182,186,197,199,203,206,207,211,212,213,215,216,219,223,237,238,247,250,254,268,271,300,317,321,322,347,352,354,355,357,358,362,383,386,387,406,412,426,443,448,450,451,458,459,465,478,479,489,491,495,496,497,504,507,513,514,515],numpi:11,nvalu:[219,223,495],nvaluelast:495,nvc_get_devic:14,nvcc:[1,9,16],nve:[1,2,3,4,5,6,7,8,9,10,15,39,42,95,99,129,178,210,216,235,238,247,248,250,253,254,255,256,260,263,268,271,276],nve_aspher:[273,277,291],nve_bodi:[274,278,292],nve_spher:[275,279,296],nvida:16,nvidia:[1,3,9,14,16,393],nvt1:518,nvt2:518,nvt:[2,3,5,6,7,8,15,42,95,99,129,159,160,161,162,165,166,167,168,170,210,216,217,220,222,223,231,235,238,246,248,250,254,255,263,268],nvt_aspher:[273,277,296],nvt_bodi:[274,278],nvt_sphere:[275,279],nvtfe:216,nwait:299,nwchem:7,nxnode:347,o_core:160,o_shell:160,oascr:7,obei:[3,231,380,492],ober:7,obj_shared_foo:12,obj_target:12,object:[6,8,11,12,14,40,42,206,229,251,257,260,303,323,330,386,387,495,500],observ:[15,271,307,338,339,342,343,350],obsolet:13,obstacl:[4,252],obtain:[1,3,9,12,15,28,77,95,113,117,176,208,212,245,248,257,276,299,300,342,377,395,412,443,448,457,466,480,482,506],obviou:[12,489,524],obvious:206,obviousli:[303,512,524],occ:421,occasion:[3,271,492],occlus:206,occup:[3,176,393,421],occur:[1,3,6,11,12,16,39,59,61,63,64,75,94,115,176,179,181,197,199,203,204,207,217,225,228,229,231,241,242,246,249,252,260,269,285,308,317,335,344,357,358,360,377,389,393,415,418,439,450,451,459,478,492,494,495,500,502,506,511,514,524],occurr:[370,497,511,524],oct:11,octahedr:24,octant:494,odd:[41,117,207,225,271,317,338,339,347,512],ode:[9,318],off:[1,3,6,12,14,16,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,36,37,39,40,43,44,45,46,47,48,49,50,51,53,54,55,56,61,63,68,73,75,118,119,123,124,126,152,153,155,161,165,176,177,182,184,185,186,187,188,189,190,191,192,193,195,196,198,199,203,204,206,207,210,213,217,223,224,227,228,231,239,245,246,247,249,251,254,255,260,271,273,274,275,276,277,278,279,280,281,285,289,291,292,294,296,302,304,305,309,310,317,320,321,335,350,352,355,356,361,362,363,364,366,367,368,370,371,372,377,378,386,388,389,391,393,394,395,397,400,401,402,403,404,405,407,408,409,411,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,441,443,444,448,449,450,451,452,453,455,459,460,461,463,465,466,468,475,476,477,478,480,481,482,483,485,487,488,489,492,493,494,497,499,500,504,506,509,510,511,516,521,523,524,527,529],offend:[3,495],offer:[6,17,181,385,409,466,492,506],offic:7,offload:[1,9,15,16,251,393],offset:[3,6,59,178,206,231,232,303,387,409,431,435,476,497],offsite:8,often:[1,3,6,7,12,13,14,15,16,17,36,55,75,172,198,206,213,222,223,225,229,244,251,271,300,319,371,380,385,386,388,389,390,393,408,413,431,478,480,482,492,511,516,518,519,523],ohio:445,old:[3,6,210,229,232,271,443,458,468,498,501,505,508,523,527],older:[3,5,12,13,15,16,207,229,271,468,524],oldlac:207,oleinik:399,olfason:[6,24,372,425,509],oliv:207,olivedrab:207,olivier:9,ollila:[257,259,260,261],olmsted:[216,298],omega0:372,omega:[2,3,6,65,92],omega_dot:271,omega_ij:414,omega_ijk:482,omega_ik:480,omegadd:[450,451],omegai:[124,129,203,204,337],omegax:[124,129,203,204,337],omegaz:[124,129,203,204,337],omgea:6,omiss:[0,7],omit:[199,207,238,354,403,412,435],omp:[1,2,3,7],omp_num_threads:[3,15,17,393],omp_proc_bind:16,ompi_comm_world_local_rank:12,on_the_fli:216,onc:[0,1,3,6,11,12,15,41,61,65,75,114,184,205,206,210,211,212,225,244,246,248,255,303,306,317,318,335,343,348,350,358,384,387,388,389,422,424,426,456,460,494,495,504,514,518,524],once:[0,2,6,8,12,40,41,62,99,207,225,226,227,232,299,348,427,511,519],one:[3,6,12,13,16,28,42,76,81,99,127,152,160,206,226,227,231,267,271,276,315,331,335,342,347,349,378,387,399,410,441,459,466,492,495,497,498,506,509,524],onelevel:494,onewai:[2,3,210],ongo:251,oniom:[9,311],onli:[1,2,3,6,7,8,9,11,12,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,32,34,35,36,37,38,39,40,41,42,43,45,46,47,48,49,50,51,53,54,55,56,58,61,62,63,65,66,68,69,70,71,73,74,75,77,79,82,84,85,86,88,89,91,94,95,96,98,100,102,103,106,107,108,109,110,111,113,114,115,116,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,161,162,164,165,166,168,169,170,171,172,173,175,176,177,178,181,182,184,185,187,188,189,190,191,192,193,195,196,197,198,199,200,202,203,204,205,206,207,208,210,211,212,213,214,215,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,235,237,238,239,240,241,242,243,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,286,287,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,306,307,308,309,310,311,312,313,314,317,318,319,320,321,322,323,324,325,326,327,328,330,335,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,363,364,365,366,367,368,370,371,372,373,375,377,378,380,383,386,387,388,389,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,494,495,497,498,500,501,502,504,505,506,507,508,509,511,512,513,514,515,516,518,519,524,525],only:[2,3,6,13,15,41,61,74,76,112,131,156,157,158,181,203,204,205,206,207,208,220,223,229,238,246,249,263,266,270,287,293,298,302,308,309,317,343,349,350,358,360,377,386,388,394,395,399,401,404,408,416,417,419,425,427,428,440,441,443,444,445,452,456,457,458,459,467,477,480,481,482,485,506,515,518,524,527],only_group:176,onn:506,onset:[307,370],ontario:9,onto:[152,180,228,232,238,257,475],onward:2,open:[0,3,5],opencl:[1,3,7,14,393],opengl:6,openkim:9,openmp:[1,3,4,7,9,10,12,15,16,17,375,393,459,510],openmpi:[12,14,15,16,17,393],opensourc:7,oper:[1,3,6,7,8,11,12,15,16,39,41,42,61,75,99,128,131,166,168,169,178,181,182,207,210,217,219,220,222,223,225,226,227,228,232,238,246,249,256,266,267,268,269,271,272,273,274,275,276,277,278,279,284,291,292,294,295,296,303,305,306,315,317,319,321,323,334,335,336,337,341,345,347,351,353,358,360,375,377,378,385,388,390,393,446,463,465,491,492,493,494,495,497,498,499,500,502,503,505,506,510,511,514,519,524,525,528],operat:3,opl:[2,15,186],opls:[7,186,195,198,426],oppelstrup2:9,oppelstrup:[9,446],oppos:[6,39,201,203,204,316,354,378,387,497],opposit:[6,28,74,184,215,254,261,298,317,350,388,409,439,483,495],opt:[1,2],optic:156,optim:0,optimiz:[15,309,386,408],option:[0,1,2,3,4],optional:[227,246,314,353,393,459,467,505],optionn:16,options:[9,12,15,16,446],orang:[2,206,207],orbit:[308,310,399,409,418,466,476],orchid:207,order:[2,3,6,9,11,12,15,26,28,37,39,41,56,61,65,68,73,75,84,95,97,98,100,102,103,117,119,123,126,129,142,152,153,154,155,156,157,158,159,160,161,164,165,166,167,168,170,171,182,187,198,199,203,204,206,207,210,213,218,220,222,223,224,226,227,228,229,230,235,237,238,242,246,248,250,251,253,257,258,260,269,271,298,306,307,311,314,315,316,317,318,319,320,321,323,328,330,336,342,346,347,348,349,359,360,361,363,364,365,367,370,371,377,382,387,388,394,395,396,399,408,414,415,416,418,419,422,423,426,428,431,439,443,446,450,451,458,459,460,466,476,477,478,479,480,481,482,483,485,486,492,494,495,497,498,502,504,506,507,511,514,518,524,529],orderomg:3,ordinari:[122,318,425,455],org:[6,7,11,12,13,298,457],organ:[0,3,6,7,8,408],organis:[463,465],organometal:24,orien:507,orient:[2,3,6,8,13,28,40,42,65,74,75,90,99,100,117,124,129,178,202,203,204,210,231,237,246,260,268,271,273,274,277,278,281,282,283,286,289,290,291,292],orientord:[2,3,65,100],origid:219,origin:[3,6,7,9,12,75,87,113,114,125,130,174,178,180,202,206,207,210,211,212,219,226,227,231,235,238,255,268,271,294,300,303,313,317,319,327,334,345,374,376,377,380,385,394,395,397,399,409,412,413,415,416,425,428,443,455,458,459,480,482,483,484,494,497,498,499,500,501,502,519,523,527],orlikowski:446,ornl:[7,9,14],orsi:28,ortho:[3,61,180,497],orthogon:[0,3],orthograph:206,orthong:61,orthongon:[61,317],orthonorm:232,orthorhomb:307,os4:177,oscil:[6,9,163,227,231,234,235,255,268,269,271,307,312,317,352,353,355,357,387,396,483],oscillatori:[268,327],ose:206,oserror:11,other:[0,1,2,3,5],otherwis:[1,3,9,12,16,17,36,39,55,57,75,122,130,156,157,158,171,179,184,198,204,207,208,217,219,226,227,231,244,246,248,255,271,317,318,371,372,382,386,393,401,426,430,440,441,456,486,490,492,495,497,498,518,524],otyp:[409,431,435,439],our:[5,6,7,8,13,257,321,448,480,482,518],out:[1,2,3,4,6,7,8,11,12,13,17,18,20,41,66,69,75,79,86,98,99,103,104,107,113,114,115,116,118,125,126,155,156,157,158,159,161,162,164,165,166,167,168,170,171,173,175,181,185,203,204,206,207,208,210,225,226,227,230,239,245,246,252,254,257,262,285,287,299,301,302,303,306,312,313,314,317,331,347,356,358,359,360,361,363,367,375,376,380,384,388,392,418,426,442,476,491,492,494,495,500,501,502,504,505,506,508,511,513,514,515,516,520,522,524,525,526,527,528,529],outcom:[317,525],outer2:[404,424],outer:[3,8,15,57,75,236,252,360,376,384,386,392,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,449,450,451,453,455,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,486,487,488,489,490,492,505,506,511,516,517,524],outer_distance_cutoff:425,outermost:[37,56,75,211,212,213,214,224,233,237,249,252,266,268,271,298,309,316,320,323,331,332,333,334,351,352,356,389,478,479,506],outfil:[13,494],outlin:[6,206],outmost:251,outpur:119,output:[0,1,2,3,5],output_frequ:216,outputss:139,outsid:[3,8,59,61,75,168,178,202,203,204,205,206,207,208,222,232,238,246,252,317,319,335,340,341,354,355,356,357,358,375,388,400,402,409,418,431,433,453,461,495,497,498,500,507,514,525],outut:6,outward:[75,176,352,356,357,497,506],over:[1,3,5,6,7,12,15,17,26,39,41,42,55,62,68,71,73,75,84,85,95,96,97,98,100,102,111,113,115,117,119,126,127,129,137,138,144,149,152,153,158,161,164,172,174,187,199,206,208,210,211,212,218,219,220,221,222,223,224,225,226,227,231,232,244,247,248,252,254,255,256,260,268,269,270,271,272,273,274,275,277,278,279,291,292,294,295,296,298,303,304,307,314,315,316,317,318,319,323,331,335,338,339,340,341,343,346,349,350,352,354,355,356,357,358,361,376,379,388,389,390,407,413,416,417,418,419,425,440,443,446,456,467,468,476,477,478,480,481,482,485,493,494,495,500,502,503,505,506,511,512,514,515,523,524,525],overal:[6,17,24,61,172,229,235,271,272,300,321,335,360,384,418,425,426,467],overalap:317,overcom:[285,335],overflow:[3,387,389],overhead:[6,11,18,41,207,219,221,225,238,243,306,389,390,500,516],overkil:317,overlai:[2,6,15,95,118,172,211,212,347,409,413,415,425],overlaid:7,overlap:[3,13,15,64,80,119,126,178,181,199,207,215,218,219,222,223,232,236,263,285,303,308,314,317,319,335,353,357,377,380,384,386,387,393,413,418,423,426,429,439,462,464,468,484,497,500,506],overli:318,overload:1,overrid:[3,9,12,15,16,21,44,75,164,178,186,206,207,211,212,229,236,266,271,320,362,377,387,389,406,425,426,443,448,458,494,495,499,507,509,514,524],overridden:[6,178,206,276,317,429,440,448,468,476,505,524,527],overview:[0,1,2,6,7,8,9],overwrit:[11,12,21,44,186,207,219,220,221,222,223,319,362,375,381,406,443,495,498,499],overwritten:[204,305,346,375,425,426,492,493,498],own:[3,4,6,7,8,11,12,13,14,16,39,41,61,63,65,68,69,73,75,77,79,84,86,98,102,103,114,116,124,125,126,128,129,131,158,161,173,175,176,203,204,207,210,216,218,219,220,221,222,223,225,228,229,231,244,247,248,254,255,257,266,269,271,273,274,275,276,277,278,279,291,292,294,296,300,304,312,317,319,338,339,340,349,377,388,393,395,399,408,417,428,456,458,459,477,480,481,482,485,494,507,512,514],oxford:[28,95,412],oxid:[9,408,409,466],oxygen:[6,40,243,306,409,431,435,466,497],oxygen_c:160,p10:423,p_e:347,p_ik:456,p_pi:399,pacakg:[15,393],pack:[5,8,70,353,393,399,443],pack_bord:8,pack_border_bodi:8,pack_border_hybrid:8,pack_border_vel:8,pack_comm:8,pack_comm_bodi:8,pack_comm_hybrid:8,pack_comm_vel:8,pack_exchang:8,pack_restart:8,pack_revers:8,pack_reverse_comm:8,pack_reverse_hybrid:8,packaag:393,packag:0,packakg:14,packet:[7,9,40,206,396,418],pad:[3,203,204,206,207,300,524],padua:[9,13],page:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,16,17,21,36,40,42,44,55,59,61,65,69,71,79,84,86,95,98,102,103,114,115,116,118,120,121,123,125,128,129,131,153,156,157,158,171,173,175,178,179,180,186,198,202,203,204,205,206,207,208,210,211,212,217,218,219,220,221,222,223,232,246,253,254,255,266,271,272,277,278,279,283,291,292,294,295,296,303,306,317,331,335,338,339,340,349,353,356,358,360,362,371,376,386,387,388,389,393,394,395,398,406,408,409,416,417,419,425,426,428,429,443,444,445,448,452,456,457,467,476,477,480,482,484,485,495,497,498,499,500,502,505,506,507,509,514,515,524,525,527,528],pai:[14,17],painless:519,pair:[1,2,3,4],pair_:[95,211,212],pair_airebo:428,pair_charmm:439,pair_class:8,pair_coeff:[2,3,6,95,99,119,126,179,184,211,212,227,314,335,394,395,396,397,398,399,400,401,402,403,404,405],pair_dpd:9,pair_dzugatov:519,pair_eam:394,pair_eff:164,pair_foo:8,pair_gayberne_extra:9,pair_hybrid:[426,483],pair_interact:216,pair_kim:211,pair_list:430,pair_lj:439,pair_lj_cut:8,pair_lj_soft_coul_soft:95,pair_modifi:[2,3,6,95,96,118,121,377,386,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,415,416,417,418,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447],pair_resquared_extra:9,pair_sph:[469,470,471,472,473,474],pair_styl:[0,1],pair_tally_callback:8,pair_writ:[2,3,406,437,476,478,479],paircoeff:[3,490],pairfoo:8,pairij:[3,497],pairkim:3,pairstyl:8,pairwis:[0,1,3,5,6,7],pakketeretet2:519,palegoldenrod:207,palegreen:207,paleturquois:207,palevioletr:207,pan:206,panagiotopoulo:[410,421],pandit:[9,310,459],papaconstantopoulo:394,papayawhip:207,paper:[3,6,7,8,9,13,39,40,66,152,166,172,190,254,257,261,270,302,308,310,317,335,343,347,350,377,385,388,395,403,409,423,425,428,433,435,455,458,459,480,482,492,511],paquai:[9,287,293,382],paradyn:5,paraemt:460,paragraph:[75,166,352,380,450,451,478,498,499],parallel:[0,1,2,3,4,5,6,7,8,9,10],parallel_studio_xe_2016:15,parallelepip:[6,180,380,497,500],parallelipip:[180,299],paralleliz:[9,302],param:[3,308,310,420,429,494,500],param_free_:211,param_free_sigma:211,paramet:[0,2,3],parameter:[130,177,395,399,408,409,416,417,418,419,428,443,444,445,456,458,459,466,477,480,481,482,485],parameter_fil:216,parameterizaion:409,parametr:[6,9,35,417,457,461],paramt:[115,308,354,460],paramter:408,paratem:439,paraview:[204,319],parent:[3,8,358],parenthes:[37,56,199,241,242,318,420,423,450,451,478,479,524],parenthesi:[2,15,219,360,524],parinello:[6,7],pariticl:225,paritlc:3,park:[3,7,9,216,323,445,455],parmin:446,parrinello1981:229,parrinello:[229,248,269,271,272,307,339],pars:0,parser:[12,524],part:[0,1,2,3,6,7,8,9,11,12,16,19,20,22,23,24,25,26,27,28,29,30,31,34,35,36,37,40,41,43,45,46,47,48,49,51,53,54,55,56,66,70,74,75,76,82,85,88,89,91,100,106,107,108,109,110,111,113,115,118,119,122,123,126,129,130,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,160,162,164,165,169,170,172,176,177,181,184,185,187,188,189,190,192,193,195,196,198,199,203,204,205,207,208,210,213,214,215,217,221,224,225,226,227,228,229,230,231,232,234,237,238,239,240,241,242,243,244,245,246,247,248,249,251,252,253,254,255,256,257,258,259,260,261,263,264,265,266,269,271,272,273,274,275,276,277,278,279,280,281,282,283,284,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,307,308,309,310,311,312,313,314,316,317,318,320,321,322,323,324,325,326,327,328,330,331,332,334,335,338,340,341,342,343,344,345,346,347,348,350,352,353,354,355,356,358,359,360,361,363,364,366,367,370,371,372,377,378,386,387,388,389,393,394,395,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,443,444,445,446,449,450,451,452,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,494,495,497,498,499,500,504,505,506,509,515,519,524,529],partai:[9,457],parti:[4,9],partial:[1,2,3,6,8,65,112,155,158,164],partic:6,particip:[197,227,398,429,484],particl:[0,3,4,5],particleenergi:3,particleviri:3,particular:[1,3,4,6,8,10,12,40,65,68,73,74,75,84,102,119,124,126,127,152,178,202,203,204,206,210,211,215,225,228,246,247,252,253,257,268,271,298,303,316,317,321,342,353,358,361,378,380,384,387,393,398,399,400,402,404,405,407,411,414,417,418,422,424,426,431,435,439,442,449,452,453,460,461,476,477,480,481,482,483,485,492,494,497,498,499,504,505,507,515,519,524,525,528,529],particularli:[6,7,9,12,14,24,39,206,229,317,378,418],particuolog:42,partilc:335,partit:[2,3,6,7,12,41,64,154,166,180,207,225,272,300,374,376,381,388,392,403,404,418,431,432,435,442,447,456],partitoin:64,partner:[3,7,63,226,227,228,255,335,350,483,507,512,518],pascal:[9,13,523],pass:[6,7,8,9,11,69,78,79,86,87,97,98,103,113,114,115,116,129,173,203,204,206,207,208,229,230,244,246,268,269,271,306,335,352,376,382,389,393,426,429,458,475,495,497,498,502,508,524,528],passphras:12,password:519,past:0,patch:[0,12],patchi:317,patel:446,path:[3,6,7,11,12,13,14,208,253,270,300,323,335,342,347,388,394,395,399,406,416,417,419,428,443,444,445,452,456,457,458,466,467,477,480,482,485,498],pathtolammp:466,patient:12,patom1:[119,126],patom2:[119,126],patrick:481,pattern:[3,7,12,64,77,499],pattnaik:317,paul:[0,7,13,254,256],pauli:[418,466],paus:505,paves:300,payn:[152,457,467],pb2:177,pb4:177,pbc:[75,352,396],pchain:[271,272,276,317],pcie:1,pd2:177,pd4:177,pdamp:[271,272,276,304,317],pdb:[6,13,208],pdebuyl:9,pdf:[0,8,9,13,16,40,109,110,111,122,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,230,253,264,265,324,325,326,327,330,455,469,470,471,472,473,474,507],pdim:350,pdlammps:[82,85,455],pdlammps_eps:[9,122,455],pdlammps_overview:9,pdlammps_ves:[9,455],pe_eta:271,pe_etap:271,pe_omega:271,pe_strain:271,peachei:13,peachpuff:207,peak:421,pearlman:95,peculiar:12,pedersen:378,peform:[39,309],penalti:[458,459],pencil:[6,75,166],pend:3,penetr:[42,132,462,464,507],penetret:40,peng:177,penn:13,peopl:[7,8,9,12],peptid:[4,9,230],per:[0,1,3,5],peratom:[3,121,153,176],perceiv:206,percent:[3,12,15,229,393,477],percentag:[1,12,229,271,303,304,317],percol:227,perfect:[6,41,74,77,100,225,298,388],perfectli:[41,225,498],perfom:[6,388],perform:0,performac:1,pergamon:[443,482,489],perhap:380,peri:[2,3,4,6,7],peridyma:82,peridynam:[3,4,6,7,9,40,65,82,85,122,455,476,497,507],perimitt:410,period:[2,3,6,7,8,9,12,21],perioid:352,perl:[6,13],perm0:523,perman:[3,39,54,75,182,226,227,251,316,358,393,425,501,509],permeabl:297,permiss:[227,495],permit:[6,257,446],permitt:[410,482,488,489],permut:[12,417,477,480,482,485],perpendicular:[6,75,156,206,231,252,262,268,270,298,301,327,352,353,385,497],perram:[378,422],persepct:206,persist:[3,8,75,244,317,393,494,495,499,503,524],person:[9,519],persp:[3,206],perspect:206,pertain:[406,476],perturb:[9,13,74,95,267,315,352,355,357,502],peru:207,peskin:257,pessimist:378,petersen:[335,378],pettifor:[399,476],pettifor_1:399,pettifor_2:399,pettifor_3:399,pfactor:206,pforc:495,phantom:251,pharmaceut:7,phase:[3,12,15,271,342,350,399,431,481,494],phd:457,phenol:518,phenomena:418,phi0:[196,316],phi1:185,phi2:[185,417,477],phi3:[185,417,477],phi:[1,3,4,7,9,10,12,15,16,84,100,117,152,197,198,199,206,249,316,364,393,394,399,416,419,443,444,445,510],phi_ij:[399,419,456],philadelphia:9,phillip:[255,413,518],phillpot:[309,408,409,466],philosoph:416,philosophi:[6,7,253],phonon:[0,2],phophor:467,phosphid:467,phy:[6,7,13,19,20,24,39,43,45,46,66,74,77,95,96,100,117,121,123,152,153,160,166,184,185,195,205,217,221,229,230,235,238,247,248,253,254,255,256,257,269,270,271,272,276,287,289,293,294,295,299,300,304,307,309,312,317,321,322,323,335,338,339,342,343,344,345,347,350,352,361,370,372,377,378,385,388,395,399,400,404,405,407,408,409,410,411,412,413,414,416,417,418,421,422,423,424,425,428,431,433,435,436,439,440,441,442,443,445,447,448,450,451,453,455,456,460,466,467,475,477,478,479,480,481,482,483,485,492,506,509,511,518],physic:[3,6,12,15,16,17,40,42,53,61,132,160,172,197,216,231,238,248,254,256,257,259,260,261,269,299,308,310,346,347,378,380,388,393,395,397,403,407,416,425,426,446,457,458,459,462,470,471,473,474,492,494,506,507,512,523],physica:[440,441],physik:[7,9],pic:9,picki:8,picocoulomb:523,picogram:523,picosecond:[207,231,515,523],picosend:418,pictur:7,piec:[3,11,152,207,271,504,529],pierr:9,pieter:13,pimd:[2,6,7,13,253],pin:15,pink:207,pipe:[6,203,206],pipelin:[3,6,15],pisarev:347,pishevar:413,piston:[2,3,9,210,215],pitera:6,pixel:206,pizza:[6,7,11,13,41,203,206,225],pjintv:13,pka:347,place:[3,6,7,11,12,32,41,50,75,95,172,178,182,191,199,203,206,207,209,210,211,212,227,228,231,238,246,247,248,250,253,254,255,256,258,260,261,271,277,278,279,291,292,296,303,306,315,317,338,339,340,347,352,355,357,376,406,425,476,484,494,495,498,505,507,512,515,524],placehold:[32,191,394,395,408,416,419,427,428,443,444,445,452,456,458,459,467,475,477,480,481,482,485],placement:[380,431],plai:[6,206,342],plain:[9,439,495],plan:[3,5,6,15,16,180,497],planar:[6,40,42,252,298,353,370,372],planck:[246,300],plane:[3,6,9,41,42,59,61,70,75,100,206,210,216,225,249,252,262,298,301,311,331,334,347,353,361,363,364,365,366,367,372,380,382,441,484,500,507],plane_wiggl:382,planeforc:[2,210,262],plasma:[96,272,347,418],plastic:[2,3,9,65,82,85],plastic_strain:133,platform:[1,3,7,9,12,13,14,15,16,203,206,208,499,504,529],plath:[6,99,210,343,350],player:206,pleas:[0,3,7,11,12,13,15,216,248,257,261,299,302,306,313,342,358,417,419,455,463,465,466],plen:396,plimpton:[0,5,7,15,74,123,153,228,298,308,335,423,455],plog:[3,12,506],ploop:[271,272,276],plos:28,plot:[7,11,13,15,57,307,437,439,478,479,486],plu:[3,11,12,39,61,71,106,176,181,207,224,229,231,232,276,317,390,418,429],plug:9,plugin:[9,13,208,498],plum:207,pm3:177,pmb:[2,9],pme:378,pmf:[230,323,331],png:[3,12,203,206],pni:206,poariz:6,poem:[2,3,6,9,12,210],poems:[3,6,7],point1:497,point2:497,point3:497,point:[1,2,3,4,6,7,8,9,11,12,15,17,28,37,40,41,42,56,61,74,75,90,92,93,124,125,130,152,156,157,171,176,177,178,189,199,201,202,203,204,206,207,210,215,219,221,223,225,229,231,232,233,237,241,242,245,246,248,251,252,257,260,268,270,271,273,274,275,277,278,279,281,282,283,286,289,290,291,292,294,296,299,300,306,307],point_data:319,pointer:[3,7,8,9,11,244,495],pois:523,poiseuil:[4,213,249],poisson:[61,231,378,423],poisson_solv:216,polak:385,polar:[6,7,117,152,160,177,216,234,408,409,431,483,518],polar_off:408,polar_on:408,polariz:0,poli:[2,3,176,303,380],politano:[9,466],pollock:[7,378],polya:358,polybond:13,polychain:317,polydispers:[3,387,401,407,423,440,441,476,488],polyethylen:395,polygon:[6,42,176],polyhedron:176,polym:[0,5,6,7,10],polymer:7,polymorph:[2,3,7],polynomi:[9,37,56,199,416,437,448,466,471,478,479],polytechn:302,poor:[16,41,225,294,295,321,393,437],poorli:[385,386],pop:[3,8],popen:12,popul:[12,312,380,415,497],popular:[12,203,417],pore:331,poros:181,porou:[257,260],port:[251,253],portabl:[7,9,12,203,205,230,458,499],portion:[1,3,9,11,12,14,41,54,67,72,75,83,96,99,101,118,119,121,124,153,154,168,203,204,207,218,219,222,223,225,229,238,243,257,271,273,274,275,277,278,279,309,314,315,317,319,360,376,389,393,400,402,403,404,405,409,410,412,413,418,420,421,422,424,425,431,435,439,442,453,460,461,482,486,496,497,502,506,507,516,519,524],poschel:423,posfreq:314,posit:[3,6,26,39,40,41,42,46,59,61,74,75,86,87,97,98,113,114,119,128,130,134,152,153,161,176,177,178,180,181,182,187,189,197,199,202,204,205,206,207,210,211,213,215,217,218,219,222,225,226,227,228,229,230,231,232,235,237,238,246,247,248,249,251,252,254,255,256,257,259,260,264,265,268,269,271,272,273,274,275,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,294,295,296,298,299,300,302,303,304,307,308,312,314,315,317,318,321,323,327,330,331,334,335,337,338,339,340,342,344,345,346,347,350,352,353,354,355,356,357,358,361,377,380,388,395,396,398,401,413,414,415,418,421,434,450,451,459,466,475,478,479,484,492,497,500,507,516,518,524,525],posix:251,posix_memalign:12,possibl:[1,3,6,8,9,11,12,14,37,40,41,55,61,65,74,75,95,124,126,152,153,156,157,171,202,203,204,205,207,210,212,216,217,225,226,227,228,232,234,240,248,255,266,298,303,311,312,314,317,318,330,335,337,347,348,353,366,376,378,386,389,390,393,415,425,443,459,463,465,466,478,479,485,495,501,510,511,515,518,524,525,528],post:[0,4,6],post_forc:8,post_force_integr:8,post_force_respa:8,post_integrate_respa:8,postit:285,postiv:94,postma:[304,338],postprocess:13,pot:[423,459],potentail:419,potenti:0,potentials:10,potentiel:439,potetni:426,potin:446,potpourri:9,pour:[2,3,4,6,9,112,180,207,210,232],pourtoi:342,pow:231,powderblu:207,power7:16,power8:16,power:[3,9,11,15,115,152,207,312,377,393,399,495],pparam:[95,211,212],ppm:[12,203,206],ppn:[14,15,16,17,393],pppm:[0,1,2,3,5],pppm_disp:3,pppmdisp:3,pproni:[3,247],pr3:177,pr4:177,practic:[3,12,229,271,272,299,306,485,494,519],prb:[480,482],prd:[2,3,4,6,9,94,231,388],pre:[3,6],pre_exchang:8,pre_forc:8,pre_force_respa:8,pre_neighbor:8,prec:[15,466],prece:465,preced:[2,6,61,184,204,218,219,220,221,222,223,253,314,318,319,360,380,388,393,399,425,511,514,515,524],preceed:[11,12,75,166,220,352,495,524],precipit:176,precis:[1,3,9,12,13,14,15,16,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,43,45,46,47,48,49,51,53,54,56,113,123,155,165,178,184,185,187,188,189,190,192,193,195,196,199,203,207,213,219,223,224,229,231,238,239,245,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,308,309,310,317,320,321,355,361,363,364,366,367,370,372,377,378,386,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,431,432,433,434,435,436,437,438,439,440,444,446,449,452,453,455,458,459,460,461,466,468,477,478,480,481,482,483,485,487,488,489,499,500,506,507,510,515,518,523,524,525],precv:494,predefin:[196,207,358,418],predict:[1,6,10,12,285,317,393,516],preexponenti:511,prefactor:[23,24,27,31,34,35,172,186,198,211,212,220,352,363,367,370,386,407,421,452,460,461,468,488],prefer:[7,8,12,250,316,348,395,519],prefix:[11,12,206,230,299,318,491,494],preliminari:[37,56,199,241,242,450,451,478,479],prematur:386,prepar:[8,9,308,311,335,508,518],prepend:458,preprint:[152,287,293,382,467],preprocessor:251,prerecord:230,prescrib:[6,8,156,157,158,171,210,211,216,219,232,268,288,348],presenc:[203,226,227,257,260,440,441,446,488,527],present:[1,3,9,12,15,17,176,199,205,206,232,247,248,253,257,258,260,261,312,330,353,356,359,408,418,430,439,446,459,460,466,494,518],preserv:[3,61,229,231,271,321,335,357,498],press:[2,3,6,9,15,28,95,106,107,121,153,164,210,229,235,246,248,255,266,269,271,273,274,275,276,277,278,279],pressdown:224,pressur:[1,2,3,6,7,8,9,59,65],pressure_with_eviri:418,presum:[77,167,210,211,212,231,388,426,500],prevent:[2,3,6,40,132,197,232,245,303,335,346,370,377,384,386,388,393,413,426,454,470,471,473,475,495,499,505,507,518,524],previou:[0,2,3,5,6,8,11],previouli:232,previous:[3,9,11,61,63,75,94,112,128,131,167,178,180,182,202,203,204,205,207,215,217,218,219,220,222,223,231,232,246,252,266,268,303,315,317,320,321,347,349,352,353,354,355,357,358,379,423,476,492,495,499,500,510,512,514,515,520,521,522,524,525],prevoiu:353,price:[6,412],primari:[0,6,347],primarili:[5,7,9,16,154],prime:[235,255,424,446,480,482,494],primit:[3,6,355,356,380],princip:[3,129,251,466],principl:[6,9,11,251,272,308,418,427,446,477,494,519],prinicp:[42,317,387],print:[0,1,2,3,6,7,8,11,12,15,16,17,18,41,99,106,107,128,152,203,204,206,207,208,210,219,220,221,222,223,228,229,232,251,254,257,266,269,271,273,274,275,276,277,278,279,287,288,291,292,293,294,296,298,302,303,304],printabl:2,printflag:427,printfluid:257,prior:[176,201,322,379,528],priori:506,prism:[3,6,166,180,500],priveleg:3,privileg:[11,12,251],prob:[226,227],probab:468,probabl:[3,8,12,40,75,168,181,182,197,217,225,226,227,228,232,246,255,271,303,352,358,386,448,450,451,478,492,511,518],probe:524,problem:[0,1,2],problemat:246,proc:[1,3,8,11,12,14,15,124,203,204,376,494],proce:[41,54,182,225,236,388,446,504,512,515],procedur:[6,12,39,41,207,217,225,246,254,255,256,271,273,274,275,276,277,278,279,291,292,294,295,296,299,338,339,340,341,344,345,386,388,395,401,498,518],proceed:[12,446],procesor:[41,494],process:[1,3,4],processor:[1,2,3,4,6,7,8,9,11,12,13,14,15,16,17,39,40,41,42,60,61,63,64,65,68,71,73,75,84,102,119,124,126,127,129,166,176,178,180,181,182,202,203,204,206,207,210,216,219,225,226,227,228,229,231,244,247,248,254,255,257,271,300,306,309,312,317,321,322,335,347,358,374,375,376,377,381,388,390,391,392,393,413,415,454,466,491,492],processsor:[41,225,494],procp1:[203,204],procsessor:516,procssor:506,produc:[1,3,4,6,7,12,13,14,15,16,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,41,42,43,45,46,47,48,49,51,53,54,56,65,68,71,73,75,84,102,119,121,123,124,125,126,128,129,131,153,155,165,176,184,185,187,188,189,190,192,193,195,196,199,203,204,206,207,210,213,218,219,220,222,223,224,225,228,231,239,244,245,247,248,249,254,255,256,266,268,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,303,307,308,309,310,312,317,318,319,320,321,336,337,347,348,349,352,355,360,361,363,364,366,367,370,372,378,386,388,391,393,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,418,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,449,452,453,455,456,459,460,461,468,477,478,479,480,481,482,483,485,487,488,489,492,494,499,500,502,503,506,511,512,515,524,525],product:[6,15,16,17,152,176,231,294,308,318,348,393,396,418,420,451,459,479,494,524],proessor:393,prof:302,profi:167,profil:[2,3,6,65,156,157,158,161],program:[3,4,6,7,9,11,12,13,15,16,154,203,206,207,208,210,230,244,251,257,311,416,495,496,508,524],programm:[13,16],progress:[1,41,225,251,269,307,385,386,388,515,518],prohibit:507,project:[6,7,13,385,476,519],promis:7,promot:399,prompt:[8,11,12,251,508],proni:[3,247,248],pronounc:250,proofread:8,prop:[6,306],propag:[4,9,215,271,307,324,418,426],propens:6,proper:[228,298,443,495,519],properati:306,properli:[213,237,317,322,330,387,388,414,495,525],properti:[0,2,3],propoerti:335,proport:[6,39,41,95,113,114,174,225,254,255,256,307,318,343,350,351,423],proportion:254,propos:[6,152,217,229,246,271,294,312,431,445,481,483],prospect:7,protect:335,protein:[7,10,15,178,315,317,333,497,505],protocol:251,proton:[482,489,523],prototyp:[42,455],prouduc:[223,349],prove:[88,89,240,257,322],proven:294,provid:[1,3,4,6,7,8,9,10,11,12,13,14,15,16,17,28,40,42,63,70,74,130,151,154,172,176,177,178,205,206,208,211,218,219,223,228,229,230,231,244,246,251,253,257,261,269,271,299,306,307,308,311,312,317,322,323,342,344,345,348,349,360,375,377,378,384,388,393,395,399,401,406,408,409,413,417,418,423,425,428,430,439,440,443,445,446,456,457,458,459,466,467,475,476,477,480,481,482,485,494,499,505,507,510,511,515,516,519,524],proxim:202,psa:355,pscreen:[3,12,506],pscrozi:[0,7,13],psec:[207,231,250,254,255,271,304,317,338,339,517,523],psend:494,pseudo:[418,492,497,502],pseudodynam:342,pseudopotenti:[9,446],psf:6,psi:[419,488],psi_ij:419,pstart:[3,271,272,276,304,317],pstop:[3,271,272,276,304,317],pstyle:[95,118,211,212],psu:[458,459],psuedo:502,psxevar:15,pt2:177,pt4:177,ptarget:229,pthread:[12,15,16],ptr:[6,11,244,495],ptype1:126,ptype2:126,pu3:177,pu4:177,pu6:177,publicli:5,publish:[7,257,261,287,293,308,382,409,443,446,480,482],pull:[323,331,519],puls:347,pump:[440,441],punctuat:[2,492,511],purchas:206,purdu:[9,13],pure:[11,335,426,444,445,480,482,506],purg:[3,498],purpl:[2,207],purport:11,purpos:[3,6,7,9,12,42,63,75,130,140,146,161,162,177,178,180,182,199,203,223,228,229,254,298,300,303,305,316,335,377,403,429,435,446,448,484,490,497,500,504,507,509,510,524,529],push:[3,8,213,224,231,252,270,298,315,323,386,423,468,519],pushd:252,put:[3,6,8,11,12,13,39,61,166,178,203,232,236,354,355,358,380,458,495,497,501],putenv:[508,524],px1:506,px2:506,pxx:[229,271,304,317,377,378,514,515],pxy:[3,6,515],pxz:[3,6,515],py1:506,py2:506,pydir:11,pyi:[229,271,304,317,377,378,515],pymol:[7,11,13],pymol_aspher:0,pympi:11,pypar:11,python:[0,2,3,4,6,7],pythonpath:11,pyz:[3,6,515],pz1:506,pz2:506,pzz:[229,269,271,304,307,317,377,378,515],q_1:466,q_2:466,q_3:466,q_d:518,q_i:[419,439],q_j:439,qbmsst:[2,9],qcore:308,qdamp:308,qdist:[409,431,435,439],qeq1:308,qeq2:308,qeq:[2,3,4,6,7],qeqall:466,qeqallparallel:466,qfile:[308,409],qin:250,qinitmod:466,qmin:385,qmmm:2,qmol:311,qoffload:15,qopenmp:15,qout:250,qoverrid:15,qstep:308,qtb:2,quad:[12,17,393,494],quadrant:15,quadrat:[2,3],quadratur:[95,216],quadrupl:394,quadruplet:[194,198,200,361,363,364,365,367,369,370,371,373],qualifi:[3,253],qualiti:[7,206,207,395],quantic:466,quantit:[78,87,113,114,115,174,423],quantiti:[1,3,4],quantum:[6,9,152,244,248,300,307,311,312,395,399,418,446,466,476],quantum_temperatur:307,quartic:[2,3,7],quartic_spher:216,quartz:[307,312],quasi:300,quat:[3,507],quaternion:[3,6,40,90,124,129,142,156,157,178,273,274,277,278,281,282,283,291,292,422,497,507],quati:[124,129,497],quatj:[124,129,497],quatk:[124,129,497],quatw:[124,129,497],queen:13,quench:[358,492,511],queri:[3,11,54,288,495,524],quest:[6,244],question:[8,9,12,13,287,298,358,455,519,524],queteschin:9,quick:[0,4,12,14,15,16,17,18],quickli:[3,4,8,12,13,39,100,225,231,246,251,335,385,386,388,395],quickmin:[263,287,293,384,385,386,388,511],quicktim:[4,206],quip:2,quit:[2,257,342,360,467],quot:[2,3,12,205,305,360,443,492,493,495,505,524],quotat:466,r0m:332,r10:399,r12:422,r_1:152,r_2:152,r_c:[410,412,421,482],r_cut:[399,442],r_d:518,r_e:419,r_ewald:319,r_fu:[440,441],r_i:[28,152],r_ii:152,r_ij:[28,399,418,456,489],r_ik:456,r_j:28,r_jik:456,r_m:442,r_me:410,r_mh:421,r_min:411,r_ub:19,r_x86_64_32:12,ra2:177,rad2theta:177,rad:358,radhi:500,radial:[65,75,106,107,124,127,152,162,164,169,219,256,272,284,295,331,341,386,418,425,448,450,451,497,500],radian:[19,20,23,27,31,34,35,37,129,177,185,196,199,316,361,363,367,370,497,500,507],radians:199,radiat:[130,177,347],radic:[180,497],radii:[75,80,119,126,152,228,232,407,416,422,423,440,441,446,462,464,488,500],radit:418,radiu:[2,3,6,40,42,65,75,80,92,93,97,98,119,124,126,130],radlo:500,rafferti:350,rahman:[6,7,229,269,271,272,307,455],rai:[9,16,177],ram:482,raman:15,ramirez:221,ramp:[2,3,6,9,65,161,162,166],ran:[3,6,11],random:[3,6,39,178,181,202,206,215,217,226,227,228,230,232,243,246,247,248,254,255,256,257,267,271,300,303,307,312,315,317,322,335,339,342,347,351,354,401,413,414,415,492,507,512,518,524,525],random_se:492,randomli:[178,181,217,232,246,254,303,335,357,511,512],rang:[1,3,6,7,8,9,10,12,14,15,17,37,39,56,63,75,76,81,96,117,119,120,121,123,127,128,133,152,153,164,172,177,179,182,183,190,199,203,204,206,207,216,217,227,231,232,246,248,266,303,319,335,336,342,343,348,350,377,378,386,389,390,393,395,397,399,400,401,402,403,404,405,407,409,410,411,412,413,415,416,418,420,422,424,425,426,428,431,432,433,434,435,436,437,438,439,440,441,442,443,446,447,448,449,453,456,459,460,461,466,475,476,478,479,482,483,487,488,489,491,495,506,507,515,528],rank:[6,11,12,251,348,375,494],rankin:276,raphson:3,rapid:[4,6,11],rapidli:[3,8,12,75,228,254,269,271,317,338,339,351,409,413],rapp:[308,309,310],rappe_and_goddard:309,rare:6,rasmol:[6,7],rasmussen:422,raster3d:[6,7],rate:[2,6,12,15,136],rather:[2,6,9,12,40,41,64,123,161,206,225,231,247,248,317,339,347,351,353,354,355,358,418,450,451,458,478,479,498,502,507,509,514,524],ratio:[6,61,95,111,152,217,225,231,254,256,335,343,350,351,377,391,422,423,460,470,484,494,497,507,511],rational:[348,509],rattl:[2,3,9,210,238,263],rattle:[3,9,210,238,248,287,293,321],rattle_debug:321,ravelo:[276,433],raw:15,rayleigh:[269,307],rb1:177,rbb:466,rbg:207,rcb:[3,41,225],rcm:[97,98],rcmx:[97,98],rcmy:[97,98],rcold:238,rcut:63,rcutfac:[152,467],rd1:388,rdc:16,rdf:[2,3,65],rdn:388,rdt:388,rdx:4,reach:[6,12,41,131,221,225,227,229,255,276,318,327,335,342,360,376,392,410,516,518,524],reacquaint:519,react:6,reactant:[318,418],reaction:[9,242,318,323,333,346,357,388,418,420,451,479],reactiv:[9,314,395],read:[2,3,6,7,8,9,11,12,13,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,36,37,38,40,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,58,61,126,176,178,179,181,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,200,202,203,204,206,207,208,209,210,216,217,228,229,231,232,241,242,246,248,251,268,269,271,273,274,275,276,277,278,279,291,292,294,295,296,299,300,302,303,305,306,310,317,318,321,323,327,330,334,337,345,346,347,353,359,361,362,363,364,365,366,367,369,370,371,372,373,374,376,383,387,388,392,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,414,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,449,450,451,453,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,484,485,486,487,488,489,490,492,494,497,498,499,501,502,503,504,505,507,508,509,511,524,525,526,527,529],read_data:[2,3,6,7,8,12,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,36,38,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,58,59,60,61,64,69,75,78,79,86,87,90,97,98,103,113,114,116,126,173,176,178,179,180,181,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,200,201,203,206,227,228,231,268,300,306,316,318,346,361,362,363,364,365,366,367,369,370,371,372,373,383,387,388,391,392,393,396,397,398,400,401,402,403,404,405,406,407,409,410,412,413,414,415,418,421,422,424,425,426,429,431,432,433,434,435,436,437,438,439,440,441,442,447,449,453,455,456,458,459,460,461,466,468,475,476,484,487,488,490,494],read_dump:[2,3,203,388,497],read_restart:[2,3,6,8,9,12,13,19,20,21,22,23,24,25,26,27,28,29,30,31,34,36,39,40,41,43,44,45,46,47,48,49,51,53,54,55,59,60,61,64,178,184,185,186,187,188,189,190,192,193,195,196,198,210,216,217,229,230,231,232,246,257,268,269,271,273,274,275,276,277,278,279,291,292,294,295,296,300,306,317,323,334,337,347,353,361,362,363,364,365,366,367,370,371,372,383,388,396,397,398,400,401,402,403,404,405,406,407,409,410,412,413,414,415,418,421,422,423,424,426,429,431,432,433,434,435,436,437,438,439,440,441,442,447,449,453,455,460,461,468,475,476,484,487,488,490,494,497,498],read_restart_set:8,readabl:[204,206,387,504,529],reader:[3,13,498],readi:[11,12,179,181,182,251,507,518,527,528,529],readme:[1,4,6,8,9,10,11,12,13,15,176,203,204,208,311,427,446,458,459,495],real:[3,6,7,11,26,29,30,61,75,99,100,117,152,167,178,187,202,207,215,231,232,235,251,252,255,268,300,307,312,315,351,352,354,355,357,366,377,378,380,384,390,409,446,448,458,459,482,497,500,506,514,517,523,525],realist:[3,232,501],realiz:[75,210,495],realli:[1,3,8,12,123,134,153,207,252,389,426,509,519],realloc:3,realtim:251,reamin:[352,356],rearrang:[204,388],reason:[3,6,7,11,12,18,39,159,170,178,197,219,254,304,317,344,345,348,358,387,388,393,406,410,418,419,421,441,448,484,486,501,506,525],reax:[0,2,3,4],reax_def:3,reaxc:7,reaxff:[3,4,5,7,9,13,210,308,310,313,314,426,458,459,476,509],rebal:[41,225],rebalanc:[41,225],rebo:[2,7,9,314],rebuild:[11,12,14,15,246,389,413,515],rebuilt:[3,12,203,204,205,206,208,389,393],recalcul:[75,95,335],receiv:[3,224,251,253,298,494],recent:[2,3,11,12,15,210,219,222,223,225,226,227,250,267],reciproc:[6,12,130,176,177,299,377,400,402,403,409,412,418,431,435,453,461,511],recog:12,recoginz:3,recogn:[3,12,77,180,226,227,271,318,387,416,443,458,495,497,504,505,518],recomend:6,recommed:318,recommend:[7,12,15,206,207,238,307,345,377,418,426,440,441,446,459,460,463,465,466,506,516,519],recompil:[1,3,9,12,208,321],recomput:[112,140,182,236,323,415,509],reconstruct:[3,230,466],record:[208,230,323],recov:[229,238,271],recreat:359,rectangl:[41,225,380],rectangular:[7,41,64,180,225,246,380,497,499,501],rectilinear:[130,177,204],rector:53,recurs:[41,225,399,484],recust:41,recv:494,red:[2,206,207,228,300],redefin:[3,499,505,524],redirect:12,redo:12,reduc:[1,2,3,6,12,16,17,18,26,41,65,75,96,120,121,123,124,125,126],reduct:[17,18,128,130,177,269,307,377],redund:419,ree:471,reed:[269,307],rees:[7,9,13],ref:[344,345,385],refactor:6,refer:[2,3,6,7,8,9,11,12,14,15,28,65,71,75,85,91,94,95,112,113,114,124,126,128,131,156,157,158,171,178,202,203,204,205,210,216,218,219,220,222,223,228,229,231,232,238,245,269,271,272,276,298,300,302,303,305,306,307,317,321,323,342,349,354,360,361,372,377,378,385,389,394,401,415,422,429,443,445,446,460,473,474,480,482,492,493,495,499,502,505,506,507,510,511,515],referenc:[3,6,12,65,71,75,125,131,203,204,210,220,246,306,349,378,409,425,452,460,495,515,524],reflect:[2,3,6,75,130,152,177,198,206,210,226,227,232,260,269,297,299,317,352,354],refman:9,reformat:7,refresh:216,reg:500,regard:[6,61,268,321,322,327,455,459],regardless:[14,75,178,181,202,222,231,254,271,273,274,275,277,278,279,304,317,328,335,393,494,500,507],regim:[6,343,350,410,506],region:[0,2,3,6,7],region_spher:8,region_styl:356,regist:[8,127,154,330],regoin:6,regress:524,regspher:178,regstrip:358,regul:6,regular:[1,3,41,64,96,176,180,203,206,217,225,246,306,347,378,410,429,494,497,499,501],reigon:524,reinder:15,reinhardt:[344,345],reject:[178,228,458,512],rel:[1,6,26,35,41,61,75,100,113,134,142,152,156,160,161,163,178,187,207,210,217,225,231,232,235,238,246,252,255,267,268,294,298,303,312,314,315,318,323,331,335,337,342,343,347,354,358,377,378,386,418,422,423,440,441,443,460,488,498,506,511,515,518,525],relat:[1,6,8,9,10,12],relationship:[6,241,308,360,377,466,488,518,524],relax:[2,3,4,6,7,210],releas:[0,5,7,8,13,226],relect:[3,448],reles:42,relev:[2,6,12,41,82,85,122,140,178,182,207,211,212,215,216,217,218,219,220,221,222,223,225,226,227,231,232,236,238,239,243,245,246,247,250,251,257,258,259,261,262,263,264,265,267,268,270,280,281,282,283,284,285,286,287,288,289,290,293,297,301,302,303,305,306,311,313,314,315,319,321,328,333,335,336,337,342,343,346,347,348,349,350,351,352,353,354,355,357,358,377,382,386,396,397,401,407,409,410,412,413,415,418,421,422,423,424,425,430,432,433,434,436,437,438,440,441,448,449,450,451,455,460,468,475,478,479,487,488,489,494,510,525],reli:[3,12,309,418,459,489,497,507],reloc:12,reltol:318,remain:[7,12,32,36,41,50,55,61,75,95,114,158,159,160,161,165,166,167,168,170,181,191,197,198,199,203,211,212,217,219,220,229,231,254,255,262,271,272,277,278,279,291,292,294,296,301,302,326,335,338,339,340,346,347,358,360,368,371,387,399,418,426,439,446,448,476,492,497,498,502,507,509,511,515,516,518,519,524,525],remaina:399,remaind:[9,178,203,232,303,335,348,482,497],remap:[3,6,12,61,63,75,161,178,202,231,252,268,294,377,497,498,499],remedi:[6,518],rememb:[2,519],remot:519,remov:[2,3,6,8,13,54,75,76,81,100,117,125,127,152,156,157,158,159,160,161,165,166,167,168,170,171,178,181,182,204,210,219,226,243,254,255,260,263,267,269,271,277,278,279,291,292,294,296,302,308,317,318,319,321,335,338,339,340,342,358,377,388,412,441,446,497,500,508,509,519,524,525],remove_bia:8,remove_bias_al:8,remove_molecul:216,remove_sourc:216,remove_speci:216,ren:177,renam:[12,359,508,519],render:[12,13,203,206,207],rendon:[271,272],reneighbor:[3,8,12,39,59,75,225,246,335,348,358,413,514,515],renssela:302,renumb:75,reorder:[3,12,39,494],rep:512,repeat:[2,6,206,207,228,229,246,318,327,380,399,480,482,484,492,511],repeatedli:2,repel:252,repes:203,replac:[2,3,6,11,12,41,65,97,98,128,155,156,157,158,159,160,161,164,165,166,167,168,170,171,203,204,206,207,208,219,220,222,223,225,228,232,254,276,305,306,312,314,353,393,395,409,423,433,450,451,478,498,499,504,505,515,524,525,527,529],replic:[2,3,7,380,494,497],replica:[0,2,3,4],replica_fil:12,report:[0,1],repositori:[7,9,12,427,457,458,459],reprens:347,repres:[1,3,6,8,9,12,14,40,41,42,61,70,74,75,98,124,127,129,190,199,203,204,206,219,220,221,222,223,229,235,242,247,249,254,257,271,300,302,304,312,317,318,319,323,331,332,347,349,356,378,388,394,399,422,429,439,440,441,443,444,445,453,456,458,459,483,484,492,494,497,507,509,512,518,524,527],represent:[3,6,8,9,59,61,146,180,203,247,248,300,347,399,418,422,446,460,497,500,518],reprocess:502,reproduc:[3,15,271,353,409,416,423],repul:443,repuls:[6,7,35,40,45,46,119,252,308,352,353,356,395,399,407,409,413,418,420,423,425,439,443,447,466,475,482,485,488,489,507],reqir:[308,310],request:[3,6,8,12,41,113,181,199,203,251,257,315,322,335,337,375,377,448,458,459,492,502,507,511,516,519,524,525,527],requir:[1,2,3,4,6,7,8,9,11],rerun:[2,3,7,76,81,100,117,127,152,203,206,448,498],rescal:[2,3,6,155,159,160,161,165,166,167,168,170,210,217,220,222,223,238,246,248,250,254,255,267,271,276,294,302,304,312,317,335,338,339],research:[5,7,88,89,240,257,261,322,446,492,511],resembl:[312,519],resepct:6,reserv:[12,251,518],reservoir:[99,238,246,250,254,347],reset:[2,3,6,8,11,12,63,69,75,78,79,86,87,97,98,103,113,114,116,173,182,210,211,212,229,231],reset_atomic_reference_posit:216,reset_dt:8,reset_target:8,reset_tim:216,reset_timestep:[2,6,99,498,502],resid:13,residu:251,residue1:389,resist:[6,251],resolut:[221,466,478,479],resolv:[229,300,335,441,519],resort:3,resourc:[7,394,416],respa:[3,15,213,214,224,233,236,237,249,251,252,266,271,298,309,316,320,323,331,332,333,334,351,352,356,391,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,440,441,442,443,444,445,446,447,449,450,451,453,455,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,487,488,489,490,505,506,516,517,524],respecifi:446,respect:[1,6,9,13,14,16,19,20,22,23,24,25,26,27,28,29,30,31,34,37,42,43,45,46,47,48,49,51,53,54,56,61,74,75,95,97,106,107,123,130,134,154,155,160,163,165,172,176,177,184,185,187,188,189,190,192,193,195,196,199,204,206,207,213,222,224,227,228,229,231,238,239,245,249,252,254,255,257,271,273,274,275,276,277,278,279,280,281,287,289,291,292,294,296,308,309,310,317,319,321,323,331,334,347,352,355,361,363,364,366,367,370,372,375,377,378,383,386,387,392,393,394,395,397,399,400,401,402,403,404,405,407,408,409,412,413,416,417,419,420,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,443,444,446,448,449,452,453,455,459,460,461,465,466,467,468,477,478,480,481,482,483,485,487,488,489,494,498,507,510,516,518,524,526,527,529],respon:9,respond:[6,7,161,231,418,455],respons:[6,7,269,343,350],resquar:[2,3,6,7,9,422],rest:[6,8,12,38,58,200,306,310,316,373,399,441,443,490,514,515,518],restart1:300,restart2:300,restart2data:[0,12],restart:[0,1,2,3],restartfil:[12,13],restor:[3,8,62,63,113,178,211,212,266,306,323,331,332,337,359,514,515],restore_bia:8,restore_bias_al:8,restrain:[2,3,28,210,217,246,269],restraint:[9,230,269,316,334,430],restratin:316,restrict:[1,2,3,6,8,9,12],result:[1,2,3,6,7,9,10,11,12,13,14,15,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,41,43,45,46,47,48,49,51,53,54,56,65,66,69,70,75,79,86,95,98,99,103,113,114,116,121,123,125,126,127,128,130,131,153,155,158,161,165,172,173,175,177,178,181,184,185,187,188,189,190,192,193,195,196,199,202,203,204,206,207,210,213,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,235,238,239,241,245,246,247,249,254,255,257,261,269,271,273,274,275,276,277,278,279,280,281,289,291,292,294,295,296,299,300,308,309,310,314,315,317,318,320,321,335,343,344,345,347,348,349,352,353,355,357,360,361,363,364,366,367,370,372,377,378,388,391,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,418,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,441,443,444,446,448,449,450,451,452,453,455,459,460,461,468,477,478,479,480,481,482,483,485,487,488,489,492,494,497,499,500,502,506,507,508,509,511,523,524,525],resum:524,retain:[2,226,227,395,399,446,494],retart:[32,50,191,368],retir:[3,458],retreiv:8,retriev:[6,8,244,444,445,524],reus:[3,509],rev:[6,13,66,74,100,117,121,152,153,166,217,248,254,256,269,271,272,276,294,299,309,312,317,323,335,339,342,344,345,350,385,399,407,408,409,412,416,417,418,422,423,428,433,440,441,442,443,445,450,451,456,460,467,477,480,481,482,485,492],revers:[2,6,8,95,189,228,252,271,289,297,298,308,327,343,344,350,388,439,506,518],review:[152,308,323,342,446,457,467,492,511,518,519],rewind:376,rewrap:203,rewrit:[5,12],rewritten:18,rezwanur:455,rfac0:[152,467],rfactor:335,rfile:317,rg0:333,rgb:207,rh3:177,rh4:177,rhaphson:3,rheolog:6,rhi:[450,451,478,479],rho0:[443,463,465,473,474],rho0_meam:443,rho:[2,3,40],rho_0:[473,474],rho_alpha_beta:416,rho_bkgd:443,rho_colloid:352,rho_e:347,rho_fin:346,rho_i:[444,445],rho_initi:346,rho_ref_meam:443,rho_wal:352,rhodo:[9,10],rhodopsin:[1,10,15],rhohi:303,rholo:303,rhosum:[2,110,469,470,471],rhot:238,rhs:318,ribier:385,richard:9,richardson:317,richi:[9,18],rick:[308,309,408,466],rick_and_stuart:309,ridg:[9,18],right:[3,6,11,12,41,74,154,178,196,198,202,204,225,228,252,257,268,297,298,318,360,380,409,497,500,507,519,524],rightmost:[41,225],rigid:[2,3,4],rigidid:129,rigidifi:317,rii:[97,98],rij:[100,117,226,227,298,413,414,450,451,475],rin:[425,436,437],ring:[2,3,6,127,184,300,302],rino:[77,485],rinv:377,rirj:[353,423],risi:[152,467],risk:[8,316,506],rix:[97,98],rjk:[226,227],rjone:[7,9,13],rk4:318,rkf45:318,rlo:[450,451,478,479],rmask:[3,524],rmass:[3,306],rmax:[75,179,226],rmdir:508,rmin0:[152,467],rmin:[75,179,227,433],rms:[318,377,378],rmsd:346,rnemd:6,robert:9,robin:207,robust:[384,385,386,459],rock:443,rockett:456,rod:317,rodata:12,rodnei:312,roi:7,role:[6,342],roll:12,ronchetti:117,room:[59,61],root:[11,95,97,98,205,342,346,416,504],rosati:39,rose:443,ross:443,rosski:300,rosybrown:207,rot:[6,99,300,316,342,525],rotat:[2,3,4,6,7,9,40,65,90,91,92,93,104,142,152,156,157,158],rotate:327,rotation:117,rotaton:500,rough:[6,178,206,357],roughli:[7,10,12,41,161,206,221,246,254,255,263,270,271,285,304,317,335,338,339,342,378,388,393,462,464,499,506],round:[1,3,12,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,42,43,45,46,47,48,49,51,53,54,56,75,123,155,165,184,185,187,188,189,190,192,193,195,196,199,207,213,224,231,239,245,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,309,310,317,320,321,355,361,363,364,366,367,370,372,378,391,394,395,397,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,429,431,432,433,434,435,436,437,438,439,440,444,449,450,451,452,453,455,459,460,461,468,477,478,480,481,482,483,485,487,488,489,499,500,506,523,524],rous:247,rout:[95,425,439],routin:[5,6,8,11,14,15,37,39,56,96,182,257,446,457,478,479,510],roux:[6,235,255,483,518],row:[6,68,69,71,73,79,84,86,98,102,103,114,116,119,125,126,127,129,131,158,166,173,175,176,177,219,220,222,223,260,317,347,349,357,418],royalblu:207,rozero:443,rperp:[268,327],rpi:302,rpm:12,rrespa:[1,3,5,7,8,15,211,212,268,271,389,394,395,396,397,398,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,440,441,442,443,444,445,447,449,450,451,453,455,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,487,488,489,490,506],rspace:3,rsq:[450,451,478,479,486],rsurfac:347,ru3:177,ru4:177,rub:19,rubia:[444,445],rudd:[448,478,479],rudra:[7,9],rudranarayan:[7,302],ruiz:217,rule:0,run1:[6,392,524],run2:[6,374,376,392,524],run3:[6,392,524],run4:[6,392,524],run5:[6,392,524],run6:[6,392,524],run7:[6,392,497,498,502,524],run8:[6,392,524],run:[0,1,2,3,4],run_styl:[2,3,7,8,9,12,15,17,271,272,355,386,389,391,393,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,440,441,442,443,444,445,446,447,449,450,451,453,455,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,484,485,487,488,489,490,491,492,494,505],rung:318,runloop:376,runtim:[12,16,206,393],russia:9,rutherford:347,rutuparna:[480,482],rxn:[318,479],ryan:9,ryckaert:[321,370],rycroft:176,rydberg:446,s00:455,s0st:6,s2050:1,s2629:416,s319:216,s_fact:324,s_i:[6,418],s_ij:6,sack:7,saddl:[270,388],saddlebrown:207,sadigh:[217,416,444,445],saed:319,saed_vtk:130,safe:[12,206,235,255,393,519],safe_zone:3,safest:[3,335],safeti:324,safezon:459,safran:488,sagui:[378,412],sai:[1,3,12,13,207,458,459,495,519],said:386,sakai:481,sall:[9,466],salmon:207,salt:[410,421,443,497],salter:466,same:[1,2,3,4,6,8,9,10,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,37,39,40,41,43,44,45,46,47,48,49,50,51,53,54,56,59,61,64,65,68,73,75,76,81,84,87,90,92,93,95,96,97,98,99,100,102,104,107,113,114,115,117,119,121,123,124,126,127,128,152,153,154,155,156,157,158,159,160,161,164,165,166,167,168,170,171,172,174,176,178,179,180,181,182,184,185,186,187,188,189,190,191,192,193,195,196,199,201,202,203,204,205,206,207,210,211,212,213,216,217,219,222,223,224,225,226,227,228,229,231,232,236,237,238,239,245,246,247,248,249,250,251,252,253,254,255,256,257,260,268,271,273,274,275,276,277,278,279,280,281,289,291,292,294,295,296,298,299,300,302,303,304,306,307,308,309,310,312,313,314,315,316,317,320,321,323,328,331,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,353,354,355,356,358,359,360,361,362,363,364,366,367,370,372,377,378,380,381,382,383,387,388,389,390,391,392,393,394,395,397,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,415,416,417,418,419,421,422,423,424,425,426,427,430,431,432,433,434,435,436,437,438,439,440,441,443,444,447,448,449,452,453,455,456,459,460,461,466,468,475,476,477,478,480,481,482,483,485,487,488,489,492,494,495,497,498,499,500,502,505,506,507,508,509,510,511,515,518,519,523,524,525,528],sampl:[1,2,4,6,9,11,12,99,113,156,157,171,176,202,206,210,219,220,230,232,244,246,248,250,271,272,293,300,303,312,314,319,331,333,335,339,342,345,357,389,399,415,497,511],sample_frequ:216,san:455,sandia:[0,5,7,9,13,16,74,122,419,443,455],sandybrown:207,saniti:[316,389],satellit:[6,160],satifsi:524,satisfi:[3,12,77,130,152,177,229,238,257,263,276,287,293,321,355,386,389,423,511],satur:410,save:[6,8,12,18,40,61,199,204,206,221,228,247,248,254,255,256,303,312,318,347,359,378,389,391,399,499,502,509],sb3:177,sb5:177,sc3:177,scalabl:[0,1,7,9],scalar:3,scalars:319,scale:[0,1,3,5,6,9,10,13,15,17,40,61,65,75,76,99,112,124,127,128,152,164,172,184,199,202,203,204,206,207,210,211,212,216,217,220,229,231,246,250,251,252,254,256,257,269,271,273,274,275,276,277,278,279,300,304,307,308,317,325,326,335,337,339,342,344,345,347,351,358,377,378,380,387,390,394,395,396,410,415,418,420,423,426,440,441,443,446,455,462,464,483,498,500,502,506,509,511,514,515,524,525],scale_factor:[462,464],scalegamma:257,scalexi:[3,229,271,276],scalexz:[229,271,276],scaleyz:[229,271,276],scan:[207,227,376,498],scatter:[11,130,177],scatter_atom:11,scatter_coord:11,scenario:[6,40,63,228,306,315,335,348,356,389,501,502,506,514],scf:518,schaik:439,schedul:492,schell:481,schemat:228,scheme:[6,9,17,247,248,271,289,300,312,321,347,377,459,483],schlitter1:346,schlitter2:346,schlitter:346,schmid:413,schneider:[254,256],schoen:377,schroding:418,schroeder:[117,518],schulten:[255,323,378,518],schunk:335,schwen:9,sci:[77,355,408,445,456,466],scienc:[8,216,228,251,298,323,344,416,444,466,481],scientif:[9,152,416,524],scm:11,scratch:[12,41,225],screen:[0,1,3,6,8,11],screenshot:11,scripe:11,script:[0,1],scripta:70,scsl:12,sdk:[2,3,9,14],sea:11,seagreen:207,seamlessli:306,search:[0,2,3,8,12,100,117,179,181,207,208,335,353,384,385,386,388,390,423,492,498,499,511,524],seashel:207,sec:[12,517,523],secant:242,second:[1,3,6,9,11,12,15,54,59,61,63,74,75,96,99,113,115,117,123,145,146,150,153,154,166,172,176,177,179,180,181,197,202,203,207,210,211,219,220,222,223,228,238,242,246,247,252,268,270,300,306,314,316,317,321,323,331,333,335,344,345,347,358,377,380,385,386,388,389,398,399,400,402,403,408,409,416,418,419,420,423,424,426,429,430,433,443,448,452,466,477,481,482,483,485,489,492,493,494,495,497,499,504,506,510,511,515,516,518,523,524,525,527,529],second_mo:466,secondari:[3,190],sectinn:528,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,29,30,31,32,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,53,54,55,56,57,58,60,61,65,66,67,68,69,70,71,72,73,75,78,79,82,83,84,85,86,87,88,89,91,94,95,96,97,98,99,101,102,103,106,107,108,109,110,111,113,114,115,116,118,119,122,123,124,125,126,129,130,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,154,155,156,157,158,159,161,162,163,164,165,166,167,168,169,170,171,172,173,174,176,177,179,184,185,186,187,188,189,190,191,192,193,195,196,197,198,199,200,202,203,204,205,206,208,210,213,214,215,216,217,219,220,221,222,223,224,225,226,227,228,230,231,232,234,235,237,238,239,240,241,242,243,245,246,247,248,249,251,253,254,255,256,257,258,259,260,261,263,264,265,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,304,306,307,308,309,310,311,312,313,314,317,318,320,321,322,323,324,325,326,327,328,330,335,338,339,340,341,342,343,344,345,346,347,348,350,353,354,355,358,359,361,362,363,364,365,366,367,368,370,371,372,373,378,379,380,383,387,388,390,392,393,394,395,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,448,449,450,451,452,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,492,493,494,495,497,498,500,502,505,506,507,508,510,511,512,515,516,518,524,525,526],section_acceler:[9,12,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,123,155,165,184,185,187,188,189,190,192,193,195,196,199,213,224,231,239,245,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,309,310,317,320,321,355,361,363,364,366,367,370,372,378,394,395,397,400,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,444,449,452,453,455,459,460,461,468,477,478,480,481,482,483,485,487,488,489,500,506],section_accerl:416,section_command:[0,1,9,360],section_error:[7,12],section_exampl:[2,6],section_histori:[7,12],section_howto15:89,section_howto:[6,8,9,11,12,40,42,59,61,66,69,70,71,74,75,76,77,79,80,81,82,85,86,87,90,91,92,93,94,95,97,98,100,103,104,105,106,107,108,109,110,111,114,116,117,120,121,122,125,127,128,132,147,148,149,150,152,153,158,160,172,173,175,176,180,201,219,270,283,286,290,350,398,411,492,497,500,511],section_modifi:[6,7,42,203,204,206,515],section_packag:[12,459],section_perf:7,section_python:[6,12],section_start:[3,6,9,11,381,388,491,492,506,512,515],section_tool:[6,7],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,39,40,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,59,60,61,63,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,263,264,265,266,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,320,321,322,323,324,325,326,327,328,330,331,334,335,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,374,377,378,380,381,382,383,385,386,387,388,389,390,392,393,394,395,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,490,491,492,493,494,495,497,498,499,500,502,503,504,505,506,507,509,510,511,512,513,514,515,516,517,518,519,524,525,527,528,529],seed1:512,seed2:512,seed:[3,178,181,202,206,215,217,226,227,228,230,232,243,246,247,248,254,255,256,257,300,303,307,312,317,335,339,342,347,354,401,413,414,415,492,507,512,518,524,525],seed_com:255,seed_drud:255,seek:[41,225],seem:[6,229,348,385,443,506],seen:[12,15,257,356],segement:3,segment:[3,6,7,12,40,42,90,124,206,210,286,303,317,335,413,429,459,475,476,497,505,507],select:[3,6,9,12,14,61,63,75,128,130,167,172,177,178,199,206,208,215,217,231,232,243,246,251,252,266,268,323,334,342,343,348,350,352,354,355,357,375,377,384,388,390,393,425,430,443,466,494,498,500,506,507,511,516,524],self:[2,3,4,6,8,9,12,128,203,204,205,210,213,218,219,222,233,235,237,255,307,308,310,312,313,316,317,318,323,331,332,333],sellerio:13,semi:[3,208,216,217,297,299,498],semiax:156,semimet:418,semin:15,send:[0,3,5,7,8,11,12,207,251,494],sender:[3,494],sens:[1,3,6,7,17,39,41,42,61,75,113,198,203,219,222,223,225,228,231,247,248,253,254,255,256,303,307,312,319,335,342,343,347,350,358,388,409,431,435,480,481,482,492,497,502,506,509,514],sensabl:251,sensibl:114,sensit:[2,6,77,229,312,525],sent:[207,251,375],sep:[6,11,524],separ:[2,3,6,7,9,12,13,15,40,41,80,127,134,152,178,181,197,204,206,207,208,216,220,225,226,227,228,229,232,235,246,254,255,271,285,300,303,304,306,308,312,317,321,335,338,339,340,343,350,358,378,393,400,402,409,410,412,414,431,440,441,443,450,451,452,457,467,476,477,478,479,482,488,495,497,498,499,506,509,514,516,518,525,526,527,528],seper:410,sequec:524,sequenc:[2,3,12,41,61,203,204,206,207,208,225,248,270,358,380,388,426,456,512,524],sequenti:[61,62,207,456,498],sequestr:7,seri:[3,4,6,9,13,15,17,152,203,204,206,207,220,223,247,248,303,392,395,422,443,446,448,450,451,460,468,478,479,495,504,505,512,514,515,524],serial:[1,5,7],serial_icc:12,serious:8,serv:[6,140,180,335,475],server:[1,253],set:[0,1,2,3],set_callback:244,set_energi:244,set_vari:[6,11,495],setarea:257,sete:[219,228],setenv:[11,12,406],setfl:[13,394,416],setforc:[2,3,6,210,213,224,245,288,317],setgamma:257,setmask:8,settl:229,setup:[3,6,7,8,11,12,13,15,36,40,55,61,75,95,99,166,179,180,181,182,198,207,216,228,231,335,348,371,389,390,393,476,494,497,505,527,529],setup_pre_exchang:8,setup_pre_forc:8,setup_pre_force_respa:8,setvel:2,seven:445,seventh:[145,150],sever:[1,4,5,6,7,8,9,10,11,12,13,14,15,17,39,40,65,75,95,172,179,182,198,203,204,205,208,210,216,226,227,229,248,254,257,261,271,302,304,306,317,323,335,342,351,375,380,386,396,399,403,415,416,426,435,439,443,448,456,458,459,465,466,492,495,499,503,511,515,518,524,525],sexton:446,sfactor:[3,206,207,387],sfftw:12,sgi:12,sgmc:217,sgrid:335,sgroup:176,shade:206,shake:[2,3,5,6,7,8,9,28,37,38,56,58,68,73,123,126,153,155,156,157,158,159,161,164,165,166,167,168,170,171,182,210,219,232,238,246,248,285,303,317],shan:[16,308,309,408],shanghai:[9,13],shape:[2,3,6,8,40,41,60,61,64,75,90,124],shape_upd:8,shapei:[124,497],shapex:[124,497],shapez:[124,497],shapshot:502,shardlow:[2,9,240,241,318],share:[0,1,3,6,7,9],sharon:317,sharp:[356,443,482],shawn:9,shear:[3,4,5,6,7,9,61,63,161,202,229,231,257,271,294,335,350,353,423,440,441,455,463,465],sheet:501,shell:[0,2,3,4],shen:9,shenderova:395,sheppard:385,shflags:12,shield:[2,3,7,210],shift:[1,2,3,6],shiftse:335,shiga:[6,271,272],shini:[206,528],shinoda:[6,9,271,272,461],shiny:206,ship:208,shlib:[11,12],shlibflags:12,shm:15,shock:4,shockvel:[269,307],shortcut:[229,271,304,317],shorter:[3,131,246,298,390,448,505],shortest:[206,390,396,506],shorthand:[207,483],shoul:484,should:[1,2,3,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,34,37,39,40,41,42,43,44,45,46,47,48,49,51,53,54,56,61,63,74,75,77,87,91,95,99,106,107,108,112,113,114,121,123,129,153,155,156,157,160,161,164,165,166,168,171,174,178,180,182,184,185,186,187,188,189,190,192,193,195,196,199,201,202,203,204,206,207,211,212,213,214,217,221,224,225,226,227,228,229,231,232,234,235,237,239,241,243,244,245,246,247,248,249,250,252,254,255,256,257,259,260,261,262,268,271,273,274,275,276,277,278,279,280,281,285,289,291,292,294,296,298,299,300,301,302,303,304,305,307,308,309,310,311,312,313,314,315,316,317,318,320,321,328,331,335,336,338,339,340,341,342,343,346,347,348,350,351,352,353,354,355,356,357,358,360,361,362,363,364,366,367,370,372,377,378,380,381,382,384,386,387,388,389,390,391,393,394,395,397,398,400,401,402,403,404,405,406,407,408,409,411,412,413,415,416,417,418,419,421,422,423,424,425,426,427,428,429,431,432,433,434,435,436,437,438,439,440,441,443,444,446,448,449,450,451,452,453,454,455,457,458,459,460,461,462,464,466,468,475,477,478,479,480,481,482,483,485,487,488,489,492,493,494,495,497,498,499,500,501,502,504,505,506,507,509,513,514,515,516,518,519,524,525,527],shouldn:[3,8],show:[6,10,11,12,127,388,425,443,446,478,479],shown:[1,12,15,16,41,106,107,130,152,164,177,198,225,228,238,254,271,294,298,300,303,312,342,377,418,419,422,423,439,446,460,466,497],shrank:75,shrink:[3,6,41,59,61,75,180,202,203,206,211,212,215,225,231,232,252,257,298,335,354,358,377,378,386,409,431,435,448,497,498],shrink_spher:287,shrunk:[75,318],shut:[6,11,389,496],si4:177,siam:355,sic:[4,409,426,443,452,477,480,482,485],sic_tersoff:456,sicc:[417,477,480,482,485],sicg:[480,482],sicsi:[417,477,480,482,485],side1:500,side2:500,side3:500,side4:500,side:[3,8,41,59,63,75,168,178,217,218,225,228,232,246,252,257,268,298,303,311,318,331,352,356,357,358,388,409,422,423,460,484,495,497,500,507],sidewai:4,sienna:207,siepmann:350,sige:[480,482],sigma0:399,sigma14:439,sigma1:399,sigma2:399,sigma:[3,6,10,45,46,50,54,95,129,184,203,204,207,211,212,232,246,257,298,322,335,351,352,356,380,390,393,395,398,399,400,404,405,407,412,413,414,415,417,418,422,424,425,429,430,431,432,433,434,435,436,437,438,439,442,447,448,460,461,471,477,483,484,506,523,524,525],sigma_14:404,sigma_:410,sigma_c:407,sigma_cc:[395,407],sigma_h:421,sigma_i:[419,448],sigma_ii:484,sigma_ij:[448,484],sigma_j:448,sigma_max:415,sigma_ss:407,sign:[3,6,12,189,198,297,331,355,360,446,505,514,519,524],signal:496,signicantli:16,signifi:[3,69,79,86,98,103,114,116,125,158,173,175,420,451,479],signific:[7,12,17,94,247,269,272,312,318,335,348,418,422,443,446,448,527],significantli:[1,6,39,153,176,257,271,316,418,477],sij:220,sikandar:16,silbert:423,silent:[207,495,508],silicon:[417,443,477,497],sill:455,silver:207,sim:[9,461],similar:[5,6,7,8,9,10,11,12,15,16,17,40,41,42,46,61,71,76,95,123,126,127,129,153,154,178,179,203,204,207,210,211,212,219,221,225,244,245,247,254,260,261,272,306,307,312,316,317,339,342,352,353,355,357,378,384,385,387,395,398,399,413,416,418,423,439,440,448,449,455,456,465,478,483,494,499,504,506,511,513,515,518,524,525,527,529],similarli:[3,6,7,8,38,58,61,123,174,180,182,200,202,203,206,207,218,219,222,223,227,231,237,252,271,273,274,275,277,278,279,302,304,317,319,321,335,342,343,350,356,361,373,378,380,388,391,395,403,423,435,477,490,494,497,500,501,506,507,511,524,528],simluat:[6,39,207,335,440,498,499],simlul:[317,347],simmul:350,simpl:[1,2,4,6,7,8,10,11,12,13,15],simpler:[8,11,42,207,317],simplest:[3,8,9,40,69,79,86,98,103,114,116,125,127,158,173,175,308,518],simpli:[1,3,6,8,9,11,12,16,40,69,75,79,86,96,98,103,105,114,116,124,125,129,131,158,173,175,181,182,207,210,211,212,219,222,223,227,229,231,235,244,253,255,260,271,300,304,315,317,319,343,349,350,377,378,380,387,388,393,403,412,426,435,443,448,494,495,502,505,512,515,523,524],simplif:418,simplifi:[9,217,316,446],simplist:11,simualt:378,simul:[0,1,2,3,4],simulatan:[15,246,393],simulation_nam:459,simulationub:466,simulatoin:[12,498],simult:393,simultan:[6,7,14,15,231,393],sin:[197,231,268,352,355,357,382,456,497,500,507,524],sinc:[0,1,2,3,6,8,9,10,11,12,13,14,20,21,32,39,41,44,54,61,63,66,70,74,75,77,97,98,121,127,129,130,154,156,158,168,176,180,181,183,184,186,191,203,204,206,207,210,211,212,213,214,217,218,219,220,221,222,223,224,225,228,229,230,231,232,236,237,246,248,250,253,254,256,257,268,271,273,274,275,276,277,278,279,282,285,294,298,300,303,305,306,312,315,317,318,323,334,335,343,347,348,349,350,352,353,356,357,358,359,361,362,376,378,386,387,388,389,392,393,394,395,399,402,403,404,405,407,408,412,413,415,416,417,422,423,424,426,427,428,429,430,431,433,434,435,436,437,438,439,440,441,442,443,444,445,446,448,450,451,453,456,457,458,459,460,461,466,467,468,477,478,479,480,481,482,485,489,492,494,495,497,498,500,502,505,506,507,508,509,511,515,518,519,523,524,525,528],sinclair:[7,298,416,476],sine:456,singapor:152,singh:394,singl:[1,2,3,6,7,8,9,10,11,12,14,15,16,17,40,41,42,59,61,63,65,68,69,71,73,79,81,84,86,95,96,98,102,103,113,114,116,119,124,125,126,127,128,129,131,154,158,173,175,176,178,197,203,204,206,207,208,210,215,218,219,220,222,223,225,227,228,229,232,235,243,245,250,257,260,268,271,272,276,285,287,293,300,302,303,305,316,317,319,321,324,330,335,337,347,349,352,353,355,357,358,360,377,378,384,387,388,389,390,392,393,394,395,399,404,406,408,415,416,417,418,419,423,424,425,426,427,428,443,444,445,446,452,453,456,457,458,459,460,466,467,468,477,480,481,482,485,492,493,495,497,504,505,506,507,508,509,510,511,512,514,516,524,528,529],singleel:399,singular:[197,439,440,441,449],sinnott:[309,395,408],sinusoid:[178,231,352,353,355,357,382],sio2:485,sio:408,sirk:[153,475],sisic:[417,477,480,482,485],sisisi:[417,477,480,481,482,485],sister:406,sit:[299,497],site:[0,1,2,3,4,5,6,7,8,10,11,12,13,14,16,70,74,95,238,251,257,258,321,378,394,399,409,416,420,421,431,435,439,449,451,453,479,483],situat:[176,229,246,257,271,300,319,385,399],sival:177,six:[6,145,150,152,220,222,452,456],sixth:452,sixthpow:[405,448],size:[0,1,3],size_restart:8,sizei:429,sizej:429,sizescal:3,sizex:279,sjplimp:[0,7,11,12],sjtu:9,skew:[3,6,60,61,180,206,231,271,497,500],skin:[3,12,39,63,77,126,179,181,246,285,317,322,347,389,390,393,429,454,515,523],skip:[12,15,32,129,184,191,302,303,376,387,392,430,497,502,505,514,516,524],skyblu:207,slab:[3,6,75,166,303,331,377,378,389,448],slateblu:207,slategrai:207,slater:[2,3,7,210],sleight:54,slepoi:443,slice:[2,3,6,65,130],slider:11,slight:[3,12,238,347],slightli:[1,6,15,39,40,203,204,205,206,208,271,289,312,317,378,395,409,431,435,458,480,482,485,492,505,527],sligthli:412,sliozberg:475,slip:[3,210,335,351,357],sllod:[2,3,6,15,161,162,210,231],slope:[6,113,114,343,345,350,410,524],slot:[1,154,516],slow:[3,6,7,12,39,247,251,254,255,269,271,287,335,342,377,388,448,466,506,516,518,525],slower:[1,16,39,255,378,393,399],slowest:[347,494],slowli:[12,75,225,351,386,446,468,499],slurm:12,slurm_localid:12,sm3:177,small:[2,3,4,6,7,8,9,12,14,16,17,39,40,41,60,74,85,95,121,129,130,153,158,161,176,177,180,203,204,210,219,225,226,227,228,232,233,235,238,246,247,254,255,263,269,271,289,294,298,303,304,306,307,308,312,314,315],smallbig:3,smaller:[1,3,6,12,15,16,39,56,61,63,75,131,180,203,204,206,207,217,232,236,246,257,299,317,318,335,345,360,377,378,384,393,448,476,484,486,497,504,506,516,524,529],smallest:[3,42,74,75,76,176,269,314,524],smallint:3,smallq:378,smallsmall:[3,12],smart:248,smd:[2,3],smd_lammps_userguid:9,smi:3,smirichinski:9,smit:246,smith:453,smmoth:507,smooth:[2,6,9,40,109,111,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,324,325,326,327,330,356,357,377,399,404,409,424,433,436],smoother:178,smoothli:[54,152,343,350,404,424,437,439,442,482,489],smpd:12,smt:[15,393],smtb:[9,466],smtbq:2,smulat:446,sn2:177,sn4:177,sna:[2,3,9,65],snad:[2,3,9,65],snap:[2,3,4,7],snapcoeff:467,snaphot:502,snapparam:467,snapshot:[0,1,3,4],snav:[2,3,9,65],snb:16,snc4:15,snow:207,soc:425,socket:[12,16,17,253,494],sodani:15,soderlind:446,soft:[2,3,7,9,11,12,13,95,211,212,285,355,386,413,420],softer:[352,356],softwar:[1,6,9,11,14,15,16,17,18,176,251,302,319],sole:[226,227,388,456,463,465],solid:[4,6,7,9,10,39,40,41,61,74,77,99,113,153,176,216,225,229,231,236,260,271,273,274,275,277,278,279,298,299,304,317,342,345,378,380,400,433,446,455,463,465,497],solut:[3,6,13,176,229,236,269,315,318,321,335,356,524],solv:[3,9,12,17,238,257,308,318,321,345,347,378,385,441],solvat:[4,10,178],solvent:[4,7,9,13,63,75,179,181,225,243,247,248,254,271,315,317,331,335,343,350,351,404,407,409,410,421,431,440,441,460,476,497,507],solver:[0,1],some:[1,2,3,4,6,7,8,9,11,12,13,15,16,17,39,40,41,55,63,65,75,115,118,124,128,129,131,156,157,158,159,170,171,172,176,178,181,186,189,198,201,203,204,206,207,210,211,212,215,217,218,219,220,222,223,225,227,228,229,230,243,246,269,271,272,303,305,306,308,310,317,318,323,336,342,347,348,349,351,352,358,375,376,377,378,384,385,386,387,388,389,390,393,396,398,399,406,409,416,418,426,429,446,448,458,459,476,478,479,490,492,494,495,496,497,499,502,503,504,505,506,507,509,511,514,515,516,519,523,524,525,526,529],somehow:3,someindex:359,someon:[7,386],someth:[2,3,7,8,11,12,61,229,271,352,355,357,389,426,495,504,519],sometim:[2,3,6,8,12,17,229,271,343,350,377,390],somewhat:[7,9,12,74,113,158,168,219,271,377,516],somewher:[16,272,418],soon:[3,42,217,228,243,246,251,458],sophist:[7,154],sorensen:511,sort:[3,13,15,39,75,203,204,207,208,251,388,389,415,498,499,528],sound:[140,257,269,324,473,474],soundspe:[473,474],sourc:[0,3,5],source_integr:216,sourceforg:11,south:152,souza:343,space:[2,3,6,8,11,12,15,17,41,57,61,75,130,152,167,172,177,178,199,202,206,211,212,215,222,225,227,231,232,252,257,265,268,271,299,300,315,319,324,335,352,354,355,357,360,377,378,380,387,388,389,400,402,403,409,412,416,418,429,431,435,443,446,450,451,453,456,461,478,479,486,488,494,497,500,509,515,518,524,525],spahn:423,span:[2,12,37,75,211,212,238,252,317,377,394,395,399,408,416,419,427,428,443,444,445,452,456,467,477,480,481,482,485,491,492,500,501,524],spars:[75,199,318],spatial:[3,5,6,7,17,39,41,69,74,75,79,86,98,103,114,116,125,142,158,166,173,175,203,204,213,216,219,220,223,225,237,250,254,320,328,332,347,462,464,507,525],spawn:251,spc:0,spce:238,spcpu:515,speak:[16,335,342],spearot:[130,177,319],specfi:[12,118,252,266,500],speci:[2,9,152,205,242,253,313],special:[2,3,6],special_bond:[2,3,6,12,15,36,45,46,54,55,76,81,100,117,119,126,127,152,179,181,182,184,198,226,227,228,371,387,389,411,425,426,448,483,497,499],species1:[242,451,479],species2:[242,451,479],species:318,speciesn:242,specif:[1,2,3,4,6,7,8,9,12,13,14,15,16,17,21,28,32,40,41,42,50,65,75,119,124,126,127,158,160,163,176,178,186,191,203,204,206,207,208,210,211,212,215,216,219,220,222,223,225,228,230,243,244,246,247,251,257,266,303,305,306,309,317,342,347,348,352,358,362,378,386,388,393,395,398,399,411,416,422,423,426,427,428,443,446,448,458,459,460,476,477,483,484,494,497,498,502,503,504,506,507,513,514,515,523,524,525,527],specifi:[2,3,6,7,8,9,11,12,13,14,15,16,17,19,20,21,22,23,24,25,26,27,28,29,30,31,32,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,53,54,55,56,57,58,59,61,63,65,67,68,69,71,72,73,74,75,77,79,80,81,82,83,84,85,86,87,91,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,126,127,128,129,130,131,132,153,155,158,160,165,166,167,172,173,174,175,176,177,178,179,180,181,182,184,185,186,187,188,189,190,191,192,193,195,196,198,199,200,202,203,204,205,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,235,236,237,238,239,241,242,245,246,247,248,249,250,252,253,254,255,257,258,259,260,262,263,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,285,289,291,292,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,312,313,314,315,316,317,318,319,320,321,322,323,327,328,331,332,333,334,335,336,337,338,339,340,342,345,346,347,349,351,352,353,354,355,356,357,358,359,360,361,362,363,364,366,367,368,370,371,372,373,376,377,378,380,381,383,386,387,388,389,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,518,519,523,524,525,526,527,528,529],specifii:[248,257],speciti:506,spectral:[9,467],spectrum:[9,152,307,312],sped:[39,269],speed:[1,3,6,9,12,14,15,16,17,18,39,41,140,203,207,225,254,257,269,307,324,335,342,348,354,377,378,388,393,399,409,446,448,473,474,480,492,506,512],speedup:[1,15,17,378,506],spefici:[178,206,425],spell:500,spellmey:[6,184,509],spend:[12,218],spent:[1,12,13,14,492,511,516],sperhic:497,sph:[2,7],sph_lammps_userguid:9,sphere1:257,sphere:[2,3,6,40,42,65,75,80,90],spheric:[0,2,3,4],spheriod:[3,6],spherioid:335,spheroid:[6,271,289,317,335],spike:127,spin:[40,124,204,353,396,418,497],spine:382,spine_two:382,spirit:[7,221],spit:3,spline:[2,3,37,56,199,241,242,386,395,399,425,443],split:[1,3,6,9,11,12,15,17,41,219,225,238,255,271,322,355,377,393,414,484,491,494,506],splittol:[6,377],spparks:6,spread:[1,6,12,360,505],spring:[2,3,5,6,7,10,13,25,26,40,45,46,48,49,53,187,197,210,213,228,233,237,270,300,315,323],springer:323,springgreen:207,sptial:75,sputter:232,sq2:[3,380],sqrt:[2,3,42,61,87,97,117,246,254,256,298,335,351,353,380,382,407,413,416,421,423,443,448,524],squar:[2,3,6,7,12,21,23],squares:[41,225],squeez:[229,252,440,441],squibb:[5,7],sr2:177,src:[0,1,3,4,6,7,8,9,11,12,14,15,16,17,18,176,203,244,321,446,519],srd:[2,3,4,7],srmax:75,srmin:75,srolovitz:416,srp:[2,413],srtio:466,srun:12,ssa:322,ssao:[206,528],stabil:[6,9,254,271,399,458,483],stabl:[6,66,140,197,257,276,316,324,399,518],stabli:247,stack:[3,8,74],stage:[3,8,95,210,244,270,311,358,388,492,511,524],stagger:[1,2,3,207,378,504,513,524],stai:[3,16,211,212,269,288,307,393,497],stall:15,stamp:[210,342,498],stamped:12,stan:[9,16],stand:[0,6,7,9,12,13,313,458,459,495],standard:[0,1,3,6,8],stanford:9,starikov:347,start:[0,3,4,6,8,9],start_6:421,start_7:506,startstep:524,stat:[12,40,54,182,298,312,386],statcoul:523,statcoulomb:523,state:[2,3,6,7,9,11,12,13,61,63,65,74,77,85,87,94,95,113,122,142,190,206,210,217,221,228,229,230,232,240,241,242,246,247,248,254,255,256,269,270,271,273,274,275,276,277,278,279,291,292,294,295,296,299,303,307,312,317],statement:[3,495,496,519],stationari:[2,113,257,264],statist:[3,6,12,33,39,41,52,66,194,221,226,227,228,247,248,254,255,256,302,303,307,312,317,318,321,335,346,347,348,369,386,388,395,413,415,423,440,488,492,499,505,507,511,514,515],statu:[3,12,54,62,133,182,230,235,255,408,496,511,516],statvolt:523,std:12,stdin:[3,12,376],steadi:[6,269,276,307],steelblu:207,steep:[478,479],steepest:[7,385],steer:[7,9,230,233,323],stefan:9,stegailov:347,steinhardt:[65,117],steinhaus:518,stencil:[3,257,377],step:[1,2,3,6,8,9,11,12,13,14,15,16,17,18,39,75,99,106,107,121,127,128,140,153,164,174,176,203,205,206,207,208,210,211,212,216,217,219,220,221,222,223,225,226,227,228,229,231,232,235,236,238,243,244,246,248,251,252,255,263,269,285,287,293,298,299,303,305,306,307,308,309,310,318,319,321,322,323,324,335,337,340,341,342,343,344,345,346,347,348,349,350,357,358,360,376,377,384,386,388,389,395,413,421,425,443,446,458,459,466,492,494,495,499,501,502,504,505,506,511,512,514,515,516,518,524,529],stepani:323,stepwis:95,stesman:342,steve:[0,5,7,13],steven:228,stiff:[6,40,51,226,227,299,300,318,386,455,518],stile:410,still:[1,3,6,9,11,12,13,15,16,37,38,41,58,63,75,100,119,127,176,182,199,200,201,203,204,207,211,212,225,250,254,285,308,312,335,347,360,373,377,378,384,405,416,422,423,426,430,440,454,458,460,468,476,497,499,505,519],stilling:[3,5,7,9,14,96,154,417,445,456,476,477,485,509],stipul:251,stl:[9,75,327,330],stl_surf:330,stochast:[4,7,9,210,248,322,335,342,357,414,415],stockmay:40,stoddard:412,stoichiometr:318,stoichiometri:466,stoke:[257,351],stokesian:9,stoll:[254,256],stone:[9,18,378,412],stop:[3,6,11,12,41,54,131],stopstep:524,stopthresh:[41,225],storag:[3,12,14,349,393,509],store:[2,3,6,7,8,11,12,16,32,36,37,39,40,42,50,55,56,61,63,64,65,68,71,73,75,80,84,87,90,92,94,97,99,100,102,113,114,118,119,123,124,125,126,128,129,131,153,155,156,157,158,159,160,161,165,166,167,168,170,171,174,176,178,181,191,198,199,201,203,205,206,207,208,210,211,212,215,216,218,219,220,221,222,223,226,227,231,232,236,239,244,247,251,257,258,259,260,261,262,263,264,265,267,268,270,271,273,274,275,276,277,278,279,280,281,282,283,284,286,287,288,289,290,291,292,293,296,297,298,299,300,301,302,303,304,305,306,308,309,310,311,313,314,317,318,319,321,323,330,331,332,333,334,335],store_st:336,storm:12,stouch:7,str:524,straatsma:6,straddl:[3,61,63,168,252,317,331,358,497,507],straight:317,straightforward:[4,13,418,518],strain:[2,3,6,61,85,133],strang:[199,206,524],strategi:0,stratford:257,strcmp:360,stream:[3,6,123,153,158,161,162,206,216,231,247,248,254,255,294,303,312,335,525],streamlin:[12,505],streitz:[2,3,4,7,308],streiz:409,strength:[3,9,152,172,183,206,316,352,356,426,459,460,509],stress:[2,3,5,6,7,9,40,42,65,99,121,123,143,144],stretch:[3,54,61,128,226,323],strict:467,strictli:[6,41,199,225,269,307,342,497],stride2:524,stride:[207,248,504,513,524],strietz:409,strike:232,string:[2,3,6,11,12,41,178,203,204,205,207,219,220,221,222,223,225,246,305,318,319,360,379,392,443,456,457,458,467,493,495,497,507,508,514,515,524],strip:524,strong:[10,308,395],stronger:6,strongest:[440,441],strongli:[1,6,13,232,317,321,347,446,518],structrur:3,structur:0,structured_points:319,strucur:77,stuart:[308,309,395,408,466,476],stub:12,stubs:12,stuck:229,student:302,studi:[6,115,287,306,433,466],studio:15,stukowski:[217,416],style1:[32,50,191,368,426,497],style2:[32,50,191,368,426,497],style:0,style_nam:[271,272],stylecomput:466,stylist:8,sub1:508,sub:[1,3,4,6,7,8,9,11,12,13,17,32,36,39,40,41,42,50,55,60,63,65,67,71,72,83,95,99,101,118,152,172,180,191,198,205,206,207,211,212,225,229,231,271,272,276,307,312,321,322,347,348,356,358,368,371,380,383,393,395,398,408,415,422,423,425,426,429,448,458,459,460,466,483,484,489,494,497,500,506,514],sub_styl:[67,72,83,101],subbox:[128,206,207],subcutoff:429,subdivis:257,subdomain:257,subequ:11,subgroup:[203,528],subinterv:205,subject:[6,15,41,181,225,483],submit:0,subramaniyan:13,subscript:[11,347,361,419,485,524],subsequ:[3,6,11,12,41,61,113,179,207,221,225,229,246,342,347,348,349,380,392,416,476,495,497,498,504,507,508,516,517,524,529],subset:[6,11,12,15,41,85,152,203,204,207,225,267,271,273,274,275,276,277,278,279,303,304,308,317,388,393,395,399,426,448,491,494,497,499,502,506,524],subspac:9,substanti:[6,477,506],substep:271,substitut:[1,2,3,12,203,253,306,388,392,418,448,495,508,524],substract:409,substrat:[180,229,271,273,274,275,277,278,279,304,317,497],substyl:[439,506],subsystem:347,subtl:[104,106,107,248],subtleti:164,subtract:[3,6,54,65,75,86,99,104,107,112,113,115,123,129,153,155,156,157,158,159,160,161,162,164,165,166,167,168,170,171,203,204,210,219,238,246,247,250,254,255,256,258,262,263,267,294,301,317,358,389,438,497,507,515,524,525],succe:12,succeed:[220,221],succes:221,succesfulli:3,success:[2,6,11,12,14,127,203,207,217,220,229,232,246,285,303,317,335,342,360,386,388,495,496,504,505,512],successfulli:[3,11,203,232,495,508],successulli:11,successv:502,sucessfulli:3,sudden:35,suddenli:356,sudo:[11,12],sufac:42,suffer:[16,17,293,350,356,393],suffici:[2,3,6,7,16,17,41,63,75,205,225,269,271,299,335,342,349,352,360,430,448,497,518],suffix2:12,suffix:[1,2,3,6,9,12,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,123,155,165,184,185,187,188,189,190,192,193,195,196,199,203,204,206,213,224,231,239,245,249,254,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,309,310,317,318,320,321,346,355,361,363,364,366,367,370,372,377,378,388,393,394,395,397,399,400,401,402,403,404,405,407,408,409,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,443,444,445,449,452,453,455,456,459,460,461,468,477,478,480,481,482,483,485,487,488,489,495,497,498,500,506],suggest:[0,6,7,12,269,307,495,518],suit:[7,13,212,257,418],suitabl:[4,12,13,16,54,95,203,228,306,339,399,406,423,439,443,458,459,492,511],sukumaran:221,sum:[3,6,8,12,40,74,75,80,85,91,96,97,98,100,104,108,113,115,117,119,120,121,123,126,127,128,135,151,152,153,155,158,159,160,161,164,165,166,167,168,170,172,174,175,176,219,220,222,223,232,244,247,254,255,260,298,299,303,307,312,317,319,323,334,345,347,349,352,356,358,377,378,386,398,409,413,418,419,429,431,434,443,458,459,467,484,495,515,518,523,524,525],summar:[6,12,419,466],summari:1,summat:[6,9,42,74,96,117,377,378,403,409,416,417,431,435,446,466,477,480,481,482,485],summer:[3,13,458,459],sumsq:128,sun:[20,43,185,361,405,448,459],sunderland:16,sup:[307,312,408,466],supercomput:[12,17,495],superpos:[426,476],superposit:7,superspher:382,supinski:446,supplement:[248,458,459],supplementari:[230,422,460],suppli:[9,12,199,246,269,347],support:[1,3,4,6,7,8,9,11,12,13,14,15,16,17,18,40,41,42,63,95,96,112,118,203,204,205,206,207,208,211,212,213,214,219,224,225,228,229,230,233,237,244,248,249,252,254,255,256,257,266,269,271,273,274,275,276,277,278,279,287,291,292,293,294,295,296,298,299,304,307,309,311,316,317,320,323,324,325,326,327,328,330,331,332,333,334,338,339,340,341,345,350,351,352,356,375,376,377,378,382,385,386,387,393,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,483,484,485,487,488,489,490,494,498,499,500,504,506,507,508,510,511,512,517,518,523,524,528,529],suppos:[3,8,419,519,524],suppress:[6,12,176],surc:8,sure:[6,8,11,13,199,211,212,229,303,317,321,357,416,478,479,519],surf:[8,146,179],surfac:[2,3,4,6,8,9,40,42,59,74,130,146,152,176,178,181,206,210,232,243,252,257,260,287,293,298,309,316,327,330,331,335,342,347,352,356,357,377,388,399,426,440,441,446,464,466,484,488,494,500],surface_exterior:8,surface_interior:8,surface_mov:347,surfact:[410,421],surpris:418,surround:[37,56,74,178,199,207,229,241,242,271,273,274,275,277,278,279,298,304,317,450,451,478,479,518],suspect:3,suspens:[440,441],sustain:[203,204,229,423],suzuki:[271,317],svg:6,svn:[7,11,12],sw_exampl:457,swamp:317,swap:[2,3,6,7,9,210],swegat:346,swiggl:[3,268,352,355,357,500,524],swiler:[152,467],switch7_section_start:421,switchflag:[152,467],swm4:518,swol:53,swope:6,sxx:207,sy0302:9,symbol:[6,12,130,177,314,399,418,467],symmetr:[6,74,95,103,123,143,144,145,148,149,150,153,211,212,229,271,272,343,350,394,406,412,416,480,482,524],symmetri:[3,5,6,7,8,65,66,74,100,117,180,203,204,269,298,361,378,394,497,518],symplect:[271,289],sync:[3,6,516],synchron:[1,248,388,516],synechococcu:7,syntax:[1,2,3,6,7,8,9,11,12,13,14,17],sysdim:299,sysmt:16,sysstem:399,syst:466,system:[0,1,2,3,4,5],system_:300,systemat:[6,9,221,246,254,446],systemx:3,t10:512,t11:512,t12:512,t13:512,t14:512,t15:512,t3e:12,t_chain:3,t_corr:3,t_correl:492,t_dephas:492,t_e:347,t_e_min:347,t_equil:[344,345],t_event:[3,492,511],t_hi:511,t_infil:347,t_init:[307,347],t_iter:3,t_j:28,t_lb:257,t_lo:511,t_order:3,t_oufil:347,t_out:347,t_outfil:347,t_qm:307,t_switch:[344,345],t_target:401,ta06a:467,ta4:446,ta5:177,ta6:446,tab:[2,497],tabbernor:130,tabinn:448,table:[241,242],tabul:[3,7,13,21,36,37,44,55,56,57,68,75,84,102,199,241,242,318,335,377,394,399,400,402,403,404,405,406,409,416,418,420,431,435,442,450,451,453,456,459,461,476,478,479,480,486,499],tabular:456,tabulate_long_rang:459,tad:[2,3,4,6,9,94,492],tadmor:9,tag:[216,242,318,420,451,479,518],tagint:3,tail:[3,95,96,118,121,172,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,412,413,415,416,417,418,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,453,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,484,485,487,488,489,490,515,524],tailor:[75,348],tait:[9,473,474],taitwat:[2,472],take:[1,2,3,6,11,12,16,19,20,21,22,23,24,25,26,27,28,29,30,31,34,37,39,40,41,42,43,44,45,46,47,48,49,51,53,54,56,61,81,95,97,99,123,124,127,128,153,155,165,172,176,182,184,185,186,187,188,189,190,192,193,195,196,199,203,206,207,211,212,213,224,225,229,231,238,239,245,249,253,254,255,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,304,306,309,310,317,318,320,321,331,333,334,335,337,338,339,340,348,355,358,361,362,363,364,366,367,370,372,377,378,383,393,394,395,397,399,400,401,402,403,404,405,406,407,408,409,412,413,416,417,419,421,422,423,424,425,431,432,433,434,435,436,437,438,439,440,444,446,449,452,453,455,458,459,460,461,466,468,475,477,478,480,481,482,483,485,487,488,489,491,495,498,500,505,506,507,512,514,515,516,524],taken:[6,61,160,178,202,228,232,246,247,248,254,255,256,257,303,307,310,318,347,366,416,418,422,450,451,477,485,492,506,507],talk:[6,7],talli:[2,3,6,8,9,41,118,124],tally:8,tan:[207,524],tandem:317,tang:446,tangent:[42,270],tangenti:[6,119,335,353,357,423],tanh:347,tantalum:[4,446,467],taper:[3,310,382,442],tar:12,tarbal:[0,8,11,12],target:[3,6,7,8,11,12,16,39,41,207,215,225,229,230,232,238,246,247,248,254,255,256,271,272,273,274,275,276,277,278,279,291,292,294,295,296,300,304,307,312,317,323,333,338,339,340,341,346,347,350,351,354,375,378,401,413,492,503,505,525],target_fil:346,task:[1,6,7,10,12,13,14,15,16,17,54,207,251,300,348,393,495,516],taskset:15,tatb:[4,313],tatom:518,tatoms:518,tau:[3,167,221,254,255,257,271,304,317,338,339,344,345,347,517,523],tau_1:247,tau_k:247,tau_n_k:247,tb3:177,tbead:170,tbp:399,tchain:[271,272,276,287,293,294,295,317],tcl:312,tcom:255,tcsh:[11,12,406],tdamp:[254,271,272,276,293,317,338,339],tdephas:492,tdrude:[163,235,255,518],teal:207,tech:[7,13],technic:[6,7,9,257,310,335,459],techniqu:[6,7,9,95,210,229,269,307,317,351,354,378,448,478,479,518],technolgi:9,technolog:[9,15,18,251],tediou:306,tell:[2,6,11,12,36,55,198,210,299,371,389,458,459,476,495,497,499,518],telsa:16,temeperatur:11,temp:[2,3,6,9,13,42,65,95,99,104,106,107,112,121,123,128,153],temp_drud:518,temp_eff:107,tempcom:[156,157,171],temper:[2,3,6,7,9,388,492,505,511],temperar:300,temperatur:[0,2,3,4,5],temperature_definit:216,tempfix:512,templ:[7,9,17],templat:[3,8,13,16,18,40,178,179,181,232,246,303,317,321,387,497],templeton2010:216,templeton2011:216,templeton:[9,216],tempor:247,temporari:[2,3,504],temporarili:[199,316,510,511],tend:[28,271,298,318],tensil:[7,231],tensor:[3,6,8,65,90,91,97,98,99,103,116,123,129,139,142,143,144,145,148,149,150,152,153,154,155,156,157,158,159,160,161,162,164,165,166,167,168,169,170,171,229,257,260,271,272,276,302,304,317,350,377,378,387,418,440,441,446,463,465,515,524],tenth:[139,211,376],term:[0,1,3,5,6,7,8,9,12,19,20,21,26,37,40,45,46,63,95,96,97,99,121,123,153,154,156,157,166,171,172,185,186,187,197,199,207,211,212,218,220,222,223,231,237,238,247,248,249,254,255,256,257,270,271,272,273,274,275,276,277,278,279,291,292,294,296,300,304,307,316,317,333,338,339,340,347,349,351,353,361,362,372,377,386,389,394,395,399,400,401,402,403,404,405,407,408,409,410,411,412,413,414,416,417,418,419,420,422,423,424,431,435,438,439,440,441,443,444,445,446,448,449,453,460,466,475,477,480,481,482,485,488,506,507,509,515,518],termin:[130,271,386,388,463,465,496,505,516],termostat:339,terrel:385,terri:7,tersoff:[2,3,5,7,8,9,15,96,121,153,154,226,227,409,417,426,456,476],tersoff_1:[480,481,482],tersoff_2:[480,481,482],tersoff_mod:481,tertiari:190,tessel:[9,176],test:[0,3,4,6,7,9,10],test_descriptor_str:3,testf:199,testu:199,tether:[6,266,315,323,331,332,334,345,421],tetot:[9,466],tex:8,texa:455,texas_holdem:316,text:[2,3,4,6,7,8,12,13,37,41,56,199,203,204,206,207,210,216,219,220,221,222,223,225,230,241,242,251,305,346,347,359,378,380,388,416,419,430,443,450,451,467,478,479,493,497,498,514,519,524,526,527],textur:16,tfac_insert:246,tfactor:[3,207],tfinal:524,tfix:316,tflag:206,tfmc:[2,3,7,210],th4:177,thakkar:15,thakker:15,than:[1,2,3,6,8,9,11,12,13,14,15,16,17,26,37,39,40,41,42,56,59,60,61,63,65,71,75,80,94,96,100,115,117,119,123,126,127,129,131,153,176,179,180,181,187,199,202,203,205,207,210,215,217,219,222,223,225,226,227,228,229,231,232,233,236,241,243,246,247,248,249,252,253,254,257,266,269,298,299,303,304,305,307,308,310,312,315,316,317,318,319,322,323,324,330,331,333,335,339,340,342,343,347,350,351,352,353,354,355,356,357,358,360,377,378,384,385,386,387,388,389,390,393,395,398,399,400,402,403,404,416,418,422,423,429,440,441,443,448,450,451,458,459,460,466,468,475,476,477,478,479,482,484,486,488,489,492,493,494,495,497,498,499,500,502,505,506,509,511,512,514,516,524,525,527],thank:[251,480,482],thb:459,thb_cutoff:459,thb_cutoff_sq:[458,459],thei:[0,1,2,3,4,6,7,8,11,12,13,14,16,19,20,22,23,24,25,26,27,28,29,30,31,34,36,37,39,40,41,42,43,45,46,47,48,49,51,53,54,55,56,59,61,63,65,66,69,71,74,75,78,79,86,87,90,92,95,96,97,98,99,103,113,114,116,118,119,123,125,126,127,128,129,131,152,155,156,158,160,161,164,165,171,173,175,176,178,180,181,182,184,185,187,188,189,190,192,193,195,196,198,199,203,204,206,207,210,211,212,213,215,218,219,220,222,223,224,225,226,227,228,229,231,232,237,239,245,246,247,249,250,251,254,255,257,260,268,271,273,274,275,276,277,278,279,280,281,282,283,289,291,292,294,296,302,303,304,305,306,308,309,310,316,317,319,320,321,335,336,339,342,346,347,349,350,353,355,356,358,359,360,361,363,364,365,366,367,370,371,372,375,377,378,380,382,383,385,386,387,388,389,392,393,394,395,397,398,399,400,401,402,403,404,405,406,407,408,409,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,429,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,449,451,452,453,455,456,458,459,460,461,466,467,468,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,493,495,497,498,499,500,501,502,506,507,509,510,515,518,519,524,527,528],them:[1,2,3,6,7,8,9,11,12,13,16,39,40,41,54,61,75,99,113,118,125,128,131,154,180,185,203,206,207,208,218,219,220,222,223,225,228,229,231,243,251,254,255,263,267,271,273,274,275,276,277,278,279,291,292,296,298,304,306,314,315,316,317,321,335,338,339,340,342,346,347,349,353,354,355,357,358,361,378,380,382,387,388,389,393,394,399,406,416,419,422,426,429,448,460,468,483,484,492,495,497,504,509,512,518,519,524,525],themselv:[6,9,11,181,211,212,225,255,377,378,388,390,394,399,409,416,439,443,444,445,467,524],theor:342,theorem:[247,254,322,399,414],theoret:[115,251,307,477],theori:[3,6,9,12,40,152,216,230,248,271,299,377,378,399,446,488,511],thereaft:[75,262,301,317,332,343,350,495],therebi:[348,440,441],therefor:[3,6,12,66,95,163,235,238,246,255,257,321,342,378,411,457,459,477,483,506,518],therein:[6,443],thereof:95,thermal:[0,2,3,4],thermo:[0,1,2,3],thermo_modifi:[2,3,6,59,65,106,107,128,155,159,161,162,164,165,166,167,168,169,170,210,229,232,271,475,513],thermo_p:[3,65,120,495,515],thermo_press:[65,123,229,235,271,273,274,275,276,277,278,279,304,514,515,518],thermo_styl:[2,3,6,8,65,88,99,104,106,107,120,121,123,128,153,155,164,174,178,202,203,204,210,211,212,213,214,219,220,223,224,228,229,231,235,236,237,249,250,252,254,255,266,269,271,273,274,275,276,277,278,279,291,292,294,296,304,307,320,328,338,339,340,349,352,355,357,358,386,395,421,425,448,458,459,500,502,507,513,514],thermo_temp:[65,123,155,228,229,246,271,273,274,275,276,277,278,279,291,292,294,296,299,304,338,339,340,514,515,518],thermoberendsen:6,thermochem:523,thermochemistri:418,thermodyam:[515,523],thermodyanm:[65,228,335,358,506],thermodynam:[0,3],thermophys:448,thermost:[6,160,215,230,235,255,354,518],thermostat:[0,3],thermostatequ:6,thesi:[377,378,440,457],thess:400,theta0:[19,20,23,25,26,27,31,32,34,35,152,187,316,370],theta0max:152,theta10:399,theta1:[185,197,361,399],theta2:[185,197,361,399],theta3:[361,399],theta4:399,theta5:399,theta6:399,theta7:399,theta8:399,theta9:399,theta:[3,6,25,26,36,37,38,65,68,85,100,117,152,177,178,187,200,202,206,249,312,316,347,361,370,425,456,481,497,500,507],theta_0:452,theta_:[370,399],theta_c:425,theta_ijk:399,theta_ijl:361,theta_jik:[444,445],theta_pi:399,theta_sigma:399,thex:308,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,34,35,36,37,38,39,40,41,42,43,44,45,46,47,48,49,50,51,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,195,196,197,198,199,200,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,370,371,372,373,374,375,376,377,378,379,380,381,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,518,519,520,521,522,523,524,525,526,527,528,529],thick:[75,130,206,500],thie:121,thijss:342,thin:[127,206],thing:[3,6,11,12,54,71,75,229,271,304,317,335,494,495,499,519,524],think:[3,6,7,8,11,13,207,317,358,363,367,380,386,426,458,459,478,479,495,499,502,524],third:[6,9,12,28,74,99,146,152,153,176,219,220,222,223,247,314,331,333,347,408,419,420,443,452,483,485,492,493,495,497,500],thirumalai:190,thistl:207,tho:417,thole:[2,6,9,163,234,235,255],thompson:[0,5,7,9,13,123,152,153,308,380,467],those:[1,2,3,5,6,7,8,9,10,12,13,16,17,19,20,22,23,24,25,26,27,28,29,30,31,32,34,37,39,40,42,43,45,46,47,48,49,50,51,53,54,56,63,75,76,81,95,99,100,117,119,120,121,123,127,152,153,155,158,165,168,176,178,182,184,185,187,188,189,190,191,192,193,195,196,199,202,203,204,206,207,213,217,218,219,220,223,224,229,231,232,238,239,243,245,249,251,252,253,254,260,268,270,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,303,306,309,310,317,321,337,344,345,349,353,354,355,358,359,361,363,364,366,367,368,370,372,377,378,386,388,389,393,394,395,397,400,401,402,403,404,405,406,407,408,409,412,413,416,417,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,443,444,448,449,452,453,455,458,459,460,461,467,468,476,477,478,480,481,482,483,485,487,488,489,492,494,495,497,499,500,501,502,504,506,507,509,511,514,515,516,518,519,524,528,529],though:[6,8,12,39,40,65,75,99,114,178,200,203,207,217,226,227,229,231,236,263,272,315,317,320,330,343,350,360,373,377,380,388,413,415,416,418,419,422,423,439,440,448,485,492,497,499,500,505,509,516,524],thought:[161,254,294,317,351,352,385,423,430,518],thread:[1,3,9,12,15,16,17,251,348,375,393,510,516],threads_per_atom:3,three:[1,3,6,54,65,74,78,95,99,100,115,128,130,142,152,156,177,178,190,210,228,229,234,238,258,271,276,299,304,308,317,318,335,342,344,347,365,366,370,377,378,387,393,394,395,399,416,417,419,422,423,427,430,443,444,445,446,452,456,459,460,466,467,477,480,481,482,485,495,497,500,516,524],threebodi:477,thresh:[41,203,204,206,207,225,495],threshhold:[3,41,206,225,358,495],threshold:[3,41,94,176,207,225,298,389,459,492,511],thrid:495,through:[3,6,7,9,11,12,65,178,182,203,204,208,229,242,244,246,251,252,257,259,260,261,271,272,300,308,318,327,342,347,352,356,376,382,384,395,414,417,418,420,423,429,431,446,451,461,466,468,475,479,483,492,495,498,506,508,514,518],throughout:[6,15,127,130,348,393,446,497],thru:[3,6,7,11,12,69,78,79,86,87,97,98,103,113,114,115,116,129,173,202,203,207,222,268,335,355,360,376,386,392,500],thrust:1,thu:[1,2,3,6,8,11,12,17,32,37,39,41,42,50,61,63,65,66,69,70,74,75,76,77,79,81,86,87,96,98,99,100,103,113,114,116,117,119,120,124,125,126,127,128,152,153,154,158,161,166,168,173,174,175,178,180,181,182,184,186,191,198,199,202,203,204,206,207,208,210,211,212,213,214,218,219,220,222,223,224,225,226,227,228,229,231,232,235,237,238,243,247,248,249,250,251,252,254,255,260,266,271,276,288,298,304,306,308,312,315,317,319,320,321,323,327,328,331,332,333,334,335,336,338,339,340,342,343,346,347,349,350,351,352,355,356,357,358,360,361,368,377,378,380,384,386,387,388,392,393,394,395,398,399,400,401,402,403,404,405,406,407,408,409,413,414,415,416,417,418,419,420,421,422,423,426,427,428,429,431,435,439,440,441,443,444,445,446,448,449,450,451,453,455,456,457,458,459,460,466,467,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,489,492,494,495,497,498,499,500,502,504,505,506,507,509,511,512,513,514,515,516,518,523,524,525,527,528],thumb:[8,16,178,202,268,317,393,407,500,506],thylakoid:382,thz:312,ti2:177,ti3:177,ti4:177,tidi:519,tight:[9,399,466],tightli:306,tij:412,tildeslei:[28,95,412],tile:[3,6,41,64,178,225,429,484,494,524],tilt:[3,6,59,60,61,75,166,180,203,204,207,229,231,232,249,269,271,272,298,307,378,380,485,497,500,515],time:[0,1,2,3,4],time_integr:216,timedelta:220,timelin:5,timeout:[515,516],timer:[1,2,12,16,515],timeremain:[515,516],timescal:[3,218,219,220,222,223,269,307,312,418,492,506],timespan:[254,255,271,304,317,338,339],timestamp:[3,502],timestep:[1,2,3,6,7,8,9,10,11,12,14,16,39,41,59,63,64,65,68,73,75,84,99,102,114,119,120,121,126,128,129,131,153,158,166,202,203,204,205,206,207,208,210,211,212,213,214,215,217,218,219,220,221,222,223,224,225,226,227,228,229,231,232,236,237,238,243,244,246,247,249,250,252,254,255,257,258,264,265,267,268,269,271,272,273,274,275,276,277,278,279,280,281,282,283,285,286,287,288,289,290,291,292,294,295,296,297,298,299,302,303,304,305,306,308,309,313,314,315,316,317,318,319,320,321,326,327,328,330,331,332,334,335,336,337,338,339,340,342,344,345,346,347,349,352,353,354,355,357,358,360,376,377,378,384,385,386,388,389,390,391,393,399,413,415,418,425,440,441,459,468,472,492,495,498,499,500,502,503,504,505,506,507,511,512,513,514,515,516],timesteppnig:321,timothi:9,tin:[408,409],tinfoil:378,tini:[76,127,178,386,399,525],tinker:7,tio2:466,tio:466,tip3p:0,tip4:6,tip4p:[0,2,3],tip:0,tirrel:352,titan:14,titer:317,titl:[219,220,221,222,223,305,459,519],title1:[219,220,221,222,223],title2:[219,220,221,222,223],title3:[219,220,222,223],tji:412,tkin:507,tl1:177,tl3:177,tlbr_msw:456,tlo:511,tloop:[271,272,276],tlsph:[2,134,136,137],tlsph_defgrad:134,tlsph_dt:324,tlsph_stress:133,tm3:177,tmax:[3,236,511],tmd:[2,3,210],tmd_dump_fil:346,tmdatom:346,tmin:236,tmm:9,tmp1:[222,223,508],tmp2:[222,223,508],tmp3:508,tmp:[6,12,41,68,69,71,73,79,84,86,98,102,103,114,116,119,125,127,129,158,173,175,203,204,206,207,225,306,317,343,350,392,504,508,524],tobia:[271,272,317],todd:294,toe:172,toff:[387,497],togeth:[2,3,6,9,11,12,15,16,39,41,75,126,153,158,172,178,179,203,204,211,212,219,222,225,229,235,248,255,271,304,317,323,328,331,335,353,357,358,421,426,495,500,505,518,528],toggl:[61,182,504],togther:3,tol:[287,293,321,335,377,477],toler:[3,229,287,293,308,309,310,318,321,335,386,388,477,492,511],tolernac:318,toma:9,tomato:207,tong:[9,13],too:[1,3,6,7,39,41,66,70,74,76,77,81,96,100,117,152,166,179,181,206,221,225,226,227,229,232,238,243,246,250,271,299,304,308,312,314,321,335,342,343,347,350,378,388,389,393,413,429,492,500,511,514,516,518,524],took:[75,468],tool:[0,1,4,6,7,8,9,11],toolkit:[6,7,13,14,204],top:[0,3,8,9,11,12,13,15,61,161,176,202,210,224,231,250,257,270,294,319,354,355,357,388,393,458,459,467,497,501,507,519],top_group:328,top_veloc:328,topic:[524,528],toplog:[3,494],topolgi:40,topolog:[2,3,6,7,8,12,13,36,39,40,55,95,119,126,181,182,198,207,226,227,251,302,371,387,426,448,494,497,498,499,501,502,509],topwal:224,torder:317,torqu:[2,3,6,28,40,65,124,129,156,157,171],torsion:[6,185,186,198,395,458,459],torsion_flag:395,toru:382,tosi:400,tot:[312,466],total:[3,6,11,12,14,15,16,17,39,41,42,65,67,72,75,83,86,87,88,89,96,97,98,99,101,108,112,113,114,115,118,120,121,128,129,134,135,136,137,139,140,141,142,143,144,145,152,153,155,158,159,160,161,164,165,166,167,168,170,172,174,175,176,203,210,213,214,217,219,221,222,224,225,227,233,235,237,244,245,246,247,252,254,255,256,257,258,260,269,271,272,276,287,288,299,300,302,303,306,307,312,314,316,317,318,319,320,323,325,328,331,332,334,343,344,345,347,350,352,356,377,386,387,388,389,390,393,394,395,396,398,399,408,416,418,423,443,444,445,446,456,458,459,463,466,467,484,492,494,495,497,499,505,506,511,512,515,516,524],touch:[12,252,353,499],toukmaji:[378,412],toward:[9,28,176,206,210,232,233,252,257,270,276,298,315,331,346,348,370,388],toxvaerd:436,tpa:393,tparam:317,tpartial:158,tpc:393,tpcpu:515,tperiod:317,tptask:[15,393],tqx:[124,129,203,204,337],tqy:[124,129,203,204,337],tqz:[124,129,203,204,337],trace:418,track:[3,7,12,227,231,257,347,357,492,497,503,511,515,524],track_displac:216,tracker:251,tractabl:318,trade:[6,12,309,377,378,409,431,435,506,511],tradeoff:448,tradit:[6,9,197,378],traffic:12,trail:[2,21,44,81,95,127,172,182,186,207,211,212,317,362,383,387,388,406,419,443,459,467,491,497,505,507],train:459,traingul:330,traj:230,traj_titl:459,trajectori:[3,6,12,39,95,203,251,271,273,274,275,277,278,279,280,281,283,284,286,289,290,291,292,294,295,296,300,317,321,323,327,348,357,413,448,459,499,507,512,518,523],tran:[189,190],transfer:[1,6,15,216,235,251,253,343,347,350,377,393,399,446,518],transform:[2,6,9,12,59,61,75,95,163,172,180,203,231,234],transit:[6,9,15,94,270,323,346,388,410,439,445,446,482,492,511],translat:[3,6,63,65,104,105,106,107,108,156,157,158,162,171,219,238,246,250,254,255,260,271,277,278,279,291,292,296,300,317,338,339,340,342,380,418,497,515],transmiss:251,transmit:[6,251],transpar:16,transport:[216,347,469],transpos:12,trap:[3,6,99,174,220,252,349,524],trapezoid:[220,524],trate:[3,231,251],travel:335,treat:[2,3,6,8,9,16,40,42,75,90,92,93,131,153,156,160,171,182,201,219,220,222,223,232,245,272,299,302,303,317,335,347,349,356,360,376,377,386,387,389,398,411,418,419,422,425,429,444,445,446,460,484,497,500,502,505,507,518,524],treatment:[9,312,411],tree:[3,302,439],tref:415,tri:[2,3,6,11,40,90,146,202,206,210,217,229,243,246,268,271,272,276],tri_surfac:[132,330],trial:[232,246,396,506],triangl:[2,3,4,6,7,9,40,42,90,124],triangle_mesh_vertic:[327,330],triangleflag:497,triangul:[2,6,13,330,464],triangular:[6,42,90,124,229,290,330,464,497],tricki:[494,518],triclin:[0,1,3],triflag:6,trigger:[3,11,12,64,94,225,228,246,386,454,490,515],trigon:24,trilinear:257,trilino:16,trim:[3,498],tringl:206,tripflag:458,tripl:[2,152,231,399,458,493,495],triplet:[3,33,36,38,417,452,456,477,480,481,482,485],trivial:[8,11,308],trj:459,trott:[7,9,16,152,467],troubl:[11,12],truli:8,truncat:[3,5,6,12,75,238,306,312,318,352,356,385,397,409,418,423,431,433,436,448,455,466,507],trung:14,tscale:[3,269,307],tschopp:70,tsige:403,tsrd:[335,357],tstart:[247,248,254,256,271,272,293,317,338,339,340,341,413,503],tstat:[2,3,6,230,247,248,254,335],tstop:[247,248,254,256,271,272,293,317,338,339,340,341,413,503,511],tsuzuki:[77,485],tthi:139,ttm:[2,3,210],ttm_mod:347,tucker:[152,467],tuckerman:[271,272,295,300,317,506],tue:9,tune:[2,3,6,14,15,210],tunnel:300,turkand:117,turn:[3,4,6,12,21,32,36,39,44,50,54,55,61,68,73,75,119,126,152,176,177,182,186,191,198,206,207,210,217,226,227,228,229,246,251,271,285,302,305,306,317,335,362,368,371,377,386,388,389,391,393,395,411,425,426,443,448,459,475,476,493,497,499,504,509,510,515,516,521,527],turquois:207,tutein:395,tutori:[6,8,9,298],tweak:[12,178,251,393],twice:[3,6,15,16,65,96,184,207,210,211,212,229,268,271,310,322,393,426,495,497,504],twin:70,twist:[440,441],two:[1,2,3,4,5,6,7,8,9,11,12,13,14,15,16,17,18,21,37,39,41,42,44,54,56,59,61,63,65,68,71,73,74,75,80,81,84,95,96,100,102,113,118,119,124,125,126,127,128,129,130,152,154,156,160,161,163,164,166,172,176,177,178,179,181,186,197,202,203,204,205,206,207,210,211,212,217,218,219,220,222,223,225,226,227,228,229,232,235,243,246,247,248,250,252,253,254,255,257,260,270,271,272,276,298,299,300,303,304,306,307,308,312,314,317,323,331,335,342,343,345,347,350,353,356,358,360,362,372,377,378,380,382,383,384,386,387,388,391,393,394,395,396,398,399,400,401,402,403,406,407,408,409,411,412,413,415,416,417,418,419,420,422,423,426,429,430,431,435,439,440,441,443,446,448,451,453,456,457,458,459,460,462,466,467,468,475,476,477,479,480,481,482,483,484,485,488,489,491,492,494,495,497,498,499,500,501,504,507,509,510,511,512,514,515,516,518,523,524,525,526,527,528,529],two_temperatur:216,twobodi:[480,482,485],twogrid:3,twojmax:[152,467],twolevel:[3,494],txt2html:8,txt:[8,13,57,203,208,305,306,347,375,387,430,466,486,502,519,524],typcial:[41,225],type1:[81,130,177],type2:[81,130,177],type:[3,6],typei:429,typej:429,typen:[81,130,177],typic:[1,2,3,6,7,8,9,10,11,12,13,14,15,16,17,28,39,40,41,45,46,55,59,61,63,65,74,75,94,95,112,118,129,131,140,172,178,179,181,197,203,204,205,206,207,210,211,212,213,215,216,219,221,225,226,227,228,229,231,232,237,243,244,246,249,255,271,285,299,302,303,306,308,310,316,317,321,324,326,335,342,350,351,357,377,380,385,386,387,388,389,390,393,404,406,407,409,421,422,425,426,430,431,435,440,441,443,448,460,463,465,476,478,479,482,492,493,495,497,498,499,500,506,509,511,512,514,519,523,524,527,529],typicali:12,tzou:347,u_chem:[88,89],u_cond:[88,89,240],u_f:257,u_i:[240,241,242],u_ij:456,u_j:242,u_mech:[88,89,240],u_prom:399,uberuaga:[270,388],ubiquit:[11,399],uchem:[40,420,451,479],ucond:40,uhf:396,uiuc:[9,16],uloop:[3,300,388,392,524],ulsph:[2,141],ultim:511,ultra:176,umbrella:[2,6,7,9,230,331,362,371],umech:40,umin:[25,26,48,49,187],unabl:[3,11,41,225],unaffect:[203,229,271,317,498,509,514],unalt:[211,212,285],unambigu:[75,485],unari:[360,524],unbalanc:3,unbias:[166,418],unbond:[227,497],unbroken:85,uncertainti:40,unchang:[61,229,232,270,271,273,274,275,277,278,279,288,304,317,497,498,501,507],uncharg:[40,378],uncom:[1,4],uncompress:[12,75,206],uncomput:[2,3,65],uncorrel:[247,342,492],uncoupl:300,undefin:[3,12],under:[0,5,6,7,8,9,12,15,17,20,21,44,152,185,186,206,251,269,271,303,307,308,322,361,362,383,414,418,439,459,467,495,511,516,518],underestim:176,underflow:206,undergo:[6,94,95,113,166,247,254,255,271,323,335],undergon:[228,335],underli:[6,12,16,74,206,271,347,380],undermin:39,underpredict:6,underscor:[2,3,65,204,210,228,229,269,271,273,274,275,276,277,278,279,291,292,294,296,304,306,338,339,340,360,387,524],understand:[1,4,6,8,246,272,446],understood:[203,399],undesir:[61,229,231,271,317],undetermin:335,undisturb:[440,441],undo:[182,251],undump:[2,3,61,203,204,205,206,207,208,376],unexpect:[3,503],unfix:[2,3,6,61,99,210,216,219,220,222,223,308,316,319,344],unfix_flux:216,unfold:333,unfortun:[348,505,506],uniaxi:[3,156,276],uniform:[7,15,41,96,127,216,225,226,227,232,254,257,260,272,342,415,422,460,492,494,524,525],uniformli:[61,127,202,257,303,347,450,451,456,478,479,525],uninstal:12,uninterrupt:[217,232,246,268,269,271,273,274,275,276,277,278,279,291,292,294,295,296,306,307,317,323,334,337,345,347,353],union:[3,6,40,207,306,356,358,497,500],uniqu:[3,6,7,8,12,39,75,134,221,247,248,254,255,276,306,312,314,388,416,418,497,524,525],unit:[2,3,5,6,7,8,19,20,31,34,35,37,39,56,57,61,63,67,68,69,70,71,72,73,74,75,76,77,78,79,81,83,86,87,88,89,90,91,92,93,94,95,96,97,98,99,100,101,103,104,105,106,107,108,109,110,111,113,114,115,116,118,119,120,121,123,124,125,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,155,156,157,158,159,160,161,162,163,165,166,167,168,169,170,171,172,173,174,175,176,177,178,181,185,199,202,203,204,206,207,213,214,215,217,219,220,224,226,227,228,229,231,232,233,236,237,238,240,241,242,244,246,247,248,249,250,251,252,254,255,256,257,268,269,270,271,272,276,285,293,298,299,300,303,304,307,308,310,312,315,316,317,318,319,323,327,331,332,333,334,335,338,339,340,341,342,343,345,346,347,350,351,352,353,354,355,356,357,361,363,367,370,375,377,378,380,383,384,386,387,388,389,390,393,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,453,455,456,457,458,459,460,461,462,464,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,483,484,485,486,487,488,489,490,495,497,499,500,506,507,511,514,515,517,518],unit_styl:3,uniti:[417,448,471],unitless:[66,70,74,75,125,129,183,219,231,246,269,271,307,318,353,386,396,423,449,453,455,477,480,481,482,485,523],unitlesss:[82,85,122],univ:[9,13],univers:[3,6,9,12,13,17,95,251,377,378,388,392,440,445,455,457,482,491,494,524],universit:[9,13],unix:[12,16,253,508],unknown:[3,12,66,77,497],unless:[2,3,9,11,12,14,15,55,59,70,113,130,163,177,178,203,204,207,208,215,229,232,246,254,271,273,274,275,277,278,279,303,304,317,335,346,379,386,407,448,478,479,495,500,504,509,524],unlik:[12,97,178,221,254,310,377,394,399,416,419,426,443,444,445,467,476],unlike:[32,50,61,168,191,203,254,271,276,304,312,338,339,340,368,376,416,425,430,444,445,459,494,499,504,509,524,529],unlimit:[456,516],unlucki:3,unmark:7,unmodifi:336,unnecessari:15,unoccupi:347,unoptim:206,unpack:[0,8,11,393],unpack_bord:8,unpack_border_bodi:8,unpack_border_hybrid:8,unpack_border_vel:8,unpack_comm:8,unpack_comm_bodi:8,unpack_comm_hybrid:8,unpack_comm_vel:8,unpack_exchang:8,unpack_restart:8,unpack_revers:8,unpack_reverse_comm:8,unpack_reverse_hybrid:8,unpad:207,unperturb:95,unphys:[3,6,255,271,317,497],unpredict:[315,507],unpublish:446,unrecogn:3,unrel:[8,9,13,184,519],unreli:448,unrestrain:316,unrestrict:396,unscal:[3,124,129,172,203,204,337,498],unset:[3,377,418],unshift:412,unsmooth:437,unsolv:[390,404],unsort:207,unspecifi:[231,497],unsplit:518,unstabl:[3,257],unstag:519,unstrain:231,unsuccess:[3,303],unsupport:[3,512],untar:12,until:[2,3,6,12,37,39,41,56,75,131,199,206,225,229,232,241,242,246,251,287,303,327,335,337,344,360,376,377,389,392,393,399,423,450,451,478,479,492,497,498,502,503,505,511,523,524],untilt:500,unus:399,unusu:[3,8,389],unwant:[3,178,377],unwrap:[3,69,78,79,86,87,97,98,103,113,114,116,124,129,153,173,203,204,207,208,218,228,230,251,268,317,331,337,497,498,501,507],unwrapexpand:203,unzip:12,up_intern:206,updat:[0,3,6,8,12,13,15,129,135,136,137,147,148,149,150,202,203,204,210,217,226,227,235,244,247,254,255,257,260,264,265,268,269,271,272,273,274,275,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,294,295,296,302,304,306,307,312,317,326,327,337,338,339,340,342,347,358,359,393,399,412,446,448,458,459,465,492,497,499,507,508,511,518],update:259,upenn:[11,13],upgrad:12,upon:[6,217,251,318,399,483,511],upper:[2,3,41,59,61,75,96,113,115,154,167,174,202,207,220,221,225,229,235,255,257,271,307,312,352,353,358,359,386,423,466,500,525],uppercas:0,upsid:6,upsilon:422,upstream:519,upto:[3,499,505],upward:232,urbana:[251,377,378,440],urey_bradlei:19,url:519,usa:9,usabl:[12,246,416],usag:[3,6,8,298,312,335,426,439,497],usage:255,use:[3,6,12,14,16,17,18,129,203,204,205,206,218,219,220,222,223,246,255,269,317,320,343,347,349,350,422,443],use_ldg:16,usec:517,used:[207,254,256],useful:446,user:[0,1,2,3,4,5,6,7,8],user_manifold:519,user_misc:[29,30,34,188,193,196,197,366],userguid:9,usernam:519,using:[0,1,3],usr:[11,12,498],usual:[2,3,6,12,14,16,17,23,27,31,34,35,47,63,75,95,128,156,157,158,163,171,176,195,197,203,204,206,211,212,217,219,228,229,230,231,246,249,254,256,269,276,299,307,308,314,316,317,335,343,347,350,352,356,360,367,375,388,389,393,404,407,410,412,422,426,427,430,439,440,441,448,452,463,465,467,475,477,483,492,496,498,502,506,508,511,514,515,516,524,529],usualli:[3,462,464],util:[8,12,16,17,393,422,516],utilizi:12,utilz:[12,516],utsa:455,uttormark:13,uwo:9,v11:6,v22:6,v33:6,v_0:[3,347],v_2:446,v_3:446,v_4:446,v_a:[8,231],v_abc:[495,515,524],v_area:[2,524],v_atomfil:507,v_c:172,v_cluster:306,v_dc:172,v_delta:95,v_dhug:[269,307],v_diff:[174,349],v_displac:231,v_dk:172,v_dlj:172,v_drai:[269,307],v_dx:[268,500],v_dy:[268,500],v_dz:268,v_e_hbond:425,v_ea:[458,459],v_eb:[458,459],v_eqeq:[458,459],v_espac:213,v_f:495,v_fac:495,v_flux:250,v_foo:[495,524],v_ij:456,v_increas:249,v_integr:349,v_jx:99,v_jy:99,v_jz:99,v_k11:99,v_k22:99,v_k33:99,v_k:172,v_ke:[203,204,528],v_left:500,v_lgr_po:[269,307],v_lgr_vel:[269,307],v_linear:[352,355,357],v_lj:[172,395],v_mol:207,v_mu:440,v_myi:268,v_myindex:524,v_myke:128,v_mystep:504,v_myvar:[8,207],v_myvec:[131,524],v_myx:268,v_n:[257,446],v_name1:[172,231],v_name2:[172,231],v_name:[3,6,75,95,128,131,202,203,204,206,207,211,212,213,214,218,219,220,221,222,223,224,237,249,250,252,254,255,268,320,328,337,338,339,340,349,352,355,357,495,500,504,507,513,515,524,525],v_nstep:358,v_occ:421,v_omega:268,v_oscil:[213,214,224,237,320],v_phi:249,v_prefactor:[211,212,468],v_press:153,v_pressdown:[355,357],v_push:213,v_pxy:6,v_pxz:6,v_pyz:6,v_r0:252,v_r1:176,v_r2:176,v_r:[176,252,287],v_rad:358,v_radiu:252,v_ramp:[352,355,357],v_rate:[231,252],v_rebo:395,v_scale1:[211,212],v_scale2:[211,212],v_size:[211,212],v_t_qm:307,v_temp:343,v_theta:[249,500],v_torsion:395,v_tp:231,v_up:500,v_v0:524,v_v11:6,v_v22:6,v_v33:6,v_v:[268,524],v_valu:[206,495],v_vx:268,v_vy:268,v_vz:[268,525],v_wiggl:[352,355,357],v_x:[2,178,252,268,352,355,357,495,500,524],v_xave:6,v_xmax:6,v_xx:178,v_y:[178,252,500],v_yi:178,v_z:500,vacanc:[4,176,344,446],vacf:[2,3,6,65],vacuum:[347,378,410,482,489],valanc:399,vale:3,valenc:[310,399,418,458,459],valent:399,valeriu:9,valid:[2,3,6,9,11,12,75,130,164,177,207,229,246,254,298,317,335,358,360,375,380,416,418,422,446,456,497,498,505,507,524],valon:443,valu:[2,3],value0:524,value1:[12,68,73,84,102,119,158,218,219,220,221,222,223,276,349,358,508],value2:[12,68,73,84,102,119,158,218,219,220,221,222,223,276,349,358,508],valuei:220,valuej:220,valuev:[7,9],valus:306,van:[9,53,95,118,304,308,313,338,407,408,439,443,458,459,488,525],vanadium:446,vanderwa:[448,515],vanilla:[6,8,12],vanillia:42,vanish:[235,312,321],vapor:[41,225,246,514],vapour:342,var1:508,var2:508,varaibl:[3,500],varavg:12,vare:347,vari:[1,10,17,41,63,64,75,95,130,166,168,177,211,212,216,219,220,225,229,231,269,271,304,316,317,338,339,347,352,377,404,413,414,424,437,440,455,468,478,479,494,512,516],variabl:[0,2,3],variable_hill_factor:13,variable_nam:459,varianc:[128,413,524],variant:[1,3,6,9,12,91,108,129,271,276,317,322,353,377,385,393,423,444,445,449,480,482,506,510,525],variat:[12,41,225,524],varieti:[1,2,4,6,7,9,13,14,75,206,251,375,380,426,443,458,459,476,485,524],variou:0,varreturn:495,varshalovich:152,varshnei:13,vartiabl:3,vashishta1990:485,vashishta2007:485,vashishta:[2,3,4,9,476],vbia:6,vcm:[2,3,6,65,108],vdim:[167,343,350,525],vdisplac:[3,252,268,352,355,357,524],vdw:[3,408,459],vec1:[128,306],vec2:[128,306],vec:298,vector:[1,2,3],vector_styl:524,vel:[3,6,63,219,231,255,303,323,354,413,414,418,423,492,499,500,502,518,524],veld:[13,335,378,403,435],veloc:[2,3,6,7,8,39,40,63,65,69,90,91,92,93,99,104,105,106,107,108,112,116,123,124,128,129,153,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,174,175,178,203,204,205,206,207,210,211,217,218,219,222,229,231,232,235,236,238,239,246,250,252,254,255,256,257,258,259,260,261,262,264,265,267,268,269,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,294,295,296,297,298,300,301,302,303,304,307,312,315,316,317,320,321,323,325,326,327,328,335,336,337,338,339,340,341,342,343,345,347,349,350,351,352,353,354,355,357,358,380,383,385,386,388,413,415,418,423,440,441,459,492,497,498,499,500,501,502,506,507,514,515,518,523,524],velocit:[250,413,414,418,423],velocity_bottom:257,velocity_gradient:465,velocity_temp:525,velocity_top:257,vendor:[9,12],verbatim:495,verbos:[12,466],veri:[1,3,6,7,8,9,10,12,13,16,41,75,76,95,127,128,129,131,203,204,206,207,218,219,220,221,222,223,225,226,227,229,246,260,263,271,272,285,287,293,300,304,315,321,338,339,349,388,389,390,393,418,423,440,441,450,451,455,458,467,468,478,479,505,515,516,518,519,523,527],verifi:[8,393,448,506,512,519],verlag:323,verlet:[1,3,7,8,9,12,15,17,216,238,254,271,285,294,300,321,336,347,355,358,393,491,494,506],versa:[3,6,13,61,172,180,228,241,252,254,255,317,497,498,518],versu:[6,14,17,39,41,85,113,114,127,174,207,225,317,321,378,403,412,423,435,448,515,524],vertex:[42,146,330],vertic:[2,15,41,42],ves:[455,476],vfinal:524,vfrac:124,vhi:[167,525],vhs:415,via:[0,1,2,3,4,6,7,8,9,11],vibrat:[6,9,232,248,298,307,312,370,418,492,506],vice:[3,6,13,61,172,180,228,241,252,254,255,317,497,498,518],video:206,view:[4,6,7,13,203,206,335,399,418,419,466],viewer:[203,206],viewpoint:206,vij:413,vika:13,vim:0,vincent:[9,18],violat:342,violet:207,virial:[3,65,99,123,152,153,172,211,212,229,235,271,272,273,274,275,276,277,278,279,302,304,317,321,377,393,396,413,414,415,418,427],virialmod:427,virtual:[6,7,8,12,477],virut:9,visa:7,viscoelast:[122,423,455],viscoelsat:455,viscos:[0,2,3,4],viscosity:[4,6],viscou:[2,6,210,247,248,250,254,257],viscous:317,vision:466,visit:319,vista:203,visual:[0,3,4],viz:[11,13],viz_tool:11,vizplotgui_tool:11,vizualiziton:319,vlo:[167,525],vmax:[229,335],vmd:[6,7,9,11,13,203,208,251,498],vmdarch:208,vmdhome:208,vname:524,voigt:[6,152],vol:[2,6,8,99,138],volfactor:377,volpress:446,volt:[457,523],volum:[2,3,6,40,41,60,61,65,85,95,99,110,123,127,130,138,142,151,153,176,177,178,181,217,219,225,229,231,232,240,246,257,269,271,272,276,280,281,283,284,286,287,289,290,291,292,294,295,296,303,304,307,317,323,347,352,356,358,377,380,387,401,440,441,446,455,473,474,489,493,494,497,500,507,515,518,523,524],volumetr:85,von:[145,150],voro:[3,9,176],vorobyov:518,voronoi:[2,3],vorselaar:221,voter2:[492,511],voter:[444,445,492,511],voth:[40,300],vpz:354,vratio:524,vri:424,vrpn:251,vshear:353,vstream:6,vtarget:[3,350],vtk:[2,6],vtp:204,vtr:204,vtu:204,vv0210:13,vx0:174,vxcm:317,vxhi:[232,303],vxlo:[232,303],vy0:174,vycm:317,vyhi:[232,303],vylo:[232,303],vz0:174,vzcm:317,vzhi:232,vzi:354,vzlo:232,w_1:152,w_2:152,w_i:152,w_ik:456,waal:[95,118,407,408,439,458,459,488],wadlei:[13,399],wag:[7,9,13],wagner:[7,9,216,257,443],wai:[1,2,3,6,7,8,9,10,11,12,14,17,21,33,44,52,61,65,68,69,73,74,75,76,79,81,84,86,95,98,99,100,102,103,114,116,117,119,125,126,127,152,153,155,156,157,158,159,160,161,164,165,166,167,168,170,171,172,173,175,178,181,186,194,199,202,203,204,206,207,210,211,212,219,222,223,224,227,228,229,231,244,247,252,254,255,257,269,271,276,285,287,300,303,304,306,315,317,319,323,331,332,335,337,338,339,340,343,346,347,349,352,355,357,358,362,363,364,365,367,369,370,378,380,383,386,388,389,393,394,395,406,409,410,413,415,416,417,419,422,425,426,428,431,443,444,445,448,452,454,456,457,460,466,467,468,475,477,480,482,485,491,492,495,497,498,499,500,501,502,505,506,507,519,524,525,526],wait:[1,12,15,251,299,492,494],walk:[3,247,254,255,271],wall:[0,2,3,5],wall_surac:146,wall_surfac:[146,327],wallhi:352,wallstyl:353,walltim:516,wander:331,wang:[378,443,456],want:[0,1,2,3,5,6,7,8,9,11,12,16,37,40,56,65,67,69,71,72,75,79,83,86,87,88,89,98,101,103,113,114,116,118,120,121,123,125,127,129,153,158,173,174,175,176,178,181,199,203,204,206,207,210,211,212,213,218,219,225,228,231,232,235,237,241,244,246,252,255,266,288,298,303,306,316,317,320,331,332,334,336,343,345,350,352,356,358,360,378,380,388,394,395,399,407,408,413,416,419,426,427,428,429,443,450,451,452,456,458,459,466,468,477,478,479,480,482,484,485,493,495,497,498,499,500,502,504,505,512,515,516,518,519,524,527,529],ward:399,warm:[15,418],warmup:15,warn:0,warner:394,warning:[2,3,12,443,458],warp:[5,443],warranti:7,warren:[413,450,451],wasn:3,wast:3,watanab:[344,345],watch:388,water:[0,3],watkin:195,wave:[7,9,40,215,269,311,354,396,418],wavefunct:[396,418],wavelength:[130,177],wavepacket:[40,396,418,497],wavevector:299,wbodi:91,weak:[10,100,308],web:[1,4,8,10,14,16,406],webb:216,weber:[3,5,7,9,14,96,154,417,445,456,476,477,485,509],websit:[8,458,459],weckner:455,weight:[2,3,6,36,55,95,119,126,127,152,177,179,182,184,198],welcom:495,well:[1,3,6,7,8,9,11,12,13,14,16,17,26,40,51,70,75,100,117,123,153,156,164,178,187,206,207,213,217,219,223,225,226,227,229,232,237,246,250,254,257,261,263,268,271,276,287,293,303,304,317,318,320,328,342,345,353,386,388,393,398,421,422,425,426,427,440,441,443,446,460,468,480,481,482,495,497,499,501,506,511,516,518,519,523,528],wennberg:377,went:[3,11],were:[3,5,6,7,9,11,12,13,14,15,18,33,41,42,52,56,62,74,75,113,117,120,121,123,127,155,158,178,181,182,194,203,206,207,210,213,219,222,223,225,231,237,243,250,251,285,294,319,353,354,358,369,377,390,392,395,418,423,426,430,455,459,478,492,494,495,497,498,499,500,502,504,512,515,519,524,525,528,529],weren:502,western:9,westview:488,what:[0,1,2,3,6],whatev:[8,12,14,119,124,127,128,129,131,206,207,211,212,229,271,304,306,353,380,385,386,388,393,405,407,446,458,459,511,518,524],wheat:207,whelan:177,when:[0,1,2,3,4,6,8,9,11,12,13,14,15,16,17,19,20,22,23,24,25,26,27,28,29,30,31,32,34,36,37,39,40,41,42,43,45,46,47,48,49,50,51,53,54,55,56,61,63,64,65,67,72,75,76,83,87,94,96,100,101,113,114,115,117,118,119,120,123,124,126,127,128,131,154,155,156,161,165,166,168,174,176,178,179,180,181,182,184,185,186,187,188,189,190,191,192,193,195,196,198,199,203,204,205,206,207,208,210,211,212,213,214,215,217,218,219,220,222,223,224,225,226,227,228,229,230,231,232,236,237,239,241,243,244,245,246,248,249,251,254,257,258,260,261,266,271,272,273,274,275,276,277,278,279,280,281,285,288,289,291,292,294,296,298,302,303,304,305,306,307,309,310,311,312,316,317,318,319,320,321,323,331,333,335,336,337,342,343,347,348,349,350,352,353,354,355,356,357,358,359,360,361,363,364,366,367,368,370,371,372,374,375,376,377,378,380,384,385,386,387,388,389,390,392,393,394,395,397,400,401,402,403,404,405,406,407,408,409,411,412,413,415,416,417,418,419,421,422,423,424,425,426,427,428,429,431,432,433,434,435,436,437,438,439,440,441,443,444,445,446,448,449,450,451,452,453,455,456,458,459,460,461,467,468,475,477,478,479,480,481,482,483,484,485,487,488,489,490,492,494,495,497,498,499,500,501,502,503,504,505,506,507,508,509,511,512,514,515,516,517,519,523,524,525,527,529],whenev:[0,8,12,75,197,207,218,317,380,425,495,506,510,524,529],whenth:3,where:[1,3,6,8,9,10,11,12,14,15,17,20,22,23,24,25,26,27,28,31,34,35,36,39,40,41,43,47,48,49,51,55,63,65,67,68,69,71,72,73,74,75,77,79,83,84,85,86,88,90,91,92,93,95,96,97,98,100,101,102,103,104,105,106,107,108,114,116,119,123,124,125,126,127,128,129,130,131,153,155,156,157,158,159,160,161,164,165,166,167,168,170,171,172,173,175,177,179,181,182,185,187,198,202,203,206,207,210,211,212,213,214,219,220,224,225,228,229,231,232,236,237,238,240,242,243,244,246,247,248,249,250,252,254,255,256,257,260,261,264,266,268,269,271,272,276,285,289,297,298,299,300,303,305,306,307,310,312,317,318,319,320,321,323,327,328,331,332,334,337,338,339,340,343,344,345,347,350,351,352,353,355,356,357,358,361,363,364,365,366,367,370,371,372,375,378,380,385,386,387,388,389,390,393,394,395,398,399,400,402,406,407,408,409,410,411,412,413,414,416,417,418,419,420,421,422,423,424,425,426,427,428,431,435,440,441,442,443,444,445,446,448,451,452,453,455,456,457,458,459,460,466,467,470,473,474,475,476,477,478,479,480,481,482,485,488,489,491,492,494,495,496,497,499,500,501,502,504,506,507,509,511,512,513,514,515,518,523,524,525,527,529],wherea:[6,11,100,217,247,271,308,342,347,518],wherebi:309,wherev:250,whether:[6,8,11,12,16,39,40,54,61,63,65,74,75,112,118,154,165,166,199,206,207,209,210,211,212,219,223,226,227,228,229,230,231,235,243,246,255,268,271,276,306,321,335,343,349,350,358,360,375,377,378,387,391,393,402,404,408,424,426,430,440,441,443,448,459,466,476,492,495,497,498,500,502,509,510,511,514,524,525],which:[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,27,28,31,32,36,37,38,39,40,41,42,44,45,46,47,50,51,53,54,55,56,58,60,61,63,65,66,67,69,70,72,74,75,76,77,78,79,80,81,82,83,85,86,87,88,89,90,91,93,95,96,97,98,99,101,103,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,131,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,152,153,155,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,184,185,186,189,190,191,192,195,198,199,202,203,204,206,207,208,210,211,212,213,214,215,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,235,236,237,238,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,260,261,265,266,268,269,270,271,272,273,274,275,276,277,278,279,281,283,285,286,287,289,290,291,292,293,294,295,296,298,299,300,302,303,304,305,306,307,308,309,310,312,313,314,315,316,317,319,320,321,323,324,325,326,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,360,361,362,364,367,368,371,372,375,376,377,378,380,383,384,385,386,387,388,389,390,392,393,394,395,396,398,399,400,402,403,404,406,407,408,409,410,411,412,413,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,433,434,435,437,439,440,441,443,444,445,446,448,449,450,451,452,453,454,456,457,458,459,460,461,462,463,464,465,466,467,468,471,475,476,477,478,479,480,481,482,483,484,485,488,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,518,519,524,525,527,528,529],whichev:[12,392,492,511],white:[207,247,254,255,256,317,339,347,497,524,528],whitesmok:207,whitespac:[2,3,207,387,497],who:[0,3,6,7,8,9,13,394,416],whole:[235,251,299,312,318,323,518],wholli:232,whose:[3,6,7,8,9,17,18,37,39,42,56,61,80,95,163,181,199,206,207,217,231,241,242,252,253,268,271,273,274,275,277,278,279,298,299,315,316,318,321,335,349,356,358,380,388,389,418,420,433,450,451,462,464,477,478,479,480,482,518,524,525],why:[3,6,255,343,350,519],wicaksono1:298,wicaksono2:298,wicaksono:298,wide:[1,6,7,63,65,210,343,350,380,390,404,407,418,458,459],width:[206,207,232,382,396,421],wiggl:[3,231,268,327,352,353,355,357,500],wiggle:327,wigner:152,wih:6,wikipedia:6,wild:[3,12,21,44,81,95,127,186,211,212,317,362,383,406,425,491,499,504,527,529],wildcard:[3,12,172,182,203,204,206,207,314,406,475,504,507,528,529],wildli:[271,304],win:393,window:[3,4,12,13,75,203,206,208,219,220,221,222,223,251,319,340,341,406,498,519],wipe:[210,426,476,520,522],wire:316,wirnsberg:[6,238],wirt:207,wisconsin:13,wise:[3,12,413,477,506],wish:[2,3,5,6,7,8,11,12,16,40,42,59,60,61,75,128,153,158,179,180,182,184,203,204,207,211,218,219,220,223,227,231,232,243,246,252,257,261,303,306,317,321,335,336,352,353,377,380,388,393,402,425,426,443,448,450,451,458,478,479,495,497,498,499,505,509,515,524,525,529],within:[1,2,3,6,8,9,11,12,13,14,15,16,28,39,40,41,42,55,61,63,65,68,73,74,75,76,77,81,84,100,102,117,119,123,126,127,128,129,131,134,152,169,178,181,205,206,207,211,212,217,218,219,222,223,225,226,227,228,232,234,241,242,243,246,252,254,298,302,303,304,306,308,317,318,319,321,324,326,330,331,336,347,350,352,356,358,360,376,380,386,387,388,389,390,393,398,400,402,409,414,415,416,417,418,420,421,426,427,430,431,443,446,451,453,454,455,460,461,476,477,479,480,481,482,483,485,490,492,494,495,497,505,506,509,511,518,523,524],without:[1,2,3,4,6,7,8,9,11,12,15,16,19,20,22,23,24,25,26,27,28,29,30,31,34,37,40,43,45,46,47,48,49,51,53,54,56,61,95,123,155,160,165,179,184,185,187,188,189,190,192,193,195,196,199,203,206,207,208,210,213,219,221,222,223,224,229,231,239,241,242,245,247,249,251,254,268,271,273,274,275,276,277,278,279,280,281,289,291,292,294,295,296,303,306,308,309,310,311,315,317,318,319,320,321,327,335,351,355,359,361,363,364,366,367,370,372,376,377,378,388,389,393,394,395,397,400,401,402,403,404,405,406,407,408,409,412,413,416,417,418,419,420,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,446,448,449,450,451,452,453,455,459,460,461,468,476,477,478,479,480,481,482,483,485,487,488,489,495,497,500,505,506,512,515,518,519,523,524],wolf:[2,3,7,76,127],wolff:[448,478,479],won:[3,315,441],wong:[216,399],word:[2,3,6,8,12,28,65,207,210,217,218,219,220,223,230,252,282,288,305,310,316,349,360,376,407,448,493,495,497,516,524,525],work:[1,3,6,7,8,9,11,12,15,17,39,54,61,62,96,128,129,130,156,157,159,160,161,165,166,167,168,170,171,176,177,203,206,208,211,212,219,228,244,246,253,254,255,257,261,268,271,277,278,279,287,291,292,294,295,296,304,306,314,316,319,321,338,339,340,345,376,377,389,393,406,408,411,413,426,440,441,443,446,448,466,492,494,495,498,499,501,505,506,508,511,524],workaround:[76,127,317,448,525],worker:[12,458,459,485],workflow:519,workhors:8,workstat:495,world:[3,12,152,376,388,392,491,494,495,512,524],worlei:413,worri:16,worsen:17,worst:356,worth:[219,220,222,223,307,319],would:[1,3,4,5,6,7,8,11,12,15,21,28,36,41,42,44,55,74,75,76,97,99,127,129,153,158,166,178,179,180,181,182,184,186,198,203,204,206,207,208,210,211,212,214,217,219,225,228,230,231,235,236,238,243,246,249,250,251,255,268,271,272,285,298,300,304,306,308,312,315,318,335,342,346,354,355,358,360,361,362,363,364,365,367,368,371,377,380,383,385,386,387,388,389,392,393,394,395,399,406,407,408,409,413,414,415,416,417,419,426,427,428,429,443,444,445,446,452,456,458,459,463,465,467,475,477,480,481,482,485,492,495,497,500,501,502,504,505,506,507,508,512,514,515,518,519,524,525,528,529],wrap:[1,3,6,9,11,12,59,61,129,178,180,202,203,204,205,207,208,218,230,231,232,251,257,268,317,331,335,352,354,356,377,378,388,495,497,498,500,505],wrapper:[0,6,7],wrigger:323,wright:386,writabl:3,write:3,write_atom_weight:216,write_coeff:2,write_data:[2,3,8,12,13,306,497,526],write_dump:[2,3,205],write_freq:459,write_head:8,write_restart:[2,3,8,9,13,210,216,257,499,504,526,527],writen:319,written:[3,5,6,7,8,9,12,13,16,57,68,73,126,152,176,203,204,205,206,207,208,210,211,212,213,214,215,216,218,219,220,221,222,223,224,225,226,227,228,229,230,231,233,235,236,237,238,239,243,244,245,247,248,249,250,251,252,254,255,256,257,258,259,260,261,262,263,264,265,267,270,280,281,282,283,284,285,286,287,288,289,290,293,297,298,299,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,319,320,321,331,332,333,335,336,338,339,340,341,342,343,344,346,347,349,350,351,352,354,355,356,357,359,375,380,389,416,426,442,446,486,488,492,493,495,498,499,503,504,511,512,513,514],wrong:[3,11,229,271,297,352,356,357,389,459,499,504],wrote:[3,9,499],wt1:448,wt2:448,wt3:448,wurtzit:380,www:[0,2,3,5,6,7,8,10,11,12,13,14,394,416,440,457,458,459,523],x200:15,x86:[12,446],x_ij:456,x_ijkl:361,x_kjli:361,x_ljik:361,xave:6,xavx:15,xcm:[8,317,524],xcore:15,xdr:[12,203],xeon:[1,7,9,10,12,15,16,17,393,510],xflag:[165,166,258,260,267,317,342],xhi:[2,6,59,61,180,203,231,346,352,355,357,497,500,515,524],xhi_bound:[6,203],xhi_new:497,xhost:[9,15],xi_ij:456,xiaowang:[13,419,480,482],xiij:298,xk7:9,xlat:[178,231,252,515],xlo:[2,6,11,59,61,180,203,231,252,346,352,355,357,497,500,515,524],xlo_bound:[6,203],xlo_new:497,xmax:[6,215,236,285,524],xmgrace:0,xmic:15,xmid:232,xmin:524,xml:[204,208,457],xml_label:457,xmovi:[0,4,6,7],xmu:[353,423],xorig:75,xplane:353,xplor:203,xpo:178,xrd:[2,9,130],xsph:9,xsu:[3,203,204,337,498],xt3:203,xt4:[17,203],xt5:[17,203],xtc:[3,6,7,12,203,205,206,207,208],xtcdump:207,xvf:12,xwall:[354,355,357],xxx:12,xyz:[3,6,7,9,13,42,69,75,116,119,166,173,178,203,205,206,207,208,229,260,271,272,276,304,314,315,317,331,334,353,355,357,379,387,494,498,525,528],xzhou:[13,419],xzy:494,yamada:15,yang:[446,456],yate:446,yb2:177,yb3:177,ybox:231,ycm:317,year:[5,7],yeh:377,yellow:[206,207],yellowgreen:207,yet:[3,7,15,16,39,42,206,211,314,352,378,385,386,393,405,407,408,418,488,495,497,498,519,524,526,527,528],yflag:[165,166,258,260,267,317,342],yhi:[6,61,180,203,231,346,352,355,357,497,500,515],yhi_bound:[6,203],yield:[6,99,121,128,153,161,166,207,220,229,235,271,294,308,318,343,349,350,353,358,377,398,413,423,448,455,515,524],yip:344,ylat:[178,231,252,515],ylo:[6,61,180,203,231,346,352,355,357,497,500,515],ylo_bound:[6,203],ymax:[215,524],ymid:232,ymin:524,yorig:75,york:[300,378],yoshida:[271,317],you:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,32,34,37,39,40,41,42,43,45,46,47,48,49,50,51,53,54,56,59,60,61,63,65,67,69,71,72,75,76,77,78,79,81,83,86,87,88,89,95,96,97,98,99,100,101,103,112,113,114,116,117,118,120,121,123,125,127,128,129,152,153,155,156,157,158,161,165,166,171,172,173,174,175,176,178,179,180,181,182,184,185,186,187,188,189,190,191,192,193,195,196,198,199,203,204,206,207,208,210,211,212,213,214,217,218,219,220,222,223,224,225,226,227,228,229,231,232,235,237,238,239,241,243,244,245,246,247,248,249,250,251,252,254,255,256,266,268,271,273,274,275,276,277,278,279,280,281,285,288,289,291,292,294,295,296,299,300,302,303,304,306,308,309,310,312,315,316,317,320,321,323,331,332,334,335,336,338,339,340,341,343,344,345,346,347,349,350,351,352,353,355,356,357,358,360,361,363,364,366,367,368,370,372,376,377,378,380,383,385,386,387,388,389,392,393,394,395,397,399,400,401,402,403,404,405,406,407,408,409,412,413,415,416,417,418,419,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,443,444,445,446,448,449,450,451,452,453,454,455,456,457,458,459,460,461,466,467,468,469,470,471,472,473,474,475,477,478,479,480,481,482,483,485,487,488,489,491,492,493,494,495,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,514,515,516,518,519,523,524,525,526,527,529],young:[423,462,464],your:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,22,23,24,25,26,27,28,29,30,31,34,37,39,40,43,45,46,47,48,49,51,53,54,56,61,63,118,123,127,155,156,157,161,165,171,176,178,179,180,181,182,184,185,187,188,189,190,192,193,195,196,199,202,203,204,205,206,213,216,220,222,223,224,226,227,228,229,231,232,239,245,246,249,251,254,268,271,273,274,275,276,277,278,279,280,281,289,291,292,294,296,303,306,309,310,315,317,320,321,323,337,343,347,349,350,352,355,356,357,358,361,363,364,366,367,370,372,378,380,387,388,389,392,393,394,395,397,399,400,401,402,403,404,405,406,407,408,409,412,413,415,416,417,419,421,422,423,424,425,426,427,428,431,432,433,434,435,436,437,438,439,440,443,444,445,446,448,449,452,453,455,456,458,459,460,461,468,475,477,478,479,480,481,482,483,485,487,488,489,491,494,495,497,499,500,501,504,505,506,507,508,509,510,514,515],yourself:[6,8,12,13,229,387,519],yplane:353,ypo:178,ysu:[3,203,204,337,498],yuan:9,yukawa:[2,3,7,9,407,476],yukawa_1_1:486,yxz:494,yzx:494,z_i:[418,482,489],z_j:[482,489],z_meam:443,zachari:13,zannoni:422,zbl:[2,3,443,467,476],zblcut:482,zblcutinn:467,zblcutout:467,zblexpscal:482,zblz:467,zcm:317,zcylind:353,zepeda:217,zero:[2,3,4,6,9,11,12,25,26,33,36],zeta:[3,257,308,419],zfactor:206,zflag:[165,166,258,260,267,317,342],zhang:[317,343,423],zhi:[3,6,180,203,215,346,352,355,357,497,500,515],zhi_bound:[6,203],zhou:[13,399,419,456,480,482],zhu:474,ziegenhain:13,ziegler:[302,443,476,482,489],zimmerman2004:216,zimmerman2010:216,zimmerman:[9,74,216,399],zlat:[231,252,515],zlib:[9,203],zlim:466,zlo:[3,6,180,203,215,346,352,354,355,357,497,500,515],zlo_bound:[6,203],zmax:[215,257,524],zmid:232,zmin:[257,524],zn2:177,zone:[130,319],zoom:[3,203,206,207],zorig:75,zplane:353,zr4:177,zrest:334,zsu:[3,203,204,337,498],zwall:352,zwall_veloc:257,zxy:494,zybin:459,zyx:494},titles:["LAMMPS Documentation","5. Accelerating LAMMPS performance","3. Commands","12. Errors","7. Example problems","13. Future and history","6. How-to discussions","1. Introduction","10. Modifying & extending LAMMPS","4. Packages","8. Performance & scalability","11. Python interface to LAMMPS","2. Getting Started","9. Additional tools","5.GPU package","5.USER-INTEL package","5.KOKKOS package","5.USER-OMP package","5.OPT package","angle_style charmm command","angle_style class2 command","angle_coeff 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 hybrid command","angle_style none command","angle_style quartic command","angle_style sdk command","angle_style command","angle_style table command","angle_style zero command","atom_modify command","atom_style command","balance command","Body particles","bond_style class2 command","bond_coeff 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 hybrid command","bond_style morse command","bond_style none command","bond_style nonlinear command","bond_style quartic command","bond_style command","bond_style table command","bond_write command","bond_style zero command","boundary command","box command","change_box command","clear command","comm_modify command","comm_style command","compute command","compute ackland/atom command","compute angle command","compute angle/local command","compute angmom/chunk command","compute basal/atom command","compute body/local command","compute bond command","compute bond/local command","compute centro/atom command","compute chunk/atom command","compute cluster/atom command","compute cna/atom command","compute com command","compute com/chunk command","compute contact/atom command","compute coord/atom command","compute damage/atom command","compute dihedral command","compute dihedral/local command","compute dilatation/atom command","compute dipole/chunk command","compute displace/atom command","compute dpd command","compute dpd/atom command","compute erotate/asphere command","compute erotate/rigid command","compute erotate/sphere command","compute erotate/sphere/atom command","compute event/displace command","compute fep command","compute group/group command","compute gyration command","compute gyration/chunk command","compute heat/flux command","compute hexorder/atom command","compute improper command","compute improper/local command","compute inertia/chunk command","compute ke command","compute ke/atom command","compute ke/atom/eff command","compute ke/eff command","compute ke/rigid command","compute meso/e/atom command","compute meso/rho/atom command","compute meso/t/atom command","compute_modify command","compute msd command","compute msd/chunk command","compute msd/nongauss command","compute omega/chunk command","compute orientorder/atom command","compute pair command","compute pair/local command","compute pe command","compute pe/atom command","compute plasticity/atom command","compute pressure command","compute property/atom command","compute property/chunk command","compute property/local command","compute rdf command","compute reduce command","compute rigid/local command","compute saed command","compute slice command","compute smd/contact/radius command","compute smd/damage command","compute smd/hourglass/error command","compute smd/internal/energy command","compute smd/plastic/strain command","compute smd/plastic/strain/rate command","compute smd/rho command","compute smd/tlsph/defgrad command","compute smd/tlsph/dt command","compute smd/tlsph/num/neighs command","compute smd/tlsph/shape command","compute smd/tlsph/strain command","compute smd/tlsph/strain/rate command","compute smd/tlsph/stress command","compute smd/triangle/mesh/vertices","compute smd/ulsph/num/neighs command","compute smd/ulsph/strain command","compute smd/ulsph/strain/rate command","compute smd/ulsph/stress command","compute smd/vol command","compute sna/atom command","compute stress/atom command","compute force/tally command","compute temp command","compute temp/asphere command","compute temp/body command","compute temp/chunk command","compute temp/com command","compute temp/cs command","compute temp/deform command","compute temp/deform/eff command","compute temp/drude command","compute temp/eff command","compute temp/partial command","compute temp/profile command","compute temp/ramp command","compute temp/region command","compute temp/region/eff command","compute temp/rotate command","compute temp/sphere command","compute ti command","compute torque/chunk command","compute vacf command","compute vcm/chunk command","compute voronoi/atom command","compute xrd command","create_atoms command","create_bonds command","create_box command","delete_atoms command","delete_bonds command","dielectric command","dihedral_style charmm command","dihedral_style class2 command","dihedral_coeff command","dihedral_style cosine/shift/exp command","dihedral_style fourier command","dihedral_style harmonic command","dihedral_style helix command","dihedral_style hybrid command","dihedral_style multi/harmonic command","dihedral_style nharmonic command","dihedral_style none command","dihedral_style opls command","dihedral_style quadratic command","dihedral_style spherical command","dihedral_style command","dihedral_style table command","dihedral_style zero command","dimension command","displace_atoms command","dump command","dump custom/vtk command","dump h5md command","dump image command","dump_modify command","dump molfile command","echo command","fix command","fix adapt command","fix adapt/fep command","fix addforce command","fix addtorque command","fix append/atoms command","fix atc command","fix atom/swap command","fix ave/atom command","fix ave/chunk command","fix ave/correlate command","fix ave/correlate/long command","fix ave/histo command","fix ave/time command","fix aveforce command","fix balance command","fix bond/break command","fix bond/create command","fix bond/swap command","fix box/relax command","fix colvars command","fix deform command","fix deposit command","fix drag command","fix drude command","fix drude/transform/direct command","fix dt/reset command","fix efield command","fix ehex command","fix enforce2d command","fix eos/cv command","fix eos/table command","fix eos/table/rx command","fix evaporate command","fix external command","fix freeze command","fix gcmc command","fix gld command","fix gle command","fix gravity command","fix heat command","fix imd command","fix indent command","fix ipi command","fix langevin command","fix langevin/drude command","fix langevin/eff command","fix lb/fluid command","fix lb/momentum command","fix lb/pc command","fix lb/rigid/pc/sphere command","fix lb/viscous command","fix lineforce command","fix manifoldforce command","fix meso command","fix meso/stationary command","fix_modify command","fix momentum command","fix move command","fix msst command","fix neb command","fix nvt command","fix nvt/eff command","fix nph/asphere command","fix nph/body command","fix nph/sphere command","fix nphug command","fix npt/asphere command","fix npt/body command","fix npt/sphere command","fix nve command","fix nve/asphere command","fix nve/asphere/noforce command","fix nve/body command","fix nve/eff command","fix nve/limit command","fix nve/line command","fix nve/manifold/rattle command","fix nve/noforce command","fix nve/sphere command","fix nve/tri command","fix nvt/asphere command","fix nvt/body command","fix nvt/manifold/rattle command","fix nvt/sllod command","fix nvt/sllod/eff command","fix nvt/sphere command","fix oneway command","fix orient/fcc command","fix phonon command","fix pimd command","fix planeforce command","fix poems","fix pour command","fix press/berendsen command","fix print command","fix property/atom command","fix qbmsst command","fix qeq/point command","fix qeq/comb command","fix qeq/reax command","fix qmmm command","fix qtb command","fix reax/bonds command","fix reax/c/species command","fix recenter command","fix restrain command","fix rigid command","fix rx command","fix saed/vtk command","fix setforce command","fix shake command","fix shardlow command","fix smd command","fix smd/adjust_dt command","fix smd/integrate_tlsph command","fix smd/integrate_ulsph command","fix smd/move_tri_surf command","fix smd/setvel command","<no title>","fix smd/wall_surface command","fix spring command","fix spring/chunk command","fix spring/rg command","fix spring/self command","fix srd command","fix store/force command","fix store/state command","fix temp/berendsen command","fix temp/csvr command","fix temp/rescale command","fix temp/rescale/eff command","fix tfmc command","fix thermal/conductivity command","fix ti/rs command","fix ti/spring command","fix tmd command","fix ttm command","fix tune/kspace command","fix vector command","fix viscosity command","fix viscous command","fix wall/lj93 command","fix wall/gran command","fix wall/piston command","fix wall/reflect command","fix wall/region command","fix wall/srd command","group command","group2ndx command","if command","improper_style class2 command","improper_coeff command","improper_style cossq command","improper_style cvff command","improper_style distance command","improper_style fourier command","improper_style harmonic command","improper_style hybrid command","improper_style none command","improper_style ring command","improper_style command","improper_style umbrella command","improper_style zero command","include command","info command","jump command","kspace_modify command","kspace_style command","label command","lattice command","log command","Description","mass command","min_modify command","min_style command","minimize command","molecule command","neb command","neigh_modify command","neighbor command","newton command","next command","package command","pair_style adp command","pair_style airebo command","pair_style awpmd/cut command","pair_style beck command","pair_style body command","pair_style bop command","pair_style born command","pair_style brownian 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_coeff 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 dsmc 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 hybrid command","pair_style kim command","pair_style lcbop command","pair_style line/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_modify 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 none command","pair_style peri/pmb command","pair_style polymorphic command","pair_style quip command","pair_style reax command","pair_style reax/c command","pair_style resquared command","pair_style lj/sdk command","pair_style smd/hertz command","pair_style smd/tlsph command","pair_style smd/tri_surface command","pair_style smd/ulsph command","pair_style smtbq command","pair_style snap command","pair_style soft command","pair_style sph/heatconduction command","pair_style sph/idealgas command","pair_style sph/lj command","pair_style sph/rhosum command","pair_style sph/taitwater command","pair_style sph/taitwater/morris command","pair_style srp command","pair_style command","pair_style sw command","pair_style table command","pair_style table/rx command","pair_style tersoff command","pair_style tersoff/mod command","pair_style tersoff/zbl command","pair_style thole command","pair_style tri/lj command","pair_style vashishta command","pair_write command","pair_style yukawa command","pair_style yukawa/colloid command","pair_style zbl command","pair_style zero command","partition command","prd command","print command","processors command","python command","quit command","read_data command","read_dump command","read_restart command","region command","replicate command","rerun command","reset_timestep command","restart command","run command","run_style command","set command","shell command","special_bonds command","suffix command","tad command","temper command","thermo command","thermo_modify command","thermo_style command","timer command","timestep command","Tutorial for Thermalized Drude oscillators in LAMMPS","LAMMPS GitHub tutorial","uncompute command","undump command","unfix command","units command","variable command","velocity command","write_coeff command","write_data command","write_dump command","write_restart command"],titleterms:{"break":226,"default":[36,39,40,55,59,60,61,63,64,74,75,95,96,100,112,113,115,117,118,119,126,130,134,135,152,158,166,167,171,177,178,181,183,198,201,202,203,204,206,207,208,209,211,212,213,215,216,217,219,223,226,227,229,230,231,232,236,243,246,247,252,254,255,256,257,258,260,266,269,271,272,276,294,295,299,300,303,304,305,306,307,309,312,314,315,317,319,335,337,342,343,344,345,348,350,352,354,358,371,375,377,378,380,381,384,385,387,389,390,391,393,396,399,401,418,440,441,446,448,458,459,475,476,492,493,494,497,498,500,502,504,505,506,509,511,513,514,515,516,517,523,525,527,528],"function":524,"long":[221,400,402,403,404,405,409,411,412,431,435,439,453,461,483],"new":8,"static":12,acceler:1,account:519,ackland:66,acknowledg:7,adapt:[211,212],addforc:213,adding:519,addition:[12,13,519],addtorqu:214,adiabat:6,adjust_dt:324,adp:394,after:519,airebo:395,alloi:416,amber2lmp:13,amber:6,angl:[8,67,68],angle_coeff:21,angle_styl:[2,19,20,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38],angmom:69,append:215,arrai:6,aspher:[6,90,156,273,277,281,282,291],asphere:9,atc:[9,216],atom:[6,7,8,66,70,74,75,76,77,80,81,82,85,87,89,93,100,105,106,109,110,111,117,121,122,124,152,153,176,215,217,218,306,524],atom_modifi:39,atom_styl:40,attract:5,aveforc:224,awpmd:[9,396],axel:519,balanc:[41,225],barostat:6,basal:70,bcc:298,beck:397,berendsen:[304,338],between:6,binary2txt:13,bodi:[6,8,42,71,157,274,278,283,292,398],body:9,bond:[8,13,72,73,226,227,228,313],bond_coeff:44,bond_styl:[2,43,45,46,47,48,49,50,51,52,53,54,55,56,58],bond_writ:57,bop:399,born:[400,411],boundari:[7,59],box:[6,60,229],branch:519,brownian:401,buck:[402,403,411,442],bug:3,build:[11,12],calcul:6,call:12,categori:2,centro:74,ch2lmp:13,chain:13,chang:519,change_box:61,charmm:[6,19,184,404,439],chunk:[6,69,75,79,86,98,103,114,116,125,158,173,175,219,332],citat:7,class2:[9,20,43,185,361,405],clear:62,cluster:76,cmm:9,cna:77,code:6,coeffici:6,colloid:[9,352,407,488],colvar:[13,230],colvars:9,com:[78,79,159],comb3:408,comb:[309,408],come:5,comm_modifi:63,comm_styl:64,command:[2,6,8,12,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,200,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,373,374,375,376,377,378,379,380,381,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,517,520,521,522,523,524,525,526,527,528,529],common:3,comparison:1,compos:6,compress:9,comput:[2,6,8,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,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,169,170,171,172,173,174,175,176,177,524],compute_modifi:112,condit:7,conduct:[6,343],constant:[6,524],constraint:7,contact:[80,132],coord:81,core:6,coreshell:9,correl:[220,221],cosin:[22,23,24,25,26,27,187],cossq:363,coul:[400,402,403,404,405,409,410,411,424,431,435,439,453,461],coupl:6,creat:227,create_atom:178,create_bond:179,create_box:180,createatom:13,creation:7,csld:339,csvr:339,cubic:433,custom:[8,203,204],cut:[49,396,402,405,409,412,418,421,431,432,439,447,453,483],cvff:364,damag:[82,133],data2xmovi:13,data:6,databas:13,deby:[409,431],defgrad:139,deform:[161,162,231],delete_atom:181,delete_bond:182,delta:23,deposit:232,descript:[19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,200,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,373,374,375,376,377,378,379,380,381,382,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,517,520,521,522,523,524,525,526,527,528,529],diagnost:7,diel:410,dielectr:183,diffraction:9,diffus:6,dihedr:[8,83,84],dihedral_coeff:186,dihedral_styl:[2,184,185,187,188,189,190,191,192,193,194,195,196,197,198,199,200],dilat:85,dimens:201,dipol:[6,28,86,412],dipole:9,direct:235,directori:4,discuss:6,disp:6,displac:[87,94],displace_atom:202,distanc:365,distribut:[7,12],document:0,dpd:[9,88,89,413,414],drag:233,dreid:425,dreiding:6,drude:[6,9,163,234,235,255,518],dsf:[409,431],dsmc:415,dump:[6,8,203,204,205,206,208],dump_modifi:207,dynam:308,eam:[13,416],echo:209,edip:417,eff:[9,13,106,107,162,164,169,256,272,284,295,341,418],efield:237,ehex:238,eim:419,elastic:6,emac:13,energi:[135,414],enforce2d:239,ensembl:7,erot:[90,91,92,93],error:[3,134],evapor:243,event:94,exampl:[4,6,11,19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,200,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,373,374,375,376,377,378,379,380,381,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,510,511,512,513,514,515,516,517,520,521,522,523,524,525,526,527,528,529],exp6:420,exp:[26,187],expand:[46,434],extend:[8,11],extern:244,fcc:298,fdt:414,featur:[7,8,519,524],fene:[45,46],fep:[9,13,95,212],field:[6,7],file:6,finit:6,fire:308,fix:[2,6,8,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,524],fix_modifi:[211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357],flow:6,fluid:257,flux:[99,154],forc:[6,7,154,336],fork:519,fourier:[29,30,188,366],freez:245,from:[6,11],futur:5,gauss:421,gaybern:422,gcmc:246,gener:[1,6,7,13],get:12,github:519,gld:247,gle:248,global:6,gpu:[9,14,397,400,402,404,405,407,409,412,413,416,421,422,424,431,432,433,434,447,449,460,461,468,477,478,480,481,482,487,488,489],gran:[353,423],granular:[6,9],graviti:249,gromac:424,group2ndx:359,group:[96,358,524],gyrat:[97,98],h5md:[9,203,205],harmon:[31,47,48,49,189,192,352,367,452],hbond:425,heat:[99,154,250],heatconduct:469,helix:190,hertz:[423,462],hexord:100,histo:222,histori:[5,423],hook:423,hourglass:134,how:6,hybrid:[32,50,191,368,426],idealga:470,imag:[203,206],imd:251,implicit:404,improp:[8,101,102],improper_coeff:362,improper_styl:[2,361,363,364,365,366,367,368,369,370,371,372,373],includ:374,inclus:8,indent:252,indice:0,individu:2,induc:6,inertia:103,info:[0,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357,375],input:[2,6,8],install:11,integr:6,integrat:7,integrate_tlsph:325,integrate_ulsph:326,intel:[9,15,19,31,45,47,184,189,195,271,280,281,294,364,367,402,404,422,431,477,480],interfac:[6,11],intern:135,introduct:7,invers:235,ipi:253,ipp:13,jul:0,jump:376,kate:13,keyword:[448,524],kim:[9,427],kokkos:[9,16],kspace:[2,8,9,348],kspace_modifi:377,kspace_styl:[6,378],label:379,lammps:[0,1,2,6,7,8,11,12,518,519],langevin:[254,255,256],lattic:380,lcbop:428,lennard:442,librari:[6,11,12],limit:285,line:[12,286,429],linear:[438,449],lineforc:262,list:[2,430],lj1043:352,lj126:352,lj93:352,lj96:432,lmp2arc:13,lmp2cfg:13,lmp2vmd:13,local:[6,68,71,73,84,102,119,126,129],log:381,lowercas:4,lubric:440,lubricateu:441,luci:[450,451],make:[12,519],manifold:[9,287,293],manifoldforc:263,manybody:9,mass:383,math:524,matlab:13,mdf:442,meam:[9,443,444,445],measur:1,merg:519,mesh:146,meso:[109,110,111,264,265],messag:3,mgpt:[9,446],micelle2d:13,mie:447,min_modifi:384,min_styl:385,minim:[8,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357,386],misc:9,mod:[347,481],model:[6,7],modifi:8,mol:154,molecul:387,molecule:9,molfil:[203,208],molfile:9,moltempl:13,momentum:[258,267],morri:474,mors:[51,395,425,449],move:268,move_tri_surf:327,movi:[203,206],mpi:11,mpiio:9,msd:[113,114,115],msi2lmp:13,msm:[400,402,404,409,431],msst:269,multi:[6,7,192,450,451],multipl:6,nb3b:452,ndx2group:359,neb:[270,388],neigh:[141,147],neigh_modifi:389,neighbor:390,nemd:6,newton:391,next:392,nharmon:193,noforc:[282,288],non:[6,7],none:[33,52,194,369,454],nongauss:115,nonlinear:53,nph:[271,272,273,274,275,317],nphug:276,npt:[271,272,277,278,279,317],num:[141,147],numer:524,nve:[280,281,282,283,284,285,286,287,288,289,290,317],nvt:[271,272,291,292,293,294,295,296,317],omega:116,omp:[9,17,19,20,22,23,24,25,26,27,28,29,30,31,34,37,43,45,46,47,48,49,51,53,54,56,184,185,187,188,189,190,192,193,195,196,199,249,271,273,275,276,277,279,280,289,291,294,296,309,361,363,364,366,367,370,372,394,395,397,400,401,402,403,404,405,407,408,409,410,412,413,416,419,421,422,423,424,425,426,431,432,433,434,435,436,437,438,439,440,444,445,449,452,453,455,460,461,468,477,478,480,481,482,483,485,487,488,489],onewai:297,open:7,operat:524,opl:195,opt:[9,18,404,416,431,435,449],optim:1,option:[6,8,12],orient:298,orientord:117,orthogon:6,oscil:518,other:6,output:[6,7,8,12,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357],overlai:426,overview:11,own:519,packag:[1,9,12,14,15,16,17,18,393],pair:[6,118,119],pair_coeff:406,pair_modifi:448,pair_styl:[2,394,395,396,397,398,399,400,401,402,403,404,405,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,487,488,489,490],pair_writ:486,pairwis:8,paquai:519,parallel:11,paramet:6,pars:2,partial:165,particl:[6,7,42],partit:491,past:5,per:6,perform:[1,10],peri:[9,455],period:24,phonon:[9,13,299],pimd:300,piston:354,planeforc:301,plastic:[122,136,137],pmb:455,poem:302,poems:9,point:308,polariz:6,poli:[401,440,441],polym:13,polymorph:456,post:7,potenti:[2,6,8],pour:303,pppm:6,prd:492,pre:7,press:304,pressur:123,previou:12,print:[305,493],problem:[3,4],process:[6,7],processor:494,profil:166,properti:[6,124,125,126,306],pymol_aspher:13,python:[9,11,13,495],qbmsst:307,qeq:[9,308,309,310],qmmm:[9,311],qtb:[9,312],quadrat:196,quantiti:6,quartic:[34,54],quip:[9,457],quit:496,radiu:132,ramp:167,rate:[137,144,149],rattl:[287,293,321],rdf:127,read_data:497,read_dump:498,read_restart:499,reax:[9,13,310,313,314,458,459],reaxc:9,rebo:395,recent:315,reduc:128,refer:524,reflect:355,region:[8,128,168,169,356,500,524],relat:[19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,40,41,43,44,45,46,47,48,49,50,51,53,54,55,56,57,58,59,61,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,91,92,93,94,95,97,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,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,169,170,171,172,173,174,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,201,202,203,204,205,206,207,208,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,240,241,242,243,245,246,247,248,249,250,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,312,313,314,315,317,318,319,320,322,323,324,325,326,327,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,374,375,376,377,378,380,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,502,503,504,505,506,507,509,510,511,512,513,514,515,516,517,520,521,522,524,525,526,527,528,529],relax:229,replic:501,replica:[6,7,9],report:3,repositori:519,requir:12,rerun:502,rescal:[340,341],reset:236,reset_timestep:503,resquar:460,restart2data:13,restart:[6,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357,504],restrain:316,restrict:[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,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,200,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,300,301,302,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,373,374,375,376,377,378,379,380,381,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,517,520,521,522,523,524,525,526,527,528,529],rho:[110,138],rhosum:472,rigid:[6,9,91,108,129,260,317],ring:370,rotat:170,rule:2,run:[6,11,12,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357,505],run_styl:506,scalabl:10,scalar:6,screen:12,script:[2,6,8,11],sdk:[35,461],self:334,serial:11,set:[6,507],setforc:320,setvel:328,shake:321,shape:142,shardlow:322,share:[11,12],shell:[6,508],shield:308,shift:[25,26,48,49,187],shock:9,simpl:30,simul:6,size:6,slater:308,slice:131,sllod:[294,295],small:317,smd:[9,132,133,134,135,136,137,138,139,140,141,142,143,144,145,146,147,148,149,150,151,323,324,325,326,327,328,330,462,463,464,465],smooth:[437,438,449],smtbq:[9,466],sna:152,snad:152,snap:[9,467],snapshot:6,snav:152,soft:[439,449,468],solver:2,sourc:7,spc:6,speci:314,special:[7,448,524],special_bond:509,sph:[9,469,470,471,472,473,474],sphere:[92,93,171,260,275,279,289,296],spheric:[6,197],spline:[444,445],spring:[331,332,333,334,345],squar:27,srd:[9,335,357],srp:475,standard:9,start:[12,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357],state:337,stationari:265,stefan:519,stop:[211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,229,230,231,232,233,235,236,237,238,239,243,244,245,246,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,298,299,301,302,303,304,305,306,307,308,309,310,311,313,314,315,316,317,319,320,321,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,349,350,351,352,353,354,355,356,357],store:[336,337],strain:[136,137,143,144,148,149],strategi:1,streitz:409,stress:[145,150,153,154],structur:2,style:[1,2,6,8],submit:8,suffix:510,summari:6,swap:[217,228],syntax:[19,20,21,22,23,24,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,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,168,169,170,171,172,173,174,175,176,177,178,179,180,181,182,183,184,185,186,187,188,189,190,191,192,193,194,195,196,197,198,199,200,201,202,203,204,205,206,207,208,209,210,211,212,213,214,215,216,217,218,219,220,221,222,223,224,225,226,227,228,229,230,231,232,233,234,235,236,237,238,239,240,241,242,243,244,245,246,247,248,249,250,251,252,253,254,255,256,257,258,259,260,261,262,263,264,265,266,267,268,269,270,271,272,273,274,275,276,277,278,279,280,281,282,283,284,285,286,287,288,289,290,291,292,293,294,295,296,297,299,300,301,303,304,305,306,307,308,309,310,311,312,313,314,315,316,317,318,319,320,321,322,323,324,325,326,327,328,330,331,332,333,334,335,336,337,338,339,340,341,342,343,344,345,346,347,348,349,350,351,352,353,354,355,356,357,358,359,360,361,362,363,364,365,366,367,368,369,370,371,372,373,374,375,376,377,378,379,380,381,383,384,385,386,387,388,389,390,391,392,393,394,395,396,397,398,399,400,401,402,403,404,405,406,407,408,409,410,411,412,413,414,415,416,417,418,419,420,421,422,423,424,425,426,427,428,429,430,431,432,433,434,435,436,437,438,439,440,441,442,443,444,445,446,447,448,449,450,451,452,453,454,455,456,457,458,459,460,461,462,463,464,465,466,467,468,469,470,471,472,473,474,475,476,477,478,479,480,481,482,483,484,485,486,487,488,489,490,491,492,493,494,495,496,497,498,499,500,501,502,503,504,505,506,507,508,509,510,511,512,513,514,515,516,517,520,521,522,523,524,525,526,527,528,529],system:6,tabl:[0,6,37,56,199,241,242,478,479,480],tad:511,taitwat:[473,474],talli:154,tally:9,temp:[155,156,157,158,159,160,161,162,163,164,165,166,167,168,169,170,171,338,339,340,341],temper:512,temperatur:6,tersoff:[480,481,482],test:11,tfmc:342,thermal:[6,343,518],thermo:[6,513,524],thermo_modifi:514,thermo_styl:515,thermodynam:[6,8],thermostat:6,thole:483,time:[6,223],timer:516,timestep:517,tip3p:6,tip4p:[6,409,431,435,439],tip:12,tlsph:[139,140,141,142,143,144,145,463],tmd:346,tool:[12,13],torqu:173,transform:235,tri:[290,484],tri_surfac:464,triangl:146,triclin:6,tstat:413,ttm:347,tune:348,tutori:[518,519],type:7,ulsph:[147,148,149,150,465],umbrella:372,uncomput:520,undump:521,unfix:522,unit:523,uppercas:4,use:448,user:[9,12,15,17],using:[6,11],vacf:174,valu:[6,524],variabl:[6,8,524],variou:1,vashishta:485,vcm:175,vector:[6,349,524],veloc:525,version:[0,5,12],vertic:146,via:12,vim:13,viscos:[6,350],viscou:[261,351],visual:6,vol:151,voronoi:[9,176],vtk:[9,203,204,319],wall:[6,352,353,354,355,356,357],wall_surfac:330,warn:3,water:6,weight:222,what:[7,12],wisdom:519,wolf:[400,409],wrapper:11,write:6,write_coeff:526,write_data:527,write_dump:528,write_restart:529,written:519,xmgrace:13,xmovi:13,xrd:177,your:519,yukawa:[487,488],zbl:[482,489],zero:[38,58,200,373,490]}}) \ 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_rigid_local","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_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","manifolds","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_modify","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","tutorial_github"],objects:{},objnames:{},objtypes:{},terms:{"00a":77,"00b":77,"02214e23":35,"0b1":3,"0e4":118,"0x98b5e0":58,"100k":1,"1024x1024":58,"10e":107,"10x":[91,92,97],"12th":74,"16e":74,"16x":1,"18986e":91,"1_prop":2,"1fluid":[115,142],"1st":[2,5,32,46,65,68,74,93,94,97,104,111,113,114,115,128,129,134,135,136,141,142,143,145,149,155,156,157,158,159],"2000k":58,"20x":97,"23899e":91,"2400k":58,"2697v2":4,"2697v4":4,"298k":106,"2k_ss":113,"2nd":[2,3,21,22,62,65,68,82,91,92,94,104,113,120,134,141,142,149,155,156,157,158,159],"2theta":44,"2x5":113,"36x":4,"3806504e":[2,35],"3n_k":66,"3nk":72,"3rd":[5,37,65,104,113,115,120,141,142,149,155,156,157,158,159],"3x3":35,"4857990943e":113,"49e":74,"4_94":3,"4th":[2,46,74,93,94,97,111,114,115,118,134,141,142,143,145,149,155,156,158,159],"50k":1,"512k":4,"524k":4,"5_1":97,"5th":[91,115],"66e":74,"6x6":2,"7120p":4,"8706e":148,"8706q":148,"8730m":148,"8730n":148,"8x1":2,"8x2":2,"948q":148,"9jan09":118,"9th":92,"break":[28,113,139],"case":[1,2,3,4,19,21,22,29,30,45,46,58,60,62,67,68,69,70,72,73,74,79,80,81,91,92,94,101,103,105,107,111,113,117,118,120,130,131,132,134,137,139,141,142,143,145,150,154,156,158,162,163],"catch":1,"char":[2,148],"class":[1,2,3,57,102,159],"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,58],"final":[2,3,19,32,43,60,62,68,69,72,74,77,79,91,92,93,94,97,111,114,115,130,134,143,145,155,156,158,159,163],"float":[2,4,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,42,46,47,48,49,50,51,52,53,54,55,56,59,62,65,66,67,68,69,71,73,74,75,77,78,79,80,82,83,84,86,87,88,89,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,148,150,151,152,153,155,156,157,158,159,160,161,162],"import":[1,2,3,37,45,50,62,68,79,130,137],"int":[2,3,79],"long":[1,2,4,18,32,39,43,46,51,58,59,63,68,75,79,91,92,95],"new":[0,2,3,19,32,45,58,60,61,62,63,68,69,71,75,91,92,111,134,137,141,142,163],"null":[2,35,36,38,39,43,45,74,76,93,94,104,111,114,118,134,135,136,143,145,149,155,156,157,158,159],"public":[0,114,141,142,148],"return":[2,3,4,19,45,68,118],"short":[1,2,4,68,90,94,97,98,99,100,101,104,105,107,113,122,126,130,133,134,139,140,144,147,148,163],"static":[2,19,58,60,68,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,42,44,46,47,48,49,50,51,52,53,54,55,58,67,68,69,75,77,78,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162,163],"true":[2,40,60,68,70,71,113,118,148,155],"try":[1,67,77,78,163],"var":[3,45],"void":[2,19,60],"while":[1,3,29,37,42,50,62,66,67,68,72,74,91,97,106,111,156,158,159],_j1m1m1:42,_j2m2m2:42,_manifold_rattl:163,_wirnsberg:63,a12:146,a2m:[2,35],a_0:[67,79,97],a_0_real:67,a_1:79,a_2:79,a_3:79,a_4:79,a_c:103,a_cc:103,a_f:158,a_ij:97,a_pi:97,a_sigma:97,a_ss:103,aat:47,aberdeen:[31,64],abil:[62,68,113],abl:[3,61],ablat:79,about:[0,1,2,3,4,19,41,45,58,59,60,61,62,63,67,69,70,73,75,76,77,78,79,80,81,90,91,92,96,101,105,161,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,41,42,43,44,45,46,47,48,49,50,51,52,53,54,55,56,58,60,61,62,68,69,71,73,74,82,83,84,85,86,87,88,89,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,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],abscissa:[141,142],absolut:[74,91,118,122],absorb:79,abstol:74,ac3:44,acceler:0,accelri:2,accept:[32,45,61,74,100,126,163],acceptor:120,access:[0,2,3,4,29,30,31,33,34,35,36,37,38,39,40,41,42,43,44,59,60,61,62,63,66,67,68,69,70,72,73,75,76,77,78,79,80,81,94,116,118,120,134,150],accident:163,accidenti:88,accomod:68,accomplish:4,accord:[2,31,58,65,67,68,72,77,78,79,80,81,113,118,125,128,145,148,150,151,152,153,154],accordingli:[3,131,132,154],account:[2,32,41,44,57,63,68,70,75,76,79,86,105,110,118,122,126,131,132,134,137,148,163],accumul:[2,31],accur:[1,2,19,60,74,75,81,97,113,117,118,139,146,156,158],accuraci:[1,2,19,60,63,68,75,94,113,139,141,142],achiev:[1,2,4,13,19,60,63,68,71,72],ackland1:111,ackland2:111,ackland:111,acknowledg:0,acolor:58,acquir:[2,62,68],across:[1,2,19,60,74,79,81,92],act:[2,40,67,77,78,79,81,91,108,117,118,120,146,154],acta:[41,44,93],actinid:137,action:[2,3,66,78],activ:[3,4,32,66,74,130],actual:[1,2,70,117,119,125,131,132,154],adapt:[2,32,74,130,131,150],adapti:70,adaptiv:94,add:[0,1,2,3,4,32,35,40,45,58,59,63,67,68,69,70,73,75,78,79,80,81,94,98,99,102,105,113,122,134,139,140,144,147,163],add_molecul:59,add_speci:59,add_to_nodeset:59,added:163,addforc:91,adding:[73,163],addit:[1,2,4,5,13,19,45,56,57,58,60,62,63,65,67,68,69,70,75,80,81,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,139,141,142,143,144,145,147,148,149,155,156,157,158,159,162,163],addition:[0,2,3,4,58,79,92,117,146,163],address:[3,58,163],addtorqu:91,adequ:92,adher:13,adhikari:67,adiabat:0,adiam:58,adjac:[45,63,92,139,156],adjiman:138,adjust:[2,4,19,41,44,58,60,62,68,69,70,72,74,80,91,92,94,131,132,148,158],admiss:69,adopt:73,advanc:[4,97],advantag:[1,2,3,19,60,112],advect:2,advis:[74,92],affect:[1,2,43,58,61,62,63,76,79,88,91,92,113,131,132,139],affin:[4,104],afshar:109,after:[2,3,6,19,45,47,56,58,59,60,61,62,67,68,72,74,75,77,78,80,82,91,93,94,97,104,111,112,113,114,115,130,131,132,134,135,136,137,141,142,143,145,148,149,155,156,157,158,159,163],afterword:19,ag1:44,ag2:44,again:[2,3,42,63,82,92,131,132],against:[3,92],aggreg:[2,76],aggress:63,agre:[91,94],ahd:120,aidan:0,aim:2,aka:58,al2o3:148,al2o3_001:41,al3:44,ala:[67,148],alat:[70,134],albe:[145,156,158],albeit:73,alchem:32,alcu:[93,97],alcu_eam:145,alderton:108,alejandr:68,algebra:137,algorithm:[0,1,2,19,59,60,61,63,67,71,75,79,91,110,113,132,137],alia:4,alias:1,align:[2,13,19,60],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,46,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,86,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,159,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,44,45,57,58,59,60,61,62,66,67,68,70,72,73,74,75,76,77,78,79,80,81,91,92,94,97,98,99,100,101,105,111,113,118,119,120,122,126,131,132,137,139,145,146,148,154,161,163],almost:[4,72,79,154],alo:105,alon:[2,61],along:[2,13,29,32,41,44,45,58,61,63,67,72,75,76,79,81,90,91,92,105,108,118,122,126,134],alonso:[135,136],alpha:[2,26,67,72,91,93,95,98,105,109,110,111,112,114,115,120,121,122,134,140,157],alpha_c:130,alpha_i:149,alpha_lj:130,alphabet:57,alreadi:[45,60,72,92,109,119,124,132,154,162],also:[0,1,2,3,4,13,18,19,28,29,30,31,32,33,34,36,37,38,39,42,43,45,46,57,58,60,61,62,64,65,66,67,68,69,70,71,72,73,74,75,76,79,81,91,92,97,100,101,106,107,108,109,111,112,113,117,118,120,126,130,131,134,137,139,143,145,146,147,151,152,153,155,156,157,158,159,163],alter:[2,3,19,45,58,61,62,68,92],altern:[1,2,3,4,35,45,64,68,74,83,87,91,93,94,105,110,111,112,114,122,130,134,135,136,143,145,149,155,156,158,159],alternat:91,although:[4,13,68],aluminum:162,alwai:[0,2,3,4,28,80,81,82,91,99,102,111,125,137,141,142,148,150,156,158,162],amaz:3,amber2lmp:0,amber:0,ambient:58,amd:137,among:[4,43,67],amorph:[45,157],amount:[1,2,58,62,68,70,74,109],amplitud:88,amzallag:148,analag:2,analalog:2,analog:[2,38,42,118],analysi:[30,137,149],analyt:[1,41,44,75,97,124,137,145],analyz:[2,92,137],andersen:75,anderson:109,andzelm:154,ang:[4,70],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,61,68,73,75,82,83,84,86,87,88,89,91,94,97,105,112,120,122,126,130,135,136,143,159],angle1:73,angle2:73,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:120,angle_cutoff:120,angle_hybrid:13,angle_styl:[0,2],angleangl:82,angleangletors:47,angletors:47,angmom:2,angmomi:40,angmomx:40,angmomz:40,angstrom:[2,40,41,44,45,58,80,93,94,101,111,130,134,143,158,162],angular:[2,13,40,42,45,75,93,97,104,118,131,132,134,137,145,156,157],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,60,61,62,63,65,67,68,69,70,71,74,75,79,80,81,91,92,94,97,100,101,104,105,108,109,111,112,114,117,126,137,139,141,142,145,146,149,155,156,157,158,159,163],anihil:[130,140],anim:[3,58,92],animat:58,anion:[114,148],aniso:[62,68,69],anisotrop:[117,146],ann:138,annoi:163,annot:[155,156,157,158,159],anoth:[2,3,4,13,58,61,63,66,68,69,79,91,92,105,109,113,114,117,120,121,122,130,146,150,154,156,157,158,163],another:[1,2,32,90],ansi:4,anthoni:78,antisymmetri:113,antonelli:[77,78],any:[1,2,58,154],anymor:78,anyth:[3,45,155,156,158,163],anywher:[45,134,149],aparam:32,apart:[96,150],api:3,appear:[2,3,19,32,36,38,42,45,58,60,62,82,91,92,103,111,134,139,141,142,148,159],append:[1,3,4,19,29,32,34,35,36,37,38,39,41,42,43,44,45,58,60,61,62,63,66,67,68,69,71,72,73,75,78,80,97,113,154],appendix:[13,108,148],appl:[62,68,159],appli:[2,13,19,32,37,42,43,44,45,46,57,58,59,60,62,63,64,65,66,67,68,69,70,71,72,73,75,78,79,91,92,96,98,99,101,105,108,113,115,118,119,120,122,128,132,137,139,142,144,147,154,161],applic:[1,2,4,61,70,73,158],applicat:59,appling:62,apply:[32,62,75,76],approach:[2,4,56,59,66,71,78,79,97,105,107,110,117,137,146,154],appropri:[1,2,3,30,35,40,57,61,62,67,68,69,71,72,80,81,92,94,97,100,103,104,105,112,118,126,130,137,155,156,157,158,159],approxim:[2,41,44,67,71,75,90,91,107,113,115,117,131,132,137,139,142,146,148,161],april:3,apu:[131,132],aqua:58,ar_thermal:59,ar_ttm:59,arbitrari:[2,58,68,71,74,155],arbitrarili:[3,42,62,68,105],arch:1,architectur:137,archiv:2,archive:3,area:[2,19,35,39,60,67,118],arg:[3,19,32,45,60,63,73,78,80,92,98,99,101,102,107,108,110,113,119,122,126,130,131,132,133,140,144,147],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,60,62,65,68,69,74,75,79,82,83,84,86,87,88,89,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,150,155,156,157,158,159,160,161,162],aris:161,arithmet:[2,101,103,125,139],arl:[31,64],army:[31,64],around:[1,2,29,30,40,42,45,46,56,58,62,68,80,81,90,148],arrang:42,arrheniu:74,arriv:4,articl:[2,148],artifici:[72,151,152],arxiv:[42,90,149],ascend:19,ascii:[92,111,114,134],ash:[131,132],aside:[45,134],ask:[3,163],asoci:58,aspect:[2,117,146],aspher:0,asphere:[117,146],asq:[131,132],assign:[1,2,3,19,34,40,41,42,43,44,45,58,60,61,62,67,68,69,71,92,97,111,114,117,120,141,142,146,162],assignemnt:2,associ:[2,32,33,34,40,57,58,62,66,67,68,73,74,76,91,92,105,109,110,111,113,120,122,126,141,142,154],assum:[2,3,45,62,67,70,79,80,85,92,97,100,103,113,120,121,126,131,132,163],assume:92,assumpt:[93,139],astar:134,astart:150,asterisk:[32,120,154],astop:[91,150],asu:111,asub:134,asymmetr:[63,97,111],asynchron:4,atc_fe_output:59,athomp:0,atm2pa:2,atobodi:40,atom1:73,atom2:73,atom3:73,atom4:73,atom:[0,1],atom_element_map:59,atom_modifi:[3,92],atom_styl:[2,31,45,58,64,65,68,74,92,96,103,108,110,113,114,117,118,132,146,161],atom_weight:59,atomey:[2,3,58],atomfil:2,atomic:[0,148],atomic_charg:59,atomic_numb:145,atomid:40,atomist:[2,59,137],attach:[2,71],attatch:78,attempt:[2,19,60,61,92],attend:59,attrac:134,attract:[0,21,22,94,100,103,126,134,138,148,161],attribut:[2,3,32,40,58,61,62,68,69,97,113],atw:[131,132],atwater:157,atwt:134,atyp:[105,122,126,130],au1:44,au3:44,aug:3,augment:[62,134],augt1:134,author:[111,112],auto:[2,3,35],autocorrel:35,autom:58,automat:[2,4,18,67,104,111,134,137,162,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,42,46,47,48,49,50,51,52,53,54,55,58,62,66,68,69,74,75,78,82,83,84,86,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,140,143,144,145,146,147,149,150,155,156,157,158,159,160,161,162],availabl:4,avalo:110,ave_chunk:2,aveforc:2,avendano:138,averag:[2,19,31,32,35,36,37,41,44,59,60,62,68,69,72,74,82,94,110,113,115,134,142],avi:58,avoid:[1,2,18,40,45,58,70,71,81,97,113,130,134,140],avx2:4,avx512:4,avx:4,awai:[2,58,61,70,80,105,122,126],awar:112,axel:163,axi:[2,19,29,36,41,44,45,58,60,79,86,89,90],axial:69,azimuth:58,b_k:149,ba2:44,babadi:146,back:[1,2,3,40,45,68,77,78,92,118],backbon:[61,75,88],background:[32,39,43,60,79,92,103,131,132,134],backtrack:91,backward:92,baczewski:66,bad:92,badli:[62,68],balanc:[1,2,4],ball:[42,131,132],bammann:59,band:[2,42,92,97,137,148],bandwidth:1,bandwith:58,bar:[32,58],barashev:111,barostat:[0,1],barostt:2,barr:104,barrier:[2,89,92,104,116],bartok2010:149,bartok2013:149,bartok:[42,149],base:[2,3,4,5,32,35,41,44,45,58,59,60,71,74,94,95,97,109,113,117,120,122,131,135,136,144,145,148,155,157,158,159,163],bashford:[2,5,46,101],basi:[2,42,45,80],basic:[2,19,43,58,59,60,68,70,81,93,137],basin:92,bask:[111,134,145],bath:72,bayli:[2,46],bb13:47,bcc:[29,30],bcolor:58,bdiam:58,be2:44,bead:[21,22,61,71,154],bear:[2,66],becaus:[0,1,2,4,19,36,38,42,45,58,60,61,62,66,68,72,79,81,84,91,92,101,105,107,109,113,114,117,118,119,120,121,130,131,132,134,139,141,142,146,154,163],becker:[93,111],becom:[1,2,4,19,28,58,60,61,63,67,68,80,81,92,94,103,105,111,113,117,122,139,145,146,155,159,161,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,40,46,47,48,49,50,51,52,53,54,55,58,60,61,62,67,68,69,72,75,79,80,82,83,84,86,87,88,89,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,140,143,144,146,147,150,154,155,156,157,158,159,160,161,162],befor:[1,2,13,19,33,34,37,45,60,62,67,68,72,80,91,92,114,115,118,130,134,137,142,163],begin:[59,60,65,74,92,111,115,137,139,141,142,145,148,150,154,162],begun:74,behav:[11,48,91],behavior:[58,61,62,66,68,72,79,97,113,134,162],behaviour:2,behind:72,believ:3,bellott:[2,5,46,101],bellow:86,belong:40,below:[1,2,3,4,19,28,35,39,41,42,43,44,45,46,57,58,59,60,61,62,65,68,69,70,72,73,74,75,77,78,79,80,90,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,139,141,142,146,147,149,150,154,159,160,161,162,163],bench:[1,2,3],benchmark:[1,3,4,19,60],benedict:137,benefit:[1,4,66],bennet:32,berardi:[117,146],beraun:79,berendsen:[2,68,69,75],bern:[71,104,117,148],bernendsen:2,beryllium:113,best:[1,2,4,68,73,97,105,122,126,139],beta:[2,72,93,95,111,112,114,134,156,157,158],beta_:97,beta_k:149,beta_pi:97,beta_sigma:97,beta_t:157,better:[2,4,11,42,48,60,67,68,92,156,163],betwe:96,between:1,beutler:130,beyond:[2,32,68,116,128,139],bflag1:58,bflag2:58,bgq:137,bi3:44,bi5:44,bia:[2,39,43,68],bias:2,biersack:[134,158,162],big:[72,103,163],bin:[2,3,34,72],binari:[2,4,57,58,59,60,61,62,63,66,67,68,69,70,72,73,75,76,77,78,79,80,81,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,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],binary2txt:0,bind:[97,148],binsiz:4,biolog:2,biologi:51,biomolecul:101,biophi:90,bios:4,bisect:[19,60],bisector:[2,105,122,126],bispectrum:[42,149],bit:[3,139,163],bitrat:58,bkgd_dyn:134,bks:72,blank:[58,65,74,92,97,112,115,134,141,142,143,149,155,156,157,158,159],blast:79,blend:134,block:[2,35,42,45,81,90,97,113,145,149,163],blow:[80,81,150],blue:[58,61],bluegen:137,board:108,bodi:0,body:96,bodyforc:67,bodyforcei:67,bodyforcex:67,bodyforcez:67,bogu:62,bohr:[111,113,137,158],boltzmann:[2,32,35,39,61,65,67,69,109],bond:[0,1,2,4,6,13,18,20,21,22,23,24,25,26,27,28,32,35,36,38,39,42,43,45,46,47,56,57,58],bond_coeff:[2,20,21,22,23,24,25,26,27,28],bond_harmon:[24,25],bond_harmonic_shift:25,bond_interact:59,bond_styl:[0,2],bondangl:6,bondbond13:47,bondbond:6,bonet:110,book:[161,163],bookkeep:139,bookmark:0,boost:1,border:[4,79],boresch:32,boreschkarplu:32,born:[2,32],boron:113,botero:113,both:[1,2,3,4,11,28,32,45,48,57,58,61,62,63,67,68,72,75,77,78,79,80,81,82,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,140,144,146,147,155,156,157,158,159],bottleneck:1,bottom:67,bound:[2,10,11,19,48,60,68,80,81,91,113],boundari:[2,33,34,35,37,39,40,41,43,44,45,58,59,62,67,68,70,72,76,79,80,81,119,131,132,137],boundary_dynam:59,boundary_faceset:59,boundary_integr:59,bounds:[2,19,60],bount:3,box:[0,1],boxcolor:58,boxxlo:3,bptype:154,br1:44,bracket:[2,19,60],bragg:[41,44],branch:[3,163],branicio2009:159,branicio:[30,159],breakdown:[1,94],brennan:[31,64,110,141,142,154],brenner:94,brick:[19,60],bridg:90,brief:[1,2,68,94,97],briefli:[2,71,104,148,163],brilliantov:118,broadwel:4,broken:[28,29,68,97],brook:2,brown:[4,41,43],brownian:[2,37,131,132],brows:0,browser:58,bryantsev:120,btype:[105,122,126,130,154],buc:99,buck:[2,4,32,98],buckingham:[98,99,100,107,133],buckplusattr:148,buffer:58,bufi:58,bug:0,bui:58,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,42,44,46,47,48,49,50,51,52,53,54,55,56,57,61,63,64,65,66,67,68,69,70,71,72,74,75,77,78,79,82,83,84,85,86,87,88,89,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,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],bulatov:[135,136],bulk:[2,29,67,70,106,134,137,139,148],bundl:[58,163],button:163,bypass:2,c11:134,c_0:[79,94,152,153],c_1:[40,41,44,66],c_2:[41,44],c_cluster:2,c_cstherm:2,c_doubl:3,c_e:79,c_flux:35,c_gauss:116,c_hb:120,c_i:65,c_id:[2,32],c_ij:2,c_ijkl:2,c_k:66,c_mychunk:[2,34],c_n_k:66,c_p:43,c_peratom:43,c_pi:97,c_prop:2,c_sigma:97,c_size:2,ca2:44,cach:[4,139],cacul:75,calcforc:67,calclat:35,calcluat:[37,39,43,105],calcualt:35,calcul:[0,1],caldwel:[2,46],calhoun:71,call:[1,2,3,4,71,94,103,161,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,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,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,58,60,61,62,66,68,72,79,80,81,91,92,99,100,102,111,117,119,122,126,128,130,139,144,146,147,154],canon:[68,71,78,137],cao1:71,cao2:71,cao:71,capabl:[3,4,94,102],capac:[64,79,151],capolungo:[41,44],captur:[2,94,100,113,118,126,134],carbid:105,carbon:[58,88,94,104,134],card:[4,32,120],care:[2,45,56,67,68,96],carefulli:[3,28],carlo:[2,61],caro:111,carri:[4,79,118],carrillo:4,cartesian:[2,93],cascad:79,cat:[4,58],cate:67,categori:[0,94],cation:[114,148],caus:[1,2,4,45,62,68,70,74,75,80,81,91,92,120,122,128,131,132,139],caution:1,cautious:94,caveat:94,cbecker:[93,111],cc1:[2,34],ccc:[112,155,156,158,159],ccflag:4,ccflags:4,ccm6:111,ccsi:[112,155,156,158,159],ccu:97,cd2:44,cdeam:111,cdll:3,cdof:2,cdte:97,cdte_bop:97,cdtese:97,cdzn:97,cdznte:97,ce3:44,ce4:44,cell:[2,41,44,45,62,68,69,72,79,113,137],cella:2,cellalpha:2,cellb:2,cellbeta:2,cellc:2,cellgamma:2,center:[2,9,33,34,37,40,41,45,58,62,66,68,76,78,80,81,82,90,96,112,113,117,118,131,132,134,135,136,155,156,157,158,159],centr:63,central:[29,36,38,42,70,75,76,85,137,143,159],centro:2,centroid:71,centrosymmetri:29,certain:[1,2,58,61,139],cfg:[2,58],cg_type:147,ch2:75,ch2lmp:[0,2],ch3:75,chain:[0,2,13,28,61,68,69,71,75,78,88,108,109,154],challeng:2,champaign:131,chan:137,chandler:[93,111],chandrasekhar:[2,122],chang:[1,2,3,4,19,22,32,45,58,59,60,61,62,67,68,69,70,72,73,74,75,77,78,79,81,91,92,109,113,118,131,132,134,137,139,148,154,163],change_box:2,chapter:71,charact:[2,19,58,60,65,74,113,115,121,141,142,145,148],character:[2,29,38,42,149],characterist:77,charg:[1,2,3,32,41,44,45,98,99,104,105,107,108,111,113,114,122,126,130,144,148,158,159,161,162],charmm:0,cheaper:[117,146],check:[2,3,19,35,60,73,75,78,91,92,121,139],checkout:163,chem:[2,5,6,9,20,21,22,32,38,39,43,46,47,54,63,66,67,68,71,72,77,78,80,82,88,89,92,94,98,101,102,104,105,106,108,109,110,113,116,117,119,120,122,126,127,130,134,138,139,141,142,144,148,154],chemic:[31,41,44,59,115,142],chemistri:[72,94,97,113],chen:79,cheng:104,chi:[70,114,117],chiral:88,chmod:3,cho:134,choic:[2,4,19,28,29,32,43,56,60,61,67,68,71,92,130,139],choos:[1,2,13,28,32,58,61,62,67,68,69],chose:[156,158],chosen:[2,42,45,51,58,62,66,67,68,69,71,110,113,118,121,124,147,156],chunk:0,chunkid:34,ciccotti:75,cieplak:[2,46],circular:2,circumv:[36,38],citat:[0,67],cite:148,cl1:44,clarendon:[13,108],clarifi:[156,158],clark:144,classic:[0,2,4,71,72,79,89,113],classifi:159,clean:2,clear:[2,3],clebsch:42,click:[3,45,57,58,92,163],climb:92,clockwis:46,clone:163,close:[2,3,19,43,61,62,67,68,75,81,92,94,97,105,106,134,139,141,142,158,163],closer:[19,60,62,77,92],closest:[70,117,146,154],cloud:148,cluster:[2,4,43,63,75],cmax:134,cmd:[3,71],cmdarg:3,cmin:134,cmm:[18,147],cna:29,co2:[44,74,75,115],coars:[13,18,28,51,65,74,115,119,142,147],coarsest:42,code:[0,1],coeff:[6,46,47,56,82,121,139,150],coeffici:0,coefficienct:109,coefficient0:111,coefficient1:111,coeffieci:[2,95],coeffincientn:111,coexist:113,cohes:[2,114,134],coincid:[81,101,131,132],cold:2,coleman:[41,44],collect:[2,34,45,103],colliex:44,collis:[67,118,162],colloid:2,color:[19,58,60,66,72],column:[2,29,34,36,38,40,42,43,44,72,79,94,116,120],colvar:0,com:[2,37,40,63,96,163],comand:61,combiant:106,combin:[2,3,18,32,56,58,59,63,68,71,81,82,103,105,106,110,113,114,115,129,130,149,155,156,158,159,161],come:[0,2,13,62,68,77,78,139,155,156,158,159,163],comit:163,comm:[0,3,30,92,109,139],comm_modifi:[2,97,103,109,113,118],comm_styl:[19,60],comm_world:3,command:[0,1],comment:[3,46,65,74,79,92,93,111,112,114,115,121,134,141,142,143,148,149,155,156,157,158,159,163],commit:163,commmand:2,common:[0,1,2,3,4,30,62,71,81,82,118,120,155,156,158],commonli:[2,9,37,38,58,89,119,124,149,156,158],commun:[1,2,3,4,19,58,60,62,67,68,79,110],comp:[75,92,113,139,146,153,157],compar:[1,2,4,41,44,57,91,92,134,148],comparison:0,compart:90,compass:[6,20,47,57,82,102],compat:[3,19,50,60,63,80,137,139],compens:[2,113],compil:[4,58,137],complain:3,complement:134,complementari:[105,122],complet:[2,3,19,60,71,92,114],complex:[2,3,9,36,38,42,45,67,81,92,113,137],complic:[2,40],compon:[2,29,30,33,34,35,36,37,38,39,40,42,43,58,61,62,63,67,68,69,71,75,81,91,92,109,113,118,131,132,148,149],componenet:2,componennt:40,composit:[2,67,111],compound:[104,113,114,159],compress:[2,58,69,72],compris:[81,115,146],compton:[41,44],comput:[0,1],computation:[2,79,97],compute_modifi:[61,62,68,69],compute_sa:41,compute_xrd:44,concav:81,concentr:[65,74,111,115,142],concept:2,conceptu:[2,62,92,105,134],concern:[2,30,32,66],concis:3,concurr:4,conden:[79,156,158],condens:[2,79,94,107,111,122,159],condit:[2,39,41,43,44,58,59,67,69,70,72,75,76,79,110,113,119],conducit:2,conduct:0,confer:[4,137],configur:[1,2,4,58,62,71,91,92,94,97,112,134,137,155,156,158,159,163],conflict:[139,163],conform:[2,61,62,73,88,92,113],confus:159,conjuct:109,conjug:113,conjunct:[2,32,45,67,92,98,99,105,109,113,120,122,139,144,147],connect:[2,32,61,75,90,92,106,118,154,158],conner:94,connor:94,consecut:[3,45,105,122,126],consequ:[1,2,79,121],conserv:[13,61,66,67,68,74,75,92,108,109,110,118,128,148],consid:[2,29,32,40,60,61,79,113,146,148,154],consider:2,consist:[2,3,39,40,45,51,66,68,69,72,73,74,90,92,94,97,103,105,113,117,131,132,134,137,139,141,142,146,148],consistent_fe_initi:59,constant:0,constantli:63,constitu:[2,80,81,103,146],constrain:[2,63,66,75,76,91,113],constraint:[19,39,43,60,63,75,76,80,91,132],construct:[2,28,29,30,36,38,41,42,44,62,68,73,74,81,108,137,139,154,155],constructor:3,consult:4,consum:1,contact:[0,106,112,114,117,118,146],contain:[0,1,2,3,19,32,35,41,42,44,45,46,57,58,59,60,65,67,70,72,74,79,81,92,93,94,97,104,105,108,111,112,113,115,134,137,141,142,143,145,149,155,156,157,158,159,163],context:[2,4,161],contibut:29,contin:4,continu:[0,2,19,60,61,62,63,66,68,69,72,77,78,79,81,97,109,124,127,146,157],continuum:[2,59,79],contour_integr:59,contract:[62,68],contrain:75,contrast:[1,2,161],contrib:79,contribut:[2,29,32,33,34,35,39,42,43,62,67,75,91,92,109,111,113,131,132,137,139,148,163],control:[2,3,4,11,13,19,32,35,42,48,58,59,60,62,68,69,74,79,113,117,137,155,158],control_typ:59,convect:35,conveni:[2,13,149,163],convent:[13,50,55,57,73,111,113],converg:[2,19,58,60,61,62,69,72,73,75,91,92,104,105,122,148],convers:[42,58,105,106,107,113,122,126,130,144],convert:[2,5,6,8,12,16,17,18,35,45,47,58,82,83,87,88,92,93,111,137,156,158,162],convex:81,cool:63,coord:[2,3,36,38,40,70,80,92],coordb:148,coordbb:148,coordiat:91,coordin:[1,2,3,19,32,33,34,40,42,45,58,60,61,62,63,68,70,75,76,78,79,91,92,93,94,96,112,148],coords:148,copi:[0,3,58,79,92,163],copper:162,coprocessor:[1,4],core:[0,1],coreshel:2,coreshell:[2,99,105,107],cornel:[2,46],corner:[2,58,81,163],corpor:4,corr:104,correct:[2,3,32,46,58,63,68,72,80,81,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,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],correction_max_iter:59,correctli:[3,68,75,81,92,107,132,137,163],correl:[2,35,36,42,66,71],correpond:65,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,42,44,46,47,48,49,50,51,52,53,54,55,56,58,62,63,65,67,68,69,70,71,74,75,80,81,82,83,84,86,87,88,89,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,140,142,143,144,145,146,147,148,149,150,155,156,157,158,159,160,161,162],correspondingli:[131,132],cosin:2,cosineshift:11,cost:[1,2,3,19,41,43,44,58,60,68,74,79,105,122,126,137,139,155],costheta0:[155,156,158,159],costheta:145,costli:[3,4],coul:[2,4,18,21,22,32,46,91],could:[2,3,19,32,34,39,58,60,72,79,80,81,91,94,116,120],coulomb:[2,43,91,98,99,100,101,102,104,105,106,107,108,113,118,119,122,126,130,133,139,144,147,148,158,159,161],coulommb:2,count:[1,2,3,19,35,46,60,68,75,81,91,92,116,120,139],counterbal:63,counterbalanc:13,counterclockwis:46,coupl:0,couple:[2,3],cours:[4,66,73,80,131,150],cov:148,coval:[2,13,113,134,148],cover:[2,59,67,113],cpp:[1,2,3,32,75],cpu:[1,4],cpuinfo:4,cr2:44,cr3:44,creat:[0,1,2,3,19,35,39,41,45,58,59,60,61,62,65,68,69,70,71,73,79,92,94,97,104,111,112,130,139,140,141,142,145,148,155,156,157,158,159,163],create_atom:[2,19,35],create_box:[2,19,35,45,62,68,154],create_elementset:59,create_faceset:59,create_nodeset:59,createatom:0,creation:45,criteria:[58,61,91],criterion:[19,45,60,61,91,92,104,113,118,148],critic:[2,24,25,79,91],cross:[4,33,40,58,92,101,109,111,119,120,122,124,126,145,147,156,158,162],crossov:1,crozier:0,crucial:72,crystal:[2,4,29,30,38,70,78],crystallin:[2,157],crystallogr:[41,44],crystallographi:[41,44],cs1:44,cs_chunk:2,csanyi:[42,149],cscl:134,csequ:2,csh:[3,4],cshrc:3,csic:[112,155,156,158,159],csinfo:2,csisi:[112,155,156,158,159],cst:111,cstherm:2,csvr:2,ctcm:[93,111],ctype:3,cu1:44,cu2:44,cu3au:134,cube:[2,81],cubes:[19,60],cubic:[38,67,70,111],cuda:1,cuh:97,cummul:[2,61,120],cumul:[2,68,69,92],current:[0,1,2,3,4,19,30,32,43,58,59,60,61,62,63,68,73,74,75,76,79,80,90,91,92,97,104,108,111,113,114,118,121,131,132,134,135,136,139,145,150,156,158,163],curv:[2,45],curvatur:[117,146,162],custom:[0,2,3,33,34,35,43,58,61,62,68,69,72,91,94,116,120],cut:[1,2,4,19],cuthi:70,cutinn:[131,132],cutlo:70,cutmax:145,cutoff1:[102,108,122,126,130,133,144,147],cutoff2:[98,99,100,102,107,108,122,126,130,133,144,147],cutoff:[2,4,21,22,28,29,30,32,36,38,42,61,65,70,72,80,81,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,162],cutoffa:112,cutoffc:112,cuu3:111,cval:44,cvff:4,cwiggl:80,cyan:58,cycl:[68,69],cyclic:46,cylind:[58,81,90],cylinder_d:90,cylindr:2,cyrot:97,d3q15:67,d3q19:67,d_e:79,daan:78,damp:[2,68,69,72,91,92,98,99,101,105,108,113,118,122,130,144,147],dampflag:118,danger:109,darden:108,darken:58,dash:118,dat:[2,35,59],data2xmovi:0,data:1,databas:0,date:[0,2],datum:2,davenport:133,davi:80,david:[156,158],daw:[111,145],dcd:[2,58,71],deactiv:130,debug:[2,3,41,44,45,71,139],decai:[36,105,162],decid:[2,4,163],decod:58,decompos:[32,149],decomposit:[59,71],decoupl:2,decreas:[4,61,63],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,64,65,67,68,69,70,71,74,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,147,149,150,151,152,153,154,155,156,157,158,159,160,161,162],definit:[2,42,64,69,80,97,103,110,113,145,149],deform:[2,43,62,68,131,132],deg2theta:44,degre:[2,5,6,8,12,13,16,17,18,36,38,39,44,45,46,47,49,50,55,56,58,61,68,69,71,73,75,78,82,83,87,88,89,91,108,111,120],delai:2,delet:[28,61,68,139,154,163],delete_atom:45,delete_bond:[20,21,22,23,24,25,26,27,28],delete_el:59,delimit:74,dellago:[2,63],deloc:[113,148],delr:134,delta_1:97,delta_3:97,delta_7:97,delta_ij:[134,145],delta_pi:97,delta_r:145,delta_sigma:97,deltah_f:65,demo:3,demonstr:[72,134],dendrim:120,dendtrit:90,denniston:67,denot:[41,63,105,119],dens:[61,74,113],densiti:[2,19,42,45,59,60,67,79,80,93,94,97,111,134,135,136,141,142,145,146,148,151,152,153],dent:90,depart:0,departur:72,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,40,42,45,46,47,48,49,50,51,52,53,54,55,57,58,60,62,65,67,68,69,70,74,75,77,79,80,81,82,83,84,86,87,88,89,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,140,141,142,143,144,145,146,147,148,149,150,155,156,157,158,159,160,161,162],dependend:2,deposit:[68,75],depth:[26,58,79,115,117,146],der:[32,103,104,130,161],deriv:[2,32,42,62,63,68,69,70,77,78,79,80,81,94,97,103,108,113,114,119,124,128,129,134,137,161],derjagin:161,derlet:70,descib:58,describ:[0,1,2,3,4,19,29,30,41,42,43,44,45,51,54,60,61,62,65,66,67,68,69,70,71,72,74,77,78,80,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,141,142,145,146,147,148,149,150,154,155,156,157,158,159,160,161,162,163],descript:[2,3],descriptor:42,design:[0,2,3,41,44,59,61,68,70,79,95,96,101,105,107,113,130,131,132,135,136,145],desir:[2,3,4,35,39,43,45,62,66,68,75,91,92,109,111,120,131,132,155,156,158],desktop:[2,58],destabil:97,destre:88,destroi:3,detail:[1,2,3,4,19,34,35,39,40,42,43,45,57,58,59,60,61,62,63,66,67,68,69,72,75,78,79,90,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,139,141,142,146,148,149,150,160,161,163],detect:[36,92,104,120,121],determin:[1,2,4,26,32,39,40,41,43,44,45,58,60,62,65,68,70,71,72,73,74,80,81,94,100,104,108,111,115,116,118,126,134,137,139,142,146,148,154,161],devan:147,devanathan:158,develop:[0,2,3,4,69,72,94,97,113,136,137,148,159],deviat:[69,70,116],devic:1,devin:104,devis:136,dfactor:58,dft:137,dhug:72,dhugoniot:72,dia:134,diag:74,diagnost:[4,61,74],diagon:[2,40,42,43,62,68],diagonalstyl:149,diagram:[19,41,44,57,60,71],diallo:120,diam:58,diamet:[2,45,58,103,117,118,124,146,161],diamond:[113,134],dick:2,did:[91,109,111,118,139,156,158],dielectr:[101,105,106,107,122,126,130,144],diff:[2,4],differ:[1,2,3,4,19,28,29,32,36,42,45,57,58,60,61,62,63,66,67,68,70,71,72,75,76,77,78,79,80,81,82,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,143,145,146,147,148,149,150,155,156,158,159,161],differenti:[1,2,13,74,105,145,157],difficult:[62,71,120],difficulti:[36,38,75],diffract:[41,44],diffraction:[41,44],diffus:0,diffuse:2,digit:137,dihedr:[0,4,28,36,38,39,42,43,45,46,47,48,49,50,51,52,53,54,55,56,57,61,73,83,84,85,87,91,94,97,101],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:113,dij:75,dilat:[62,68,69],dim:[45,134],dimens:[1,2,19,35,40,43,45,58,60,62,67,68,69,72,80,92,139],dimension:[36,39,41,42,44,79,92,145],dimensionless:[37,42,79,149,161],dimer:[2,134],dimstr:[19,60],dintel_offload_noaffinity:4,dipol:0,dipolar:13,dipole:108,dir:[1,3,70,72,145],dirac:42,direc:145,direct:[2,4,13,29,38,41,42,44,45,46,58,67,69,70,72,77,78,79,80,81,91,92,109,110,118,132],directli:[2,3,32,40,42,58,67,74,81,93,94,98,99,100,105,108,111,113,122,126,139,144,147,154],directori:[0,1,2,3,4,77,78,92,93,94,97,104,105,111,112,114,130,134,135,136,137,143,145,148,149,155,156,157,158,159],disabl:[4,79,121],disadvantag:[2,60],disallow:68,discard:[19,60,81],discontinu:[91,128],discourag:134,discret:[2,58,67],discuss:[0,1],disk:[2,36],disloc:[29,137],disord:[29,137],disp:0,dispar:146,disperion:[108,126],dispers:[2,100,108,126,131,139,159],displac:[2,37,62,68,70,118],displai:[3,57,58],disregard:137,dissip:[2,31,64,66,77,78,109,110,118,131,132],dist:[2,35,71,73,154],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,61,62,63,67,68,69,70,72,73,75,76,78,79,80,81,82],distinct:[2,146],distinguish:[2,42,113],distort:93,distrbut:93,distribut:[0,2,3,19,32,42,57,60,66,67,68,93,97,105,111,112,114,134,135,136,139,143,145,146,155,156,157,158,159],distro:145,ditto:162,div:4,diverg:[78,94],divid:[2,4,19,35,39,43,57,60,70,91,92,114,148,159],divis:[2,56,67,97,130],dl_poly:2,dlammps_ffmpeg:58,dlammps_gzip:58,dlammps_jpeg:58,dlammps_memalign:4,dlammps_png:58,dlm:68,dlmp_intel_offload:4,dlopen:2,dlvo:[103,161],dm_lb:67,doc:[0,1,2,3,32,34,37,39,40,43,45,57,58,68,81,90,91,92,93,94,96,104,105,111,112,114,120,134,135,136,139,143,145,149,155,156,158,159,163],docuement:146,doe:[0,1,2,3,19,28,29,32,35,41,44,45,46,57,58,59,60,61,62,63,65,66,67,68,79,80,81,83,84,85,87,88,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,139,141,142,145,146,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],doesn:[45,94,104,112,155,156,157,158,159],dof:39,doi:[2,70],domain:[2,19,41,44,58,60,62,67,68,71,79,80,92,139],domin:[1,113],don:[0,4,81,134,148,163],done:[1,2,19,45,56,58,59,60,61,62,65,68,71,75,77,78,91,92,94,100,111,126,132,133,134,139,141,142,154,163],donor:120,dot:43,doti:[97,145],doubl:[1,2,3,4,32,46,81,97,114,119,137],dover:59,down:[2,3,62,113,139,148],download:3,downsid:2,dpd:2,dpdtheta:[31,110],dpdtheta_i:[64,65],dr_ewald:41,drag:[2,35,68,69,76],dragforc:67,drai:[58,72],drain:91,dramat:[61,62,68,139,148],drautz:97,draw:58,drawn:[58,66],drayleigh:72,dreid:2,dreiding:0,drfourth:37,drho:[93,111,141,142],drift:[2,37,63,66],drive:[3,62,68,70,92],driven:[2,51],driver:2,drop:109,drsquar:37,drude:0,dt_collis:67,dt_lb:67,dt_md:67,dtqm:72,dudarev:44,due:[1,2,4,28,29,33,34,37,41,42,43,44,45,58,61,62,66,67,68,69,70,73,77,78,79,80,81,91,92,106,109,110,111,116,117,131,132,139,145,146,147,154,156,158,161,162],duffi:79,dullweb:68,dumbbel:90,dummi:[13,157],dump:[0,1],dump_modifi:[2,58],dunbrack:[2,5,46,101],duplic:[19,60,70],durat:[57,79,118],dure:[2,4,19,32,40,46,59,60,61,62,63,65,66,67,68,69,70,71,72,73,75,76,77,78,79,80,81,91,92,109,130,137,139,140,141,142],dvlo:161,dvx:2,dx_lb:67,dy3:44,dyanam:2,dynam:[0,2,3,4,19,31,37,45,58,59,60,61,64,66,68,69,71,72,73,77,78,79,91,92,109,110,113,131,132,139,153],dynamo:[93,111,134],dyre:127,e28637:13,e_1:97,e_2:97,e_a:74,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:82,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,65,66,67,68,69,70,71,74,75,76,78,79,80,81,82,83,84,85,86,87,88,89,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,155,158,159,160,161,162],eacn:[19,60],eam:[0,93,105],earli:[19,60],earlier:[92,118,134,139],earth:113,easi:[2,3,32,43,80],easier:[4,58],easili:[3,58,92],eat:47,eaxmpl:2,eba:6,ebb13:47,ebb:6,ebt:47,ec_ii:134,ec_ij:134,ec_jj:134,echo:[3,41,44],ecp:113,edg:[2,19,41,44,58,80,81],edge:80,edit:[4,163],edition:4,edu:[3,111,131],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,43,46,47,48,49,50,51,52,53,54,55,57,58,59,61,62,63,66,68,69,70,71,72,73,75,78,79,80,81,82,83,84,86,87,88,89,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,144,146,147,148,150,155,156,157,158,159,160,161,162],effici:[0,1,2,4,39,56,58,62,68,71,75,97,103,105,122,126,137,141,142,146],efficienc:4,efield:[75,91],eggebrecht:[105,148],ehex:2,eigenvalu:71,einstein:[2,78],either:[1,2,3,4,19,29,41,42,43,44,45,58,60,61,62,63,67,68,69,70,74,75,81,91,97,103,111,115,118,131,132,134,137,139,142,145,154,156,158],ejtehadi:[103,117,146],elaps:[80,150],elast:[2,21,22,92,118,157],elastic:0,elba:13,electr:[2,59,114,162],electric:4,electrolyt:161,electron:[2,41,59,79,93,104,108,111,113,114,134,137,145,148,158,159,162],electron_integr:59,electron_temperatur:59,electron_unit:113,electroneg:[2,104,114,148],electroneg_compon:148,electrostat:[2,4,103,108,113,122,130,132,148,161],elem1:[114,134,149],elem2:[114,134,149],elem:148,element1:[93,111,148],element2:[93,111,148],element:[2,33,37,39,42,43,58,59,93,94,97,104,111,112,113,114,134,135,136,137,143,145,148,149,155,156,157,158,159],elementn:[93,111],elementset:59,elif:42,elig:120,elimin:[2,66,75,77,78],elj:108,ellips:2,ellipsoid:[2,45,90,91,117,132,146],els:[58,68,79],elsewher:134,elt:134,emac:0,email:[0,3,114],emb:81,emb_lin_neg:134,embed:[3,13,79,93,111,114,130,134,135,136,145],embt:47,emphas:118,empir:[59,113],empiric:94,emploi:[63,157],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,42,44,46,47,48,49,50,51,52,53,54,55,57,61,63,64,65,66,67,68,69,70,71,72,73,74,75,77,78,79,80,81,82,83,84,86,87,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,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],enclos:[2,134,148],encod:58,encompass:2,encount:38,encourag:[74,76],end:[1,2,3,4,19,47,58,61,63,66,68,73,74,79,92,109,111,117,133,137,146,149,150],endbondtors:47,energet:[61,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,43,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,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,88,89,91,92,93,94,95,96,97,98,99,100,101,102,103,104,105,106,107,108,109],energy_compon:148,enforc:[2,58,61,68,75,122],enforce2d:[2,91],eng:[3,104,136],engineer:[59,77,111],enginer:135,enhanc:[59,63],enlarg:58,enough:[45,60,72,80,81,105],enpub:111,ensembl:[2,32,35,68,71,72,109,148],ensight:2,ensur:[2,42,62,66,68,97,130,155,159],enter:[114,137,159],enthalpi:[74,111],entir:[0,2,3,19,31,39,40,41,43,44,45,60,61,63,66,68,69,70,71,74,76,79,108,126,139],entiti:2,entri:[40,41,65,72,97,112,134,141,142,143,149,155,156,157,158,159],entry1:[141,142],enumuer:2,environ:[1,2,3,4,58,70,93,97,104,112,113,145,156],eos:65,epair:[94,116,120],epp:108,epq:108,eps0:161,eps14:130,epsilon0:158,epsilon:[2,18,21,22,27,28,32,46,80,81,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,144,146,147,155,160,161],epsilon_0:162,epsilon_14:101,epsilon_:146,epsilon_d:106,epsilon_i:[117,139,146],epsilon_i_:146,epsilon_i_a:[117,146],epsilon_i_b:[117,146],epsilon_i_c:[117,146],epsilon_ij:139,epsilon_j:[117,139,146],epsilon_j_:146,epsilon_j_a:[117,146],epsilon_j_b:[117,146],epsilon_j_c:[117,146],epsilon_lj:146,eqp:108,eqq:108,equal:[2,3,19,28,32,35,43,45,58,60,62,66,67,69,70,71,72,73,74,77,78,79,80,91,92,94,104,109,110,116,117,120,131,137,138,145,146,148,149,150,159,162],equat:[2,35,38,39,41,44,57,62,63,64,65,67,68,69,70,71,72,74,75,79,80,90,103,108,109,110,113,114,115,118,131,132,134,139,142,146,151,152,153,162],equation:[70,88],equilibr:[2,35,45,61,62,68,72,77,78,104,105],equilibrium:[1,2,6,8,10,11,12,13,16,17,18,20,23,24,25,26,27,47,48,62,66,67,68,69,72,73,75,78,82,83,87,88,104,134,143,148],equilibrium_start:59,equival:[2,13,62,68,73,94,109,113,148,156,158],equlibrium:2,er3:44,eradiu:113,eras:77,erat:132,erc:105,erfc:[105,122,139],erhart:[111,156,158],eros:134,erose_form:134,erot:2,errata:[156,158],erratum:80,error:[0,1,2,3,11,48,58,62,63,65,68,74,79,80,81,91,105,122,139,146,154,156,158],erta:118,especi:[4,45,60,72,73],essenti:[3,11,48,94,105,122,158],essential:69,essex:13,establish:32,estim:[1,2,19,29,35,43,59,60,74,139],esub:134,eta:[2,67,68,72,112,114,117,145,157,159],eta_dot:68,eta_ij:145,eta_ji:114,etap:68,etap_dot:68,etc:[1,2,3,4,28,33,34,35,40,43,45,58,59,66,68,79,81,91,92,111,112,130,132,137,155,156,158,159],etol:[91,92],etot0:72,etot:[2,43,72],eu2:44,eu3:44,euler:[74,91,92],eulerian:59,europhi:67,evalu:[3,32,35,42,45,46,58,59,66,74,80,91,137,139,141,142,145,148],evanseck:[2,5,46,101],evaul:91,even:[2,4,19,29,56,60,62,63,68,79,80,81,91,92,96,113,114,118,139,146,159],evenli:[19,43,60,67],event:[2,68,79],eventu:2,ever:28,everaer:[103,117,146],everi:[0,1,2,3,4,19,35,58,59,60,61,62,63,67,68,69,70,72,74,75,79,92,109,130,148,163],everyth:163,everywher:124,eviri:113,evolut:[63,67,71],evolv:[67,71],ewald:[2,41,43,91,98,99,100,105,108,113,122,126,144,147],ewald_disp:108,exact:[19,60,61,66,79],exactli:[2,19,35,45,60,66,72,109,111,118,131,139,141,142],examin:[2,61,74],exampl:[0,1],exce:[2,4,19,60,62,68,91],exceed:[19,60,68],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,43,45,46,47,48,49,50,51,52,53,54,55,57,60,62,68,69,71,75,79,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],excess:113,exchang:[2,59,63,79,113],excit:113,excite:113,exclud:[2,4,39,40,42,91,118,131,132,139,154],exclus:[1,4,32,46,104,137,139],excurs:68,execut:[1,2,3,58],exempl:148,exemplari:66,exemplifi:113,exert:[2,81],exhaust:59,exhibit:[36,63,68,113],exist:[2,3,29,45,57,58,62,82,83,84,85,87,110,154,163],exit:[3,19,60],expans:[42,56],expect:[1,4,19,60,70,72,134,137,139],expens:[2,70,79],experi:[2,73,92,109,139],experienc:[2,4],explain:[1,2,3,19,30,40,58,60,62,68,70,92,96,111,148,150,163],explan:[2,40,42,70],explic:138,explicit:[2,3,32,74,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,45,46,47,48,49,50,51,52,53,54,55,66,68,69,72,75,79,82,83,84,86,87,88,89,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,144,146,147,150,151,152,153,155,156,157,158,159,160,161,162,163],explictli:4,exploit:71,explor:[41,44],expon:[74,111,115,117,120,130,138,147],exponenti:[32,74,115,145,155,159,162],expos:3,exposit:[59,109],express:[2,42,45,62,70,74,79,97,111,113,124,134,148,149],expressiont:97,extend:[0,2],extens:[2,4,21,22,27,32,35,63,68,69,70,73,77,78,79,80,81,117,134,137,146,149],extent:[1,19,21,60,94],exterior:[2,81],extern:[32,58,62,66,67,68,69,79,91,135,136],extra:[2,3,4,19,22,39,41,43,44,45,60,68,72,91,108,118,134,139],extract:[2,3,18,32,92,105,114,134,149],extract_atom:3,extract_comput:3,extract_fix:3,extract_glob:3,extract_vari:3,extrapol:1,extrem:[1,2,58,62,68,78,113,157],extrema:130,extreme:113,extrins:59,f_1:2,f_a:[156,157,158],f_c:157,f_f:158,f_fix_id:72,f_harm:78,f_i:[13,145],f_id:2,f_ij:145,f_int:77,f_j:13,f_jj:35,f_k:145,f_langevin:79,f_max:72,f_r:[156,157,158],f_sigma:97,f_solid:78,f_ss:2,face:[2,80,81,117,134,146],facil:0,facilit:2,fact:[2,4,78,118,148],factor:[1,2,8,12,16,17,18,19,22,23,32,35,41,42,44,46,54,58,60,62,63,67,68,69,71,73,74,75,80,81,87,94,97,98,99,101,105,106,107,109,110,113,118,121,122,134,137,139,141,142,143,144,147,150,155],fail:[3,62,91,92,107],fairli:[3,139,163],faken:30,fall:2,fals:148,famili:159,familiar:[0,3,163],fan:145,far:[2,60,62,68,70,73,80,83,87,92],farrel:[156,158],fashion:[2,19,45,60,68,69,72,78,79,80,92,131],fast:[2,4,72,74,131,132,137],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,60,68,69,75,77,79,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],fastest:[1,2,79],fault:29,fava:117,favor:61,fcc:[2,29,30,35,38],fcold:63,fdt:[64,65,74],fdti:32,fe2:44,fe3:44,fe_md_boundari:59,featur:[0,2,3,42,58,61,66,71,81,91,163],fecr:111,feel:[70,81,92,139],fehlberg:74,felling:136,felt:81,fene:[2,4],fennel:[105,122],fep:0,ferguson:[2,46],fermi:[1,158],fermion:113,fernando:133,few:[1,2,3,63,68,75,91,92,94,148],fewer:[1,3,4],feynman:71,ffield:[104,114,148],fflag1:58,fflag2:58,ffmpeg:58,ffplai:58,fft:[1,3,43],fhot:63,ficiti:154,fictiti:[2,71,73,105,122,126,154],field:0,fifth:[2,115,143],figshar:70,figur:[1,4,72,163],fij:108,file0:70,file1:[3,65,70],file2:[3,65],file:[0,1],filenam:[4,19,58,59,60,65,70,74,79,92,93,94,97,105,111,112,114,115,134,135,136,141,142,143,145,148,149,155,156,157,158,159],fill:[45,58,79,97,137,163],filter:59,finchham:[2,107],find:[0,2,3,4,30,32,61,62,65,70,73,91,92,105,122,126,134,141,142,148,163],fine:[4,78,163],finer:[42,45],finger:45,finish:[2,3,19,60],finit:0,finni:111,fire:[91,92],first:[0,1,2,3,4,6,19,21,22,28,29,35,37,38,39,43,44,47,58,60,61,65,66,67,68,70,71,72,75,76,77,78,79,82,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,139,141,142,143,145,148,149,154,155,156,157,158,159,162,163],fischer:[2,5,46,101],fit:[2,73,94,97,134,139,141,142,157,163],five:[30,72,97,135],fix:[0,1],fix_flux:59,fix_heat:63,fix_id:[62,68,69,72],fix_manifoldforc:163,fix_modifi:2,fix_nv:163,fix_rattl:75,fix_shak:75,fixedpoint:[62,68],fixid:[58,59],fji:108,flag:[3,4,33,34,40,41,44,58,61,94,120,121,134,137,154,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,79,80],fld:[80,131,132],flexibl:[2,58,113,157],flip:[2,68],fluctuat:[2,32,62,66,67,68,69,70,78,79,88,110],fluid:[2,62],flux:2,flv:58,fly:[19,58,59,75,97,137],fmass:71,fmax:91,fmsec:68,fno:4,fnorm:91,fnve:63,focu:75,foil:[42,70,149],fold:[4,76],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,42,43,45,46,48,49,50,51,52,53,54,55,56,58,59,60,64,65,66,67,68,69,71,72,73,74,75,77,78,79,83,84,85,86,87,88,89,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,162,163],foo:[3,58,74],foo_species:74,foot:2,forc:[0,1],forcefield:[73,120],forcegroup:67,ford:108,forgiv:68,fork:163,form:[2,28,32,33,34,36,42,43,66,73,74,79,80,81,82,85,88,92,94,97,110,111,113,116,120,121,133,134,136,137,141,142,143,144,145,146,148,149,150,156,157,158,161],formal:[2,35,66,68,71,148],format:[2,19,58,60,65,74,79,92,93,94,97,111,114,115,121,134,136,141,142,147,149,159],formation:65,former:[2,19,60,79,97],formul:[1,2,43,68,73,75,94,97,111,113,117,134],formula:[2,6,28,29,30,32,33,34,35,39,41,43,44,45,47,57,70,76,80,82,84,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,140,146,147,150,155,156,157,158,159,160,161],forth:[1,2,3],fortran:[2,3,111,134],forward:[32,92],foster:[97,145],found:[2,30,61,63,67,105,108],four:[2,3,28,42,79,88,92,137],fourier:2,fourth:[2,4,37,73,101,115,143,148],fox:[2,41,46,153],fqq:108,fraction:[1,2,4,19,43,58,61,62,72,74,92,97,115,118,131,132],frame:[42,59,72,117],framer:58,framework:[93,149],frattl:63,free:[2,13,29,32,70,77,78,79,92,113,130,137,140,145,161],freedom:[2,39,61,68,69,71,75,78,91,108],freeli:[0,2,58],freez:2,frenkel:[2,63,78],frequenc:[2,4,71,72,74,109,113,148],frequent:[29,30,36,38,42,63,139],fri:72,friction:[2,72,79,118],from:[0,1],front:72,frontend:58,frozen:[2,39,66,116],fs2:[2,35],ftol:[91,92],fuction:105,fudg:75,fulfil:2,full:[1,2,4,35,58,63,67,70,74,97,111,113,114,117],fuller:91,fulli:[2,70,91,92,105,145,163],fulton:111,fumi:98,funcfl:111,fund:0,funrol:137,further:[2,37,58,67,71,79,91,92,93,96,104,137,148],furthermor:[11,48,63,74,110,113],futur:[0,2,60,66,92,135,136],g_jik:145,g_p:79,ga3:44,gaa:97,gai:117,gain:4,galindo:138,gamma0:13,gamma:[2,13,67,72,109,110,112,117,134,138,151,152,153,155,156,158,159],gamma_:79,gamma_ijk:156,gamma_n:118,gamma_p:79,gamma_t:118,gammaa:138,gammafactor:67,gammar:138,gan:[145,155,156,158,159],gan_sw:145,gan_tersoff:145,gao:[2,5,46,101],gap:[131,132,149],gather:3,gather_atom:3,gathert_atom:3,gauch:51,gauss:106,gaussian:[2,35,37,66,71,73,109,113,116],gave:139,gavhan:4,gaybern:[2,4,91],gcmc:139,gd3:44,gdot:132,ge4:44,gec:[156,158],gen:68,gener:0,gentler:80,gentli:112,geom:2,geometr:[2,40,45,60,68,81,92,96,102,103,105,108,113,115,117,119,122,123,124,125,126,127,128,129,130,131,132,133,138,139,142,146,150,160,161],geometri:[2,9,19,45,60,62,139],gerber:130,germann:[69,124],germano:117,get:[0,1,2,3,4,19,35,40,42,45,58,60,62,81,92,105,159,163],get_natom:3,get_rank:3,get_siz:3,gewald:2,gezelt:[105,122],ghost:[2,4,30,62,68,109,110,113,118,121],gif:58,gifsicl:58,gillan:149,gingold:[151,152],git:163,give:[0,1,2,3,4,28,36,38,45,62,68,70,91,94,97,113,120,134,137,139,146,156,157,158],given:[2,3,4,11,38,42,43,48,57,62,63,66,67,68,69,70,71,72,73,74,75,76,79,80,81,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,149,162],glosli:137,glotzer:109,glue:3,gnu:0,gnuplot:3,goddard:[2,9,89,113,120],goe:[28,42,45,63,91,108,112,119,124,127,150,162],gold:29,goldman:72,good:[1,2,4,19,30,41,44,60,68,75,92,93,103,111,137,139,159,163],gordan:42,gordon:2,got:163,gould:[2,46],gov:[0,93,111,114],govern:67,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,46,47,48,49,50,51,52,53,54,55,68,69,75,82,83,84,86,87,88,89,93,94],grab:2,grad:2,gradient:[2,62,63,79,92,132,141,142],graft:61,grain:[2,13,18,28,45,51,65,70,74,115,119,137,142,147],gram:111,gran:[2,80,81],grana:90,granular:0,graph:3,graphic:3,graviti:2,grdient:59,great:[72,163],greater:[1,62,66,68,70,96,98,99,100,139],greatli:[41,63],green:[2,35,58,71,97,163],green_kubo:2,grest:[21,22,61,100,118,126],grid:[19,41,44,60,67,79],grigera:2,gromac:91,gromacs:[2,91,119],groot:109,ground:[2,31,64,113],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,92,148,159],group_id:3,grow:[2,68,70,74,118],growth:2,gsmooth_factor:134,guarante:45,guess:163,gui:[3,163],guid:[1,151,152,153],guidelin:1,gullet:134,gulp:2,gunnel:137,gunsteren:130,guo:[2,5,46,51,101],gyrat:2,gzip:[58,92],h12:117,h2o:[115,142],had:[2,3,40,61,62,66,68,69,79,109,118,154],hafskjold:[2,63],half:[1,2,4,19,58,60,68,79,80,81,97,103,113,137],halfwai:[19,58,163],halperin:36,halsei:118,halt:[19,60,63],halv:58,hamak:[80,81,103,146],hamilton:29,hamiltonian:[68,113],han:111,hand:[2,28,29,40,45,55,58,67,74,105,113],handl:[4,58,113,131,159],happen:2,hara:157,hard:[1,73,148],harden:150,harder:[80,81],hardi:59,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,68,69,75,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],harmon:[2,4],harmonic_fix_wal:132,harrison:94,hartre:[111,113,137],hassl:73,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,60,61,62,66,67,68,69,70,71,72,75,79,80,81,82,83,84,86,87,88,89,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,148,150,155,156,157,158,159,160,161,162,163],hbond:2,hcn:74,hcp:[29,30,134],he1:44,head:[2,6,47,82,94,116,120,163],header:[2,58,72,79,93,97,111,154],heat:2,heavili:[19,60],heavisid:79,hebenstreit:4,height:[58,92,116],held:[2,74,92,118],helic:51,helium:95,help:[4,62,70,97,140,156,158,163],henc:[1,5,6,10,16,17,18,29,47,68,80,81,82,83,87,88,105,116,130,145],henderson:27,henkelman1:92,henkelman2:92,henkelman:92,here:[1,2,3,4,19,29,40,41,44,50,57,58,60,61,66,67,70,72,79,80,90,91,92,94,97,114,117,120,121,133,145,146,148,162,163],hertzian:[2,118],hertzsch:118,heterogen:37,hex:[45,63],hexagon:[36,134],hexat:36,hey:43,hf4:44,hfo:104,hftn:[91,92],hg1:44,hg2:44,hibb:71,hierarchi:[100,101,122,123,126,133,138],higdon:[131,132],high:[1,2,4,19,38,58,60,62,79,91,94,97,113,117,137,141,142,146,162],higher:[1,4,42,63,91,94,113,148],highest:[63,92],highli:[2,4,45,58,68,72,91,113],highlight:2,hight:116,hill:71,histo:[2,44],histogram:[1,2],histor:114,histori:[0,2],ho3:44,hoc:88,hoh:[2,105,122,126],hold:[2,73,91,92,118,130,161],holdem:73,holian:[69,124],holm:70,home:3,homepag:58,homogen:139,hone:71,hood:137,hook:[2,3],hookean:118,hoover:[2,68,69,71,78,109],hop:[61,92,97,148],hope:[19,60],hopefulli:91,horn:2,host:4,hot:2,hove:134,how:[0,1],howev:[1,2,3,4,18,19,35,41,42,44,58,60,61,62,66,67,68,70,71,72,79,92,102,103,111,112,118,134,137,141,142,145,155,158,163],howto:[2,68,105,120,122,126],hoyt:59,hpc:1,htm:111,html:[0,3,116,132],htmldoc:0,http:[0,2,3,70,93,111,131,163],https:163,htype:[105,122,126,130],hubbard:106,huge:163,huggin:[98,99],hugh:59,hugoniostat:69,hugoniot:[69,72],hundr:63,hura:2,hybrid:[1,2,4,32,57,68,93,94,104,105,109,111,114,117,118,120,121,130,134,135,136,137,139,143,145,146,148,149,154,155,156,157,158,159,162],hydrat:116,hydrocarbon:[94,104,113],hydrodynam:[67,131,132],hydrogen:[2,94,97,105,113,120,122,126,130],hydrostat:[62,68,69],hynninen:[106,116],hyoungki:136,hyper:[4,71],hyperbol:106,hyperradiu:90,hyperspher:42,i_0:79,i_1:145,i_csid:2,i_mpi_pin_domain:4,i_mpi_shm_lmt:4,i_n:145,ialloi:134,ibar:134,ibead:71,ibm:137,icc:137,ice:2,icm:163,icms:163,icosohedr:30,id1:[92,121],id2:[92,121],id_press:[62,68,69],id_temp:[61,62,68,69],idea:[1,2,3,19,43,58,60,70,139,163],ideal:[2,30,70,131,151,163],idealiz:2,ident:[1,4,42,62,66,68,70,71,92,98,99,105,107,111,122,124,130,143,148,149,159,162],identifi:[1,2,29,45,65,120,121,134,141,142],idn:92,ielement:134,ignor:[2,3,4,19,32,58,60,62,68,69,73,79,80,81,92,93,102,103,111,112,114,117,121,134,141,142,143,145,146,155,156,157,158,159],iii:[2,9,89,120],ijj:159,ijk:[86,88,89,97,145,159],ijl:88,ikeshoji:[2,63],ikj:159,illinoi:131,illustr:[1,2,3,4,70,71,92],imag:[2,3,33,34,40,41,45],image2pip:58,image:58,imagemagick:58,imagin:[97,112,135,136,143,145,155,156,157,158,159],imaginari:[2,36,71],imbal:[1,19,60,74],imbalanc:[19,60],img:58,immedi:[0,45,74,75],immers:67,impact:[1,2,94],impart:2,impei:[2,122],implement:[1,2,11,31,32,38,41,44,45,48,57,63,64,67,68,71,72,74,75,79,88,91,92,93,97,104,105,107,109,110,111,112,113,122,126,130,134,146,156,158],impli:[2,32,43,58,73],implicit:[2,66,80],implict:106,important:78,impos:[2,39,63,70,77,78,80,81,91,92],imposs:1,improp:[0,4,39,43,45,61,82,83,84,85,86,87,88,89,91],improper:[4,88],improper_coeff:[82,83,84,85,86,87,88,89],improper_styl:[0,2],improv:[0,1,4,19,60,63,68,120,122,137,139,155,157],in3:44,inaccur:[1,2],inaccuraci:81,inact:120,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,61,62,66,67,68,69,70,71,72,73,74,75,78,79,80,81,82,83,84,86,87,88,89,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,140,143,144,145,146,147,149,150,155,156,157,158,159,160,161,162,163],inclus:[0,32,139],incompat:3,incomplet:3,incompress:113,inconsist:61,incorpor:[56,72,97,106,163],incorrect:134,incorrectli:118,increas:[1,2,4,41,43,58,61,63,65,73,74,92,94,113,117,141,142,157],increasingli:113,increment:[3,60,68,148],incur:79,indefinit:77,indent:91,independ:[2,3,19,35,45,60,61,62,66,67,68,78,79,118,137],index:[0,2,3,40,65,71,79,139,141,142],indic:[2,3,4,6,28,31,33,35,37,39,43,47,58,62,68,79,82,88,104,114,134,137,139,143,148,156,158,163],indirectli:2,indium:149,individu:[0,1,2,3,4,32,39,43,45,57,58,62,63,67,68,75,91,98,99,101,102,105,111,113,119,121,122,126,139,144,147],induc:0,ineffici:[2,29,30,36,38,42,58,68],inerti:132,inertia:[2,40,132],inertiai:40,inertiax:40,inertiaz:40,infer:[60,114],infin:91,infininti:58,infinit:[67,79,113],infinitesim:2,inflect:[106,124],influenc:[19,139,156,157,158],inform:[0,1,2,3,4,19,40,41,44,45,46,58,59,60,61,62,63,67,70,73,75,76,77,80,81,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,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],infrequ:[2,68,109],infti:[106,131,132],ingtegr:97,inher:[91,139],inherit:2,inhomogen:[79,139],inidividu:91,init:148,init_fil:79,initi:[2,3,19,32,58,59,60,61,62,65,66,67,68,69,71,72,73,74,77,78,79,80,91,92,94,108,109,137,141,142,148],initial:2,initialt:79,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,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],inner_distance_cutoff:120,innner:128,inorgan:[2,159],inp:[149,159],input1:40,input2:40,input:[0,1],insert:[45,149,154],insid:[2,3,40,45,63,67,80,81],inside:[67,124],insight:2,instabl:[67,108],instal:[1,2,3,4,58,92,100,101,122,126,130,137,163],install:0,instanc:[2,3,116,139,145],instantan:[2,61,62,66,68,69,72],instanti:[2,3,59],instead:[1,2,3,4,19,29,34,46,60,62,67,99,100,111,121,123,130,134,137,140],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,58,68,69,75,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],instruction:3,insuffici:2,insult:68,insur:[2,3,30,45,58,79,80,81,103,117,146],integ:[2,3,29,38,42,45,46,49,50,53,56,58,61,66,67,72,74,79,86,109,110,134,149],integral:[71,141,142],intel:1,intel_coprocessor:4,intel_cpu_intelmpi:4,intel_cpu_mpich:4,intel_cpu_openpmi:4,intend:[2,18,66],intens:[1,2,33,34,35,37,39,41,44,60,61,68,69,79],inter:[61,92,97],interact:[1,2,3,13,28,32,36,38,39,42,43,46,51,56,57,61,70,71,73,74,79,80,81,83,84,85,87,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,142,144,145,146,147,148,149,150,154,155,156,157,158,159,160,161,162],interatom:[45,77,78,93,97,111,113,134,137,148,157],intercept:41,interchang:2,interconvert:113,interesect:81,interest:[1,3,44,71,78,112,132],interf:163,interfac:0,interfer:[68,94],interg:2,interi:132,interior:[2,19,81],interlac:134,interleav:[2,45],intermedi:[2,58,70,88,92],intermolecular:94,intern:[0,2,3,4,5,6,8,12,16,17,18,31,32,40,43,47,58,59,64,65,68,69,74,82,83,87,88,91,110,115,141,142,151],internal:58,internal_element_set:59,internal_quadratur:59,internat:[4,41,44,59],interpenetr:134,interpentr:[151,152],interpol:[2,58,59,65,67,70,92,97,139,141,142,156],interpret:[2,3,56,58,118,150],interrupt:72,intersect:[2,41,81],intersert:81,interspers:91,interstiti:137,interv:[2,35,68,72,148],intestieti:41,intial:[2,94],intiial:19,intramolecular:13,introduc:[2,36,38,58,63,68,72,88,93,105,113,122,126,130,155],introduct:0,inv:[41,44],invalid:[33,92,131,132],invari:[38,42],invent:75,invers:[2,26,41,44,72,88,89,98,105,122,160,161],invert:[1,2],invis:81,invoc:61,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,45,46,47,48,49,50,51,52,53,54,55,58,59,60,61,62,63,66,67,68,69,70,75,76,77,78,79,80,81,82,83,84,86,87,88,89,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,140,143,144,146,147,149,150,155,156,157,158,159,160,161,162],involv:[2,67,91,92,96,117,155,156,158],ion:[2,79,97,106,114,116,134,137,148,158,162],ionic:[2,98,99,106,113,114,144,148],ioniz:[104,113],ipp:0,ir3:44,ir4:44,irregular:[2,19,60,62,68],irrelev:143,irrespect:[131,132],irrevers:74,isbn:161,isenthalp:68,ismail:[100,126],isn:[3,63],iso:[62,68,69],isobar:[68,110],isodem:113,isoenerget:110,isoenthalp:110,isol:118,isomorph:71,isotherm:[68,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,46,47,48,49,50,51,52,53,54,55,58,61,62,63,68,69,71,75,78,82,83,84,86,87,88,89,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,140,143,144,146,147,150,154,155,156,157,158,159,160,161,162],issue:59,item:[2,19,60],iter:[2,19,60,62,75,91,92,148],iterat:91,itself:[2,3,35,58,79,92,105,114,117,141,142],ityp:45,izumi:157,j0jt:35,j_m:42,jackson:138,jacs:[2,46],janssen:70,januari:134,jaramillo:113,jcp:80,jeffer:4,jello:68,jeremi:136,jik:97,jmm:42,job:75,jochim:68,join:[2,29,118],joint:120,jon:29,jone:[1,2,21,22,32,46,59,63,80,81,91,94,96,99,100,101,102,103,108,117,119,120,121,122,123,124,126,127,129,130,133,138,139,145,146,147],jonsson:[30,92,148],jorgensen:[2,54,105,122,126],journal:[51,59,111,137,151,152],jpeg:58,jpg:58,judici:2,jump:[2,18,69],jun:4,just:[2,3,13,35,43,58,79,92,94,96,145,163],justo:112,jusufi:[106,116],jut:81,k11:35,k22:35,k33:35,k_2:85,k_4:85,k_sigma:97,k_ub:5,kalia:159,kapfer:38,kappa:[2,35,105,110,122,160,161],kappa_:79,karplu:32,karttunen:67,kate:0,kaufmann:4,kayser:106,kcal2j:35,ke_eta_dot:68,ke_etap_dot:68,ke_omega_dot:68,keblinski:[105,148],keef:41,keep:[55,74,78,91,105,130,149,163],kei:[2,159],kelchner:29,kemper:104,kepler:1,kept:[2,69,77,78],kernel:[4,59,66,137,151,152,153],keword:58,keyword:[2,4,19,29,32,34,36,37,38,39,40,41,42,43,44,45,58,59,60,61,62,63,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81,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,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],keywrod:113,khersonskii:42,khvostov:4,kim:[134,135,136],kind:[1,2,3,19,30,58,60,61,75,92,97,113],kinemat:[131,132],kinet:[2,32,35,39,43,62,63,68,69,72,74,91,113,115,142],kjl:88,klein:[2,59,68,122,147],kmax:41,kmp_affinity:4,knight:4,knl:4,knock:79,know:[3,19,91,112,163],knowledg:58,known:[42,58,63,77],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,68,69,75,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],kollman:[2,46],kone:[77,78],koning00a:77,koning00b:77,koning96:[77,78],koning97:78,koning99:77,kraker:4,kremer:[21,22],kress:[135,136],kspace:[0,1,2,32,39,43,91,98,99,100,101,105,108,122,126,130,132,139,147],kspace_modifi:[2,4],kspace_styl:0,kstart:73,kstop:73,kth:[66,71],kub:5,kubo:[2,35],kumagai:157,kumar:[131,132],kuronen:145,kuster:90,kutta:74,l12:134,l_box:113,l_skin:79,la3:44,label:[63,71,92],laboratori:[0,31,64,72],lack:[4,113],lackmann:97,ladd:78,lafitt:138,lag:79,lagrangian:[2,59,72],lagrangian_posit:72,lagrangian_spe:72,lambda1:[156,157,158,159],lambda2:[156,157,158],lambda3:[156,158],lambda4:159,lambda:[32,41,44,67,77,78,79,93,112,130,140,155],lambda_fin:77,lambda_initi:77,lamda:[27,140],laminar:153,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:74,lammps_set_vari:2,lammps_sppark:2,lammps_vers:2,lamms:2,lamoureux:2,land:4,landron:148,lane:1,langevin:[2,66,68,69,72,73,78,79,92,108,109],languag:[2,3],larentzo:[31,64],larg:[0,1,2,4,19,29,40,43,45,51,58,60,61,62,63,67,68,72,73,75,79,80,81,88,90,91,103,109,113,117,118,121,137,139,141,142,146],larger:[1,2,3,19,29,45,58,63,67,68,73,79,80,81,91,92,97,103,105,106,113,118,122,126,132,139,154],largest:[2,45,91,141,142,154],laser:79,last:[1,2,3,43,56,58,60,74,91,92,95,96,97,98,103,104,109,110,111,116,117,118,119,120,123,125,127,128,129,132,138,140,146,148,150,154,160,161],lat:134,later:[2,3,69,91,94,97,163],latitud:42,lattc:134,latter:[2,3,4,19,32,60,62,68,74,81,97,99,100,101,102,108,122,126,130,137,144,147,148],lattic:[2,19,29,30,35,36,41,44,45,60,67,70,80,81,93,111,134],launch:[1,2,3,4],laupretr:88,law:2,layer:[2,79],layout:1,lb_fluid:67,lbtype:67,ld_library_path:3,lead:[2,9,19,32,60,67,69,72,74,75,88,92,105,122,126,128,137,163],least:[2,41,44,63],leav:[3,6,19,43,47,60,62,68,75,82,139],lee2:134,lee:[59,134],left:[2,3,19,57,58,61,70,74,163],leftmost:[19,60],legaci:4,leimkuhl:68,leiu:109,lenart:[106,116],length:[2,3,4,6,19,27,28,29,31,32,33,34,35,37,39,40,41,44,47,58,60,61,62,65,67,68,69,70,75,79,80,81,90,91,92,94,97,98,99,105,106,113,116,120,122,134,139,141,142,156,160,161],lennard:[1,2,21,22,32,46,63,80,81,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,40,60,61,62,63,68,70,91,97,101,117,118,131,132,139,146,155,158,161],let:[1,50,65,75,103,141,142],lett:[42,67,77,78,97,111,113,117,130,141,142,149],letter:[19,60,71],level:[3,58,68,70,73,76,80,81,97,100,101,122,123,126,133,137,138],lever:154,levin:118,lgr_po:72,lgr_vel:72,li1:44,liang:104,lib:[1,3,4,104],libdir:3,liblammp:3,liblammps_foo:3,liblammps_g:3,libmpi:3,librari:[0,1],licens:[0,58],lie:[2,29],like:[2,3,4,28,58,62,68,70,72,74,80,81,90,92,97,103,108,109,110,113,114,118,120,127,128,134,149,158,160,161,163],likelihood:[41,44,61],likewis:[1,2,19,59,60,68,69,92,93,96,97,105,111,114,137],limit:[2,4,11,41,42,44,45,48,58,62,63,66,68,72,91,106,113,118,132,147,150],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,42,43,46,47,48,49,50,51,52,53,54,55,58,60,62,65,68,69,70,72,74,75,79,82,83,84,86,87,88,89,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,140,141,142,143,144,145,146,147,148,149,150,155,156,157,158,159,160,161,162,163],linear:[2,9,11,42,48,59,61,62,65,68,73,75,79,80,83,84,85,87,92,118,128],linearli:[2,80,92],lineflag:2,lineforc:91,lingo:3,link:[2,3,57,58,134],linkflags:4,linux:[3,4,58],liouvil:68,lipid:13,liquid:[2,4,13,19,32,36,43,60,62,68,72,108,137,139,144,157],lisal:[110,154],list:[0,1,2,3,4,6,19,29,30,32,36,38,39,42,43,47,57,58,59,60,61,65,68,70,74,75,82,83,84,85,87,88,90,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,148,155],lithium:113,littl:[1,4,63,68],littmark:[134,158,162],liu:120,lj126:2,lj12_4:147,lj12_6:147,lj93:2,lj9_6:147,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:71,lmpptr:3,load:[1,2,3,4,19,58,60,72,74,104],loadabl:3,localized_lambda:59,localtemp:74,locat:[2,3,11,41,44,48,56,63,67,78,81,105,114,115,116,122,124,126],lockstep:[62,68],log:[1,2,4,72,75,92,94,116,120,131,132],logfil:[0,2],logic:[3,4,19,45,60],lomdahl:[69,124],longer:[1,2,28,68,70,72,74,75,80,81,94,118,148],longest:[19,60],look:[1,2,3,28,58,149,163],lookup:[139,141,142],loop:[2,3,40,43,58,91,92,137,148],loopmax:148,lopez:68,lorentz:44,lose:[2,62,68,118],loss:2,lossi:58,lossless:58,lost:139,low:[1,2,19,58,60,137,141,142,161],lower:[2,3,4,19,58,60,62,67,68,72,80,106,134],lowercas:[0,58],lowest:42,lrt:4,lsurfac:79,ltbbmalloc:4,lu3:44,lubric:2,lubricateu:[80,131],luci:74,lumped_lambda_solv:59,lyulin:88,m4v:58,m_eff:118,m_i:76,m_u:67,m_v:67,machin:[1,2,3,4,58,68,91,137,163],mackai:67,mackerel:[2,5,46,101],macos:58,made:[2,3,19,58,60,78,117,118,146,150,163],madura:[2,122],magazin:111,magda:80,magic:3,magnitud:[2,29,37,45,91,108,118],mai:[0,1,2,3,4,13,19,29,32,33,34,36,37,38,39,40,41,42,43,44,45,57,58,60,62,63,66,67,68,69,71,72,73,74,75,78,79,80,81,91,92,94,96,97,103,109,113,118,128,130,132,134,135,136,137,139,141,142,147,149,154,159,162,163],mail:163,main:[2,3,67,77,78,111,148],mainboard:1,mainli:144,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,42,44,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,77,78,79,81,82,83,84,85,86,87,88,89,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,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162,163],makefil:[3,4,137],maks:118,manag:71,manbi:149,mandadapu:59,manh:97,mani:[1,2,4,19,35,45,58,60,61,62,63,65,66,67,68,69,70,74,75,79,91,92,104,113,116,120,141,142,148,149,156,158],manipul:[19,60,105,145],manner:[2,3,19,43,58,60,68,77,78,80,81,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,41,44,46,47,48,49,50,51,52,53,54,55,58,68,69,75,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],manybodi:[43,91],manybody:[93,94,97,104,111,114,143,145,155,156,157,158,159],map:[3,41,42,44,45,58,59,63,73,92,93,94,97,104,111,112,114,134,135,136,139,143,145,148,149,154,155,156,157,158,159],mara:148,march:134,mark:[119,130,148],maroonmpi:3,marrink:119,marsaglia:66,martin:134,martyna:68,mask:70,mask_direct:59,mass:[2,32,33,34,35,37,40,45,59,63,66,67,68,71,72,75,76,78,79,93,96,97,111,113,114,118,131,132,135,136,137,145,148,151,152,153],mass_matrix:59,massdelta:75,massiv:[0,58,67,71],massless:[2,105,122,126,130],master:92,mat:[59,104,157],match:[2,3,19,60,61,65,68,97,120,128,134,141,142],mater:[30,93,136,145,148],materi:[2,29,59,70,79,105,111,112,113,118,134,135,137],material_fil:59,math:[4,68],mathemat:[41,42,44,45,62,66,80,149],mathrm:163,matlab:0,matric:[42,117],matrix:[2,35,62,74,137],matter:[2,79,94,107,111,113,134,147,148,156,158,159,162],mattson:[31,39,43,64],max2theta:44,max:[2,60,62,74,75,91,92,148],max_step:74,maxev:91,maxim:92,maximum:[2,9,19,21,27,28,36,38,41,44,60,63,70,74,75,92,97,116,131,132,148],maxit:91,maxstep:74,maxx:145,mayer:[98,99,148],mayo:[2,9,89,120],mbt:47,mcdram:4,mcgraw:71,mclachlan:68,mdregion:59,mdump:[19,60],meam:105,meam_sw_splin:136,meamf:134,mean:[2,3,4,19,28,32,35,36,37,38,39,40,42,43,45,46,57,58,60,61,62,63,66,68,69,70,71,74,75,79,80,81,83,84,85,87,91,92,98,99,100,101,105,109,111,113,117,118,120,122,123,126,133,134,138,139,141,142,144,145,146,147,154,155,156,157,158,161],meant:2,measur:0,mechan:[2,3,31,59,63,64,71,74,97,113,124,137],meck:38,media:58,medium:161,meet:[58,61],mehl:93,mei:133,melros:[131,132],melt:[61,97,137,157],member:[46,97],membran:[13,161],memori:[2,4,66,79,97,139],mendelev:111,mention:[1,2,3,67,69,80,92,94],menu:58,mep:92,mer:61,mercuri:163,meremianin:42,merg:163,merz:[2,46],mesh:[1,2,19,41,44,59,60,67,137],mesoparticl:[64,65,110],messag:[0,2,3,58,63,131,132,163],met:[19,60,91,92],metal:[45,59,72,80,93,94,97,104,111,112,113,114,134,135,136,137,145,148,155,156,157,158,159],methan:72,methin:88,method:[1,2,3,4,19,32,35,43,59,60,65,67,68,71,72,74,75,77,78,91,92,93,97,104,105,111,113,114,134,135,136,139,141,142,145,148,159],methodolog:[2,30,43,71],mezei:32,mg2:44,mgoh:143,mgptfast:137,micel:76,micelle2d:0,michael:136,mickel:38,microscal:131,mid:[137,154],middl:[2,4,19,32,47,60,73,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,140,141,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],middlebondtors:47,midpoint:154,might:[2,4,9,148,163],migrat:[19,40,60,70],mikami:[2,68],mike:4,mil:111,militz:70,million:[19,60],mimic:[2,28,105,116,122],mimim:[62,92],min2theta:44,min:[2,42,74,148,154],min_modifi:[62,91],min_step:74,min_styl:[91,92],mind:66,minim:[0,2,19,45,58],minima:[51,56,89],minimi:92,minimizaiton:92,minimum:[9,10,11,21,37,44,48,58,62,73,74,80,81,89,91,92,101,113,115,117,119,120,122,124,126,131,132,147,154],minmiz:62,minstep:74,mintmir:105,minu:92,misc:[2,10,11,13,24,25,37,48,66,70,71,77,78,79,83,85,88,106,108,111,112,116,121,127,133,135,136,140,144,154],miscellan:59,mishin:93,mishra:4,miss:[121,139],mitchel:[2,107],mitig:68,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,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],mixtur:[2,68,103,115,134,142],mixture_ref_t:134,mjpeg:58,mkv:58,mn2:44,mn3:44,mn4:44,mo3:44,mo5:[44,137],mo6:44,mobil:[2,37,43,58],mode:[1,2,3,4,34,44,58,68,71,105,113,137,148],model:[0,1],modern:4,modest:1,modif:[2,4,32,134,137,146,158,163],modifi:[0,1,2,3,32,58,63,73,75,78,94,108,111,113,130,134,135,136,139,140,148,157,163],modin:59,modul:[3,90],modulu:[118,134],mol:[40,45,75,108,117,147],molchunk:34,mole:[111,115],molecul:[2,13,33,34,40,43,45,61,63,65,73,74,75,101,105,117,122,126,146],molecular:[0,2,4,27,45,51,59,63,71,72,73,79,95,97,100,113],molecule:[5,7,8,9,12,16,21,22,23,26,27,28,46,50,51,52,54,57,84,87,89,101,122],moltempl:0,molybdenum:137,mom:[2,35,73],moment:[2,40,45,67,68,76,108,112,148],momenta:[63,113],momentum:[2,13,40,42,45,59,66,67,68,132],momon:61,monaghan:[151,152],monitor:[2,62,68,72,75,91,92,108],mono:[30,131],monodispers:[118,131,132],monom:[28,61],monoton:[65,92],mont:[2,61],month:0,moor:[31,43,64,141,142],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,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,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],morgan:4,moriarti:137,moriarty1:137,moriarty2:137,moriarty3:137,mors:2,mosi2:134,moskalev:42,most:[0,1,2,3,4,19,29,57,58,60,62,68,71,72,94,113,117,134,158,163],mostli:[3,58],motiion:2,motion:[2,63,67,68,69,70,71,73,79,81,90,92,108,113,131,132],motiv:70,mov:58,move:[1,2,3,37,62,67,68,70,72,73,79,80,81,91,92,105,109,131,132,137],movement:[2,91],mp2:94,mp4:58,mpeg:58,mpg:58,mpi4pi:3,mpi:[0,1,2],mpi_barrier:1,mpi_comm:2,mpicc:3,mpich:4,mpirun:[1,2,3,4,71],mplayer:58,msd:2,msi2lmp:0,msmse:[41,44],msse3:137,msst:[69,72],mtk:[68,69],mu_j:13,muccioli:117,much:[1,2,3,58,62,72,94,117,146,163],muller:[2,35,138],multi:[0,1],multibodi:[141,142],multicent:113,multicor:1,multinod:4,multiphys:3,multipl:[0,1],multipli:[32,35,57,67,70,91,94],multiscal:3,multisect:[19,60],multistag:32,multithread:4,murdick:97,murti:157,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,65,66,67,68,69,70,72,73,74,75,78,79,80,81,82,83,84,85,86,87,88,89,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:58,mxn:71,mychunk:[2,34],myflux:35,myhug:69,myke:35,mymol:75,mympi:3,mype:35,myramp:43,myrigid:40,myspher:81,mystress:35,n_f:72,n_hbond:120,n_ij:118,n_ion:79,n_k:66,n_particl:31,na1:44,nabla:79,nacl:[2,134],nacl_cs_x0:2,nakano:[92,159],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,71,72,73,74,75,76,77,78,80,81,92,93,94,97,99,111,112,114,117,118,121,134,135,136,143,145,148,149,155,156,157,158,159,163],namespac:2,nanoindent:29,nanoparticl:60,nanosecond:63,narrow:2,narulkar:[156,158],nation:0,nativ:[1,2],natom:[2,3],natur:[2,42,68,70,111,113,114,134,145],navi:111,navier:67,nb3:44,nb3bharmon:143,nb5:44,nbodi:137,nbot:97,nchunk:[2,34],ncoeff:149,nd3:44,nden:[2,35],ndof:[68,69],nearbi:[81,94,131,132,161],nearest:[29,30,36,38,40,67,70,81,121,134,141,142,148],nearli:[2,28,60,113,137,139],neb:2,neb_combin:92,neb_fin:92,necessari:[2,3,4,32,57,60,62,66,74,130,137,139,148],necessarili:[63,83,84,85,87,139],need:[1,2,3,19,28,29,30,35,36,38,39,42,43,45,46,56,57,58,59,60,62,65,67,68,73,79,80,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,161,163],needless:2,neg:[2,11,22,33,42,43,48,50,58,62,66,69,70,74,80,114,125,134],neglect:[120,132],neglig:[2,3,32,68,155],neigh_modifi:[2,4,60,91,109],neighbor:[1,2,4,19,29,30,36,38,42,43,45,58,60,61,70,71,92,103,105,109,111,112,114,115,121,122,126,134,139,142,145,148,149,154,155,156,157,158,159],neighborhood:[10,29,36,149],neighobr:[2,105,122,126],neither:[19,59,61,94,113,131,132],nelem:149,nelement:[93,111],nelson:[36,38],nemd:0,net:[2,3,70,132],netpbm:58,neutral:[105,122,148],never:[62,68,70,75,80,111,134,149,159],neveri:[61,63,67,92,148],newer:134,newtion:[97,137,145],newton:[4,13,94,104,112,135,136,148,154,155,156,157,158,159],newtonian:66,next:[1,2,3,29,35,40,58,65,66,74,75,79,91,92,97,115,118,131,132,141,142,145,163],nfile:[65,141,142],nfreq:60,ngb:70,ngp:37,nguyen:97,nhc:71,ni2:44,ni3:44,ni_000:41,nialh_jea:111,nice:[2,163],nickla:136,nine:[114,148],nissila:[67,148],nist:[93,111],niter:[19,60],nitrid:105,niu3:111,nkb:72,nlocal:3,nlvalu:38,nmpimd:71,nn2:134,nnn:[36,38],no2:[65,74,115],no_affin:4,no_histori:2,noced:91,nocheck:121,nodal:[2,59,65,79,141,142],node:[1,4,19,41,44,60,67,79,121],node_area:67,node_group:59,nodeless:113,nodes:[19,60],nodeset:59,nodeset_to_elementset:59,noforc:[2,132],nois:[2,66,67,72,79],nomenclatur:2,nomin:68,non:[0,1],nonbond:143,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,73,74,75,76,79,80,81,82,83,84,85,86,87,89,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,144,146,147,149,150,151,152,153,154,155,156,157,158,159,160,161,162],nonequilibrium:[77,78,113],nongaussian:37,nonlinear:[21,22],noordhoek:104,nor:[19,59,104],nord:[145,156,158],nordlund:[145,156,158],norm:[2,74,91,92,154],normal:[2,3,4,19,29,30,35,39,45,46,60,62,68,70,71,79,80,81,82,83,84,85,87,90,91,92,103,104,117,118,137,154,162],norman:79,nose:[2,68,69,71,78,109],notat:[2,29,42,68,111,159],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,64,65,67,68,69,71,72,73,74,76,79,80,81,82,83,84,85,87,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,139,141,142,143,145,146,147,148,149,150,154,155,156,158,159,161,162,163],notes:[32,130],noth:163,notic:[0,2,78,79],novemb:134,now:[2,3,4,22,66,81,111,113,118,150,163],np3:44,np4:44,np6:44,nparticl:96,nph:[2,40],nphi:4,nproc:3,npt:[2,4,32,40,62],nreset:[62,68,69],nreset_ref:62,nrho:[93,111],nrl:111,nstat:70,nstep:[62,68],ntabl:[141,142],ntheta:97,ntype:[42,45,113,120,145],nuclear:[72,113,162],nuclei:113,nucleu:158,nudg:[2,92],num_step:74,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,60,61,65,66,67,68,69,70,71,72,74,75,77,78,79,80,91,92,93,94,97,104,109,111,112,113,114,120,134,135,136,137,139,141,142,143,145,146,148,149,154,155,156,157,158,159,162],numer:[1,2,3,19,32,38,56,58,59,63,66,68,71,75,79,80,91,108,134,139,141,142,162],numpi:3,nvcc:1,nve:[1,2,4,32,35,40,45,59,63,66,68,69,73,75,79,108,117,131,132,146,148,150],nvidia:1,nvt:[2,4,32,35,40,59,63],nvtfe:59,nxnode:79,object:[2,3,58,62,67,91],observ:[4,68,72],obtain:[1,4,13,30,32,38,67,69,71,94,108,134,139,148,156,158],obviou:162,obvious:58,occ:116,occasion:68,occlus:58,occup:116,occur:[1,2,3,37,56,60,61,62,65,77,113,130,141,142],occurr:88,oct:3,octahedr:9,odd:[19,38,60,68,79],ode:74,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,61,66,68,69,75,80,81,82,83,84,86,87,88,89,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,144,146,147,148,150,154,155,156,157,158,159,160,161,162],offer:[2,105,148],offload:[1,4],offset:[2,45,58,105,122,126],often:[1,2,4,57,58,60,62,68,71,91,92,104,109,122,156,158,163],ohio:136,old:[2,62,68,134,150],older:[4,62,68,150],oleinik:97,olfason:[2,9,89,120],ollila:67,olmsted:[59,70],omega0:89,omega:[2,68,80,86,89,108,118,137],omega_dot:68,omega_ij:110,omega_ijk:158,omega_ik:156,omegadd:[141,142],omegai:40,omegax:40,omegaz:40,omgea:2,omiss:0,omit:[63,100,108,126],omp:[1,4],omp_num_threads:4,on_the_fli:59,onc:[0,1,2,3,4,19,46,58,60,74,92,117,119,145,146],once:[0,2,19,35,60,163],one:[2,13,35,42,58,68,69,79,97,106,132,148],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,60,61,62,63,64,65,66,67,68,69,70,71,72,74,75,77,78,79,80,81,82,83,84,85,86,87,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,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,58,62,63,70,91,92,93,94,97,101,104,111,112,114,120,131,132,134,135,136,143,145,149,155,156,157,158,159],onset:[72,88],onto:[42,61,63,67,154],open:[0,3,58,163],opencl:1,opengl:2,openmp:[1,4],openmpi:4,oper:[1,2,3,4,19,35,45,60,61,63,68,69,75,78,79,92,137,163],opl:4,opls:[54,57],oppelstrup:137,oppos:[2,73],opposit:[2,13,29,46,70,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,46,47,48,49,50,51,52,53,54,55,68,69,75,82,83,84,86,87,88,89,93,94,95,98,99,100],optim:0,optimiz:[4,91,104],option:[0,1],optional:149,options:[4,137],orang:58,orbit:[97,105,113,148],order:[2,3,4,11,13,19,32,33,34,36,38,39,40,42,43,48,57,58,61,62,63,65,67,68,70,72,73,74,75,79,82,83,84,85,87,88,90,92,93,94,97,104,110,111,113,114,117,118,122,130,134,137,141,142,146,148,155,156,157,158,159],ordinari:[74,120],org:[2,3,70],organ:[0,2,104],organometal:9,orient:[2,13,29,35,36,38,40,45,68],orientord:36,origin:[2,41,45,58,63,68,71,78,93,94,95,97,105,108,109,111,120,134,156,158,163],orlikowski:137,orsi:13,orthogon:0,orthograph:58,orthorhomb:72,os4:44,oscil:[2,68,72,80],ose:58,oserror:3,other:[0,1],otherwis:[1,41,46,57,68,74,89,90,91,121,131,132,145],otyp:[105,122,126,130],our:[2,67,75,139,156,158],out:[1,2,3,6,19,34,35,37,47,58,60,67,79,81,82,83,87,92,113,133],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,140,141,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],outer_distance_cutoff:120,outermost:[68,70,73,76,80,81],outlin:[2,58],output:[0,1],output_frequ:59,outsid:[45,58,63,81,92,98,99,105,113,122,124,144,147],outut:2,outward:[80,81],over:[1,2,4,11,19,32,33,34,36,37,38,40,42,43,48,58,60,66,68,70,72,73,74,80,81,82,92,103,109,111,112,113,114,120,131,134,137,145,149,150,155,156,157,158,159],overal:[2,9,62,68,71,75,113,120,149],overhead:[2,3,19,60,63],overlai:[2,4,32,79,105,109,120,121,130,139,149,162],overlap:[4,45,91,109,113,118,130,150],overli:74,overload:1,overrid:[4,45,58,62,68,120,134,139],overridden:[2,45,58,69,131,139,150],overview:[0,1,2],overwrit:[3,134],overwritten:120,own:[2,3,19,30,34,40,59,60,61,62,66,67,68,69,71,92,94,97,104,112,145,155,156,157,158,159,163],oxford:[13,32,108],oxid:[104,105,148],oxygen:[2,105,122,126,148],p10:118,p_e:79,p_ik:145,p_pi:97,pacakg:4,pack:[97,134],packag:0,packet:[58,113],pad:[58,71],page:[0,1,2,3,32,34,37,39,40,43,45,57,58,68,81,90,91,92,93,94,96,104,105,111,112,114,120,134,135,136,139,143,145,149,155,156,158,159],painless:163,pair:1,pair_:32,pair_charmm:130,pair_coeff:[2,32,35,46,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],pair_dzugatov:163,pair_eam:93,pair_interact:59,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],pair_sph:[151,152,153],pair_styl:[0,1,2,4,18,28,32,35,42,46,66,80,81,91],pair_writ:128,pairwis:[0,1,2,28,29,36,38,39,42,43,46,57,61,66,80,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,140,144,147,150,154,158,160,161],pakketeretet2:163,pan:58,panagiotopoulo:[106,116],papaconstantopoulo:93,paper:[2,42,51,67,79,92,94,100,105,118,120,124,126,156,158],paquai:[90,163],paraemt:146,paragraph:[80,141,142],parallel:[0,1,2],parallel_studio_xe_2016:4,parallelepip:2,param:115,paramet:0,parameter:[41,44,94,97,104,105,111,112,113,114,134,135,136,145,148,155,156,157,158,159],parameter_fil:59,parameterizaion:105,parametr:[2,18,112,147],paramt:[37,146],paramter:104,paratem:130,parenthes:[65,74,115,118,141,142],parenthesi:4,parinello:2,pariticl:60,park:[59,136],parmin:137,parrinello1981:62,parrinello:[62,68,72],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,44,46,47,48,49,50,51,52,53,54,55,57,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,77,78,79,80,81,82,83,84,86,87,88,89,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,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,62,67,69,71,134,139],partic:2,particip:[56,96],particl:0,particular:[1,2,29,42,45,58,60,61,66,67,68,70,73,75,82,96,97,98,99,101,102,103,107,110,112,113,117,119,122,126,130,133,140,143,144,146,147,155,156,157,158,159,163],particularli:[2,9,58,62,113],partit:[2,19,60,71,92,100,101,113,122,123,126,133,138,145],partner:61,pass:[2,3,33,34,37,40,58,62,68,80,90,154],password:163,past:[0,72,109],patch:0,patel:137,path:[2,3,71,79,92,93,94,97,111,112,114,134,135,136,143,145,148,149,155,156,158,159],pathtolammp:148,patrick:157,pattern:30,paul:0,pauli:[113,148],paves:71,payn:[42,149],pb2:44,pb4:44,pbc:80,pchain:[68,69],pcie:1,pd2:44,pd4:44,pdamp:[68,69],pdb:2,pdf:[0,151,152,153],pe_eta:68,pe_etap:68,pe_omega:68,pe_strain:68,peak:116,pearlman:32,pencil:2,peng:44,per:[0,1],peratom:43,perceiv:58,percent:[4,62,155],percentag:[1,62,68],perfect:[2,19,29,30,36,60,70,92],perfectli:[19,60],perfom:[2,92],perform:0,performac:1,pergamon:[134,158,162],peri:[2,45],peridynam:2,perimitt:106,period:2,perioid:80,perl:2,perman:[28,73,120],permit:[2,67,137],permitt:[106,158,161,162],permut:[112,155,156,158,159],perpendicular:[2,58,70,80],perram:117,persepct:58,person:163,persp:58,perspect:58,perturb:[29,32,80],peskin:67,pettifor:97,pettifor_1:97,pettifor_2:97,pettifor_3:97,pfactor:58,phase:[4,68,97,122,157],phenomena:113,phi0:[55,73],phi1:47,phi2:[47,112,155],phi3:[47,112,155],phi:[1,4,36,38,42,56,57,58,73,84,93,97,111,114,134,135,136],phi_ij:[97,114,145],phillip:109,phillpot:[104,105,148],philosoph:111,philosophi:2,phonon:[0,59,79],phophor:149,phosphid:149,phy:[2,5,6,9,20,21,22,29,30,32,36,38,39,42,43,46,47,54,62,63,66,67,68,69,71,72,75,77,78,79,80,82,88,89,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,139,141,142,144,145,146,148,149,154,155,156,157,158,159],physic:[2,4,27,56,59,63,67,79,92,94,95,100,103,111,120,137,151,152,153],physica:[131,132],picosend:113,piec:[3,42,68],pimd:2,pin:4,pipe:[2,58],pipelin:[2,4],pisarev:79,pishevar:109,pitera:2,pixel:58,pizza:[2,3,19,58,60],pka:79,place:[2,3,19,32,45,58,61,63,66,68,79,80,120],placehold:[93,94,104,111,114,134,135,136,143,145,149,154,155,156,157,158,159],placement:122,plai:[2,58],plain:130,plan:[2,4],planar:[2,70,88,89],planck:71,plane:[2,19,36,58,59,60,70,79,82,83,84,85,86,87,89,90,132],plane_wiggl:90,planeforc:91,plasma:[79,113],platform:[1,4,58],plath:[2,35],player:58,pleas:[0,3,4,59,67,112,114,148],plimpton:[0,4,29,39,43,61,70,118],ploop:[68,69],plos:13,plot:[3,4,72,128,130],plu:[3,62,69,113],pm3:44,png:58,pni:58,poariz:2,poem:2,poems:2,point:[1,2,3,4,13,19,29,41,42,44,45,50,58,60,62,65,67,68,71,72,79,81,90,91,92,96,104,106,108,110,113,117,124,137,141,142,145,146,148,154,157,161],pointer:3,poisson:118,poisson_solv:59,polar:[2,38,42,44,59,104,105,122],polar_off:104,polar_on:104,polariz:0,politano:148,polydispers:[103,118,131,132,161],polyethylen:94,polygon:2,polym:[0,2,21,22,28,61,71,75,76,109,154],polynomi:[111,128,139,148],poor:[19,60,75,128],poorli:91,popular:112,porou:67,portion:[1,3,19,28,35,43,60,62,63,67,68,98,99,100,101,102,105,106,108,109,113,115,116,117,119,120,122,126,130,133,144,146,147,158,163],poschel:118,posit:[2,11,19,22,29,33,34,41,42,43,44,45,48,50,56,58,60,61,62,63,66,67,68,70,71,72,74,75,77,78,79,80,81,82,92,94,96,109,110,113,116,125,141,142,148,154],possibl:[1,2,3,19,29,32,40,42,43,59,60,61,64,70,74,79,86,91,120,134,148,159],post:[0,2,35,59,72],pot:118,potentail:114,potenti:0,potentiel:130,potin:137,pour:[2,75],power:[3,4,37,42,97],pparam:32,ppm:58,ppn:4,pppm:[0,1],pproni:66,pr3:44,pr4:44,practic:[62,68,159,163],prb:[156,158],prd:[2,92],pre:[2,73,80,97,118,139,141,142,148,150],prec:[4,148],preced:[2,46,74,92,97,120],preceed:[3,80],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,62,63,68,69,75,82,83,84,86,87,88,89,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,140,143,144,146,147,148,150,155,156,157,158,159,160,161,162],predefin:[55,113],predict:[1,2],prefactor:[8,9,12,16,17,18,57,80,83,87,88,91,103,116,143,146,147,150,161],prefer:[73,94,163],prefix:[3,58,74],preliminari:[65,141,142],prematur:91,preprint:[42,90,149],prescrib:[2,59],presenc:[67,131,132,137,161],present:[1,4,58,66,67,81,104,113,121,130,137,146,148],preserv:[62,68,75],press:[2,4,13,32,43,62,68,69,108,134,158,161],pressur:[1,2],pressure_with_eviri:113,presum:[30,92],prevent:[2,56,88,91,92,109,151,152,154],previou:[0,2,3,60,91,97,118,120,134,141,142],previous:[3,45,75,79,80,118],price:[2,108],primari:[0,2,79],prime:[119,137,156,158],primit:[2,81],princip:[40,148],principl:[2,3,113,137,155,163],print:[0,1,2,3,4,19,35,42,58,61,62,67,68,69,70,72,74,75,91,92,94,109,116,120,139,148],printfluid:67,prism:2,privileg:3,probab:150,probabl:[56,60,61,68,80,91,139,141,142],problem:[0,1,2,3,19,35,59,60,62,73,78,81,91,92,105,108,120,163],proc:[1,3,4],proce:[19,28,60,92,137],procedur:[2,19,60,68,69,77,78,91,92,94],proceed:137,procesor:19,process:1,processor:[1,2,3,4,19,40,45,58,59,60,61,62,66,67,68,71,75,79,92,109,148],processsor:[19,60],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,60,61,66,68,69,72,74,75,79,80,82,83,84,86,87,88,89,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,140,143,144,145,146,147,150,155,156,157,158,159,160,161,162],product:[2,4,42,74,113,115,142],profil:[2,63,92],program:[2,3,4,58,67,111],progress:[1,19,60,72,91,92],project:[2,163],promot:97,prompt:3,proni:66,prop:2,propag:[68,72,113],propens:2,proper:[61,70,134,163],properli:[92,110],properti:0,proport:[2,19,32,60,72,74,118],propos:[2,42,62,68,122,136,157],protein:[4,45,76],proton:[158,162],prove:[31,64,67],provid:[1,2,3,4,13,29,41,44,45,58,61,62,67,68,72,77,78,92,94,97,104,105,109,112,113,118,120,121,130,131,134,136,137,145,148,149,154,155,156,157,158,159,163],pscrozi:0,psec:68,pseudo:113,pseudopotenti:137,psf:2,psi:[114,161],psi_ij:114,pstart:[68,69],pstop:[68,69],pstyle:32,psxevar:4,pt2:44,pt4:44,ptarget:62,pthread:4,ptr:[2,3],pu3:44,pu4:44,pu6:44,publish:[67,90,105,134,137,156,158],pull:163,puls:79,pump:[131,132],purchas:58,pure:[3,135,136,156,158],purport:3,purpos:[2,41,44,45,61,62,70,71,73,100,126,137,139],push:[70,91,118,150,163],put:[2,3,45],pxx:[62,68],pxy:2,pxz:2,pydir:3,pyi:[62,68],pymol:3,pymol_aspher:0,pympi:3,pypar:3,python:[0,2],pythonpath:3,pyz:2,pzz:[62,68,72],q_1:148,q_2:148,q_3:148,q_i:[114,130],q_j:130,qdist:[105,122,126,130],qeq:[2,104,105,148],qeqall:148,qeqallparallel:148,qfile:105,qinitmod:148,qoffload:4,qopenmp:4,qoverrid:4,qtb:72,quadrant:4,quadratur:[32,59],quadrupl:93,quadruplet:[57,82,83,84,85,87,88],qualiti:[58,94],quantic:148,quantit:[37,118],quantiti:1,quantum:[2,42,71,72,94,97,113,137,148],quantum_temperatur:72,quartic_spher:59,quartz:72,quasi:71,quaternion:[2,40,45,117],quati:40,quatj:40,quatk:40,quatw:40,queri:[3,28],quest:2,question:[70,163],quick:[0,4],quickli:[36,60,91,92,94],quickmin:[91,92],quicktim:58,quit:[67,149],quot:134,quotat:148,r10:97,r12:117,r_1:42,r_2:42,r_c:[106,108,116,158],r_cut:[97,133],r_e:114,r_fu:[131,132],r_i:[13,42],r_ii:42,r_ij:[13,97,113,145,162],r_ik:145,r_j:13,r_jik:145,r_m:133,r_me:106,r_mh:116,r_min:107,r_ub:5,ra2:44,rad2theta:44,radial:[42,91,113,120,139,141,142],radian:[5,6,8,12,16,17,18,40,44,47,55,73,82,83,87,88],radiat:[41,44,79],radii:[42,61,103,111,117,118,131,132,137,161],radit:113,radiu:[2,33,34,41,42,58,67,76,80,81,90,97,103,113,114,118,122,130,131,132,133,134,148,149,158,161],rahman:[2,62,68,72],rai:44,ram:158,raman:4,ramp:[2,66,68,72,80,101,109,119,130,131,133,150,162],ran:[2,3],random:[2,45,58,61,66,67,68,71,72,79,109,110],randomli:45,rang:[1,2,4,38,39,42,43,44,51,58,59,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,140,144,145,146,147,148,154,158,160,161,162],rank:[2,3],rankin:69,rapid:[2,3],rapidli:[61,68,105,109],rare:2,rasmol:2,rasmussen:117,raster3d:2,rate:[2,4,59,72,74,77,78,115,131,132,142],rather:[2,19,39,58,60,66,79,113,141,142],ratio:[2,32,42,60,117,118,146,151],rattl:63,rattle:[63,75],rattle_debug:75,ravelo:[69,124],raw:4,rayleigh:72,rb1:44,rbb:148,rcb:[19,60],rcm:[33,34],rcmx:[33,34],rcmy:[33,34],rcold:63,rcutfac:[42,149],rd1:92,rdf:139,rdn:92,rdt:92,reach:[2,19,60,62,69,74,106],reacquaint:163,react:2,reactant:[74,113],reaction:[65,74,76,92,113,115,142],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,45,46,47,48,49,50,51,52,53,54,55,56,57,58,59,61,62,65,68,69,71,74,75,78,79,82,83,84,85,86,87,88,89,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,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],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,61,71,73,74,82,83,84,85,86,87,88,89,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,140,144,145,146,147,148,150,154,160,161],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,45,46,47,48,49,50,51,52,53,54,55,57,59,62,67,68,69,71,79,82,83,84,85,86,87,88,89,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,140,144,146,147,150,154,160,161],readabl:58,readi:3,readme:[1,2,3,4,90,137],real:[2,3,11,14,15,35,36,38,42,45,48,71,72,80,86,105,137,139,158],realli:[1,39,43,163],reamin:[80,81],rearrang:92,reason:[2,3,45,56,77,78,92,106,113,114,116,132,139],reax:[0,72],rebal:[19,60],rebalanc:[19,60],rebuild:[3,4,109],rebuilt:58,recalcul:32,receiv:70,recent:[3,4,60,134],reciproc:[2,41,44,98,99,100,105,108,113,122,126,144,147],recogn:[30,68,74,111,134],recomend:2,recommed:74,recommend:[4,58,63,72,78,113,131,132,137,146,148,163],recompil:[1,75],reconstruct:148,recov:[62,63,68],rectangl:[19,60],rectangular:[19,60],rectilinear:[41,44],rector:27,recurs:[19,60,97],recust:19,red:[58,61,71],reduc:[1,2,11,19,39,40,41,43,44,58,60,61,70,73,74,91,113,117,145,146,155,156,158],reduct:[41,44,72],redund:114,reed:72,ref:[77,78],refactor:2,refer:[2,3,4,13,32,45,59,61,62,63,68,69,70,71,72,75,82,89,93,117,134,136,137,146,152,153,156,158],referenc:[2,105,120,143,146],reflect:[2,41,42,44,57,58,80,97],refresh:59,regard:[2,75],regardless:[45,68],regim:[2,106],region:[0,2,19,35,44,45,51,58,59,60,63,68,79,80],region_styl:81,regoin:2,regspher:45,regul:2,regular:[1,19,58,60,79,106],reinder:4,reinhardt:[77,78],reject:[45,61],rel:[1,2,11,18,19,36,42,45,48,60,63,70,74,79,91,113,117,118,131,132,134,146,161],relat:[1,2],relationship:[2,148,161],relax:2,releas:0,relect:139,relev:[2,19,45,59,60,63,66,67,75,76,79,80,90,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,142,146,150,154,160,161,162],reli:[113,162],reltol:74,remain:[19,32,56,57,62,68,79,97,113,130,137,139,163],remaina:97,remaind:[45,158],remap:[2,45],remedi:2,rememb:163,remot:163,remov:[2,28,36,38,42,45,68,74,75,92,108,132,137,163],remove_molecul:59,remove_sourc:59,remove_speci:59,ren:44,renam:163,render:58,rendon:68,reneighbor:[60,109],repeat:[2,58,61,62,74,97,156,158],replac:[2,3,19,33,34,58,60,61,69,94,105,118,124,141,142],replica:0,report:[0,1,4,41,44,72,73,74,79,92,108,113,134,139],repositori:163,reprens:79,repres:[1,2,19,29,34,40,51,58,62,65,66,67,68,71,74,79,81,92,93,97,117,130,131,132,134,135,136,144,145],represent:[2,66,71,79,97,113,117,137,146],reproduc:[4,68,105,111,118],repul:134,repuls:[2,18,21,22,80,81,94,97,103,105,109,113,115,118,120,130,134,138,148,154,158,159,161,162],request:[2,19,67,139,163],requir:[1,2,3,4,18,19,28,31,32,41,43,44,45,46,56,58,59,60,61,64,65,66,67,68,74,75,79,80,82,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,143,145,146,147,148,149,154,155,156,157,158,159,161,162],rerun:[36,38,42,58,139],rescal:[2,63,68,69,77,78],research:[31,64,67,137],resembl:163,resepct:2,reservoir:[35,63,79],reset:[2,3,33,34,62,68,69,75,79,91,132],reset_atomic_reference_posit:59,reset_tim:59,reset_timestep:[2,35],resist:2,resolut:148,resolv:[62,71,132,163],resourc:[93,111],respa:[4,68,70,73,76,80,81,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,140,141,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],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,41,44,46,47,48,49,50,51,52,53,54,55,58,61,62,63,67,68,69,75,79,80,82,83,84,86,87,88,89,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,140,143,144,146,147,148,149,150,155,156,157,158,159,160,161,162],respond:[2,113],respons:2,resquar:[2,117],rest:[2,73,97,132,134],restart1:71,restart2:71,restart2data:0,restart:[0,1],restor:45,restrain:13,restraint:[73,121],restratin:73,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,41,43,44,45,46,47,48,49,50,51,52,53,54,55,58,60,61,62,63,66,67,68,69,71,74,75,77,78,79,80,82,83,84,86,87,88,89,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,144,146,147,150,155,156,157,158,159,160,161,162],retain:[94,97,137],retriev:[2,135,136],rev:[2,29,36,38,42,43,68,69,77,78,97,103,104,105,108,111,112,113,117,118,124,131,132,133,134,136,141,142,145,146,149,155,156,157,158,159],revers:[2,32,50,61,68,70,77,92,130],review:[42,137,149,163],rfac0:[42,149],rg0:76,rh3:44,rh4:44,rheolog:2,rhi:[141,142],rho0:[134,152,153],rho0_meam:134,rho:[67,93,98,99,100,111,133,134,135,136,141,142,146,151],rho_0:[152,153],rho_alpha_beta:111,rho_bkgd:134,rho_colloid:80,rho_e:79,rho_i:[135,136],rho_ref_meam:134,rho_wal:80,rhodopsin:[1,4],rhosum:[151,152,153],rhot:63,rhs:74,rick:[104,148],right:[2,3,19,29,45,55,57,60,61,67,70,74,105,163],rightmost:[19,60],rigidid:40,rii:[33,34],rij:[36,38,70,109,110,141,142,154],rin:[120,127,128],ring:[2,46,71],rino:[30,159],rirj:118,risi:[42,149],risk:73,rix:[33,34],rk4:74,rkf45:74,rlo:[141,142],rmin0:[42,149],rmin:124,rms:74,rnemd:2,robust:91,rock:134,rockett:145,role:2,ronchetti:38,root:[3,32,33,34,111],rose:134,ross:134,rosski:71,rot:[2,35,71,73],rotat:[2,42,45,81,91,108,117,146],rotation:38,rough:[2,45,58],roughli:[19,58,68,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,46,47,48,49,50,51,52,53,54,55,68,69,75,82,83,84,86,87,88,89,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,140,141,142,143,144,146,147,150,155,156,157,158,159,160,161,162],rous:66,rout:[32,120,130],routin:[2,3,4,67,137],roux:2,row:[2,34,40,44,79,113],rozero:134,rrespa:[1,4,68,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,140,141,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],rsq:[141,142],rsurfac:79,ru3:44,ru4:44,rub:5,rubia:[135,136],rudd:139,rule:[0,2,13,29,45,61,68,81,93,95,96,102,103,108,120,125,134,138,139,150,154,155,156,158,162],run1:2,run2:2,run3:2,run4:2,run5:2,run6:2,run7:2,run8:2,run:[0,1],run_styl:[4,68,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,140,141,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],rung:74,runtim:58,rutherford:79,rutuparna:[156,158],rxn:74,ryckaert:[75,88],rydberg:137,s0st:2,s2050:1,s2629:111,s319:59,s_i:[2,113],s_ij:2,saddl:92,sadigh:[111,135,136],saed_vtk:41,safe:[58,163],safran:161,sagui:108,sai:[1,163],said:91,sakai:157,sall:148,salt:[106,116,134],salter:148,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,42,43,45,46,47,48,49,50,51,52,53,54,55,58,59,60,61,62,63,66,67,68,69,70,71,72,73,75,77,78,79,81,82,83,84,86,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,140,143,144,145,146,147,148,150,154,155,156,157,158,159,160,161,162,163],sampl:[1,2,3,35,58,68,71,76,78,97],sample_frequ:59,sandia:[0,29,114,134],saniti:73,satellit:2,satisfi:[30,41,42,44,62,63,67,69,75,91,118],satur:106,save:[2,58,61,66,74,79,97],sb3:44,sb5:44,sc3:44,scalabl:[0,1,4],scale:[0,1,2,4,35,42,46,58,59,62,67,68,69,71,72,77,78,79,93,94,106,113,115,118,131,132,134,137],scalegamma:67,scalexi:[62,68,69],scalexz:[62,68,69],scaleyz:[62,68,69],scatter:[3,41,44],scatter_atom:3,scatter_coord:3,scenario:[2,61,81],schaik:130,schell:157,schemat:61,scheme:[2,66,68,71,75,79],schmid:109,schroding:113,schroeder:38,sci:[30,104,136,145,148],scienc:[59,61,70,77,111,135,148,157],scientif:[42,111],scm:3,scratch:[19,60],screen:[0,1,2,3,4,41,44,58,67,75,92,101,105,122,134,155,158,159,160,161,162],screenshot:3,scripe:3,script:[0,1],sea:3,search:[0,36,38,91,92,118],secant:65,second:[1,2,3,4,28,29,35,37,38,39,43,44,56,61,63,65,66,71,73,75,76,77,78,79,91,92,96,97,98,99,100,104,105,111,113,114,115,118,119,121,124,134,139,143,148,155,157,158,159,162],second_mo:148,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,40,41,42,44,46,47,48,49,50,51,52,53,54,55,56,57,58,59,60,61,63,64,65,66,67,68,69,70,71,72,74,75,77,78,79,82,83,84,85,86,87,88,89,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,46,47,48,49,50,51,52,53,54,55,68,69,75,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],section_accerl:111,section_command:[0,1],section_exampl:2,section_howto:[2,3,29,30,32,33,34,36,38,42,43,96,107],section_modifi:[2,58],section_python:2,section_start:[2,3,92],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,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],seed:[45,58,61,66,67,71,72,79,109,110],seek:[19,60],seem:[2,62,134],seen:[4,67,81],segment:[2,58,109,154],select:[2,41,44,45,58,80,92,120,121,134,148],self:[2,72,73,74,76,78,91,104,105,137,145,148],semi:59,semimet:113,semin:4,send:[0,3],sens:[1,2,19,57,60,61,66,72,79,92,105,122,126,156,157,158],sensit:[2,30,62],sep:[2,3],separ:[2,4,19,42,45,56,58,59,60,61,62,68,71,75,98,99,105,106,108,110,122,131,132,134,141,142,143,149,155,158,161],seper:106,sequenc:[19,58,60,92,145],sequenti:145,seri:[2,4,42,58,66,94,117,134,137,139,141,142,146,150],serial:1,serv:[2,154],server:1,set:[0,1],set_vari:[2,3],setarea:67,sete:61,setenv:3,setfl:[93,111],setforc:[2,91,92],setgamma:67,settl:62,setup:[2,3,4,32,35,57,59,61],seven:136,sever:[1,2,3,4,32,57,59,62,67,68,91,97,100,111,126,130,134,139,145,148],sexton:137,sfactor:58,shade:58,shake:[2,13,39,43,63],shan:104,shape:[2,19,45,58,60,62,68,72,81,96,117,146],shardlow:[64,74,110],share:[0,1,2],sharp:[81,134,158],shear:[2,62,67,68,118,131,132],shell:0,shenderova:94,shift:[1,2],shiga:[2,68],shini:58,shinoda:[2,68,147],shiny:58,shlib:3,shm:4,shock:[69,72,124],shockvel:72,shortcut:[62,68],shorter:[70,139],shortest:58,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,40,43,45,46,47,48,49,50,51,52,53,54,55,58,60,61,62,66,67,68,69,70,71,72,73,74,75,79,80,81,82,83,84,86,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,144,146,147,148,150,154,155,156,157,158,159,160,161,162,163],show:[2,3,92,120,134,137],shown:[1,4,19,41,42,44,57,60,61,63,68,70,71,113,114,117,118,130,137,146,148],shrink:[2,19,58,60,67,70,91,105,122,126,139],shrunk:74,shut:[2,3],si4:44,sic:[105,134,143,155,156,158,159],sic_tersoff:145,sicc:[112,155,156,158,159],sicg:[156,158],sicsi:[112,155,156,158,159],side:[19,45,60,61,67,70,74,80,81,92,105,117,118,146],sige:[156,158],sigma0:97,sigma14:130,sigma1:97,sigma2:97,sigma:[2,21,22,28,32,40,46,67,70,80,81,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,139,146,147,155],sigma_14:101,sigma_:106,sigma_c:103,sigma_cc:[94,103],sigma_h:116,sigma_i:[114,139],sigma_ij:139,sigma_j:139,sigma_ss:103,sign:[2,50,57,137,163],signifi:[34,115,142],signific:[66,74,113,117,134,137,139],significantli:[1,2,43,67,68,73,113,155],silbert:118,silicon:[112,134,155],sim:147,similar:[2,3,4,19,22,32,39,40,43,45,60,66,72,73,80,94,96,97,109,111,113,118,130,131,139,140,145],similarli:[2,39,58,68,75,81,82,92,94,100,118,126,155],simluat:[2,131],simlul:79,simpl:[1,2,3,4],simpler:3,simplest:34,simpli:[1,2,3,34,40,62,68,71,92,100,108,126,134,139],simplif:113,simplifi:[73,137],simplist:3,simul:[0,1],simulatan:4,simulationub:148,simultan:[2,4],sin:[56,80,90,145],sinc:[0,1,2,3,6,19,28,29,30,33,34,40,41,46,58,60,61,62,67,68,69,70,71,74,79,80,81,82,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,139,141,142,144,145,146,147,148,149,150,155,156,157,158,159,162,163],sinclair:[70,111],sine:145,singapor:42,singh:93,singl:[1,2,3,4,19,32,34,40,45,56,58,60,61,62,67,68,69,71,73,75,79,80,92,93,94,97,101,104,111,112,113,114,118,119,120,134,135,136,137,143,144,145,146,148,149,150,155,156,157,158,159],singleel:97,singular:[56,130,131,132,140],sinnott:[94,104],sinusoid:[45,80,90],sio2:159,sio:104,sirk:[43,154],sisic:[112,155,156,158,159],sisisi:[112,155,156,157,158,159],site:[0,1,2,3,29,32,63,67,75,93,97,105,111,115,116,122,126,130,140,142,144],situat:[62,67,68,71,97],sival:44,six:[2,42,143,145],sixth:143,sixthpow:[102,139],size:[0,1],sjplimp:[0,3],skew:[2,58,68],skin:[30,79],skip:[4,40,46,121],slab:[2,139],slater:[105,148],sleight:28,slepoi:134,slice:[2,41,71],slider:3,slight:[63,79],slightli:[1,2,4,58,68,94,105,122,126,156,158,159],sligthli:108,sliozberg:154,sllod:[2,4],slope:[2,78,106],slot:1,slow:[2,66,68,92,139,148],slower:[1,97],slowest:79,slowli:[60,91,137,150],sm3:44,small:[2,19,29,32,40,41,43,44,60,61,63,66,68,70,72,74,75,88,90,91,92,94,103,105,106,107,122,131,132,134,146,149,155,158,163],smaller:[1,2,4,58,67,74,78,139],smallest:29,smd:76,smith:144,smooth:[2,81,97,101,105,119,124,127],smoother:45,smoothli:[28,42,101,119,128,130,133,158,162],smt:4,smtb:148,smulat:137,sn2:44,sn4:44,snap:[42,58],snapcoeff:149,snapparam:149,snapshot:[0,1],snc4:4,soc:120,sodani:4,soderlind:137,soft:[3,32,91,109,115],softer:[80,81],softwar:[1,2,3,4],sole:[92,145],solid:[2,19,29,30,35,43,59,60,62,68,70,78,98,124,137],solut:[2,62,74,75,81],solv:[63,67,74,75,78,79,132],solvat:45,solvent:[60,66,68,101,103,105,106,116,122,131,132,146],solver:[0,1,2,19,43,59,60,65,74,105,107,115,122,130,142],some:[1,2,3,4,19,37,40,45,50,57,58,60,61,62,68,74,79,80,91,92,96,97,105,111,113,137,139,163],someon:91,someth:[3,62,68,80,163],sometim:[2,62,68],somewhat:[29,68],somewher:113,soon:61,sort:[4,92],sound:[67,152,153],soundspe:[152,153],sourc:[0,3,4,59,62,79,130],source_integr:59,sourceforg:3,south:42,space:[2,3,4,19,41,42,44,45,58,60,67,68,71,80,92,98,99,100,105,108,111,113,122,126,134,137,141,142,144,145,147,161],spahn:118,span:[63,93,94,97,104,111,114,134,135,136,143,145,149,155,156,157,158,159],spars:74,spatial:[2,19,29,34,59,60,79],spc:0,spce:63,spearot:[41,44],speci:[42,65,74,111,114,115,142,145,156,158],special:[2,45,46,59,75,93,104,107,139],special_bond:[2,4,21,22,28,36,38,42,46,57,61,107,120,139],species1:[65,142],species2:[65,142],species:74,speciesn:65,specif:[1,2,4,13,19,45,58,59,60,61,66,67,79,80,91,92,94,96,97,107,111,117,118,134,137,139,146,155],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,65,66,67,68,69,70,72,73,74,75,76,78,79,80,81,82,83,84,86,87,88,89,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:67,spectral:149,spectrum:[42,72],speed:[1,2,4,19,60,67,72,92,97,105,137,139,152,153,156],speedup:[1,4],spefici:[45,58,120],spellmey:[2,46],spent:1,sphere1:67,sphere:[2,41,42,45,58,67,68,81,90,103,108,113,117,118,122,131,132,146,161],spheric:0,spheriod:2,spheroid:[2,68],spin:113,spine:90,spine_two:90,spline:[65,91,94,97,120,134],split:[1,2,3,4,19,60,63,68,110],splittol:2,spparks:2,spread:[1,2],spring:[2,10,11,21,22,24,25,27,48,56,61,71],sqrt:[33,38,70,90,103,109,111,116,118,134,139],squar:[2,8],squares:[19,60],squeez:[62,131,132],sr2:44,src:[0,1,2,3,4,75,90,137,163],srolovitz:111,srp:109,srtio:148,ssao:58,stabil:[2,68,97],stabl:[2,56,67,69,73,97],stabli:66,stack:29,stage:[32,92],stagger:1,stai:72,stall:4,stand:[0,2],standard:[0,1,2,3,4,38,45,51,59,67,71,75,80,93,94,96,105,108,113,116,117,122,123,124,125,126,129,133,134,137,138,146,155],starikov:79,start:[0,2,4,19,39,45],start_6:116,stat:[28,70,91],state:[2,3,29,30,32,51,58,61,62,64,65,66,68,69,72,77,78,79,92,97,108,110,113,117,118,134,136,137,146,148,151,152,153],statement:163,stationari:[67,131,132],statist:[2,19,61,66,72,74,75,79,91,92,94,109,118,131,161],statu:[28,104],steadi:[2,69,72],stefan:163,stegailov:79,steinhardt:38,stencil:67,step:[1,2,3,4,35,43,58,59,60,61,62,63,70,72,74,75,77,78,79,91,92,94,109,116,120,134,137,148],stepwis:32,steve:0,steven:61,stiff:[2,26,71,74,91],stile:106,still:[1,2,3,4,19,36,60,79,102,111,117,118,121,131,146,150,163],stilling:[112,136,145,155,159],stochast:110,stoddard:108,stoichiometr:74,stoichiometri:148,stoke:67,stone:108,stop:[2,3,19,28],stopthresh:[19,60],store:[2,3,33,35,36,39,40,43,45,57,58,59,66,67,68,69,70,71,74,75,76,78,79,93,94,97,104,109,110,111,112,113,114,115,117,118,134,135,136,137,139,141,142,145,148,149,155,156,157,158,159],straatsma:2,straightforward:113,strain:[2,62,68,69,131,132],strang:58,strategi:0,stratford:67,stream:[2,39,43,58,59,66],streiz:105,strength:[42,58,73,80,81,146],stress:[2,35,39],stretch:28,strict:149,strictli:[2,19,60,72],strietz:105,string:[2,3,19,45,60,74,134,145,149],strong:94,stronger:2,strongest:[131,132],strongli:[1,2,75,79,137],structur:[0,2,3,29,30,38,41,44,51,73,89,97,104,113,134,137,145,148],strucur:30,stuart:[94,104,148],stuck:62,studi:[2,37,124,148],studio:4,stukowski:111,style:0,style_nam:68,stylecomput:148,sub:[1,2,3,19,32,35,42,57,58,60,62,68,69,72,75,79,81,94,96,104,117,118,120,139,146,148,162],subbox:58,subdivis:67,subdomain:67,subequ:3,subject:[2,4,19,60],submit:[0,57,114],subscript:[3,79,82,114,159],subsequ:[2,3,19,60,62,79,111],subset:[2,3,4,19,42,60,68,69,92,94,97,139],substanti:[2,155],substep:68,substitut:[1,92,113,139],substract:105,substrat:[62,68],substyl:130,subsystem:79,subtract:[2,28,35,37,39,40,43,63,66,129],success:[2,3,62,91,92],successfulli:3,successulli:3,sudden:18,suddenli:81,sudo:3,suffer:81,suffici:[2,19,60,68,80,121,139],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,68,69,74,75,82,83,84,86,87,88,89,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,140,143,144,145,146,147,150,155,156,157,158,159,160,161,162],suggest:[0,2,72],suit:[67,113],suitabl:[28,32,61,97,118,130,134],sum:[2,29,33,34,36,37,38,39,42,43,66,70,72,78,79,80,81,91,96,105,109,113,114,122,125,134,149],summar:[2,114,148],summari:1,summat:[2,29,38,100,105,111,112,122,126,137,148,155,156,157,158,159],sun:[6,20,47,82,102,139],sup:[72,104,148],superspher:90,supinski:137,supplementari:[117,146],suppli:79,support:[1,2,3,4,19,32,58,60,61,62,67,68,69,70,72,73,76,78,80,81,90,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,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],suppos:[114,163],suppress:2,sure:[2,3,62,75,111,163],surfac:[2,29,41,42,45,58,67,70,73,79,80,81,90,92,97,131,132,137,148,161],surface_mov:79,surfact:[106,116],surpris:113,surround:[29,45,62,65,68,70,141,142],suspens:[131,132],sustain:[62,118],suzuki:68,svg:2,svn:3,swap:2,swiggl:80,swiler:[42,149],switch7_section_start:116,switchflag:[42,149],swol:27,swope:2,symbol:[2,41,44,97,113,149],symmetr:[2,29,32,39,43,62,68,93,108,111,156,158],symmetri:[2,29,36,38,70,82,93],symplect:68,sync:2,synchron:[1,92],syntax:[1,2,3],sysstem:97,syst:148,system:[0,1],system_:71,systemat:[2,137],t_e:79,t_e_min:79,t_equil:[77,78],t_infil:79,t_init:[72,79],t_j:13,t_lb:67,t_oufil:79,t_out:79,t_outfil:79,t_qm:72,t_switch:[77,78],ta06a:149,ta4:137,ta5:44,ta6:137,tabbernor:41,tabinn:139,table:65,tabul:[65,74,93,97,98,99,100,101,102,105,111,113,115,122,126,133,141,142,144,145,147,156],tabular:145,tad:2,tag:[59,65,74,115,142],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,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],tait:[152,153],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,43,46,47,48,49,50,51,52,53,54,55,58,60,62,63,68,69,74,75,76,82,83,84,86,87,88,89,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,140,143,144,146,147,148,150,154,155,156,157,158,159,160,161,162],taken:[2,45,61,66,67,72,74,79,86,111,113,117,141,142,155,159],talk:2,talli:[2,19,60,94,113,116,120],tang:137,tangenti:[2,118],tanh:79,tantalum:[137,149],taper:[90,133],tarbal:[0,3],target:[2,3,19,60,62,63,66,68,69,71,72,76,79,109],task:[1,2,4,28,71],taskset:4,tau:[67,68,77,78,79],tau_1:66,tau_k:66,tau_n_k:66,tb3:44,tbp:97,tchain:[68,69],tcsh:3,tdamp:[68,69],technic:[2,67],techniqu:[2,32,62,72,139],technolog:4,tell:[2,3,57],temeperatur:3,temp:[2,32,35,39,43,61,62,63,68,69,71,72,79,94,108,116,117,120,146],temper:[2,92],temperar:71,temperatur:0,temperature_definit:59,templat:[45,75],templeton2010:59,templeton2011:59,templeton:59,tempor:66,temporarili:73,tend:[13,68,70,74],tensor:[2,33,34,35,39,40,42,43,62,67,68,69,113,131,132,137],term:[0,1,2,5,6,11,21,22,32,33,35,39,43,47,48,56,63,66,67,68,69,71,72,73,76,79,82,89,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,140,144,146,148,154,155,156,157,158,159,161],termin:[41,68,91,92],tersoff:[4,43,105,112,145],tersoff_1:[156,157,158],tersoff_2:[156,157,158],tersoff_mod:157,tertiari:51,test:[0,2],tether:[2,78,116],tetot:148,texas_holdem:73,text:[2,19,58,59,60,65,79,92,111,114,121,134,141,142,149,163],tfix:73,tflag:58,th4:44,thakkar:4,thakker:4,than:[1,2,3,4,11,19,36,37,38,39,40,43,48,60,61,62,66,67,70,72,73,74,76,79,80,81,91,92,94,96,97,98,99,100,101,111,113,117,118,131,132,134,139,141,142,146,148,150,154,155,158,161,162],thank:[156,158],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,60,61,62,66,67,68,69,73,75,79,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,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,140,142,143,144,145,146,147,148,149,150,154,155,156,157,158,159,160,161,162,163],them:[1,2,3,19,28,35,47,58,60,61,62,68,69,70,73,75,79,82,90,92,93,97,111,114,117,139,146,150,163],themselv:[2,3,60,92,93,97,105,111,130,134,135,136,149],theorem:[66,97,110],theoret:[37,72,155],theori:[2,42,59,68,97,137,161],therebi:[131,132],therefor:[2,32,63,67,75,107,155],therein:[2,134],thereof:32,thermal:0,thermo:[0,1],thermo_modifi:[2,62,68,154],thermo_press:[39,62,68,69],thermo_styl:[2,31,35,39,43,45,61,62,68,69,72,80,91,94,116,120,139],thermo_temp:[39,61,62,68,69],thermoberendsen:2,thermochemistri:113,thermodyanm:61,thermodynam:0,thermophys:139,thermost:2,thermostat:0,thermostatequ:2,thesi:131,thess:98,theta0:[5,6,8,10,11,12,16,17,18,42,48,73,88],theta0max:42,theta10:97,theta1:[47,56,82,97],theta2:[47,56,82,97],theta3:[82,97],theta4:97,theta5:97,theta6:97,theta7:97,theta8:97,theta9:97,theta:[2,10,11,36,38,42,44,45,48,58,73,79,82,88,120,145,157],theta_0:143,theta_:[88,97],theta_c:120,theta_ijk:97,theta_ijl:82,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:[41,58],thin:58,thing:[2,3,28,62,68,163],think:[2,3,83,87,91],third:[2,13,29,35,42,43,66,76,79,104,114,115,134,143,159],thirumalai:51,tho:112,thole:2,thompson:[0,39,42,43,149],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,62,63,68,69,75,77,78,82,83,84,86,87,88,89,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,140,143,144,146,147,149,150,155,156,157,158,159,160,161,162,163],though:[2,35,45,62,92,109,111,113,114,117,118,130,131,139,159],thought:[80,118,121],thread:[1,4],three:[1,2,28,29,32,35,36,37,41,42,44,45,51,61,62,63,68,69,74,77,79,85,86,88,93,94,97,111,112,114,117,118,121,134,135,136,137,143,145,146,148,149,155,156,157,158,159],threebodi:155,thresh:[19,58,60],threshhold:[19,58,60],threshold:[19,60,70],through:[2,3,45,62,65,67,68,71,74,79,80,81,90,94,110,112,113,115,118,122,137,142,147,148,150,154],throughout:[2,4,41,137],thru:[2,3,33,34,37,40,91],thrust:1,thu:[1,2,3,19,29,30,34,35,36,38,42,43,45,46,57,58,60,61,62,63,66,68,69,70,75,76,79,80,81,82,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,142,144,145,146,148,149,151,152,153,154,155,156,157,158,159,162],thumb:[45,103],thylakoid:90,ti2:44,ti3:44,ti4:44,tidi:163,tight:[97,148],tij:108,tildeslei:[13,32,108],tile:[2,19,45,60],tilt:[2,62,68,70,72,159],time:[0,1],time_integr:59,timer:1,timescal:[72,113],timespan:68,timestep:[1,2,3,19,35,40,43,58,60,61,62,63,66,67,68,69,70,73,74,75,77,78,79,80,91,92,97,109,113,120,131,132,150],timesteppnig:75,tin:[104,105],tini:[45,91,97],tio2:148,tio:148,tip3p:0,tip4:2,tip4p:0,tip:0,tirrel:80,titl:163,tji:108,tl1:44,tl3:44,tlbr_msw:145,tloop:[68,69],tm3:44,tmp:[2,19,34,40,58,60],tobia:68,togeth:[2,3,4,19,43,45,60,62,68,116],tol:[75,155],toler:[62,74,75,91,92,155],tolernac:74,too:[1,2,19,29,30,36,38,42,58,60,62,63,68,75,79,92,109],took:150,tool:[0,1,2,3,19,58,60,92],toolkit:2,top:[0,3,4,67,92,149,163],topolog:[2,32,57,139],torqu:[2,13,40,67,91,96,108,117,118,132],torsion:[2,47,57,94],torsion_flag:94,toru:90,tosi:98,tot:148,total:[2,3,4,19,31,33,34,35,37,40,42,43,60,66,67,68,69,71,72,73,74,77,78,79,80,81,91,92,93,94,96,97,104,111,113,118,134,135,136,137,145,148,149],toukmaji:108,toward:[13,58,67,69,70,88,92],toxvaerd:127,tptask:4,tqx:40,tqy:40,tqz:40,trace:113,track:[67,79,90],track_displac:59,tractabl:74,trade:[2,105,122,126],tradeoff:139,tradit:[2,56],trail:[32,92,114,134,149],trajectori:[2,32,68,71,75,109,139],tran:[50,51],transfer:[1,2,4,59,79,97,137],transform:[2,32,117,140],transit:[2,4,92,106,130,136,137,158],translat:[2,63,68,71,113],transmit:2,transport:[59,79],trap:[2,35],treat:[2,43,79,81,91,96,107,113,114,117,120,135,136,137,146],treatment:107,tree:130,tri:[2,3,58,62,68,69,91],triangl:[2,58],triangul:2,triangular:[2,62],triclin:[0,1],triflag:2,trigger:[3,60,61,91],trigon:9,trilinear:67,tringl:58,tripl:[42,97],triplet:[112,143,145,155,156,157,158,159],trivial:3,trott:[42,149],troubl:3,truncat:[2,63,74,80,81,95,105,113,118,122,124,127,139,148],tscale:72,tsige:100,tstart:[66,68,109],tstat:[2,66],tstop:[66,68,109],tsuzuki:[30,159],ttm_mod:79,tucker:[42,149],tuckerman:[68,71],tune:[2,4],tunnel:71,turkand:38,turn:[2,28,42,44,57,58,61,62,68,91,92,94,107,120,134,139,154],tutein:94,tutori:[2,70],tweak:45,twice:[2,4,46,62,68],twist:[131,132],two:[1,2,3,4,19,28,29,32,36,40,41,42,44,45,56,58,60,61,62,66,67,68,69,70,71,72,78,79,81,89,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,139,142,144,145,146,148,149,150,154,155,156,157,158,159,161,162],two_temperatur:59,twobodi:[156,158,159],twojmax:[42,149],txt:[79,121,148,163],typcial:[19,60],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,67,75,81,82,83,84,85,86,87,88,89,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,162,163],typen:[41,44],typic:[1,2,3,4,13,19,21,22,29,32,40,45,56,58,59,60,61,62,68,73,75,91,92,101,103,105,116,117,120,121,122,126,131,132,134,139,146,158,163],tzou:79,u_chem:31,u_cond:[31,64],u_f:67,u_i:[64,65],u_ij:145,u_j:65,u_mech:[31,64],u_prom:97,uberuaga:92,ubiquit:[3,97],uchem:[115,142],uloop:[71,92],umbrella:2,umin:[10,11,24,25,48],unabl:[3,19,60],unaffect:[62,68],unambigu:159,unbias:113,unchang:[62,68],uncom:1,uncompress:58,uncorrel:66,uncoupl:71,under:[0,2,4,6,42,47,58,68,72,82,110,113,130,149],underflow:58,undergo:[2,32,66,68],undergon:61,underli:[2,29,58,68,79],underpredict:2,underscor:[61,62,68,69],understand:[1,2,137],understood:97,undesir:[62,68],undisturb:[131,132],undump:58,unfix:[2,35,59,73,77],unfix_flux:59,unfold:76,uniaxi:69,uniform:[4,19,59,60,67,117,146],uniformli:[67,79,141,142,145],uninterrupt:[68,69,72,78,79],union:[2,81],uniqu:[2,66,69,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,45,47,58,61,62,63,64,65,66,67,68,69,70,71,72,73,74,76,78,79,80,81,82,83,87,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,140,141,142,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],uniti:[112,139],unitless:[29,40,68,72,74,91,118,140,144,155,156,157,158,159],univers:[2,32,92,131,136,158],unknown:30,unless:[3,4,41,44,45,62,68,91,103,139],unlik:[33,45,93,97,111,114,134,135,136,149],unlike:[68,69,111,120,121,135,136],unlimit:145,unnecessari:4,unoccupi:79,unoptim:58,unpack:[0,3],unperturb:32,unphys:[2,68],unpublish:137,unrel:[46,163],unreli:139,unrestrain:73,unscal:40,unset:113,unshift:108,unsmooth:128,unsolv:101,unstabl:67,unstag:163,until:[2,19,58,60,62,65,77,97,118,141,142],unus:97,unwant:45,unwrap:[33,34,40,43,61],up_intern:58,updat:[0,2,4,40,66,67,68,72,79,97,108,137,139],upenn:3,upon:[2,74,97],upper:[19,37,60,62,67,68,72,80,91,118,148],uppercas:0,upsid:2,upsilon:117,upstream:163,urbana:131,urey_bradlei:5,url:163,usabl:111,usag:[2,70,130],use:[2,40,58,79,117,134,146,148,163],useful:137,user:[0,1,2,3],user_manifold:163,user_misc:[14,15,17,49,53,55,56,86],usernam:163,using:[0,1],usr:3,usual:[2,8,12,16,17,18,23,32,54,56,58,61,62,69,72,73,79,80,81,87,92,101,103,106,108,117,121,130,131,132,139,143,149,154,155],util:117,v11:2,v22:2,v33:2,v_0:79,v_2:137,v_3:137,v_4:137,v_delta:32,v_dhug:72,v_drai:72,v_e_hbond:120,v_ij:145,v_jx:35,v_jy:35,v_jz:35,v_k11:35,v_k22:35,v_k33:35,v_lgr_po:72,v_lgr_vel:72,v_linear:80,v_lj:94,v_mu:131,v_n:[67,137],v_name:[2,32,58,80],v_occ:116,v_prefactor:150,v_press:43,v_pxy:2,v_pxz:2,v_pyz:2,v_ramp:80,v_rebo:94,v_t_qm:72,v_torsion:94,v_v11:2,v_v22:2,v_v33:2,v_valu:58,v_wiggl:80,v_x:[45,80],v_xave:2,v_xmax:2,v_xx:45,v_y:45,v_yi:45,vacanc:[77,137],vacf:2,vacuum:[79,106,158,162],valanc:97,valenc:[97,113],valent:97,valid:[2,3,41,44,62,70,111,113,117,137,145],valon:134,value1:69,value2:69,van:[27,32,103,104,130,134,161],vanadium:137,vanderwa:139,vanilla:2,vanish:75,vapor:[19,60],vare:79,vari:[1,19,32,41,44,59,60,62,68,73,79,80,101,109,110,119,128,131,150],variabl:0,varianc:109,variant:[1,2,40,68,69,118,135,136,140,156,158],variat:[19,60],varieti:[1,2,58,134,159],variou:0,varshalovich:42,vashishta1990:159,vashishta2007:159,vbia:2,vcm:2,vdisplac:80,vdw:104,vec:70,vector:1,vel:[2,109,110,113,118],veld:[100,126],veloc:[2,35,39,40,43,45,58,62,63,67,68,69,70,71,72,73,75,78,79,80,91,92,109,113,118,131,132],velocit:[109,110,113,118],velocity_bottom:67,velocity_top:67,verbos:148,veri:[1,2,19,32,40,58,60,62,68,71,75,92,113,118,131,132,141,142,149,150,163],verifi:[139,163],verlet:[1,4,59,63,68,71,75,79],versa:[2,61],versu:[2,19,60,75,100,108,118,126,139],vertic:[4,19,58,60],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,60,61,62,67,68,69,71,73,75,79,80,81,82,83,84,85,86,87,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,142,144,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],vibrat:[2,70,72,88,113],vice:[2,61],video:58,view:[2,58,97,113,114,148],viewer:58,viewpoint:58,vij:109,vim:0,virial:[35,39,42,43,62,68,69,75,109,110,113],virtual:[2,155],viscoelast:118,viscos:0,viscosity:2,viscou:[2,66,67,91,92],vision:148,visual:0,viz:3,viz_tool:3,vizplotgui_tool:3,vmax:62,vmd:[2,3],voigt:[2,42],vol:[2,35,43,134,158],volpress:137,volum:[2,19,32,35,39,41,43,44,45,60,62,64,67,68,69,72,79,80,81,131,132,137,152,153,162],voronoi:43,voter:[135,136],voth:71,vri:119,vstream:2,vtk:[2,41],w_1:42,w_2:42,w_i:42,w_ik:145,waal:[32,103,104,130,161],wadlei:97,wagner:[59,67,134],wai:[1,2,3,29,32,34,35,36,38,42,43,45,58,61,62,66,67,68,69,71,79,80,83,84,85,87,88,91,92,93,94,105,106,109,111,112,114,117,120,122,134,135,136,139,143,145,146,148,149,150,154,155,156,158,159,163],wait:[1,4],walk:[66,68],wall:0,wallhi:80,wang:[134,145],want:[0,1,2,3,31,34,39,40,43,45,58,60,61,70,73,78,80,81,92,93,94,97,103,104,109,111,114,134,141,142,143,145,148,150,155,156,158,159,163],ward:97,warm:[4,113],warmup:4,warn:[0,21,22,30,58,68,69,74,131,132,134,141,142,163],warner:93,warning:134,warp:134,warren:[109,141,142],watanab:[77,78],watch:92,water:0,watkin:54,wave:113,wavefunct:113,wavelength:[41,44],wavepacket:113,weak:36,web:1,webb:59,weber:[112,136,145,155,159],weight:[2,32,42,44,46,57,66,67,74,107,109,110,115,134,139,141,142,149],well:[1,2,3,11,26,36,38,39,43,45,48,58,60,62,67,68,69,74,78,91,92,96,116,117,120,131,132,134,137,146,150,156,157,158,163],went:3,were:[2,3,4,19,29,38,39,45,58,60,94,113,118,121,163],westview:161,what:[0,1,2,3,40,45,58,60,61,65,68,71,73,75,80,91,92,134,139,141,142,150,154,163],whatev:[40,58,62,68,91,92,102,103,137],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,45,46,47,48,49,50,51,52,53,54,55,57,58,60,61,62,67,68,69,70,72,73,74,75,76,79,80,81,82,83,84,86,87,88,89,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,147,149,150,154,155,156,157,158,159,160,161,162,163],whenev:[0,56,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,41,43,44,47,48,57,58,60,61,62,63,64,65,66,67,68,69,70,71,72,74,75,77,78,79,80,81,82,83,84,85,86,87,88,89,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,139,142,143,144,145,146,148,149,151,152,153,154,155,156,157,158,159,161,162],wherea:[2,3,36,66,68,79],whether:[2,3,28,29,58,61,62,68,69,75,99,101,104,119,121,131,132,134,139,148],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,60,61,62,63,65,66,67,68,69,70,71,72,73,75,76,77,78,79,80,81,82,84,87,89,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,150,154,155,156,157,158,159,161,163],white:[66,79],who:[0,2,93,111],whole:74,whose:[2,32,58,65,68,70,73,74,75,81,92,113,115,124,141,142,155,156,158],why:[2,163],wicaksono1:70,wicaksono2:70,wicaksono:70,wide:[1,2,101,103,113],width:[58,90,116],wiggl:80,wigner:42,wih:2,wikipedia:2,wild:[32,120],wildcard:[58,154],wildli:68,window:[58,163],wire:73,wirnsberg:[2,63],wisdom:163,wise:[109,155],wish:[2,3,43,46,67,75,80,92,99,120,134,139,141,142],within:[1,2,3,4,13,19,29,30,36,38,39,40,42,45,58,60,61,65,70,74,75,79,80,81,91,92,96,98,99,105,110,111,112,113,115,116,121,122,134,137,142,144,146,147,155,156,157,158,159],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,62,65,66,68,69,74,75,82,83,84,86,87,88,89,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,144,146,147,150,155,156,157,158,159,160,161,162,163],wolff:139,won:132,wong:[59,97],word:[2,13,73,103,139],work:[1,2,3,4,28,40,41,44,58,61,67,68,73,75,78,104,107,109,131,132,134,137,139,148],workaround:139,worker:159,workflow:163,world:[42,92],worlei:109,worst:81,worth:72,would:[1,2,3,4,13,19,29,33,35,40,43,45,46,57,58,60,61,63,68,70,71,74,82,83,84,85,87,91,92,93,94,97,103,104,105,109,110,111,112,114,134,135,136,137,143,145,149,154,155,156,157,158,159,163],wrap:[1,2,3,40,45,67,80,81,92],wrapper:[0,2],wright:91,write_atom_weight:59,write_restart:[59,67],written:[2,42,58,59,60,61,62,63,66,67,70,72,73,75,76,77,79,80,81,111,133,137,161,163],wrong:[3,62,68,80,81],wt1:139,wt2:139,wt3:139,www:[0,2,3,93,111,131],x200:4,x86:137,x_ij:145,x_ijkl:82,x_kjli:82,x_ljik:82,xave:2,xavx:4,xcore:4,xeon:[1,4],xhi:[2,80],xhi_bound:2,xhost:4,xi_ij:145,xiaowang:[114,156,158],xiij:70,xlat:45,xlo:[2,3,80],xlo_bound:2,xmax:2,xmgrace:0,xmic:4,xmovi:[0,2],xmu:118,xpo:45,xrd:41,xtc:[2,58],xyz:[2,45,58,62,68,69],xzhou:114,yamada:4,yang:[137,145],yate:137,yb2:44,yb3:44,yellow:58,yet:[4,58,80,91,102,103,104,113,161,163],yhi:[2,80],yhi_bound:2,yield:[2,35,43,62,68,74,96,109,118,139],yip:77,ylat:45,ylo:[2,80],ylo_bound:2,york:71,yoshida:68,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,60,61,62,63,66,68,69,71,73,75,77,78,79,80,81,82,83,84,86,87,88,89,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,45,46,47,48,49,50,51,52,53,54,55,58,59,61,62,68,69,75,79,80,81,82,83,84,86,87,88,89,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,140,143,144,145,146,147,150,154,155,156,157,158,159,160,161,162,163],yourself:[2,62,163],ypo:45,yukawa:103,z_i:[113,158,162],z_j:[158,162],z_meam:134,zannoni:117,zbl:[134,149],zblcut:158,zblcutinn:149,zblcutout:149,zblexpscal:158,zblz:149,zero:[2,3,10,11,19,24,25,29,32,34,36,37,38,39,41,42,43,44,45,46,48,55,57,58,60,62,63,66,67,68,69,71,72,74,75,78,79,80,86,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,140,146,147,148,154,159,162],zeta:[67,114],zfactor:58,zhang:118,zhi:[2,80],zhi_bound:2,zhou:[97,114,145,156,158],zhu:153,ziegler:[134,158,162],zimmerman2004:59,zimmerman2010:59,zimmerman:[29,59,97],zlim:148,zlo:[2,80],zlo_bound:2,zmax:67,zmin:67,zn2:44,zone:41,zoom:58,zr4:44,zwall:80,zwall_veloc:67},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 rigid/local 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 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","Manifolds (surfacse)","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_modify 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","LAMMPS GitHub tutorial"],titleterms:{"default":[29,32,36,37,38,41,42,44,45,57,58,59,62,66,67,68,69,71,72,77,78,80,97,113,131,132,137,139,154],"long":[98,99,100,101,102,105,107,108,122,126,130,144,147],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:59,atom:[2,29,30,36,38,42,43],balanc:[19,60],barostat:2,bcc:70,beck:95,between:2,bodi:[2,96],bond:61,bond_styl:[20,21,22,23,24,25,26,27,28],bop:97,born:[98,107],box:[2,62],buck:[99,100,107,133],build:3,calcul:2,centro:29,charmm:[2,5,46,101,130],chunk:[2,34],class2:[6,20,47,82,102],cna:30,code:2,coeffici:2,colloid:[80,103,161],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,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,44],conduct:2,constant:2,core:2,cosin:[7,8,9,10,11,12,48],cossq:83,coul:[98,99,100,101,102,105,106,107,119,122,126,130,144,147],coupl:2,create_atom:45,cubic:124,cut:[25,99,102,105,108,113,116,122,123,130,138,144],cvff:84,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,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:[46,47,48,49,50,51,52,53,54,55,56,57],dipol:[2,13,108],discuss:2,disp:2,distanc:85,document:0,dpd:[31,109,110],dreid:120,dreiding:2,drude:2,dsf:[105,122],dump:[2,58],eam:111,edip:112,eff:113,ehex:63,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,79,80,81,82,83,84,85,86,87,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,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,48],expand:[22,125],extend:3,fcc:70,fdt:110,fene:[21,22],fep:32,field:2,file:2,finit:2,fix:[2,59,60,61,62,63,64,65,66,67,68,69,70,71,72,73,74,75,76,77,78,79,80,81],fix_modifi:[59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],flow:2,fluid:67,flux:35,forc:2,fourier:[14,15,49,86],from:[2,3],gauss:116,gaybern:117,gener:[1,2],github:163,gld:66,global:2,gpu:[95,98,99,101,102,103,105,108,109,111,116,117,119,122,123,124,125,138,140,146,147,150,155,156,157,158,160,161,162],gran:118,granular:2,gromac:119,gyrat:[33,34],harmon:[16,23,24,25,50,52,80,87,143],hbond:120,heat:35,helix:51,hertz:118,hexord:36,histori:118,hook:118,how:2,idealga:151,imag:58,implicit:101,improper_styl:[82,83,84,85,86,87,88,89],indice:0,induc:2,info:[0,59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],input:2,install:3,integr:2,intel:[4,5,16,21,23,46,50,54,68,84,87,99,101,117,122,155,156],interfac:[2,3],jul:0,kspace_styl:2,lammps:[0,1,2,3,163],lennard:133,librari:[2,3],linear:[129,140],list:121,lj1043:80,lj126:80,lj93:80,lj96:123,local:[2,40],lubric:131,lubricateu:132,luci:[141,142],manifold:90,mdf:133,meam:[134,135,136],measur:1,mgpt:137,mie:138,minim:[59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81,91],mod:[79,157],model:2,morri:153,mors:[26,94,120,140],movi:58,mpi:3,msd:37,msm:[98,99,101,105,122],multi:[2,52,141,142],multipl:2,nb3b:143,neb:92,nemd:2,nharmon:53,non:2,nongauss:37,nonlinear:27,nph:68,nphug:69,npt:68,nvt:68,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,68,69,82,83,84,86,87,88,89,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,140,143,144,146,147,150,155,156,157,158,159,160,161,162],opl:54,opt:[101,111,122,126,140],optim:1,option:2,orient:70,orientord:38,orthogon:2,other:2,output:[2,59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],overview:3,packag:[1,4],pair:2,pair_modifi:139,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,140,141,142,143,144,145,146,147,148,149,150,151,152,153,154,155,156,157,158,159,160,161,162],parallel:3,paramet:2,particl:2,per:2,perform:1,period:9,pimd:71,polariz:2,poli:[131,132],polymorph:145,potenti:2,pppm:2,pressur:39,process:2,properti:2,python:3,qbmsst:72,quadrat:55,quantiti:2,quartic:[17,28],rattl:75,rebo:94,region:81,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,72,74,76,77,78,79,80,81,82,83,84,85,86,87,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,142,143,144,145,146,147,149,150,151,152,153,154,155,156,157,158,159,160,161,162],relax:62,replica:2,resquar:146,restart:[2,59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],restrain:73,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,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,149,150,151,152,153,154,155,156,157,158,159,160,161,162],rigid:[2,40],ring:88,run:[2,3,59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],scalar:2,script:[2,3],sdk:[18,147],serial:3,set:2,shake:75,share:3,shell:2,shift:[10,11,24,25,48],simpl:15,simul:2,size:2,smooth:[128,129,140],smtbq:148,sna:42,snad:42,snap:149,snapshot:2,snav:42,soft:[130,140,150],spc:2,sph:[151,152,153],spheric:[2,56],spline:[135,136],spring:[76,78],squar:12,srp:154,start:[59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],stop:[59,60,62,63,67,68,69,70,72,73,75,76,77,78,79,80,81],strategi:1,streitz:105,stress:43,style:[1,2],summari:2,surfacs:90,swap:61,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,71,72,73,74,75,76,77,78,79,80,81,82,83,84,85,86,87,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,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,65,156],taitwat:[152,153],temperatur:2,tersoff:[156,157,158],test:3,thermal:2,thermo:2,thermodynam:2,thermostat:2,time:2,tip3p:2,tip4p:[2,105,122,126,130],triclin:2,tstat:109,ttm:79,tutori:163,umbrella:89,user:4,using:[2,3],valu:2,variabl:2,variou:1,vashishta:159,vector:2,version:0,viscos:2,visual:2,wall:[2,80,81],water:2,wolf:[98,105],wrapper:3,write:2,xrd:44,yukawa:[160,161],zbl:[158,162]}}) \ No newline at end of file diff --git a/doc/html/tutorial_github.html b/doc/html/tutorial_github.html index 5f6c9e69b..e6170b896 100644 --- a/doc/html/tutorial_github.html +++ b/doc/html/tutorial_github.html @@ -1,365 +1,349 @@ LAMMPS GitHub tutorial — LAMMPS documentation

LAMMPS GitHub tutorial

-
-

written by Stefan Paquay

+

written by Stefan Paquay


-

This document briefly describes how to use GitHub to merge changes -into LAMMPS using GitHub. It assumes that you are familiar with +

This document briefly describes how to use GitHub to merge changes you +make into LAMMPS, using GitHub. It assumes that you are familiar with git. You may want to have a look at the Git book to reacquaint yourself.

-
-

-
-

Making an account

+

Making an account

First of all, you need a GitHub account. This is fairly simple, just go to GitHub and create an account by clicking the ``Sign up for GitHub’’ button. Once your account is created, you can sign in by clicking the button in the top left and filling in your username or e-mail address and password.

-

-
-

Forking the repository

+

Forking the repository

To get changes into LAMMPS, you need to first fork the repository. At the time of writing, LAMMPS-ICMS is the preferred fork. Go to LAMMPS on GitHub and make sure branch is set to ``lammps-icms’‘, see the figure below.

_images/tutorial_branch.png

Now, click on fork in the top right corner:

_images/tutorial_fork.png

This will create your own fork of the LAMMPS repository. You can make changes in this fork and later file pull requests to allow the upstream repository to merge changes from your own fork into the one we just forked from. At the same time, you can set things up, so you can include changes from upstream into your repository.

-

-
-

Adding changes to your own fork

+

Adding changes to your own fork

Before adding changes, it is better to first create a new branch that will contain these changes, a so-called feature branch.

-
-

Feature branches

+

Feature branches

Since LAMMPS is such a big project and most user contributions come in small portions, the most ideal workflow for LAMMPS is the so-called ``Feature branch’’ workflow. It is explained in great detail here: feature branch workflow.

The idea is that every new feature for LAMMPS gets its own branch. This way, it is fairly painless to incorporate new features into the upstream repository. I will explain briefly here how to do it. In this feature branch, I will add a USER-package.

I assume that git is installed on the local machine and you know how to use a command line.

First of all, you need to clone your own fork of LAMMPS:

$ git clone https://github.com/<your user name>/lammps.git
 

You can find the proper url to the right of the “HTTPS” block, see figure.

_images/tutorial_https_block.png

The above command copies (``clones’‘) the git repository to your local machine. You can use this local clone to make changes and test them without interfering with the repository on github. First, however, it is recommended to make a new branch for a particular feature you would like added to LAMMPS. In this example, I will try adding a new USER-package called USER-MANIFOLD.

To create a new branch, run the following git command in your repository:

$ git checkout -b add-user-manifold
 

The name of this new branch is “add-user-manifold” in my case. Just name it after something that resembles the feature you want added to LAMMPS.

Now that you’ve changed branches, you can edit the files as you see fit, add new files, and commit as much as you would like. Just remember that if halfway you decide to add another, unrelated feature, you should switch branches!

After everything is done, add the files to the branch and commit them:

 $ git add src/USER-MANIFOLD examples/USER/manifold/
 $ git add doc/fix_nvt,e_manifold_rattle.txt
 $ git add doc/fix_manifoldforce.txt doc/user_manifolds.txt
 

After the files are added, the change should be comitted:

$ git commit -m 'Added user-manifold package'
 

The “-m” switch is used to add a message to the commit. Use this to indicate what type of change was commited.

-
-

Wisdom by Axel:

+

Wisdom by Axel

“Do not use “git commit -a”. the -a flag will automatically include *all modified or new files. mercurial does that and it find it hugely annoying and often leading to accidental commits of files you don’t want. use git add, git rm, git mv for adding, removing, renaming and then git commit to finalize the commit. personally, i find it very convenient to use the bundled gui for commits, i.e. git gui. typically, i will do git add and other operations, but then verify and review them with git gui. git gui also allows to do line-by-line unstaging and other convenient operations.”*

After the commit, the changes can be pushed to the same branch on GitHub:

$ git push
 

Git will ask you for your user name and password on GitHub if you have not configured anything. If you correctly type your user name and password, the change should be added to your fork on GitHub.

If you want to make really sure you push to the right repository (which is good practice), you can provide it explicitly:

$ git push origin
 

or using an explicit URL:

$ git push git@github.com:Pakketeretet2/lammps.git
 

After that, you can file a new pull request based on this branch. GitHub will now look like this:

_images/tutorial_pull_request_feature_branch1.png

Make sure that the current branch is set to the correct one, which, in this case, is “add-user-manifold”. Now click “New pull request”. If done correctly, the only changes you will see are those that were made on this branch, so in my case, I will see nothing related to $mathrm*pair_dzugatov*.$

This will open up a new window that lists changes made to the repository. If you are just adding new files, there is not much to do, but I suppose merge conflicts are to be resolved here if there are changes in existing files. If all changes can automatically be merged, green text at the top will say so and you can click the “Create pull request” button, see image.

_images/tutorial_pull_request2.png

After this you have to specify a short title and a comment with details about your pull request. I guess here you write what your modifications do and why they should be incorporated upstream. After that, click the “Create pull request” button, see image below.

_images/tutorial_pull_request3.png

Now just write some nice comments, click “Comment”, and that is it. It is now up to the maintainer(s) of the upstream repository to incorporate the changes into the repository and to close the pull request.

_images/tutorial_pull_request4.png -
-
-

-
-

Additional changes

+

Additional changes

Before the pull request is accepted, any additional changes you push into your repository will automatically become part of the pull request.

-

-
-

After a merge

+

After a merge

When everything is fine the feature branch is merged into the LAMMPS repositories:

_images/tutorial_merged.png

Now one question remains: What to do with the feature branch that got merged into upstream?

It is in principle safe to delete them from your own fork. This helps keep it a bit more tidy. Note that you first have to switch to another branch!

$ git checkout lammps-icms
 $ git pull lammps-icms
 $ git branch -d add-user-manifold
 

If you do not pull first, it is not really a problem but git will warn you at the next statement that you are deleting a local branch that was not yet fully merged into HEAD. This is because git does not yet know your branch just got merged into lammps-icms upstream. If you first delete and then pull, everything should still be fine.

Finally, if you delete the branch locally, you might want to push this to your remote(s) as well:

$ git push origin :add-user-manifold
 
\ No newline at end of file diff --git a/doc/lammps.book b/doc/lammps.book index e72adeb70..f768cdc7d 100644 --- a/doc/lammps.book +++ b/doc/lammps.book @@ -1,603 +1,622 @@ #HTMLDOC 1.8.27 -t pdf14 -f "../Manual.pdf" --book --toclevels 4 --no-numbered --toctitle "Table of Contents" --title --textcolor #000000 --linkcolor #0000ff --linkstyle plain --bodycolor #ffffff --size Universal --left 1.00in --right 0.50in --top 0.50in --bottom 0.50in --header .t. --header1 ... --footer ..1 --nup 1 --tocheader .t. --tocfooter ..i --portrait --color --no-pscommands --no-xrxcomments --compression=1 --jpeg=0 --fontsize 11.0 --fontspacing 1.2 --headingfont helvetica --bodyfont times --headfootsize 11.0 --headfootfont helvetica --charset iso-8859-1 --links --embedfonts --pagemode document --pagelayout single --firstpage c1 --pageeffect none --pageduration 10 --effectduration 1.0 --no-encryption --permissions all --owner-password "" --user-password "" --browserwidth 680 --no-strict --no-overflow Manual.html Section_intro.html Section_start.html Section_commands.html Section_packages.html Section_accelerate.html accelerate_gpu.html accelerate_intel.html accelerate_kokkos.html accelerate_omp.html accelerate_opt.html Section_howto.html Section_example.html -tutorial_drude.html Section_perf.html Section_tools.html Section_modify.html Section_python.html Section_errors.html Section_history.html + +tutorial_drude.html +tutorial_github.html + +body.html +manifolds.html + +angle_coeff.html +angle_style.html +atom_modify.html +atom_style.html balance.html -box.html +bond_coeff.html +bond_style.html +bond_write.html boundary.html +box.html change_box.html clear.html -comm_style.html comm_modify.html +comm_style.html +compute.html +compute_modify.html create_atoms.html create_bonds.html create_box.html delete_atoms.html delete_bonds.html dielectric.html +dihedral_coeff.html +dihedral_style.html dimension.html displace_atoms.html +dump.html +dump_custom_vtk.html +dump_h5md.html +dump_image.html +dump_modify.html +dump_molfile.html echo.html +fix.html +fix_modify.html group.html group2ndx.html if.html +improper_coeff.html +improper_style.html include.html info.html jump.html +kspace_modify.html +kspace_style.html label.html lattice.html log.html mass.html -minimize.html -min_style.html min_modify.html +min_style.html +minimize.html molecule.html neb.html -neighbor.html neigh_modify.html +neighbor.html newton.html next.html package.html +pair_coeff.html +pair_modify.html +pair_style.html +pair_write.html partition.html prd.html print.html processors.html python.html quit.html +read_data.html +read_dump.html +read_restart.html region.html replicate.html +rerun.html reset_timestep.html +restart.html run.html run_style.html set.html shell.html special_bonds.html suffix.html tad.html temper.html thermo.html -thermo_style.html thermo_modify.html -timestep.html +thermo_style.html timer.html +timestep.html +uncompute.html +undump.html +unfix.html units.html variable.html velocity.html -read_data.html -write_data.html write_coeff.html -restart.html -read_restart.html -write_restart.html -dump.html -undump.html -dump_modify.html -dump_custom_vtk.html -dump_h5md.html -dump_image.html -dump_molfile.html -rerun.html -read_dump.html +write_data.html write_dump.html -atom_style.html -body.html -atom_modify.html -kspace_style.html -kspace_modify.html -fix.html -unfix.html -fix_modify.html +write_restart.html + fix_adapt.html fix_adapt_fep.html fix_addforce.html fix_addtorque.html fix_append_atoms.html +fix_atc.html fix_atom_swap.html fix_ave_atom.html +fix_ave_chunk.html fix_ave_correlate.html fix_ave_correlate_long.html -fix_ave_chunk.html fix_ave_histo.html fix_ave_time.html fix_aveforce.html fix_balance.html fix_bond_break.html fix_bond_create.html fix_bond_swap.html fix_box_relax.html fix_colvars.html fix_deform.html fix_deposit.html fix_drag.html -fix_drude_transform.html fix_drude.html -fix_eos_cv.html -fix_eos_table.html -fix_langevin_drude.html +fix_drude_transform.html fix_dt_reset.html fix_efield.html +fix_ehex.html fix_enforce2d.html +fix_eos_cv.html +fix_eos_table.html +fix_eos_table_rx.html fix_evaporate.html fix_external.html fix_freeze.html fix_gcmc.html fix_gld.html fix_gle.html fix_gravity.html fix_heat.html fix_imd.html -fix_ipi.html fix_indent.html +fix_ipi.html fix_langevin.html +fix_langevin_drude.html fix_langevin_eff.html fix_lb_fluid.html fix_lb_momentum.html fix_lb_pc.html fix_lb_rigid_pc_sphere.html fix_lb_viscous.html fix_lineforce.html fix_manifoldforce.html -fix_nve_manifold_rattle.html -fix_nvt_manifold_rattle.html -manifolds.html fix_meso.html fix_meso_stationary.html fix_momentum.html fix_move.html fix_msst.html fix_neb.html fix_nh.html fix_nh_eff.html fix_nph_asphere.html fix_nph_body.html fix_nph_sphere.html fix_nphug.html fix_npt_asphere.html fix_npt_body.html fix_npt_sphere.html fix_nve.html -fix_nve_eff.html fix_nve_asphere.html fix_nve_asphere_noforce.html fix_nve_body.html +fix_nve_eff.html fix_nve_limit.html fix_nve_line.html +fix_nve_manifold_rattle.html fix_nve_noforce.html fix_nve_sphere.html fix_nve_tri.html fix_nvt_asphere.html fix_nvt_body.html +fix_nvt_manifold_rattle.html fix_nvt_sllod.html fix_nvt_sllod_eff.html fix_nvt_sphere.html fix_oneway.html -fix_orient_fcc.html +fix_orient.html fix_phonon.html fix_pimd.html fix_planeforce.html fix_poems.html fix_pour.html fix_press_berendsen.html fix_print.html fix_property_atom.html fix_qbmsst.html fix_qeq.html fix_qeq_comb.html fix_qeq_reax.html fix_qmmm.html fix_qtb.html -fix_reaxc_bonds.html +fix_reax_bonds.html fix_reaxc_species.html fix_recenter.html fix_restrain.html fix_rigid.html +fix_rx.html +fix_saed_vtk.html fix_setforce.html fix_shake.html -fix_saed_vtk.html fix_shardlow.html fix_smd.html fix_smd_adjust_dt.html fix_smd_integrate_tlsph.html fix_smd_integrate_ulsph.html fix_smd_move_triangulated_surface.html fix_smd_setvel.html fix_smd_tlsph_reference_configuration.html fix_smd_wall_surface.html fix_spring.html +fix_spring_chunk.html fix_spring_rg.html fix_spring_self.html fix_srd.html fix_store_force.html fix_store_state.html fix_temp_berendsen.html fix_temp_csvr.html fix_temp_rescale.html fix_temp_rescale_eff.html fix_tfmc.html fix_thermal_conductivity.html fix_ti_rs.html fix_ti_spring.html fix_tmd.html -fix_tune_kspace.html fix_ttm.html +fix_tune_kspace.html fix_vector.html fix_viscosity.html fix_viscous.html -fix_wall_gran.html fix_wall.html +fix_wall_gran.html fix_wall_piston.html fix_wall_reflect.html fix_wall_region.html fix_wall_srd.html -compute.html -uncompute.html -compute_modify.html -compute_group_group.html -compute_pair.html + +compute_ackland_atom.html compute_angle.html -compute_bond.html -compute_dihedral.html -compute_improper.html -compute_pair_local.html -compute_body_local.html compute_angle_local.html -compute_dihedral_local.html -compute_improper_local.html -compute_property_local.html -compute_chunk_atom.html compute_angmom_chunk.html -compute_com_chunk.html -compute_dipole_chunk.html -compute_gyration_chunk.html -compute_inertia_chunk.html -compute_msd_chunk.html -compute_omega_chunk.html -compute_property_chunk.html -compute_temp_chunk.html -compute_torque_chunk.html -compute_vcm_chunk.html -compute_com.html -compute_dpd.html -compute_erotate_asphere.html -compute_erotate_sphere.html -compute_erotate_rigid.html -compute_event_displace.html -compute_fep.html -compute_gyration.html -compute_heat_flux.html -compute_ke.html -compute_msd.html -compute_pe.html -compute_msd_nongauss.html -compute_pressure.html -compute_rdf.html -compute_reduce.html -compute_slice.html -compute_saed.html -compute_property_atom.html -compute_ackland_atom.html compute_basal_atom.html +compute_body_local.html +compute_bond.html compute_bond_local.html compute_centro_atom.html +compute_chunk_atom.html compute_cluster_atom.html compute_cna_atom.html +compute_com.html +compute_com_chunk.html compute_contact_atom.html compute_coord_atom.html compute_damage_atom.html +compute_dihedral.html +compute_dihedral_local.html compute_dilatation_atom.html +compute_dipole_chunk.html compute_displace_atom.html +compute_dpd.html compute_dpd_atom.html +compute_erotate_asphere.html +compute_erotate_rigid.html +compute_erotate_sphere.html compute_erotate_sphere_atom.html +compute_event_displace.html +compute_fep.html +compute_group_group.html +compute_gyration.html +compute_gyration_chunk.html +compute_heat_flux.html compute_hexorder_atom.html +compute_improper.html +compute_improper_local.html +compute_inertia_chunk.html +compute_ke.html compute_ke_atom.html -compute_ke_eff.html compute_ke_atom_eff.html +compute_ke_eff.html compute_ke_rigid.html compute_meso_e_atom.html compute_meso_rho_atom.html compute_meso_t_atom.html +compute_msd.html +compute_msd_chunk.html +compute_msd_nongauss.html +compute_omega_chunk.html compute_orientorder_atom.html +compute_pair.html +compute_pair_local.html +compute_pe.html compute_pe_atom.html compute_plasticity_atom.html -compute_sna_atom.html -compute_stress_atom.html -compute_voronoi_atom.html -compute_xrd.html +compute_pressure.html +compute_property_atom.html +compute_property_chunk.html +compute_property_local.html +compute_rdf.html +compute_reduce.html +compute_rigid_local.html +compute_saed.html +compute_slice.html compute_smd_contact_radius.html compute_smd_damage.html compute_smd_hourglass_error.html compute_smd_internal_energy.html -compute_smd_plastic_strain_rate.html compute_smd_plastic_strain.html +compute_smd_plastic_strain_rate.html compute_smd_rho.html compute_smd_tlsph_defgrad.html compute_smd_tlsph_dt.html compute_smd_tlsph_num_neighs.html compute_smd_tlsph_shape.html -compute_smd_tlsph_strain_rate.html compute_smd_tlsph_strain.html +compute_smd_tlsph_strain_rate.html compute_smd_tlsph_stress.html compute_smd_triangle_mesh_vertices.html compute_smd_ulsph_num_neighs.html -compute_smd_ulsph_strain_rate.html compute_smd_ulsph_strain.html +compute_smd_ulsph_strain_rate.html compute_smd_ulsph_stress.html compute_smd_vol.html +compute_sna_atom.html +compute_stress_atom.html compute_tally.html compute_temp.html compute_temp_asphere.html compute_temp_body.html +compute_temp_chunk.html compute_temp_com.html compute_temp_cs.html compute_temp_deform.html +compute_temp_deform_eff.html compute_temp_drude.html +compute_temp_eff.html compute_temp_partial.html compute_temp_profile.html compute_temp_ramp.html compute_temp_region.html +compute_temp_region_eff.html compute_temp_rotate.html compute_temp_sphere.html -compute_temp_eff.html -compute_temp_deform_eff.html -compute_temp_region_eff.html compute_ti.html +compute_torque_chunk.html compute_vacf.html -pair_style.html -pair_modify.html -pair_write.html -pair_none.html -pair_zero.html +compute_vcm_chunk.html +compute_voronoi_atom.html +compute_xrd.html + pair_adp.html pair_airebo.html pair_awpmd.html pair_beck.html pair_body.html pair_bop.html pair_born.html pair_brownian.html pair_buck.html pair_buck_long.html pair_charmm.html pair_class2.html -pair_coeff.html pair_colloid.html pair_comb.html pair_coul.html pair_coul_diel.html pair_cs.html pair_dipole.html pair_dpd.html pair_dpd_fdt.html pair_dsmc.html pair_eam.html pair_edip.html pair_eff.html pair_eim.html +pair_exp6_rx.html pair_gauss.html pair_gayberne.html pair_gran.html pair_gromacs.html pair_hbond_dreiding.html pair_hybrid.html pair_kim.html pair_lcbop.html +pair_line_lj.html pair_list.html pair_lj.html -pair_line_lj.html pair_lj96.html pair_lj_cubic.html pair_lj_expand.html pair_lj_long.html pair_lj_sf.html pair_lj_smooth.html pair_lj_smooth_linear.html pair_lj_soft.html pair_lubricate.html pair_lubricateU.html -pair_nb3b_harmonic.html pair_mdf.html pair_meam.html pair_meam_spline.html pair_meam_sw_spline.html pair_mgpt.html pair_mie.html pair_morse.html pair_multi_lucy.html +pair_multi_lucy_rx.html +pair_nb3b_harmonic.html pair_nm.html +pair_none.html pair_peri.html pair_polymorphic.html pair_quip.html +pair_reax.html pair_reax_c.html pair_resquared.html pair_sdk.html -pair_snap.html -pair_soft.html pair_smd_hertz.html pair_smd_tlsph.html pair_smd_triangulated_surface.html pair_smd_ulsph.html pair_smtbq.html +pair_snap.html +pair_soft.html pair_sph_heatconduction.html pair_sph_idealgas.html pair_sph_lj.html pair_sph_rhosum.html pair_sph_taitwater.html pair_sph_taitwater_morris.html pair_srp.html pair_sw.html pair_table.html +pair_table_rx.html pair_tersoff.html pair_tersoff_mod.html pair_tersoff_zbl.html pair_thole.html pair_tri_lj.html pair_vashishta.html pair_yukawa.html pair_yukawa_colloid.html pair_zbl.html -bond_style.html -bond_write.html -bond_none.html -bond_zero.html +pair_zero.html + bond_class2.html -bond_coeff.html -bond_fene_expand.html bond_fene.html +bond_fene_expand.html bond_harmonic.html bond_harmonic_shift.html bond_harmonic_shift_cut.html bond_hybrid.html bond_morse.html +bond_none.html bond_nonlinear.html bond_quartic.html bond_table.html -angle_style.html -angle_none.html -angle_zero.html +bond_zero.html + angle_charmm.html angle_class2.html -angle_coeff.html angle_cosine.html angle_cosine_delta.html angle_cosine_periodic.html angle_cosine_shift.html angle_cosine_shift_exp.html angle_cosine_squared.html angle_dipole.html angle_fourier.html angle_fourier_simple.html angle_harmonic.html angle_hybrid.html +angle_none.html angle_quartic.html angle_sdk.html angle_table.html -dihedral_style.html -dihedral_none.html -dihedral_zero.html +angle_zero.html + dihedral_charmm.html dihedral_class2.html -dihedral_coeff.html dihedral_cosine_shift_exp.html dihedral_fourier.html dihedral_harmonic.html dihedral_helix.html dihedral_hybrid.html dihedral_multi_harmonic.html dihedral_nharmonic.html +dihedral_none.html dihedral_opls.html dihedral_quadratic.html +dihedral_spherical.html dihedral_table.html -improper_style.html -improper_none.html -improper_zero.html +dihedral_zero.html + improper_class2.html -improper_coeff.html improper_cossq.html improper_cvff.html improper_distance.html improper_fourier.html improper_harmonic.html improper_hybrid.html +improper_none.html improper_ring.html improper_umbrella.html +improper_zero.html -fix_atc.html -USER/atc/man_poisson_solver.html +USER/atc/man_add_molecule.html +USER/atc/man_add_species.html USER/atc/man_atom_element_map.html -USER/atc/man_pair_interactions.html -USER/atc/man_output_nodeset.html -USER/atc/man_mesh_write.html -USER/atc/man_set.html -USER/atc/man_localized_lambda.html -USER/atc/man_mesh_delete_elements.html -USER/atc/man_internal_atom_integrate.html -USER/atc/man_mesh_create_faceset_plane.html +USER/atc/man_atom_weight.html +USER/atc/man_atomic_charge.html +USER/atc/man_boundary.html +USER/atc/man_boundary_dynamics.html USER/atc/man_boundary_faceset.html +USER/atc/man_boundary_integral.html +USER/atc/man_consistent_fe_initialization.html +USER/atc/man_contour_integral.html USER/atc/man_control.html +USER/atc/man_control_momentum.html USER/atc/man_control_thermal.html -USER/atc/man_source.html -USER/atc/man_material.html -USER/atc/man_write_restart.html -USER/atc/man_add_molecule.html USER/atc/man_control_thermal_correction_max_iterations.html +USER/atc/man_decomposition.html +USER/atc/man_electron_integration.html +USER/atc/man_equilibrium_start.html +USER/atc/man_extrinsic_exchange.html +USER/atc/man_fe_md_boundary.html +USER/atc/man_fem_mesh.html +USER/atc/man_filter_scale.html +USER/atc/man_filter_type.html +USER/atc/man_fix_atc.html USER/atc/man_fix_flux.html USER/atc/man_fix_nodes.html -USER/atc/man_track_displacement.html -USER/atc/man_unfix_flux.html -USER/atc/man_mesh_output.html +USER/atc/man_hardy_computes.html +USER/atc/man_hardy_fields.html +USER/atc/man_hardy_gradients.html +USER/atc/man_hardy_kernel.html USER/atc/man_hardy_on_the_fly.html -USER/atc/man_contour_integral.html -USER/atc/man_fem_mesh.html -USER/atc/man_electron_integration.html -USER/atc/man_remove_source.html -USER/atc/man_time_filter.html -USER/atc/man_write_atom_weights.html -USER/atc/man_mesh_read.html -USER/atc/man_extrinsic_exchange.html -USER/atc/man_mesh_create_nodeset.html -USER/atc/man_source_integration.html +USER/atc/man_hardy_rates.html +USER/atc/man_initial.html +USER/atc/man_internal_atom_integrate.html +USER/atc/man_internal_element_set.html +USER/atc/man_internal_quadrature.html USER/atc/man_kernel_function.html +USER/atc/man_localized_lambda.html USER/atc/man_lumped_lambda_solve.html -USER/atc/man_reset_atomic_reference_positions.html -USER/atc/man_boundary_dynamics.html -USER/atc/man_mesh_nodeset_to_elementset.html +USER/atc/man_mask_direction.html USER/atc/man_mass_matrix.html -USER/atc/man_atom_weight.html -USER/atc/man_hardy_gradients.html -USER/atc/man_hardy_kernel.html -USER/atc/man_boundary_integral.html +USER/atc/man_material.html +USER/atc/man_mesh_add_to_nodeset.html +USER/atc/man_mesh_create.html +USER/atc/man_mesh_create_elementset.html +USER/atc/man_mesh_create_faceset_box.html +USER/atc/man_mesh_create_faceset_plane.html +USER/atc/man_mesh_create_nodeset.html +USER/atc/man_mesh_delete_elements.html +USER/atc/man_mesh_nodeset_to_elementset.html +USER/atc/man_mesh_output.html +USER/atc/man_mesh_quadrature.html +USER/atc/man_mesh_read.html +USER/atc/man_mesh_write.html +USER/atc/man_momentum_time_integration.html USER/atc/man_output.html -USER/atc/man_atomic_charge.html +USER/atc/man_output_elementset.html +USER/atc/man_output_nodeset.html +USER/atc/man_pair_interactions.html +USER/atc/man_poisson_solver.html USER/atc/man_read_restart.html +USER/atc/man_remove_molecule.html +USER/atc/man_remove_source.html USER/atc/man_remove_species.html -USER/atc/man_control_momentum.html -USER/atc/man_filter_scale.html +USER/atc/man_reset_atomic_reference_positions.html +USER/atc/man_reset_time.html USER/atc/man_sample_frequency.html -USER/atc/man_internal_quadrature.html -USER/atc/man_fe_md_boundary.html -USER/atc/man_add_species.html -USER/atc/man_mesh_quadrature.html -USER/atc/man_momentum_time_integration.html +USER/atc/man_set.html +USER/atc/man_source.html +USER/atc/man_source_integration.html +USER/atc/man_temperature_definition.html USER/atc/man_thermal_time_integration.html -USER/atc/man_mesh_add_to_nodeset.html -USER/atc/man_internal_element_set.html -USER/atc/man_mesh_create_elementset.html -USER/atc/man_fix_atc.html -USER/atc/man_initial.html -USER/atc/man_equilibrium_start.html +USER/atc/man_time_filter.html +USER/atc/man_track_displacement.html +USER/atc/man_unfix_flux.html USER/atc/man_unfix_nodes.html -USER/atc/man_reset_time.html -USER/atc/man_consistent_fe_initialization.html -USER/atc/man_mask_direction.html -USER/atc/man_mesh_create.html -USER/atc/man_temperature_definition.html -USER/atc/man_hardy_fields.html -USER/atc/man_hardy_rates.html -USER/atc/man_output_elementset.html -USER/atc/man_boundary.html -USER/atc/man_filter_type.html -USER/atc/man_hardy_computes.html -USER/atc/man_remove_molecule.html -USER/atc/man_mesh_create_faceset_box.html -USER/atc/man_decomposition.html -tutorial_github.html - +USER/atc/man_write_atom_weights.html +USER/atc/man_write_restart.html diff --git a/doc/src/Manual.txt b/doc/src/Manual.txt index bc9aea78b..ae09f79b4 100644 --- a/doc/src/Manual.txt +++ b/doc/src/Manual.txt @@ -1,318 +1,318 @@ LAMMPS-ICMS Users Manual - + "LAMMPS WWW Site"_lws - "LAMMPS-ICMS Documentation"_ld - "LAMMPS Commands"_lc :c :link(lws,http://lammps.sandia.gov) :link(ld,Manual.html) :link(lc,Section_commands.html#comm) :line

LAMMPS-ICMS Documentation :c,h3 -28 Jul 2016 version :c,h4 +30 Jul 2016 version :c,h4 Version info: :h4 The LAMMPS "version" is the date when it was released, such as 1 May 2010. LAMMPS is updated continuously. Whenever we fix a bug or add a feature, we release it immediately, and post a notice on "this page of the WWW site"_bug. Each dated copy of LAMMPS contains all the features and bug-fixes up to and including that version date. The version date is printed to the screen and logfile every time you run LAMMPS. It is also in the file src/version.h and in the LAMMPS directory name created when you unpack a tarball, and at the top of the first page of the manual (this page). LAMMPS-ICMS is an experimental variant of LAMMPS with additional features made available for testing before they will be submitted for inclusion into the official LAMMPS tree. The source code is based on the official LAMMPS svn repository mirror at the Institute for Computational Molecular Science at Temple University and generally kept up-to-date as much as possible. Sometimes, e.g. when additional development work is needed to adapt the upstream changes into LAMMPS-ICMS it can take longer until synchronization; and occasionally, e.g. in case of the rewrite of the multi-threading support, the development will be halted except for important bugfixes until all features of LAMMPS-ICMS fully compatible with the upstream version or replaced by alternate implementations. If you browse the HTML doc pages on the LAMMPS WWW site, they always describe the most current version of upstream LAMMPS, but may be missing some new features in LAMMPS-ICMS. :ulb,l If you browse the HTML doc pages included in your tarball, they describe the version you have, however, not all new features in LAMMPS-ICMS are documented immediately. :l The "PDF file"_Manual.pdf on the WWW site or in the tarball is updated about once per month. This is because it is large, and we don't want it to be part of every patch. :l There is also a "Developer.pdf"_Developer.pdf file in the doc directory, which describes the internal structure and algorithms of LAMMPS. :ule,l LAMMPS stands for Large-scale Atomic/Molecular Massively Parallel Simulator. LAMMPS is a classical molecular dynamics simulation code designed to run efficiently on parallel computers. It was developed at Sandia National Laboratories, a US Department of Energy facility, with funding from the DOE. It is an open-source code, distributed freely under the terms of the GNU Public License (GPL). The primary developers of LAMMPS are "Steve Plimpton"_sjp, Aidan Thompson, and Paul Crozier who can be contacted at sjplimp,athomps,pscrozi at sandia.gov. The "LAMMPS WWW Site"_lws at http://lammps.sandia.gov has more information about the code and its uses. :link(bug,http://lammps.sandia.gov/bug.html) :link(sjp,http://www.sandia.gov/~sjplimp) :line The LAMMPS documentation is organized into the following sections. If you find errors or omissions in this manual or have suggestions for useful information to add, please send an email to the developers so we can improve the LAMMPS documentation. Once you are familiar with LAMMPS, you may want to bookmark "this page"_Section_commands.html#comm at Section_commands.html#comm since it gives quick access to documentation for all LAMMPS commands. "PDF file"_Manual.pdf of the entire manual, generated by "htmldoc"_http://freecode.com/projects/htmldoc "Introduction"_Section_intro.html :olb,l 1.1 "What is LAMMPS"_intro_1 :ulb,b 1.2 "LAMMPS features"_intro_2 :b 1.3 "LAMMPS non-features"_intro_3 :b 1.4 "Open source distribution"_intro_4 :b 1.5 "Acknowledgments and citations"_intro_5 :ule,b "Getting started"_Section_start.html :l 2.1 "What's in the LAMMPS distribution"_start_1 :ulb,b 2.2 "Making LAMMPS"_start_2 :b 2.3 "Making LAMMPS with optional packages"_start_3 :b 2.4 "Building LAMMPS via the Make.py script"_start_4 :b 2.5 "Building LAMMPS as a library"_start_5 :b 2.6 "Running LAMMPS"_start_6 :b 2.7 "Command-line options"_start_7 :b 2.8 "Screen output"_start_8 :b 2.9 "Tips for users of previous versions"_start_9 :ule,b "Commands"_Section_commands.html :l 3.1 "LAMMPS input script"_cmd_1 :ulb,b 3.2 "Parsing rules"_cmd_2 :b 3.3 "Input script structure"_cmd_3 :b 3.4 "Commands listed by category"_cmd_4 :b 3.5 "Commands listed alphabetically"_cmd_5 :ule,b "Packages"_Section_packages.html :l 4.1 "Standard packages"_pkg_1 :ulb,b 4.2 "User packages"_pkg_2 :ule,b "Accelerating LAMMPS performance"_Section_accelerate.html :l 5.1 "Measuring performance"_acc_1 :ulb,b 5.2 "Algorithms and code options to boost performace"_acc_2 :b 5.3 "Accelerator packages with optimized styles"_acc_3 :b 5.3.1 "GPU package"_accelerate_gpu.html :ulb,b 5.3.2 "USER-INTEL package"_accelerate_intel.html :b 5.3.3 "KOKKOS package"_accelerate_kokkos.html :b 5.3.4 "USER-OMP package"_accelerate_omp.html :b 5.3.5 "OPT package"_accelerate_opt.html :ule,b 5.4 "Comparison of various accelerator packages"_acc_4 :ule,b "How-to discussions"_Section_howto.html :l 6.1 "Restarting a simulation"_howto_1 :ulb,b 6.2 "2d simulations"_howto_2 :b 6.3 "CHARMM and AMBER force fields"_howto_3 :b 6.4 "Running multiple simulations from one input script"_howto_4 :b 6.5 "Multi-replica simulations"_howto_5 :b 6.6 "Granular models"_howto_6 :b 6.7 "TIP3P water model"_howto_7 :b 6.8 "TIP4P water model"_howto_8 :b 6.9 "SPC water model"_howto_9 :b 6.10 "Coupling LAMMPS to other codes"_howto_10 :b 6.11 "Visualizing LAMMPS snapshots"_howto_11 :b 6.12 "Triclinic (non-orthogonal) simulation boxes"_howto_12 :b 6.13 "NEMD simulations"_howto_13 :b 6.14 "Finite-size spherical and aspherical particles"_howto_14 :b 6.15 "Output from LAMMPS (thermo, dumps, computes, fixes, variables)"_howto_15 :b 6.16 "Thermostatting, barostatting, and compute temperature"_howto_16 :b 6.17 "Walls"_howto_17 :b 6.18 "Elastic constants"_howto_18 :b 6.19 "Library interface to LAMMPS"_howto_19 :b 6.20 "Calculating thermal conductivity"_howto_20 :b 6.21 "Calculating viscosity"_howto_21 :b 6.22 "Calculating a diffusion coefficient"_howto_22 :b 6.23 "Using chunks to calculate system properties"_howto_23 :b 6.24 "Setting parameters for pppm/disp"_howto_24 :b 6.25 "Polarizable models"_howto_25 :b 6.26 "Adiabatic core/shell model"_howto_26 :b 6.27 "Drude induced dipoles"_howto_27 :ule,b "Example problems"_Section_example.html :l "Performance & scalability"_Section_perf.html :l "Additional tools"_Section_tools.html :l "Modifying & extending LAMMPS"_Section_modify.html :l 10.1 "Atom styles"_mod_1 :ulb,b 10.2 "Bond, angle, dihedral, improper potentials"_mod_2 :b 10.3 "Compute styles"_mod_3 :b 10.4 "Dump styles"_mod_4 :b 10.5 "Dump custom output options"_mod_5 :b 10.6 "Fix styles"_mod_6 :b 10.7 "Input script commands"_mod_7 :b 10.8 "Kspace computations"_mod_8 :b 10.9 "Minimization styles"_mod_9 :b 10.10 "Pairwise potentials"_mod_10 :b 10.11 "Region styles"_mod_11 :b 10.12 "Body styles"_mod_12 :b 10.13 "Thermodynamic output options"_mod_13 :b 10.14 "Variable options"_mod_14 :b 10.15 "Submitting new features for inclusion in LAMMPS"_mod_15 :ule,b "Python interface"_Section_python.html :l 11.1 "Overview of running LAMMPS from Python"_py_1 :ulb,b 11.2 "Overview of using Python from a LAMMPS script"_py_2 :b 11.3 "Building LAMMPS as a shared library"_py_3 :b 11.4 "Installing the Python wrapper into Python"_py_4 :b 11.5 "Extending Python with MPI to run in parallel"_py_5 :b 11.6 "Testing the Python-LAMMPS interface"_py_6 :b 11.7 "Using LAMMPS from Python"_py_7 :b 11.8 "Example Python scripts that use LAMMPS"_py_8 :ule,b "Errors"_Section_errors.html :l 12.1 "Common problems"_err_1 :ulb,b 12.2 "Reporting bugs"_err_2 :b 12.3 "Error & warning messages"_err_3 :ule,b "Future and history"_Section_history.html :l 13.1 "Coming attractions"_hist_1 :ulb,b 13.2 "Past versions"_hist_2 :ule,b :ole :link(intro_1,Section_intro.html#intro_1) :link(intro_2,Section_intro.html#intro_2) :link(intro_3,Section_intro.html#intro_3) :link(intro_4,Section_intro.html#intro_4) :link(intro_5,Section_intro.html#intro_5) :link(start_1,Section_start.html#start_1) :link(start_2,Section_start.html#start_2) :link(start_3,Section_start.html#start_3) :link(start_4,Section_start.html#start_4) :link(start_5,Section_start.html#start_5) :link(start_6,Section_start.html#start_6) :link(start_7,Section_start.html#start_7) :link(start_8,Section_start.html#start_8) :link(start_9,Section_start.html#start_9) :link(cmd_1,Section_commands.html#cmd_1) :link(cmd_2,Section_commands.html#cmd_2) :link(cmd_3,Section_commands.html#cmd_3) :link(cmd_4,Section_commands.html#cmd_4) :link(cmd_5,Section_commands.html#cmd_5) :link(pkg_1,Section_packages.html#pkg_1) :link(pkg_2,Section_packages.html#pkg_2) :link(acc_1,Section_accelerate.html#acc_1) :link(acc_2,Section_accelerate.html#acc_2) :link(acc_3,Section_accelerate.html#acc_3) :link(acc_4,Section_accelerate.html#acc_4) :link(howto_1,Section_howto.html#howto_1) :link(howto_2,Section_howto.html#howto_2) :link(howto_3,Section_howto.html#howto_3) :link(howto_4,Section_howto.html#howto_4) :link(howto_5,Section_howto.html#howto_5) :link(howto_6,Section_howto.html#howto_6) :link(howto_7,Section_howto.html#howto_7) :link(howto_8,Section_howto.html#howto_8) :link(howto_9,Section_howto.html#howto_9) :link(howto_10,Section_howto.html#howto_10) :link(howto_11,Section_howto.html#howto_11) :link(howto_12,Section_howto.html#howto_12) :link(howto_13,Section_howto.html#howto_13) :link(howto_14,Section_howto.html#howto_14) :link(howto_15,Section_howto.html#howto_15) :link(howto_16,Section_howto.html#howto_16) :link(howto_17,Section_howto.html#howto_17) :link(howto_18,Section_howto.html#howto_18) :link(howto_19,Section_howto.html#howto_19) :link(howto_20,Section_howto.html#howto_20) :link(howto_21,Section_howto.html#howto_21) :link(howto_22,Section_howto.html#howto_22) :link(howto_23,Section_howto.html#howto_23) :link(howto_24,Section_howto.html#howto_24) :link(howto_25,Section_howto.html#howto_25) :link(howto_26,Section_howto.html#howto_26) :link(howto_27,Section_howto.html#howto_27) :link(mod_1,Section_modify.html#mod_1) :link(mod_2,Section_modify.html#mod_2) :link(mod_3,Section_modify.html#mod_3) :link(mod_4,Section_modify.html#mod_4) :link(mod_5,Section_modify.html#mod_5) :link(mod_6,Section_modify.html#mod_6) :link(mod_7,Section_modify.html#mod_7) :link(mod_8,Section_modify.html#mod_8) :link(mod_9,Section_modify.html#mod_9) :link(mod_10,Section_modify.html#mod_10) :link(mod_11,Section_modify.html#mod_11) :link(mod_12,Section_modify.html#mod_12) :link(mod_13,Section_modify.html#mod_13) :link(mod_14,Section_modify.html#mod_14) :link(mod_15,Section_modify.html#mod_15) :link(py_1,Section_python.html#py_1) :link(py_2,Section_python.html#py_2) :link(py_3,Section_python.html#py_3) :link(py_4,Section_python.html#py_4) :link(py_5,Section_python.html#py_5) :link(py_6,Section_python.html#py_6) :link(err_1,Section_errors.html#err_1) :link(err_2,Section_errors.html#err_2) :link(err_3,Section_errors.html#err_3) :link(hist_1,Section_history.html#hist_1) :link(hist_2,Section_history.html#hist_2) diff --git a/doc/src/compute_rigid_local.txt b/doc/src/compute_rigid_local.txt index 21cf3aa19..5cdd58fbc 100644 --- a/doc/src/compute_rigid_local.txt +++ b/doc/src/compute_rigid_local.txt @@ -1,185 +1,185 @@ "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 compute rigid/local command :h3 [Syntax:] compute ID group-ID rigid/local rigidID input1 input2 ... :pre ID, group-ID are documented in "compute"_compute.html command :ulb,l rigid/local = style name of this compute command :l rigidID = ID of fix rigid/small command or one of its variants :l input = one or more rigid body attributes :l possible attributes = id, mol, mass, x, y, z, xu, yu, zu, ix, iy, iz vx, vy, vz, fx, fy, fz, omegax, omegay, omegaz, angmomx, angmomy, angmomz, quatw, quati, quatj, quatk, tqx, tqy, tqz, inertiax, inertiay, inertiaz id = atom ID of atom within body which owns body properties mol = molecule ID used to define body in "fix rigid/small"_fix_rigid.html command mass = total mass of body x,y,z = center of mass coords of body xu,yu,zu = unwrapped center of mass coords of body ix,iy,iz = box image that the center of mass is in vx,vy,vz = center of mass velocities fx,fy,fz = force of center of mass omegax,omegay,omegaz = angular velocity of body angmomx,angmomy,angmomz = angular momentum of body quatw,quati,quatj,quatk = quaternion components for body tqx,tqy,tqz = torque on body - inertiax,inertiay,inertiaz = diagonalized moments of inertia of body :per + inertiax,inertiay,inertiaz = diagonalized moments of inertia of body :pre :ule [Examples:] compute 1 all rigid/local myRigid mol x y z :pre [Description:] Define a computation that simply stores rigid body attributes for rigid bodies defined by the "fix rigid/small"_fix_rigid.html command or one of its NVE, NVT, NPT, NPH variants. The data is stored as local data so it can be accessed by other "output commands"_Section_howto.html#howto_15 that process local data, such as the "compute reduce"_compute_reduce.html or "dump local"_dump.html commands. Note that this command only works with the "fix rigid/small"_fix_rigid.html command or its variants, not the fix rigid command and its variants. The ID of the "fix rigid/small"_fix_rigid.html command used to define rigid bodies must be specified as {rigidID}. The "fix rigid"_fix_rigid.html command is typically used to define a handful of (potentially very large) rigid bodies. It outputs similar per-body information as this command directly from the fix as global data; see the "fix rigid"_fix_rigid.html doc page for details The local data stored by this command is generated by looping over all the atoms owned on a processor. If the atom is not in the specified {group-ID} or is not part of a rigid body it is skipped. If it is not the atom within a body that is assigned to store the body information it is skipped (only one atom per body is so assigned). If it is the assigned atom, then the info for that body is output. This means that information for N bodies is generated. N may be less than the # of bodies defined by the fix rigid command, if the atoms in some bodies are not in the {group-ID}. NOTE: Which atom in a body owns the body info is determined internal to LAMMPS; it's the one nearest the geometric center of the body. Typically you should avoid this complication, by defining the group associated with this fix to include/exclude entire bodies. Note that as atoms and bodies migrate from processor to processor, there will be no consistent ordering of the entries within the local vector or array from one timestep to the next. Here is an example of how to use this compute to dump rigid body info to a file: compute 1 all rigid/local myRigid mol x y z fx fy fz dump 1 all local 1000 tmp.dump index c_1\[1\] c_1\[2\] c_1\[3\] c_1\[4\] c_1\[5\] c_1\[6\] c_1\[7\] :pre :line This section explains the rigid body attributes that can be specified. The {id} attribute is the atomID of the atom which owns the rigid body, which is assigned by the "fix rigid/small"_fix_rigid.html command. The {mol} attribute is the molecule ID of the rigid body. It should be the molecule ID which all of the atoms in the body belong to, since that is how the "fix rigid/small"_fix_rigid.html command defines its rigid bodies. The {mass} attribute is the total mass of the rigid body. There are two options for outputting the coordinates of the center of mass (COM) of the body. The {x}, {y}, {z} attributes write the COM "unscaled", in the appropriate distance "units"_units.html (Angstroms, sigma, etc). Use {xu}, {yu}, {zu} if you want the COM "unwrapped" by the image flags for each atobody. Unwrapped means that if the body COM has passed thru a periodic boundary one or more times, the value is generated what the COM coordinate would be if it had not been wrapped back into the periodic box. The image flags for the body can be generated directly using the {ix}, {iy}, {iz} attributes. For periodic dimensions, they specify which image of the simulation box the COM is considered to be in. An image of 0 means it is inside the box as defined. A value of 2 means add 2 box lengths to get the true value. A value of -1 means subtract 1 box length to get the true value. LAMMPS updates these flags as the rigid body COMs cross periodic boundaries during the simulation. The {vx}, {vy}, {vz}, {fx}, {fy}, {fz} attributes are components of the COM velocity and force on the COM of the body. The {omegax}, {omegay}, and {omegaz} attributes are the angular velocity componennts of the body around its COM. The {angmomx}, {angmomy}, and {angmomz} attributes are the angular momentum components of the body around its COM. The {quatw}, {quati}, {quatj}, and {quatk} attributes are the components of the 4-vector quaternion representing the orientation of the rigid body. See the "set"_set.html command for an explanation of the quaternion vector. The {angmomx}, {angmomy}, and {angmomz} attributes are the angular momentum components of the body around its COM. The {tqx}, {tqy}, {tqz} attributes are components of the torque acting on the body around its COM. The {inertiax}, {inertiay}, {inertiaz} attributes are components of diagonalized inertia tensor for the body, i.e the 3 moments of inertia for the body around its principal axes, as computed internally by LAMMPS. :line [Output info:] This compute calculates a local vector or local array depending on the number of keywords. The length of the vector or number of rows in the array is the number of rigid bodies. If a single keyword is specified, a local vector is produced. If two or more keywords are specified, a local array is produced where the number of columns = the number of keywords. The vector or array can be accessed by any command that uses local values from a compute as input. See "this section"_Section_howto.html#howto_15 for an overview of LAMMPS output options. The vector or array values will be in whatever "units"_units.html the corresponding attribute is in: id,mol = unitless mass = mass units x,y,z and xy,yu,zu = distance units vx,vy,vz = velocity units fx,fy,fz = force units omegax,omegay,omegaz = radians/time units angmomx,angmomy,angmomz = mass*distance^2/time units quatw,quati,quatj,quatk = unitless tqx,tqy,tqz = torque units inertiax,inertiay,inertiaz = mass*distance^2 units :ul [Restrictions:] This compute is part of the RIGID package. It is only enabled if LAMMPS was built with that package. See the "Making LAMMPS"_Section_start.html#start_3 section for more info. [Related commands:] "dump local"_dump.html, "compute reduce"_compute_reduce.html [Default:] none diff --git a/doc/src/manifolds.txt b/doc/src/manifolds.txt index 07e11aa98..dc2b0e3fa 100644 --- a/doc/src/manifolds.txt +++ b/doc/src/manifolds.txt @@ -1,31 +1,40 @@ "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 -[Description:] +Manifolds (surfacse) :h3 -Below is a list of currently supported manifolds, their parameters and a short description of them. -The parameters listed here are in the same order as they should be passed to the relevant fixes. +[Overview:] +This doc page is not about a LAMMPS input script command, but about +manifolds, which are generalized surfaces, as defined and used by the +USER-MANIFOLD package, to track particle motion on the manifolds. See +the src/USER-MANIFOLD/README file for more details about the package +and its commands. + +Below is a list of currently supported manifolds by the USER-MANIFOLD +package, their parameters and a short description of them. The +parameters listed here are in the same order as they should be passed +to the relevant fixes. {manifold} || {parameters} || {equation} || {description} cylinder || R || x^2 + y^2 - R^2 = 0 || Cylinder along z-axis, axis going through (0,0,0) cylinder_dent || R l a || x^2 + y^2 - r(z)^2 = 0, r(x) = R if |z| > l, r(z) = R - a*(1 + cos(z/l))/2 otherwise || A cylinder with a dent around z = 0 dumbbell || a A B c || -( x^2 + y^2 ) * (a^2 - z^2/c^2) * ( 1 + (A*sin(B*z^2))^4) = 0 || A dumbbell || ellipsoid || a b c || (x/a)^2 + (y/b)^2 + (z/c)^2 = 0 || An ellipsoid plane || a b c x0 y0 z0 || a*(x-x0) + b*(y-y0) + c*(z-z0) = 0 || A plane with normal (a,b,c) going through point (x0,y0,z0) plane_wiggle || a w || z - a*sin(w*x) = 0 || A plane with a sinusoidal modulation on z along x. sphere || R || x^2 + y^2 + z^2 - R^2 = 0 || A sphere of radius R supersphere || R q || |x|^q + |y|^q + |z|^q - R^q = 0 || A supersphere of hyperradius R spine || a, A, B, B2, c || -(x^2 + y^2)*(a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^4), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise || An approximation to a dendtritic spine spine_two || a, A, B, B2, c || -(x^2 + y^2)*(a^2 - z^2/f(z)^2)*(1 + (A*sin(g(z)*z^2))^2), f(z) = c if z > 0, 1 otherwise; g(z) = B if z > 0, B2 otherwise || Another approximation to a dendtritic spine thylakoid || wB LB lB || Various, see "(Paquay)"_#Paquay || A model grana thylakoid consisting of two block-like compartments connected by a bridge of width wB, length LB and taper length lB torus || R r || (R - sqrt( x^2 + y^2 ) )^2 + z^2 - r^2 || A torus with large radius R and small radius r, centered on (0,0,0) :tb(s=||) :link(Paquay) [(Paquay)] Paquay and Kusters, Biophys. J., 110, ???, (2016), to be published, preprint available at "arXiv:1411.3019"_http://arxiv.org/abs/1411.3019/. diff --git a/doc/src/pair_modify.txt b/doc/src/pair_modify.txt index fba45f7f0..eb60c6b00 100644 --- a/doc/src/pair_modify.txt +++ b/doc/src/pair_modify.txt @@ -1,261 +1,259 @@ "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 pair_modify command :h3 [Syntax:] pair_modify keyword values ... :pre one or more keyword/value pairs may be listed :ulb,l keyword = {pair} or {shift} or {mix} or {table} or {table/disp} or {tabinner} or {tabinner/disp} or {tail} or {compute} :l {pair} values = sub-style N {special} which wt1 wt2 wt3 sub-style = sub-style of "pair hybrid"_pair_hybrid.html N = which instance of sub-style (only if sub-style is used multiple times) {special} which wt1 wt2 wt3 = override {special_bonds} settings (optional) which = {lj/coul} or {lj} or {coul} w1,w2,w3 = 1-2, 1-3, and 1-4 weights from 0.0 to 1.0 inclusive {mix} value = {geometric} or {arithmetic} or {sixthpower} {shift} value = {yes} or {no} {table} value = N 2^N = # of values in table {table/disp} value = N 2^N = # of values in table {tabinner} value = cutoff cutoff = inner cutoff at which to begin table (distance units) {tabinner/disp} value = cutoff cutoff = inner cutoff at which to begin table (distance units) {tail} value = {yes} or {no} {compute} value = {yes} or {no} :pre :ule [Examples:] pair_modify shift yes mix geometric pair_modify tail yes pair_modify table 12 pair_modify pair lj/cut compute no pair_modify pair lj/cut/coul/long 1 special lj/coul 0.0 0.0 0.0 :pre [Description:] Modify the parameters of the currently defined pair style. Not all parameters are relevant to all pair styles. If used, the {pair} keyword must appear first in the list of keywords. It can only be used with the "hybrid and hybrid/overlay"_pair_hybrid.html pair styles. It means that all the following parameters will only be modified for the specified sub-style. If the sub-style is defined multiple times, then an additional numeric argument {N} must also be specified, which is a number from 1 to M where M is the number of times the sub-style was listed in the "pair_style hybrid"_pair_hybrid.html command. The extra number indicates which instance of the sub-style the remaining keywords will be applied to. Note that if the {pair} keyword is not used, and the pair style is {hybrid} or {hybrid/overlay}, then all the specified keywords will be applied to all sub-styles. The {special} keyword can only be used in conjunction with the {pair} keyword and must directly follow it. It allows to override the "special_bonds"_special_bonds.html settings for the specified sub-style. More details are given below. The {mix} keyword affects pair coefficients for interactions between atoms of type I and J, when I != J and the coefficients are not explicitly set in the input script. Note that coefficients for I = J must be set explicitly, either in the input script via the "pair_coeff" command or in the "Pair Coeffs" section of the "data file"_read_data.html. For some pair styles it is not necessary to specify coefficients when I != J, since a "mixing" rule will create them from the I,I and J,J settings. The pair_modify {mix} value determines what formulas are used to compute the mixed coefficients. In each case, the cutoff distance is mixed the same way as sigma. Note that not all pair styles support mixing. Also, some mix options are not available for certain pair styles. See the doc page for individual pair styles for those restrictions. Note also that the "pair_coeff"_pair_coeff.html command also can be to directly set coefficients for a specific I != J pairing, in which case no mixing is performed. mix {geometric} epsilon_ij = sqrt(epsilon_i * epsilon_j) sigma_ij = sqrt(sigma_i * sigma_j) :pre mix {arithmetic} epsilon_ij = sqrt(epsilon_i * epsilon_j) sigma_ij = (sigma_i + sigma_j) / 2 :pre mix {sixthpower} epsilon_ij = (2 * sqrt(epsilon_i*epsilon_j) * sigma_i^3 * sigma_j^3) / (sigma_i^6 + sigma_j^6) sigma_ij = ((sigma_i**6 + sigma_j**6) / 2) ^ (1/6) :pre The {shift} keyword determines whether a Lennard-Jones potential is shifted at its cutoff to 0.0. If so, this adds an energy term to each pairwise interaction which will be included in the thermodynamic output, but does not affect pair forces or atom trajectories. See the doc page for individual pair styles to see which ones support this option. The {table} and {table/disp} keywords apply to pair styles with a long-range Coulombic term or long-range dispersion term respectively; see the doc page for individual styles to see which potentials support these options. If N is non-zero, a table of length 2^N is pre-computed for forces and energies, which can shrink their computational cost by up to a factor of 2. The table is indexed via a bit-mapping technique "(Wolff)"_#Wolff and a linear interpolation is performed between adjacent table values. In our experiments with different table styles (lookup, linear, spline), this method typically gave the best performance in terms of speed and accuracy. The choice of table length is a tradeoff in accuracy versus speed. A larger N yields more accurate force computations, but requires more memory which can slow down the computation due to cache misses. A reasonable value of N is between 8 and 16. The default value of 12 (table of length 4096) gives approximately the same accuracy as the no-table (N = 0) option. For N = 0, forces and energies are computed directly, using a polynomial fit for the needed erfc() function evaluation, which is what earlier versions of LAMMPS did. Values greater than 16 typically slow down the simulation and will not improve accuracy; values from 1 to 8 give unreliable results. The {tabinner} and {tabinner/disp} keywords set an inner cutoff above which the pairwise computation is done by table lookup (if tables are invoked), for the corresponding Coulombic and dispersion tables discussed with the {table} and {table/disp} keywords. The smaller the cutoff is set, the less accurate the table becomes (for a given number of table values), which can require use of larger tables. The default cutoff value is sqrt(2.0) distance units which means nearly all pairwise interactions are computed via table lookup for simulations with "real" units, but some close pairs may be computed directly (non-table) for simulations with "lj" units. When the {tail} keyword is set to {yes}, certain pair styles will add a long-range VanderWaals tail "correction" to the energy and pressure. These corrections are bookkeeping terms which do not affect dynamics, unless a constant-pressure simulation is being performed. See the doc page for individual styles to see which support this option. These corrections are included in the calculation and printing of thermodynamic quantities (see the "thermo_style"_thermo_style.html command). Their effect will also be included in constant NPT or NPH simulations where the pressure influences the simulation box dimensions (e.g. the "fix npt"_fix_nh.html and "fix nph"_fix_nh.html commands). The formulas used for the long-range corrections come from equation 5 of "(Sun)"_#Sun. NOTE: The tail correction terms are computed at the beginning of each run, using the current atom counts of each atom type. If atoms are deleted (or lost) or created during a simulation, e.g. via the "fix gcmc"_fix_gcmc.html command, the correction factors are not re-computed. If you expect the counts to change dramatically, you can break a run into a series of shorter runs so that the correction factors are re-computed more frequently. Several additional assumptions are inherent in using tail corrections, including the following: The simulated system is a 3d bulk homogeneous liquid. This option should not be used for systems that are non-liquid, 2d, have a slab geometry (only 2d periodic), or inhomogeneous. :ulb,l G(r), the radial distribution function (rdf), is unity beyond the cutoff, so a fairly large cutoff should be used (i.e. 2.5 sigma for an LJ fluid), and it is probably a good idea to verify this assumption by checking the rdf. The rdf is not exactly unity beyond the cutoff for each pair of interaction types, so the tail correction is necessarily an approximation. :l The tail corrections are computed at the beginning of each simulation run. If the number of atoms changes during the run, e.g. due to atoms leaving the simulation domain, or use of the "fix gcmc"_fix_gcmc.html command, then the corrections are not updates to relect the changed atom count. If this is a large effect in your simulation, you should break the long run into several short runs, so that the correction factors are re-computed multiple times. Thermophysical properties obtained from calculations with this option enabled will not be thermodynamically consistent with the truncated force-field that was used. In other words, atoms do not feel any LJ pair interactions beyond the cutoff, but the energy and pressure reported by the simulation include an estimated contribution from those interactions. :l,ule The {compute} keyword allows pairwise computations to be turned off, even though a "pair_style"_pair_style.html is defined. This is not useful for running a real simulation, but can be useful for debugging purposes or for performing a "rerun"_rerun.html simulation, when you only wish to compute partial forces that do not include the pairwise contribution. Two examples are as follows. First, this option allows you to perform a simulation with "pair_style hybrid"_pair_hybrid.html with only a subset of the hybrid sub-styles enabled. Second, this option allows you to perform a simulation with only long-range interactions but no short-range pairwise interactions. Doing this by simply not defining a pair style will not work, because the "kspace_style"_kspace_style.html command requires a Kspace-compatible pair style be defined. :line -Use of {special} keyword :h5 - The {special} keyword allows to override the 1-2, 1-3, and 1-4 exclusion settings for individual sub-styles of a "hybrid pair style"_pair_hybrid.html. It requires 4 arguments similar to the "special_bonds"_special_bonds.html command, {which} and wt1,wt2,wt3. The {which} argument can be {lj} to change the Lennard-Jones settings, {coul} to change the Coulombic settings, or {lj/coul} to change both to the same set of 3 values. The wt1,wt2,wt3 values are numeric weights from 0.0 to 1.0 inclusive, for the 1-2, 1-3, and 1-4 bond topology neighbors, respectively. The {special} keyword can only be used in conjunction with the {pair} keyword and has to directly follow it. NOTE: The global settings specified by the "special_bonds"_special_bonds.html command affect the construction of neighbor lists. Weights of 0.0 (for 1-2, 1-3, or 1-4 neighbors) exclude those pairs from the neighbor list entirely. Weights of 1.0 store the neighbor with no weighting applied. Thus only global values different from exactly 0.0 or 1.0 can be overridden and an error is generated if the requested setting is not compatible with the global setting. Substituting 1.0e-10 for 0.0 and 0.9999999999 for 1.0 is usually a sufficient workaround in this case without causing a significant error. :line [Restrictions:] none You cannot use {shift} yes with {tail} yes, since those are conflicting options. You cannot use {tail} yes with 2d simulations. [Related commands:] "pair_style"_pair_style.html, "pair_coeff"_pair_coeff.html, "thermo_style"_thermo_style.html [Default:] The option defaults are mix = geometric, shift = no, table = 12, tabinner = sqrt(2.0), tail = no, and compute = yes. Note that some pair styles perform mixing, but only a certain style of mixing. See the doc pages for individual pair styles for details. :line :link(Wolff) [(Wolff)] Wolff and Rudd, Comp Phys Comm, 120, 200-32 (1999). :link(Sun) [(Sun)] Sun, J Phys Chem B, 102, 7338-7364 (1998). diff --git a/doc/src/tutorial_github.txt b/doc/src/tutorial_github.txt index 941cabd6d..06f15df87 100644 --- a/doc/src/tutorial_github.txt +++ b/doc/src/tutorial_github.txt @@ -1,214 +1,214 @@ "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 -LAMMPS GitHub tutorial :h2 -written by Stefan Paquay :h3 +LAMMPS GitHub tutorial :h3 +[written by Stefan Paquay] :line -This document briefly describes how to use GitHub to merge changes -into LAMMPS using GitHub. It assumes that you are familiar with +This document briefly describes how to use GitHub to merge changes you +make into LAMMPS, using GitHub. It assumes that you are familiar with git. You may want to have a look at the "Git book"_http://git-scm.com/book/ to reacquaint yourself. :line -Making an account :h2 +[Making an account] First of all, you need a GitHub account. This is fairly simple, just go to "GitHub"_https://github.com and create an account by clicking the ``Sign up for GitHub'' button. Once your account is created, you can sign in by clicking the button in the top left and filling in your username or e-mail address and password. :line -Forking the repository :h2 +[Forking the repository] To get changes into LAMMPS, you need to first fork the repository. At the time of writing, LAMMPS-ICMS is the preferred fork. Go to "LAMMPS on GitHub"_https://github.com/lammps/lammps and make sure branch is set to ``lammps-icms'', see the figure below. :c,image(JPG/tutorial_branch.png) Now, click on fork in the top right corner: :c,image(JPG/tutorial_fork.png) This will create your own fork of the LAMMPS repository. You can make changes in this fork and later file {pull requests} to allow the upstream repository to merge changes from your own fork into the one we just forked from. At the same time, you can set things up, so you can include changes from upstream into your repository. :line -Adding changes to your own fork :h2 +[Adding changes to your own fork] Before adding changes, it is better to first create a new branch that will contain these changes, a so-called feature branch. -Feature branches :h3 +[Feature branches] Since LAMMPS is such a big project and most user contributions come in small portions, the most ideal workflow for LAMMPS is the so-called ``Feature branch'' workflow. It is explained in great detail here: "feature branch workflow"_https://www.atlassian.com/git/tutorials/comparing-workflows/feature-branch-workflow. The idea is that every new feature for LAMMPS gets its own branch. This way, it is fairly painless to incorporate new features into the upstream repository. I will explain briefly here how to do it. In this feature branch, I will add a USER-package. I assume that git is installed on the local machine and you know how to use a command line. First of all, you need to clone your own fork of LAMMPS: $ git clone https://github.com//lammps.git :pre You can find the proper url to the right of the "HTTPS" block, see figure. :c,image(JPG/tutorial_https_block.png) The above command copies (``clones'') the git repository to your local machine. You can use this local clone to make changes and test them without interfering with the repository on github. First, however, it is recommended to make a new branch for a particular feature you would like added to LAMMPS. In this example, I will try adding a new USER-package called USER-MANIFOLD. To create a new branch, run the following git command in your repository: $ git checkout -b add-user-manifold :pre The name of this new branch is "add-user-manifold" in my case. Just name it after something that resembles the feature you want added to LAMMPS. Now that you've changed branches, you can edit the files as you see fit, add new files, and commit as much as you would like. Just remember that if halfway you decide to add another, unrelated feature, you should switch branches! After everything is done, add the files to the branch and commit them: $ git add src/USER-MANIFOLD examples/USER/manifold/ $ git add doc/fix_nv{t,e}_manifold_rattle.txt $ git add doc/fix_manifoldforce.txt doc/user_manifolds.txt :pre After the files are added, the change should be comitted: $ git commit -m 'Added user-manifold package' :pre The "-m" switch is used to add a message to the commit. Use this to indicate what type of change was commited. -Wisdom by Axel: :h4 +[Wisdom by Axel] {"Do not use "git commit -a". the -a flag will automatically include *all* modified or new files. mercurial does that and it find it hugely annoying and often leading to accidental commits of files you don't want. use git add, git rm, git mv for adding, removing, renaming and then git commit to finalize the commit. personally, i find it very convenient to use the bundled gui for commits, i.e. git gui. typically, i will do git add and other operations, but then verify and review them with git gui. git gui also allows to do line-by-line unstaging and other convenient operations."} After the commit, the changes can be pushed to the same branch on GitHub: $ git push :pre Git will ask you for your user name and password on GitHub if you have not configured anything. If you correctly type your user name and password, the change should be added to your fork on GitHub. If you want to make really sure you push to the right repository (which is good practice), you can provide it explicitly: $ git push origin :pre or using an explicit URL: $ git push git@github.com:Pakketeretet2/lammps.git :pre After that, you can file a new pull request based on this branch. GitHub will now look like this: :c,image(JPG/tutorial_pull_request_feature_branch1.png) Make sure that the current branch is set to the correct one, which, in this case, is "add-user-manifold". Now click "New pull request". If done correctly, the only changes you will see are those that were made on this branch, so in my case, I will see nothing related to $\mathrm{pair\_dzugatov}.$ This will open up a new window that lists changes made to the repository. If you are just adding new files, there is not much to do, but I suppose merge conflicts are to be resolved here if there are changes in existing files. If all changes can automatically be merged, green text at the top will say so and you can click the "Create pull request" button, see image. :c,image(JPG/tutorial_pull_request2.png) After this you have to specify a short title and a comment with details about your pull request. I guess here you write what your modifications do and why they should be incorporated upstream. After that, click the "Create pull request" button, see image below. :c,image(JPG/tutorial_pull_request3.png) Now just write some nice comments, click "Comment", and that is it. It is now up to the maintainer(s) of the upstream repository to incorporate the changes into the repository and to close the pull request. :c,image(JPG/tutorial_pull_request4.png) :line -Additional changes :h2 +[Additional changes] Before the pull request is accepted, any additional changes you push into your repository will automatically become part of the pull request. :line -After a merge :h2 +[After a merge] When everything is fine the feature branch is merged into the LAMMPS repositories: :c,image(JPG/tutorial_merged.png) Now one question remains: What to do with the feature branch that got merged into upstream? It is in principle safe to delete them from your own fork. This helps keep it a bit more tidy. Note that you first have to switch to another branch! $ git checkout lammps-icms $ git pull lammps-icms $ git branch -d add-user-manifold :pre If you do not pull first, it is not really a problem but git will warn you at the next statement that you are deleting a local branch that was not yet fully merged into HEAD. This is because git does not yet know your branch just got merged into lammps-icms upstream. If you first delete and then pull, everything should still be fine. Finally, if you delete the branch locally, you might want to push this to your remote(s) as well: $ git push origin :add-user-manifold :pre diff --git a/examples/nb3b/MOH.nb3b.harmonic b/examples/nb3b/MOH.nb3b.harmonic index b30435933..9520767a4 100644 --- a/examples/nb3b/MOH.nb3b.harmonic +++ b/examples/nb3b/MOH.nb3b.harmonic @@ -1,21 +1,44 @@ # DATE: 2013-06-28 CONTRIBUTOR: Todd Zeitler, tzeitle@sandia.gov CITATION: none # nb3b/harmonic (nonbonded 3-body harmonic) parameters for various elements # # multiple entries can be added to this file, LAMMPS reads the ones it needs # # these entries are in LAMMPS "real" units: # k [kcal/mol/rad^2], theta_0 [degrees], cutoff [Angstroms] # # format of a single entry (one or more lines): # element 1 (central atom), element 2, element 3, # k_theta, theta_0, cutoff # # (ijj)-->determines cutoff for i-j distance # (jik)-->determines k, theta_0 for i-j-k angle term # # ielem jelem kelem k theta_0 cutoff + O O O 0.00 0.00 0.00 + O O M 0.00 0.00 0.00 + O O H 0.00 0.00 0.00 O M M 0.00 0.00 2.80 - O H H 0.00 0.00 1.20 + O M O 0.00 0.00 0.00 O M H 6.35 120.00 0.00 + O H H 0.00 0.00 1.20 + O H O 0.00 0.00 0.00 O H M 6.35 120.00 0.00 + M M M 0.00 0.00 0.00 + M M H 0.00 0.00 0.00 + M M O 0.00 0.00 0.00 + M O O 0.00 0.00 2.80 + M O M 0.00 0.00 2.80 + M O H 6.35 120.00 0.00 + M H H 0.00 0.00 0.00 + M H M 0.00 0.00 0.00 + M H O 0.00 0.00 0.00 + H H H 0.00 0.00 0.00 + H H M 0.00 0.00 0.00 + H H O 0.00 0.00 0.00 + H O O 0.00 0.00 1.20 + H O H 0.00 0.00 1.20 + H O M 6.35 120.00 0.00 + H M M 0.00 0.00 0.00 + H M O 0.00 0.00 0.00 + H M H 0.00 0.00 0.00 diff --git a/potentials/MOH.nb3b.harmonic b/potentials/MOH.nb3b.harmonic index b30435933..1ff90675c 100644 --- a/potentials/MOH.nb3b.harmonic +++ b/potentials/MOH.nb3b.harmonic @@ -1,21 +1,44 @@ -# DATE: 2013-06-28 CONTRIBUTOR: Todd Zeitler, tzeitle@sandia.gov CITATION: none +# DATE: 2016-07-29 CONTRIBUTOR: Todd Zeitler, tzeitle@sandia.gov CITATION: none # nb3b/harmonic (nonbonded 3-body harmonic) parameters for various elements # # multiple entries can be added to this file, LAMMPS reads the ones it needs # # these entries are in LAMMPS "real" units: # k [kcal/mol/rad^2], theta_0 [degrees], cutoff [Angstroms] # # format of a single entry (one or more lines): # element 1 (central atom), element 2, element 3, # k_theta, theta_0, cutoff # # (ijj)-->determines cutoff for i-j distance # (jik)-->determines k, theta_0 for i-j-k angle term # # ielem jelem kelem k theta_0 cutoff + O O O 0.00 0.00 0.00 + O O M 0.00 0.00 0.00 + O O H 0.00 0.00 0.00 O M M 0.00 0.00 2.80 - O H H 0.00 0.00 1.20 + O M O 0.00 0.00 0.00 O M H 6.35 120.00 0.00 + O H H 0.00 0.00 1.20 + O H O 0.00 0.00 0.00 O H M 6.35 120.00 0.00 + M M M 0.00 0.00 0.00 + M M H 0.00 0.00 0.00 + M M O 0.00 0.00 0.00 + M O O 0.00 0.00 2.80 + M O M 0.00 0.00 2.80 + M O H 6.35 120.00 0.00 + M H H 0.00 0.00 0.00 + M H M 0.00 0.00 0.00 + M H O 0.00 0.00 0.00 + H H H 0.00 0.00 0.00 + H H M 0.00 0.00 0.00 + H H O 0.00 0.00 0.00 + H O O 0.00 0.00 1.20 + H O H 0.00 0.00 1.20 + H O M 6.35 120.00 0.00 + H M M 0.00 0.00 0.00 + H M O 0.00 0.00 0.00 + H M H 0.00 0.00 0.00 diff --git a/src/KSPACE/ewald_disp.cpp b/src/KSPACE/ewald_disp.cpp index d51485880..49b7cde12 100644 --- a/src/KSPACE/ewald_disp.cpp +++ b/src/KSPACE/ewald_disp.cpp @@ -1,1483 +1,1501 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator http://lammps.sandia.gov, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains certain rights in this software. This software is distributed under the GNU General Public License. See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- Contributing authors: Pieter in 't Veld (SNL), Stan Moore (SNL) ------------------------------------------------------------------------- */ #include #include #include #include #include #include "ewald_disp.h" #include "math_vector.h" #include "math_const.h" #include "math_special.h" #include "atom.h" #include "comm.h" #include "force.h" #include "pair.h" #include "domain.h" #include "memory.h" #include "error.h" #include "update.h" using namespace LAMMPS_NS; using namespace MathConst; using namespace MathSpecial; #define SMALL 0.00001 enum{GEOMETRIC,ARITHMETIC,SIXTHPOWER}; // same as in pair.h //#define DEBUG /* ---------------------------------------------------------------------- */ EwaldDisp::EwaldDisp(LAMMPS *lmp, int narg, char **arg) : KSpace(lmp, narg, arg) { if (narg!=1) error->all(FLERR,"Illegal kspace_style ewald/n command"); ewaldflag = dispersionflag = dipoleflag = 1; accuracy_relative = fabs(force->numeric(FLERR,arg[0])); memset(function, 0, EWALD_NFUNCS*sizeof(int)); kenergy = kvirial = NULL; cek_local = cek_global = NULL; ekr_local = NULL; hvec = NULL; kvec = NULL; B = NULL; first_output = 0; energy_self_peratom = NULL; virial_self_peratom = NULL; nmax = 0; q2 = 0; b2 = 0; M2 = 0; } /* ---------------------------------------------------------------------- */ EwaldDisp::~EwaldDisp() { deallocate(); deallocate_peratom(); delete [] ekr_local; delete [] B; } /* --------------------------------------------------------------------- */ void EwaldDisp::init() { nkvec = nkvec_max = nevec = nevec_max = 0; nfunctions = nsums = sums = 0; nbox = -1; bytes = 0.0; if (!comm->me) { if (screen) fprintf(screen,"EwaldDisp initialization ...\n"); if (logfile) fprintf(logfile,"EwaldDisp initialization ...\n"); } triclinic_check(); if (domain->dimension == 2) error->all(FLERR,"Cannot use EwaldDisp with 2d simulation"); if (slabflag == 0 && domain->nonperiodic > 0) error->all(FLERR,"Cannot use nonperiodic boundaries with EwaldDisp"); if (slabflag == 1) { if (domain->xperiodic != 1 || domain->yperiodic != 1 || domain->boundary[2][0] != 1 || domain->boundary[2][1] != 1) error->all(FLERR,"Incorrect boundaries with slab EwaldDisp"); } scale = 1.0; mumurd2e = force->qqrd2e; dielectric = force->dielectric; int tmp; Pair *pair = force->pair; int *ptr = pair ? (int *) pair->extract("ewald_order",tmp) : NULL; double *cutoff = pair ? (double *) pair->extract("cut_coul",tmp) : NULL; if (!(ptr||cutoff)) error->all(FLERR,"KSpace style is incompatible with Pair style"); int ewald_order = ptr ? *((int *) ptr) : 1<<1; int ewald_mix = ptr ? *((int *) pair->extract("ewald_mix",tmp)) : GEOMETRIC; memset(function, 0, EWALD_NFUNCS*sizeof(int)); for (int i=0; i<=EWALD_NORDER; ++i) // transcribe order if (ewald_order&(1<all(FLERR, "Unsupported mixing rule in kspace_style ewald/disp"); default: error->all(FLERR,"Unsupported order in kspace_style ewald/disp"); } nfunctions += function[k] = 1; nsums += n[k]; } if (!gewaldflag) g_ewald = 0.0; pair->init(); // so B is defined init_coeffs(); init_coeff_sums(); if (function[0]) qsum_qsq(); natoms_original = atom->natoms; // turn off coulombic if no charge if (function[0] && qsqsum == 0.0) { function[0] = 0; nfunctions -= 1; nsums -= 1; } double bsbsum = 0.0; if (function[1]) bsbsum = sum[1].x2; if (function[2]) bsbsum = sum[2].x2; if (function[3]) M2 = sum[9].x2; if (function[3] && strcmp(update->unit_style,"electron") == 0) error->all(FLERR,"Cannot (yet) use 'electron' units with dipoles"); if (qsqsum == 0.0 && bsbsum == 0.0 && M2 == 0.0) error->all(FLERR,"Cannot use Ewald/disp solver " "on system with no charge, dipole, or LJ particles"); if (fabs(qsum) > SMALL && comm->me == 0) { char str[128]; sprintf(str,"System is not charge neutral, net charge = %g",qsum); error->warning(FLERR,str); } if (!function[1] && !function[2]) dispersionflag = 0; if (!function[3]) dipoleflag = 0; pair_check(); // set accuracy (force units) from accuracy_relative or accuracy_absolute if (accuracy_absolute >= 0.0) accuracy = accuracy_absolute; else accuracy = accuracy_relative * two_charge_force; // setup K-space resolution q2 = qsqsum * force->qqrd2e; M2 *= mumurd2e; b2 = bsbsum; //Are these units right? bigint natoms = atom->natoms; if (!gewaldflag) { if (function[0]) { g_ewald = accuracy*sqrt(natoms*(*cutoff)*shape_det(domain->h)) / (2.0*q2); if (g_ewald >= 1.0) g_ewald = (1.35 - 0.15*log(accuracy))/(*cutoff); else g_ewald = sqrt(-log(g_ewald)) / (*cutoff); } else if (function[1] || function[2]) { //Try Newton Solver //Use old method to get guess g_ewald = (1.35 - 0.15*log(accuracy))/ *cutoff; double g_ewald_new = NewtonSolve(g_ewald,(*cutoff),natoms,shape_det(domain->h),b2); if (g_ewald_new > 0.0) g_ewald = g_ewald_new; else error->warning(FLERR,"Ewald/disp Newton solver failed, " "using old method to estimate g_ewald"); } else if (function[3]) { //Try Newton Solver //Use old method to get guess g_ewald = (1.35 - 0.15*log(accuracy))/ *cutoff; double g_ewald_new = NewtonSolve(g_ewald,(*cutoff),natoms,shape_det(domain->h),M2); if (g_ewald_new > 0.0) g_ewald = g_ewald_new; else error->warning(FLERR,"Ewald/disp Newton solver failed, " "using old method to estimate g_ewald"); } } if (!comm->me) { if (screen) fprintf(screen, " G vector = %g\n", g_ewald); if (logfile) fprintf(logfile, " G vector = %g\n", g_ewald); } g_ewald_6 = g_ewald; deallocate_peratom(); peratom_allocate_flag = 0; } /* ---------------------------------------------------------------------- adjust EwaldDisp coeffs, called initially and whenever volume has changed ------------------------------------------------------------------------- */ void EwaldDisp::setup() { volume = shape_det(domain->h)*slab_volfactor; memcpy(unit, domain->h_inv, sizeof(shape)); shape_scalar_mult(unit, 2.0*MY_PI); unit[2] /= slab_volfactor; // int nbox_old = nbox, nkvec_old = nkvec; if (accuracy >= 1) { nbox = 0; error->all(FLERR,"KSpace accuracy too low"); } bigint natoms = atom->natoms; double err; int kxmax = 1; int kymax = 1; int kzmax = 1; err = rms(kxmax,domain->h[0],natoms,q2,b2,M2); while (err > accuracy) { kxmax++; err = rms(kxmax,domain->h[0],natoms,q2,b2,M2); } err = rms(kymax,domain->h[1],natoms,q2,b2,M2); while (err > accuracy) { kymax++; err = rms(kymax,domain->h[1],natoms,q2,b2,M2); } err = rms(kzmax,domain->h[2]*slab_volfactor,natoms,q2,b2,M2); while (err > accuracy) { kzmax++; err = rms(kzmax,domain->h[2]*slab_volfactor,natoms,q2,b2,M2); } nbox = MAX(kxmax,kymax); nbox = MAX(nbox,kzmax); double gsqxmx = unit[0]*unit[0]*kxmax*kxmax; double gsqymx = unit[1]*unit[1]*kymax*kymax; double gsqzmx = unit[2]*unit[2]*kzmax*kzmax; gsqmx = MAX(gsqxmx,gsqymx); gsqmx = MAX(gsqmx,gsqzmx); gsqmx *= 1.00001; reallocate(); coefficients(); init_coeffs(); init_coeff_sums(); init_self(); if (!(first_output||comm->me)) { first_output = 1; if (screen) fprintf(screen, " vectors: nbox = %d, nkvec = %d\n", nbox, nkvec); if (logfile) fprintf(logfile, " vectors: nbox = %d, nkvec = %d\n", nbox, nkvec); } } /* ---------------------------------------------------------------------- compute RMS accuracy for a dimension ------------------------------------------------------------------------- */ double EwaldDisp::rms(int km, double prd, bigint natoms, double q2, double b2, double M2) { double value = 0.0; // Coulombic double g2 = g_ewald*g_ewald; value += 2.0*q2*g_ewald/prd * sqrt(1.0/(MY_PI*km*natoms)) * exp(-MY_PI*MY_PI*km*km/(g2*prd*prd)); // Lennard-Jones double g7 = g2*g2*g2*g_ewald; value += 4.0*b2*g7/3.0 * sqrt(1.0/(MY_PI*natoms)) * (exp(-MY_PI*MY_PI*km*km/(g2*prd*prd)) * (MY_PI*km/(g_ewald*prd) + 1)); // dipole value += 8.0*MY_PI*M2/volume*g_ewald * sqrt(2.0*MY_PI*km*km*km/(15.0*natoms)) * exp(-pow(MY_PI*km/(g_ewald*prd),2.0)); return value; } void EwaldDisp::reallocate() { int ix, iy, iz; int nkvec_max = nkvec; vector h; nkvec = 0; int *kflag = new int[(nbox+1)*(2*nbox+1)*(2*nbox+1)]; int *flag = kflag; for (ix=0; ix<=nbox; ++ix) for (iy=-nbox; iy<=nbox; ++iy) for (iz=-nbox; iz<=nbox; ++iz) if (!(ix||iy||iz)) *(flag++) = 0; else if ((!ix)&&(iy<0)) *(flag++) = 0; else if ((!(ix||iy))&&(iz<0)) *(flag++) = 0; // use symmetry else { h[0] = unit[0]*ix; h[1] = unit[5]*ix+unit[1]*iy; h[2] = unit[4]*ix+unit[3]*iy+unit[2]*iz; if ((*(flag++) = h[0]*h[0]+h[1]*h[1]+h[2]*h[2]<=gsqmx)) ++nkvec; } if (nkvec>nkvec_max) { deallocate(); // free memory hvec = new hvector[nkvec]; // hvec bytes += (nkvec-nkvec_max)*sizeof(hvector); kvec = new kvector[nkvec]; // kvec bytes += (nkvec-nkvec_max)*sizeof(kvector); kenergy = new double[nkvec*nfunctions]; // kenergy bytes += (nkvec-nkvec_max)*nfunctions*sizeof(double); kvirial = new double[6*nkvec*nfunctions]; // kvirial bytes += 6*(nkvec-nkvec_max)*nfunctions*sizeof(double); cek_local = new complex[nkvec*nsums]; // cek_local bytes += (nkvec-nkvec_max)*nsums*sizeof(complex); cek_global = new complex[nkvec*nsums]; // cek_global bytes += (nkvec-nkvec_max)*nsums*sizeof(complex); nkvec_max = nkvec; } flag = kflag; // create index and kvector *k = kvec; // wave vectors hvector *hi = hvec; for (ix=0; ix<=nbox; ++ix) for (iy=-nbox; iy<=nbox; ++iy) for (iz=-nbox; iz<=nbox; ++iz) if (*(flag++)) { hi->x = unit[0]*ix; hi->y = unit[5]*ix+unit[1]*iy; (hi++)->z = unit[4]*ix+unit[3]*iy+unit[2]*iz; k->x = ix+nbox; k->y = iy+nbox; (k++)->z = iz+nbox; } delete [] kflag; } +/* ---------------------------------------------------------------------- */ void EwaldDisp::reallocate_atoms() { if (eflag_atom || vflag_atom) if (atom->nmax > nmax) { deallocate_peratom(); allocate_peratom(); nmax = atom->nmax; } if ((nevec = atom->nmax*(2*nbox+1))<=nevec_max) return; delete [] ekr_local; ekr_local = new cvector[nevec]; bytes += (nevec-nevec_max)*sizeof(cvector); nevec_max = nevec; } +/* ---------------------------------------------------------------------- */ void EwaldDisp::allocate_peratom() { memory->create(energy_self_peratom, atom->nmax,EWALD_NFUNCS,"ewald/n:energy_self_peratom"); memory->create(virial_self_peratom, atom->nmax,EWALD_NFUNCS,"ewald/n:virial_self_peratom"); } +/* ---------------------------------------------------------------------- */ void EwaldDisp::deallocate_peratom() // free memory { if (energy_self_peratom) { memory->destroy(energy_self_peratom); energy_self_peratom = NULL; } if (virial_self_peratom) { memory->destroy(virial_self_peratom); virial_self_peratom = NULL; } } +/* ---------------------------------------------------------------------- */ void EwaldDisp::deallocate() // free memory { delete [] hvec; hvec = NULL; delete [] kvec; kvec = NULL; delete [] kenergy; kenergy = NULL; delete [] kvirial; kvirial = NULL; delete [] cek_local; cek_local = NULL; delete [] cek_global; cek_global = NULL; } +/* ---------------------------------------------------------------------- */ void EwaldDisp::coefficients() { vector h; hvector *hi = hvec, *nh; double eta2 = 0.25/(g_ewald*g_ewald); double b1, b2, expb2, h1, h2, c1, c2; double *ke = kenergy, *kv = kvirial; int func0 = function[0], func12 = function[1]||function[2], func3 = function[3]; for (nh = (hi = hvec)+nkvec; hintypes; if (function[1]) { // geometric 1/r^6 double **b = (double **) force->pair->extract("B",tmp); delete [] B; B = new double[n+1]; bytes += (n+1)*sizeof(double); for (int i=0; i<=n; ++i) B[i] = sqrt(fabs(b[i][i])); } if (function[2]) { // arithmetic 1/r^6 double **epsilon = (double **) force->pair->extract("epsilon",tmp); double **sigma = (double **) force->pair->extract("sigma",tmp); double eps_i, sigma_i, sigma_n, *bi = B = new double[7*n+7]; double c[7] = { 1.0, sqrt(6.0), sqrt(15.0), sqrt(20.0), sqrt(15.0), sqrt(6.0), 1.0}; if (!(epsilon&&sigma)) error->all( FLERR,"Epsilon or sigma reference not set by pair style in ewald/n"); for (int i=0; i<=n; ++i) { eps_i = sqrt(epsilon[i][i]); sigma_i = sigma[i][i]; sigma_n = 1.0; for (int j=0; j<7; ++j) { *(bi++) = sigma_n*eps_i*c[j]; sigma_n *= sigma_i; } } } } +/* ---------------------------------------------------------------------- */ + void EwaldDisp::init_coeff_sums() { if (sums) return; // calculated only once sums = 1; Sum sum_local[EWALD_MAX_NSUMS]; memset(sum_local, 0, EWALD_MAX_NSUMS*sizeof(Sum)); // now perform qsum and qsq via parent qsum_qsq() sum_local[0].x = 0.0; sum_local[0].x2 = 0.0; //if (function[0]) { // 1/r // double *q = atom->q, *qn = q+atom->nlocal; // for (double *i=q; itype, *ntype = type+atom->nlocal; for (int *i=type; itype, *ntype = type+atom->nlocal; for (int *i=type; imu) { // dipole double *mu = atom->mu[0], *nmu = mu+4*atom->nlocal; for (double *i = mu; i < nmu; i += 4) sum_local[9].x2 += i[3]*i[3]; } MPI_Allreduce(sum_local, sum, 2*EWALD_MAX_NSUMS, MPI_DOUBLE, MPI_SUM, world); } +/* ---------------------------------------------------------------------- */ void EwaldDisp::init_self() { double g1 = g_ewald, g2 = g1*g1, g3 = g1*g2; const double qscale = force->qqrd2e * scale; memset(energy_self, 0, EWALD_NFUNCS*sizeof(double)); // self energy memset(virial_self, 0, EWALD_NFUNCS*sizeof(double)); if (function[0]) { // 1/r virial_self[0] = -0.5*MY_PI*qscale/(g2*volume)*qsum*qsum; energy_self[0] = qsqsum*qscale*g1/MY_PIS-virial_self[0]; } if (function[1]) { // geometric 1/r^6 virial_self[1] = MY_PI*MY_PIS*g3/(6.0*volume)*sum[1].x*sum[1].x; energy_self[1] = -sum[1].x2*g3*g3/12.0+virial_self[1]; } if (function[2]) { // arithmetic 1/r^6 virial_self[2] = MY_PI*MY_PIS*g3/(48.0*volume)*(sum[2].x*sum[8].x+ sum[3].x*sum[7].x+sum[4].x*sum[6].x+0.5*sum[5].x*sum[5].x); energy_self[2] = -sum[2].x2*g3*g3/3.0+virial_self[2]; } if (function[3]) { // dipole virial_self[3] = 0; // in surface energy_self[3] = sum[9].x2*mumurd2e*2.0*g3/3.0/MY_PIS-virial_self[3]; } } +/* ---------------------------------------------------------------------- */ void EwaldDisp::init_self_peratom() { if (!(vflag_atom || eflag_atom)) return; double g1 = g_ewald, g2 = g1*g1, g3 = g1*g2; const double qscale = force->qqrd2e * scale; double *energy = energy_self_peratom[0]; double *virial = virial_self_peratom[0]; int nlocal = atom->nlocal; memset(energy, 0, EWALD_NFUNCS*nlocal*sizeof(double)); memset(virial, 0, EWALD_NFUNCS*nlocal*sizeof(double)); if (function[0]) { // 1/r double *ei = energy; double *vi = virial; double ce = qscale*g1/MY_PIS; double cv = -0.5*MY_PI*qscale/(g2*volume); double *qi = atom->q, *qn = qi + nlocal; for (; qi < qn; qi++, vi += EWALD_NFUNCS, ei += EWALD_NFUNCS) { double q = *qi; *vi = cv*q*qsum; *ei = ce*q*q-vi[0]; } } if (function[1]) { // geometric 1/r^6 double *ei = energy+1; double *vi = virial+1; double ce = -g3*g3/12.0; double cv = MY_PI*MY_PIS*g3/(6.0*volume); int *typei = atom->type, *typen = typei + atom->nlocal; for (; typei < typen; typei++, vi += EWALD_NFUNCS, ei += EWALD_NFUNCS) { double b = B[*typei]; *vi = cv*b*sum[1].x; *ei = ce*b*b+vi[0]; } } if (function[2]) { // arithmetic 1/r^6 double *bi; double *ei = energy+2; double *vi = virial+2; double ce = -g3*g3/3.0; double cv = 0.5*MY_PI*MY_PIS*g3/(48.0*volume); int *typei = atom->type, *typen = typei + atom->nlocal; for (; typei < typen; typei++, vi += EWALD_NFUNCS, ei += EWALD_NFUNCS) { bi = B+7*typei[0]+7; for (int k=2; k<9; ++k) *vi += cv*sum[k].x*(--bi)[0]; /* PJV 20120225: should this be this instead? above implies an inverse dependence seems to be the above way in original; i recall having tested arithmetic mixing in the conception phase, but an extra test would be prudent (pattern repeats in multiple functions below) bi = B+7*typei[0]; for (int k=2; k<9; ++k) *vi += cv*sum[k].x*(bi++)[0]; */ *ei = ce*bi[0]*bi[6]+vi[0]; } } if (function[3]&&atom->mu) { // dipole double *ei = energy+3; double *vi = virial+3; double *imu = atom->mu[0], *nmu = imu+4*atom->nlocal; double ce = mumurd2e*2.0*g3/3.0/MY_PIS; for (; imu < nmu; imu += 4, vi += EWALD_NFUNCS, ei += EWALD_NFUNCS) { *vi = 0; // in surface *ei = ce*imu[3]*imu[3]-vi[0]; } } } - /* ---------------------------------------------------------------------- compute the EwaldDisp long-range force, energy, virial ------------------------------------------------------------------------- */ void EwaldDisp::compute(int eflag, int vflag) { if (!nbox) return; // set energy/virial flags // invoke allocate_peratom() if needed for first time if (eflag || vflag) ev_setup(eflag,vflag); else evflag = eflag_global = vflag_global = eflag_atom = vflag_atom = 0; if (!peratom_allocate_flag && (eflag_atom || vflag_atom)) { allocate_peratom(); peratom_allocate_flag = 1; nmax = atom->nmax; } reallocate_atoms(); init_self_peratom(); compute_ek(); compute_force(); //compute_surface(); // assume conducting metal (tinfoil) boundary conditions // update qsum and qsqsum, if atom count has changed and energy needed if ((eflag_global || eflag_atom) && atom->natoms != natoms_original) { if (function[0]) qsum_qsq(); natoms_original = atom->natoms; } compute_energy(); compute_energy_peratom(); compute_virial(); compute_virial_dipole(); compute_virial_peratom(); } void EwaldDisp::compute_ek() { cvector *ekr = ekr_local; int lbytes = (2*nbox+1)*sizeof(cvector); hvector *h = NULL; kvector *k, *nk = kvec+nkvec; cvector *z = new cvector[2*nbox+1]; cvector z1, *zx, *zy, *zz, *zn = z+2*nbox; complex *cek, zxyz, zxy = COMPLEX_NULL, cx = COMPLEX_NULL; vector mui; double *x = atom->x[0], *xn = x+3*atom->nlocal, *q = atom->q, qi = 0.0; double bi = 0.0, ci[7]; double *mu = atom->mu ? atom->mu[0] : NULL; int i, kx, ky, n = nkvec*nsums, *type = atom->type, tri = domain->triclinic; int func[EWALD_NFUNCS]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); memset(cek_local, 0, n*sizeof(complex)); // reset sums while (xx, 1, 0); C_SET(zz->y, 1, 0); C_SET(zz->z, 1, 0); // z[0] if (tri) { // triclinic z[1] C_ANGLE(z1.x, unit[0]*x[0]+unit[5]*x[1]+unit[4]*x[2]); C_ANGLE(z1.y, unit[1]*x[1]+unit[3]*x[2]); C_ANGLE(z1.z, x[2]*unit[2]); x += 3; } else { // orthogonal z[1] C_ANGLE(z1.x, *(x++)*unit[0]); C_ANGLE(z1.y, *(x++)*unit[1]); C_ANGLE(z1.z, *(x++)*unit[2]); } for (; zzx, zz->x, z1.x); // 3D k-vector C_RMULT(zy->y, zz->y, z1.y); C_CONJ(zx->y, zy->y); C_RMULT(zy->z, zz->z, z1.z); C_CONJ(zx->z, zy->z); } kx = ky = -1; cek = cek_local; if (func[0]) qi = *(q++); if (func[1]) bi = B[*type]; if (func[2]) memcpy(ci, B+7*type[0], 7*sizeof(double)); if (func[3]) { memcpy(mui, mu, sizeof(vector)); mu += 4; h = hvec; } for (k=kvec; ky) { // based on order in if (kx!=k->x) cx = z[kx = k->x].x; // reallocate C_RMULT(zxy, z[ky = k->y].y, cx); } C_RMULT(zxyz, z[k->z].z, zxy); if (func[0]) { cek->re += zxyz.re*qi; (cek++)->im += zxyz.im*qi; } if (func[1]) { cek->re += zxyz.re*bi; (cek++)->im += zxyz.im*bi; } if (func[2]) for (i=0; i<7; ++i) { cek->re += zxyz.re*ci[i]; (cek++)->im += zxyz.im*ci[i]; } if (func[3]) { register double muk = mui[0]*h->x+mui[1]*h->y+mui[2]*h->z; ++h; cek->re += zxyz.re*muk; (cek++)->im += zxyz.im*muk; } } ekr = (cvector *) ((char *) memcpy(ekr, z, lbytes)+lbytes); ++type; } MPI_Allreduce(cek_local, cek_global, 2*n, MPI_DOUBLE, MPI_SUM, world); delete [] z; } +/* ---------------------------------------------------------------------- */ void EwaldDisp::compute_force() { kvector *k; hvector *h, *nh; cvector *z = ekr_local; vector sum[EWALD_MAX_NSUMS], mui = COMPLEX_NULL; complex *cek, zc, zx = COMPLEX_NULL, zxy = COMPLEX_NULL; complex *cek_coul; double *f = atom->f[0], *fn = f+3*atom->nlocal, *q = atom->q, *t = NULL; double *mu = atom->mu ? atom->mu[0] : NULL; const double qscale = force->qqrd2e * scale; double *ke, c[EWALD_NFUNCS] = { 8.0*MY_PI*qscale/volume, 2.0*MY_PI*MY_PIS/(12.0*volume), 2.0*MY_PI*MY_PIS/(192.0*volume), 8.0*MY_PI*mumurd2e/volume}; int i, kx, ky, lbytes = (2*nbox+1)*sizeof(cvector), *type = atom->type; int func[EWALD_NFUNCS]; if (atom->torque) t = atom->torque[0]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); memset(sum, 0, EWALD_MAX_NSUMS*sizeof(vector)); // fj = -dE/dr = for (; fy) { // based on order in if (kx!=k->x) zx = z[kx = k->x].x; // reallocate C_RMULT(zxy, z[ky = k->y].y, zx); } C_CRMULT(zc, z[k->z].z, zxy); if (func[0]) { // 1/r register double im = *(ke++)*(zc.im*cek->re+cek->im*zc.re); if (func[3]) cek_coul = cek; ++cek; sum[0][0] += h->x*im; sum[0][1] += h->y*im; sum[0][2] += h->z*im; } if (func[1]) { // geometric 1/r^6 register double im = *(ke++)*(zc.im*cek->re+cek->im*zc.re); ++cek; sum[1][0] += h->x*im; sum[1][1] += h->y*im; sum[1][2] += h->z*im; } if (func[2]) { // arithmetic 1/r^6 register double im, c = *(ke++); for (i=2; i<9; ++i) { im = c*(zc.im*cek->re+cek->im*zc.re); ++cek; sum[i][0] += h->x*im; sum[i][1] += h->y*im; sum[i][2] += h->z*im; } } if (func[3]) { // dipole register double im = *(ke)*(zc.im*cek->re+ cek->im*zc.re)*(mui[0]*h->x+mui[1]*h->y+mui[2]*h->z); register double im2 = *(ke)*(zc.re*cek->re- cek->im*zc.im); sum[9][0] += h->x*im; sum[9][1] += h->y*im; sum[9][2] += h->z*im; t[0] += -mui[1]*h->z*im2 + mui[2]*h->y*im2; // torque t[1] += -mui[2]*h->x*im2 + mui[0]*h->z*im2; t[2] += -mui[0]*h->y*im2 + mui[1]*h->x*im2; if (func[0]) { // charge-dipole register double qi = *(q)*c[0]; im = - *(ke)*(zc.re*cek_coul->re - cek_coul->im*zc.im)*(mui[0]*h->x+mui[1]*h->y+mui[2]*h->z); im += *(ke)*(zc.re*cek->re - cek->im*zc.im)*qi; sum[9][0] += h->x*im; sum[9][1] += h->y*im; sum[9][2] += h->z*im; im2 = *(ke)*(zc.re*cek_coul->im + cek_coul->re*zc.im); im2 += -*(ke)*(zc.re*cek->im - cek->im*zc.re); t[0] += -mui[1]*h->z*im2 + mui[2]*h->y*im2; // torque t[1] += -mui[2]*h->x*im2 + mui[0]*h->z*im2; t[2] += -mui[0]*h->y*im2 + mui[1]*h->x*im2; } ++cek; ke++; } } if (func[0]) { // 1/r register double qi = *(q++)*c[0]; f[0] -= sum[0][0]*qi; f[1] -= sum[0][1]*qi; f[2] -= sum[0][2]*qi; } if (func[1]) { // geometric 1/r^6 register double bi = B[*type]*c[1]; f[0] -= sum[1][0]*bi; f[1] -= sum[1][1]*bi; f[2] -= sum[1][2]*bi; } if (func[2]) { // arithmetic 1/r^6 register double *bi = B+7*type[0]+7; for (i=2; i<9; ++i) { register double c2 = (--bi)[0]*c[2]; f[0] -= sum[i][0]*c2; f[1] -= sum[i][1]*c2; f[2] -= sum[i][2]*c2; } } if (func[3]) { // dipole f[0] -= sum[9][0]; f[1] -= sum[9][1]; f[2] -= sum[9][2]; } z = (cvector *) ((char *) z+lbytes); ++type; t += 3; } } +/* ---------------------------------------------------------------------- */ void EwaldDisp::compute_surface() { // assume conducting metal (tinfoil) boundary conditions, so this function is // not called because dielectric at the boundary --> infinity, which makes all // the terms here zero. if (!function[3]) return; if (!atom->mu) return; vector sum_local = VECTOR_NULL, sum_total; memset(sum_local, 0, sizeof(vector)); double *i, *n, *mu = atom->mu[0]; for (n = (i = mu) + 4*atom->nlocal; i < n; ++i) { sum_local[0] += (i++)[0]; sum_local[1] += (i++)[0]; sum_local[2] += (i++)[0]; } MPI_Allreduce(sum_local, sum_total, 3, MPI_DOUBLE, MPI_SUM, world); virial_self[3] = mumurd2e*(2.0*MY_PI*vec_dot(sum_total,sum_total)/(2.0*dielectric+1)/volume); energy_self[3] -= virial_self[3]; if (!(vflag_atom || eflag_atom)) return; double *ei = energy_self_peratom[0]+3; double *vi = virial_self_peratom[0]+3; double cv = 2.0*mumurd2e*MY_PI/(2.0*dielectric+1)/volume; for (i = mu; i < n; i += 4, ei += EWALD_NFUNCS, vi += EWALD_NFUNCS) { *vi = cv*(i[0]*sum_total[0]+i[1]*sum_total[1]+i[2]*sum_total[2]); *ei -= *vi; } } +/* ---------------------------------------------------------------------- */ void EwaldDisp::compute_energy() { energy = 0.0; if (!eflag_global) return; complex *cek = cek_global; complex *cek_coul; double *ke = kenergy; const double qscale = force->qqrd2e * scale; double c[EWALD_NFUNCS] = { 4.0*MY_PI*qscale/volume, 2.0*MY_PI*MY_PIS/(24.0*volume), 2.0*MY_PI*MY_PIS/(192.0*volume), 4.0*MY_PI*mumurd2e/volume}; double sum[EWALD_NFUNCS]; int func[EWALD_NFUNCS]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); memset(sum, 0, EWALD_NFUNCS*sizeof(double)); // reset sums for (int k=0; kre*cek->re+cek->im*cek->im); if (func[3]) cek_coul = cek; ++cek; } if (func[1]) { // geometric 1/r^6 sum[1] += *(ke++)*(cek->re*cek->re+cek->im*cek->im); ++cek; } if (func[2]) { // arithmetic 1/r^6 register double r = (cek[0].re*cek[6].re+cek[0].im*cek[6].im)+ (cek[1].re*cek[5].re+cek[1].im*cek[5].im)+ (cek[2].re*cek[4].re+cek[2].im*cek[4].im)+ 0.5*(cek[3].re*cek[3].re+cek[3].im*cek[3].im); cek += 7; sum[2] += *(ke++)*r; } if (func[3]) { // dipole sum[3] += *(ke)*(cek->re*cek->re+cek->im*cek->im); if (func[0]) { // charge-dipole sum[3] += *(ke)*2.0*(cek->re*cek_coul->im - cek->im*cek_coul->re); } ke++; ++cek; } } for (int k=0; kq; double *eatomj = eatom; double *mu = atom->mu ? atom->mu[0] : NULL; const double qscale = force->qqrd2e * scale; double *ke = kenergy; double c[EWALD_NFUNCS] = { 4.0*MY_PI*qscale/volume, 2.0*MY_PI*MY_PIS/(24.0*volume), 2.0*MY_PI*MY_PIS/(192.0*volume), 4.0*MY_PI*mumurd2e/volume}; int i, kx, ky, lbytes = (2*nbox+1)*sizeof(cvector), *type = atom->type; int func[EWALD_NFUNCS]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); for (int j = 0; j < atom->nlocal; j++, ++eatomj) { k = kvec; kx = ky = -1; ke = kenergy; cek = cek_global; memset(sum, 0, EWALD_MAX_NSUMS*sizeof(double)); if (func[3]) { register double di = c[3]; mui[0] = di*(mu++)[0]; mui[1] = di*(mu++)[0]; mui[2] = di*(mu++)[0]; mu++; } for (nh = (h = hvec)+nkvec; hy) { // based on order in if (kx!=k->x) zx = z[kx = k->x].x; // reallocate C_RMULT(zxy, z[ky = k->y].y, zx); } C_CRMULT(zc, z[k->z].z, zxy); if (func[0]) { // 1/r sum[0] += *(ke++)*(cek->re*zc.re - cek->im*zc.im); if (func[3]) cek_coul = cek; ++cek; } if (func[1]) { // geometric 1/r^6 sum[1] += *(ke++)*(cek->re*zc.re - cek->im*zc.im); ++cek; } if (func[2]) { // arithmetic 1/r^6 register double im, c = *(ke++); for (i=2; i<9; ++i) { im = c*(cek->re*zc.re - cek->im*zc.im); ++cek; sum[i] += im; } } if (func[3]) { // dipole double muk = (mui[0]*h->x+mui[1]*h->y+mui[2]*h->z); sum[9] += *(ke)*(cek->re*zc.re - cek->im*zc.im)*muk; if (func[0]) { // charge-dipole register double qj = *(q)*c[0]; sum[9] += *(ke)*(cek_coul->im*zc.re + cek_coul->re*zc.im)*muk; sum[9] -= *(ke)*(cek->re*zc.im + cek->im*zc.re)*qj; } ++cek; ke++; } } if (func[0]) { // 1/r register double qj = *(q++)*c[0]; *eatomj += sum[0]*qj - energy_self_peratom[j][0]; } if (func[1]) { // geometric 1/r^6 register double bj = B[*type]*c[1]; *eatomj += sum[1]*bj - energy_self_peratom[j][1]; } if (func[2]) { // arithmetic 1/r^6 register double *bj = B+7*type[0]+7; for (i=2; i<9; ++i) { register double c2 = (--bj)[0]*c[2]; *eatomj += 0.5*sum[i]*c2; } *eatomj -= energy_self_peratom[j][2]; } if (func[3]) { // dipole *eatomj += sum[9] - energy_self_peratom[j][3]; } z = (cvector *) ((char *) z+lbytes); ++type; } } +/* ---------------------------------------------------------------------- */ #define swap(a, b) { register double t = a; a= b; b = t; } void EwaldDisp::compute_virial() { memset(virial, 0, sizeof(shape)); if (!vflag_global) return; complex *cek = cek_global; complex *cek_coul; double *kv = kvirial; const double qscale = force->qqrd2e * scale; double c[EWALD_NFUNCS] = { 4.0*MY_PI*qscale/volume, 2.0*MY_PI*MY_PIS/(24.0*volume), 2.0*MY_PI*MY_PIS/(192.0*volume), 4.0*MY_PI*mumurd2e/volume}; shape sum[EWALD_NFUNCS]; int func[EWALD_NFUNCS]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); memset(sum, 0, EWALD_NFUNCS*sizeof(shape)); for (int k=0; kre*cek->re+cek->im*cek->im; if (func[3]) cek_coul = cek; ++cek; sum[0][0] += *(kv++)*r; sum[0][1] += *(kv++)*r; sum[0][2] += *(kv++)*r; sum[0][3] += *(kv++)*r; sum[0][4] += *(kv++)*r; sum[0][5] += *(kv++)*r; } if (func[1]) { // geometric 1/r^6 register double r = cek->re*cek->re+cek->im*cek->im; ++cek; sum[1][0] += *(kv++)*r; sum[1][1] += *(kv++)*r; sum[1][2] += *(kv++)*r; sum[1][3] += *(kv++)*r; sum[1][4] += *(kv++)*r; sum[1][5] += *(kv++)*r; } if (func[2]) { // arithmetic 1/r^6 register double r = (cek[0].re*cek[6].re+cek[0].im*cek[6].im)+ (cek[1].re*cek[5].re+cek[1].im*cek[5].im)+ (cek[2].re*cek[4].re+cek[2].im*cek[4].im)+ 0.5*(cek[3].re*cek[3].re+cek[3].im*cek[3].im); cek += 7; sum[2][0] += *(kv++)*r; sum[2][1] += *(kv++)*r; sum[2][2] += *(kv++)*r; sum[2][3] += *(kv++)*r; sum[2][4] += *(kv++)*r; sum[2][5] += *(kv++)*r; } if (func[3]) { register double r = cek->re*cek->re+cek->im*cek->im; sum[3][0] += *(kv++)*r; sum[3][1] += *(kv++)*r; sum[3][2] += *(kv++)*r; sum[3][3] += *(kv++)*r; sum[3][4] += *(kv++)*r; sum[3][5] += *(kv++)*r; if (func[0]) { // charge-dipole kv -= 6; register double r = 2.0*(cek->re*cek_coul->im - cek->im*cek_coul->re); sum[3][0] += *(kv++)*r; sum[3][1] += *(kv++)*r; sum[3][2] += *(kv++)*r; sum[3][3] += *(kv++)*r; sum[3][4] += *(kv++)*r; sum[3][5] += *(kv++)*r; } ++cek; } } for (int k=0; kmu ? atom->mu[0] : NULL; double *vatomj = NULL; if (vflag_atom && vatom) vatomj = vatom[0]; const double qscale = force->qqrd2e * scale; double *ke, c[EWALD_NFUNCS] = { 8.0*MY_PI*qscale/volume, 2.0*MY_PI*MY_PIS/(12.0*volume), 2.0*MY_PI*MY_PIS/(192.0*volume), 8.0*MY_PI*mumurd2e/volume}; int i, kx, ky, lbytes = (2*nbox+1)*sizeof(cvector), *type = atom->type; int func[EWALD_NFUNCS]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); memset(&sum[0], 0, 6*sizeof(double)); memset(&sum_total[0], 0, 6*sizeof(double)); for (int j = 0; j < atom->nlocal; j++) { k = kvec; kx = ky = -1; ke = kenergy; cek = cek_global; memset(&sum[0], 0, 6*sizeof(double)); if (func[3]) { register double di = c[3]; mui[0] = di*(mu++)[0]; mui[1] = di*(mu++)[0]; mui[2] = di*(mu++)[0]; mu++; } for (nh = (h = hvec)+nkvec; hy) { // based on order in if (kx!=k->x) zx = z[kx = k->x].x; // reallocate C_RMULT(zxy, z[ky = k->y].y, zx); } C_CRMULT(zc, z[k->z].z, zxy); double im = 0.0; if (func[0]) { // 1/r ke++; if (func[3]) cek_coul = cek; ++cek; } if (func[1]) { // geometric 1/r^6 ke++; ++cek; } if (func[2]) { // arithmetic 1/r^6 ke++; for (i=2; i<9; ++i) { ++cek; } } if (func[3]) { // dipole im = *(ke)*(zc.re*cek->re - cek->im*zc.im); if (func[0]) { // charge-dipole im += *(ke)*(zc.im*cek_coul->re + cek_coul->im*zc.re); } sum[0] -= mui[0]*h->x*im; sum[1] -= mui[1]*h->y*im; sum[2] -= mui[2]*h->z*im; sum[3] -= mui[0]*h->y*im; sum[4] -= mui[0]*h->z*im; sum[5] -= mui[1]*h->z*im; ++cek; ke++; } } if (vflag_global) for (int n = 0; n < 6; n++) sum_total[n] -= sum[n]; if (vflag_atom) for (int n = 0; n < 6; n++) vatomj[n] -= sum[n]; z = (cvector *) ((char *) z+lbytes); ++type; if (vflag_atom) vatomj += 6; } if (vflag_global) { MPI_Allreduce(&sum_total[0],&sum[0],6,MPI_DOUBLE,MPI_SUM,world); for (int n = 0; n < 6; n++) virial[n] += sum[n]; } } +/* ---------------------------------------------------------------------- */ + void EwaldDisp::compute_virial_peratom() { if (!vflag_atom) return; kvector *k; hvector *h, *nh; cvector *z = ekr_local; vector mui = VECTOR_NULL; complex *cek, zc = COMPLEX_NULL, zx = COMPLEX_NULL, zxy = COMPLEX_NULL; complex *cek_coul; double *kv; double *q = atom->q; double *vatomj = vatom ? vatom[0] : NULL; double *mu = atom->mu ? atom->mu[0] : NULL; const double qscale = force->qqrd2e * scale; double c[EWALD_NFUNCS] = { 4.0*MY_PI*qscale/volume, 2.0*MY_PI*MY_PIS/(24.0*volume), 2.0*MY_PI*MY_PIS/(192.0*volume), 4.0*MY_PI*mumurd2e/volume}; shape sum[EWALD_MAX_NSUMS]; int func[EWALD_NFUNCS]; memcpy(func, function, EWALD_NFUNCS*sizeof(int)); int i, kx, ky, lbytes = (2*nbox+1)*sizeof(cvector), *type = atom->type; for (int j = 0; j < atom->nlocal; j++) { k = kvec; kx = ky = -1; kv = kvirial; cek = cek_global; memset(sum, 0, EWALD_MAX_NSUMS*sizeof(shape)); if (func[3]) { register double di = c[3]; mui[0] = di*(mu++)[0]; mui[1] = di*(mu++)[0]; mui[2] = di*(mu++)[0]; mu++; } for (nh = (h = hvec)+nkvec; hy) { // based on order in if (kx!=k->x) zx = z[kx = k->x].x; // reallocate C_RMULT(zxy, z[ky = k->y].y, zx); } C_CRMULT(zc, z[k->z].z, zxy); if (func[0]) { // 1/r if (func[3]) cek_coul = cek; register double r = cek->re*zc.re - cek->im*zc.im; ++cek; sum[0][0] += *(kv++)*r; sum[0][1] += *(kv++)*r; sum[0][2] += *(kv++)*r; sum[0][3] += *(kv++)*r; sum[0][4] += *(kv++)*r; sum[0][5] += *(kv++)*r; } if (func[1]) { // geometric 1/r^6 register double r = cek->re*zc.re - cek->im*zc.im; ++cek; sum[1][0] += *(kv++)*r; sum[1][1] += *(kv++)*r; sum[1][2] += *(kv++)*r; sum[1][3] += *(kv++)*r; sum[1][4] += *(kv++)*r; sum[1][5] += *(kv++)*r; } if (func[2]) { // arithmetic 1/r^6 register double r; for (i=2; i<9; ++i) { r = cek->re*zc.re - cek->im*zc.im; ++cek; sum[i][0] += *(kv++)*r; sum[i][1] += *(kv++)*r; sum[i][2] += *(kv++)*r; sum[i][3] += *(kv++)*r; sum[i][4] += *(kv++)*r; sum[i][5] += *(kv++)*r; kv -= 6; } kv += 6; } if (func[3]) { // dipole double muk = (mui[0]*h->x+mui[1]*h->y+mui[2]*h->z); register double r = (cek->re*zc.re - cek->im*zc.im)*muk; sum[9][0] += *(kv++)*r; sum[9][1] += *(kv++)*r; sum[9][2] += *(kv++)*r; sum[9][3] += *(kv++)*r; sum[9][4] += *(kv++)*r; sum[9][5] += *(kv++)*r; if (func[0]) { // charge-dipole kv -= 6; register double qj = *(q)*c[0]; r = (cek_coul->im*zc.re + cek_coul->re*zc.im)*muk; r += -(cek->re*zc.im + cek->im*zc.re)*qj; sum[9][0] += *(kv++)*r; sum[9][1] += *(kv++)*r; sum[9][2] += *(kv++)*r; sum[9][3] += *(kv++)*r; sum[9][4] += *(kv++)*r; sum[9][5] += *(kv++)*r; } ++cek; } } if (func[0]) { // 1/r register double qi = *(q++)*c[0]; for (int n = 0; n < 6; n++) vatomj[n] += sum[0][n]*qi; } if (func[1]) { // geometric 1/r^6 register double bi = B[*type]*c[1]; for (int n = 0; n < 6; n++) vatomj[n] += sum[1][n]*bi; } if (func[2]) { // arithmetic 1/r^6 register double *bj = B+7*type[0]+7; for (i=2; i<9; ++i) { register double c2 = (--bj)[0]*c[2]; for (int n = 0; n < 6; n++) vatomj[n] += 0.5*sum[i][n]*c2; } } if (func[3]) { // dipole for (int n = 0; n < 6; n++) vatomj[n] += sum[9][n]; } for (int k=0; kq; double **x = atom->x; double zprd = domain->zprd; int nlocal = atom->nlocal; double dipole = 0.0; for (int i = 0; i < nlocal; i++) dipole += q[i]*x[i][2]; if (function[3] && atom->mu) { double **mu = atom->mu; for (int i = 0; i < nlocal; i++) dipole += mu[i][2]; } // sum local contributions to get global dipole moment double dipole_all; MPI_Allreduce(&dipole,&dipole_all,1,MPI_DOUBLE,MPI_SUM,world); // need to make non-neutral systems and/or // per-atom energy translationally invariant double dipole_r2 = 0.0; if (eflag_atom || fabs(qsum) > SMALL) { if (function[3] && atom->mu) error->all(FLERR,"Cannot (yet) use kspace slab correction with " "long-range dipoles and non-neutral systems or per-atom energy"); for (int i = 0; i < nlocal; i++) dipole_r2 += q[i]*x[i][2]*x[i][2]; // sum local contributions double tmp; MPI_Allreduce(&dipole_r2,&tmp,1,MPI_DOUBLE,MPI_SUM,world); dipole_r2 = tmp; } // compute corrections const double e_slabcorr = MY_2PI*(dipole_all*dipole_all - qsum*dipole_r2 - qsum*qsum*zprd*zprd/12.0)/volume; const double qscale = force->qqrd2e * scale; if (eflag_global) energy += qscale * e_slabcorr; // per-atom energy if (eflag_atom) { double efact = qscale * MY_2PI/volume; for (int i = 0; i < nlocal; i++) eatom[i] += efact * q[i]*(x[i][2]*dipole_all - 0.5*(dipole_r2 + qsum*x[i][2]*x[i][2]) - qsum*zprd*zprd/12.0); } // add on force corrections double ffact = qscale * (-4.0*MY_PI/volume); double **f = atom->f; for (int i = 0; i < nlocal; i++) f[i][2] += ffact * q[i]*(dipole_all - qsum*x[i][2]); // add on torque corrections if (function[3] && atom->mu && atom->torque) { double **mu = atom->mu; double **torque = atom->torque; for (int i = 0; i < nlocal; i++) { torque[i][0] += ffact * dipole_all * mu[i][1]; torque[i][1] += -ffact * dipole_all * mu[i][0]; } } } /* ---------------------------------------------------------------------- Newton solver used to find g_ewald for LJ systems ------------------------------------------------------------------------- */ double EwaldDisp::NewtonSolve(double x, double Rc, bigint natoms, double vol, double b2) { double dx,tol; int maxit; maxit = 10000; //Maximum number of iterations tol = 0.00001; //Convergence tolerance //Begin algorithm for (int i = 0; i < maxit; i++) { dx = f(x,Rc,natoms,vol,b2) / derivf(x,Rc,natoms,vol,b2); x = x - dx; //Update x if (fabs(dx) < tol) return x; if (x < 0 || x != x) // solver failed return -1; } return -1; } /* ---------------------------------------------------------------------- Calculate f(x) ------------------------------------------------------------------------- */ double EwaldDisp::f(double x, double Rc, bigint natoms, double vol, double b2) { double a = Rc*x; double f = 0.0; if (function[1] || function[2]) { // LJ f = (4.0*MY_PI*b2*powint(x,4)/vol/sqrt((double)natoms)*erfc(a) * (6.0*powint(a,-5) + 6.0*powint(a,-3) + 3.0/a + a) - accuracy); } else { // dipole double rg2 = a*a; double rg4 = rg2*rg2; double rg6 = rg4*rg2; double Cc = 4.0*rg4 + 6.0*rg2 + 3.0; double Dc = 8.0*rg6 + 20.0*rg4 + 30.0*rg2 + 15.0; f = (b2/(sqrt(vol*powint(x,4)*powint(Rc,9)*natoms)) * sqrt(13.0/6.0*Cc*Cc + 2.0/15.0*Dc*Dc - 13.0/15.0*Cc*Dc) * exp(-rg2)) - accuracy; } return f; } /* ---------------------------------------------------------------------- Calculate numerical derivative f'(x) ------------------------------------------------------------------------- */ double EwaldDisp::derivf(double x, double Rc, bigint natoms, double vol, double b2) { double h = 0.000001; //Derivative step-size return (f(x + h,Rc,natoms,vol,b2) - f(x,Rc,natoms,vol,b2)) / h; } diff --git a/src/MANYBODY/pair_nb3b_harmonic.cpp b/src/MANYBODY/pair_nb3b_harmonic.cpp index ae0282293..231119fe2 100644 --- a/src/MANYBODY/pair_nb3b_harmonic.cpp +++ b/src/MANYBODY/pair_nb3b_harmonic.cpp @@ -1,499 +1,499 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator http://lammps.sandia.gov, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains certain rights in this software. This software is distributed under the GNU General Public License. See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- Contributing author: Todd R. Zeitler (SNL) (based on Stillinger-Weber pair style) ------------------------------------------------------------------------- */ #include #include #include #include #include "pair_nb3b_harmonic.h" #include "atom.h" #include "neighbor.h" #include "neigh_request.h" #include "force.h" #include "comm.h" #include "memory.h" #include "neighbor.h" #include "neigh_list.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; #define MAXLINE 1024 #define DELTA 4 #define SMALL 0.001 #define PI 3.141592653589793238462643383279 /* ---------------------------------------------------------------------- */ PairNb3bHarmonic::PairNb3bHarmonic(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; one_coeff = 1; manybody_flag = 1; nelements = 0; elements = NULL; nparams = maxparam = 0; params = NULL; elem2param = NULL; map = NULL; } /* ---------------------------------------------------------------------- check if allocated, since class can be destructed when incomplete ------------------------------------------------------------------------- */ PairNb3bHarmonic::~PairNb3bHarmonic() { if (elements) for (int i = 0; i < nelements; i++) delete [] elements[i]; delete [] elements; memory->destroy(params); memory->destroy(elem2param); if (allocated) { memory->destroy(setflag); memory->destroy(cutsq); delete [] map; } } /* ---------------------------------------------------------------------- */ void PairNb3bHarmonic::compute(int eflag, int vflag) { int i,j,k,ii,jj,kk,inum,jnum,jnumm1; int itype,jtype,ktype,ijparam,ikparam,ijkparam; double xtmp,ytmp,ztmp,evdwl; double rsq1,rsq2; double delr1[3],delr2[3],fj[3],fk[3]; int *ilist,*jlist,*numneigh,**firstneigh; evdwl = 0.0; if (eflag || vflag) ev_setup(eflag,vflag); else evflag = vflag_fdotr = 0; double **x = atom->x; double **f = atom->f; int *type = atom->type; inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; firstneigh = list->firstneigh; // loop over full neighbor list of my atoms for (ii = 0; ii < inum; ii++) { i = ilist[ii]; itype = map[type[i]]; xtmp = x[i][0]; ytmp = x[i][1]; ztmp = x[i][2]; jlist = firstneigh[i]; jnum = numneigh[i]; jnumm1 = jnum - 1; for (jj = 0; jj < jnumm1; jj++) { j = jlist[jj]; j &= NEIGHMASK; jtype = map[type[j]]; ijparam = elem2param[itype][jtype][jtype]; delr1[0] = x[j][0] - xtmp; delr1[1] = x[j][1] - ytmp; delr1[2] = x[j][2] - ztmp; rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; if (rsq1 > params[ijparam].cutsq) continue; for (kk = jj+1; kk < jnum; kk++) { k = jlist[kk]; k &= NEIGHMASK; ktype = map[type[k]]; ikparam = elem2param[itype][ktype][ktype]; ijkparam = elem2param[itype][jtype][ktype]; delr2[0] = x[k][0] - xtmp; delr2[1] = x[k][1] - ytmp; delr2[2] = x[k][2] - ztmp; rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; if (rsq2 > params[ikparam].cutsq) continue; threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); f[i][0] -= fj[0] + fk[0]; f[i][1] -= fj[1] + fk[1]; f[i][2] -= fj[2] + fk[2]; f[j][0] += fj[0]; f[j][1] += fj[1]; f[j][2] += fj[2]; f[k][0] += fk[0]; f[k][1] += fk[1]; f[k][2] += fk[2]; if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); } } } if (vflag_fdotr) virial_fdotr_compute(); } /* ---------------------------------------------------------------------- */ void PairNb3bHarmonic::allocate() { allocated = 1; int n = atom->ntypes; memory->create(setflag,n+1,n+1,"pair:setflag"); memory->create(cutsq,n+1,n+1,"pair:cutsq"); map = new int[n+1]; } /* ---------------------------------------------------------------------- global settings ------------------------------------------------------------------------- */ void PairNb3bHarmonic::settings(int narg, char **arg) { if (narg != 0) error->all(FLERR,"Illegal pair_style command"); } /* ---------------------------------------------------------------------- set coeffs for one or more type pairs ------------------------------------------------------------------------- */ void PairNb3bHarmonic::coeff(int narg, char **arg) { int i,j,n; if (!allocated) allocate(); if (narg != 3 + atom->ntypes) error->all(FLERR,"Incorrect args for pair coefficients"); // insure I,J args are * * if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) error->all(FLERR,"Incorrect args for pair coefficients"); // read args that map atom types to elements in potential file // map[i] = which element the Ith atom type is, -1 if NULL // nelements = # of unique elements // elements = list of element names if (elements) { for (i = 0; i < nelements; i++) delete [] elements[i]; delete [] elements; } elements = new char*[atom->ntypes]; for (i = 0; i < atom->ntypes; i++) elements[i] = NULL; nelements = 0; for (i = 3; i < narg; i++) { if (strcmp(arg[i],"NULL") == 0) { map[i-2] = -1; continue; } for (j = 0; j < nelements; j++) if (strcmp(arg[i],elements[j]) == 0) break; map[i-2] = j; if (j == nelements) { n = strlen(arg[i]) + 1; elements[j] = new char[n]; strcpy(elements[j],arg[i]); nelements++; } } // read potential file and initialize potential parameters read_file(arg[2]); setup_params(); // clear setflag since coeff() called once with I,J = * * n = atom->ntypes; for (int i = 1; i <= n; i++) for (int j = i; j <= n; j++) setflag[i][j] = 0; // set setflag i,j for type pairs where both are mapped to elements int count = 0; for (int i = 1; i <= n; i++) for (int j = i; j <= n; j++) if (map[i] >= 0 && map[j] >= 0) { setflag[i][j] = 1; count++; } if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); } /* ---------------------------------------------------------------------- init specific to this pair style ------------------------------------------------------------------------- */ void PairNb3bHarmonic::init_style() { if (atom->tag_enable == 0) error->all(FLERR,"Pair style nb3b/harmonic requires atom IDs"); if (force->newton_pair == 0) error->all(FLERR,"Pair style nb3b/harmonic requires newton pair on"); // need a full neighbor list int irequest = neighbor->request(this,instance_me); neighbor->requests[irequest]->half = 0; neighbor->requests[irequest]->full = 1; } /* ---------------------------------------------------------------------- init for one type pair i,j and corresponding j,i ------------------------------------------------------------------------- */ double PairNb3bHarmonic::init_one(int i, int j) { if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); return cutmax; } /* ---------------------------------------------------------------------- */ void PairNb3bHarmonic::read_file(char *file) { int params_per_line = 6; char **words = new char*[params_per_line+1]; memory->sfree(params); params = NULL; nparams = maxparam = 0; // open file on proc 0 FILE *fp = NULL; if (comm->me == 0) { fp = force->open_potential(file); if (fp == NULL) { char str[128]; sprintf(str,"Cannot open nb3b/harmonic potential file %s",file); error->one(FLERR,str); } } // read each set of params from potential file // one set of params can span multiple lines // store params if all 3 element tags are in element list int n,nwords,ielement,jelement,kelement; char line[MAXLINE],*ptr; int eof = 0; while (1) { if (comm->me == 0) { ptr = fgets(line,MAXLINE,fp); if (ptr == NULL) { eof = 1; fclose(fp); } else n = strlen(line) + 1; } MPI_Bcast(&eof,1,MPI_INT,0,world); if (eof) break; MPI_Bcast(&n,1,MPI_INT,0,world); MPI_Bcast(line,n,MPI_CHAR,0,world); // strip comment, skip line if blank if ((ptr = strchr(line,'#'))) *ptr = '\0'; nwords = atom->count_words(line); if (nwords == 0) continue; // concatenate additional lines until have params_per_line words while (nwords < params_per_line) { n = strlen(line); if (comm->me == 0) { ptr = fgets(&line[n],MAXLINE-n,fp); if (ptr == NULL) { eof = 1; fclose(fp); } else n = strlen(line) + 1; } MPI_Bcast(&eof,1,MPI_INT,0,world); if (eof) break; MPI_Bcast(&n,1,MPI_INT,0,world); MPI_Bcast(line,n,MPI_CHAR,0,world); if ((ptr = strchr(line,'#'))) *ptr = '\0'; nwords = atom->count_words(line); } if (nwords != params_per_line) error->all(FLERR,"Incorrect format in nb3b/harmonic potential file"); // words = ptrs to all words in line nwords = 0; words[nwords++] = strtok(line," \t\n\r\f"); while ((words[nwords++] = strtok(NULL," \t\n\r\f"))) continue; // ielement,jelement,kelement = 1st args // if all 3 args are in element list, then parse this line // else skip to next entry in file for (ielement = 0; ielement < nelements; ielement++) if (strcmp(words[0],elements[ielement]) == 0) break; if (ielement == nelements) continue; for (jelement = 0; jelement < nelements; jelement++) if (strcmp(words[1],elements[jelement]) == 0) break; if (jelement == nelements) continue; for (kelement = 0; kelement < nelements; kelement++) if (strcmp(words[2],elements[kelement]) == 0) break; if (kelement == nelements) continue; // load up parameter settings and error check their values if (nparams == maxparam) { maxparam += DELTA; params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); } params[nparams].ielement = ielement; params[nparams].jelement = jelement; params[nparams].kelement = kelement; params[nparams].k_theta = atof(words[3]); params[nparams].theta0 = atof(words[4]); params[nparams].cutoff = atof(words[5]); if (params[nparams].k_theta < 0.0 || params[nparams].theta0 < 0.0 || params[nparams].cutoff < 0.0) error->all(FLERR,"Illegal nb3b/harmonic parameter"); nparams++; } delete [] words; } /* ---------------------------------------------------------------------- */ void PairNb3bHarmonic::setup_params() { int i,j,k,m,n; double rtmp; // set elem2param for all triplet combinations // must be a single exact match to lines read from file // do not allow for ACB in place of ABC memory->destroy(elem2param); memory->create(elem2param,nelements,nelements,nelements,"pair:elem2param"); for (i = 0; i < nelements; i++) for (j = 0; j < nelements; j++) for (k = 0; k < nelements; k++) { n = -1; for (m = 0; m < nparams; m++) { if (i == params[m].ielement && j == params[m].jelement && k == params[m].kelement) { if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); n = m; } } -// if (n < 0) error->all(FLERR,"Potential file is missing an entry"); + if (n < 0) error->all(FLERR,"Potential file is missing an entry"); elem2param[i][j][k] = n; } // compute parameter values derived from inputs // set cutsq using shortcut to reduce neighbor list for accelerated // calculations. cut must remain unchanged as it is a potential parameter // (cut = a*sigma) for (m = 0; m < nparams; m++) { params[m].cut = params[m].cutoff; params[m].cutsq = params[m].cut * params[m].cut; params[m].theta0 = params[m].theta0 / 180.0 * PI; } // set cutmax to max of all params cutmax = 0.0; for (m = 0; m < nparams; m++) { rtmp = sqrt(params[m].cutsq); if (rtmp > cutmax) cutmax = rtmp; } } /* ---------------------------------------------------------------------- */ void PairNb3bHarmonic::threebody(Param *paramij, Param *paramik, Param *paramijk, double rsq1, double rsq2, double *delr1, double *delr2, double *fj, double *fk, int eflag, double &eng) { double dtheta,tk; double r1,r2,c,s,a,a11,a12,a22; // angle (cos and sin) r1 = sqrt(rsq1); r2 = sqrt(rsq2); c = delr1[0]*delr2[0] + delr1[1]*delr2[1] + delr1[2]*delr2[2]; c /= r1*r2; if (c > 1.0) c = 1.0; if (c < -1.0) c = -1.0; s = sqrt(1.0 - c*c); if (s < SMALL) s = SMALL; s = 1.0/s; // force & energy dtheta = acos(c) - paramijk->theta0; tk = paramijk->k_theta * dtheta; if (eflag) eng = tk*dtheta; a = -2.0 * tk * s; a11 = a*c / rsq1; a12 = -a / (r1*r2); a22 = a*c / rsq2; fj[0] = a11*delr1[0] + a12*delr2[0]; fj[1] = a11*delr1[1] + a12*delr2[1]; fj[2] = a11*delr1[2] + a12*delr2[2]; fk[0] = a22*delr2[0] + a12*delr1[0]; fk[1] = a22*delr2[1] + a12*delr1[1]; fk[2] = a22*delr2[2] + a12*delr1[2]; } diff --git a/src/USER-QMMM/fix_qmmm.cpp b/src/USER-QMMM/fix_qmmm.cpp index 4db40fe84..4ee472cfa 100644 --- a/src/USER-QMMM/fix_qmmm.cpp +++ b/src/USER-QMMM/fix_qmmm.cpp @@ -1,847 +1,847 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator http://lammps.sandia.gov, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains certain rights in this software. This software is distributed under the GNU General Public License. See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- Contributing author: Axel Kohlmeyer (ICTP) ------------------------------------------------------------------------- */ #include "fix_qmmm.h" #include "atom.h" #include "domain.h" #include "comm.h" #include "update.h" #include "force.h" #include "error.h" #include "group.h" #include "memory.h" #include #include #include "libqmmm.h" // message tags for QM/MM inter communicator communication // have to match with those from the QM code enum {QMMM_TAG_OTHER=0, QMMM_TAG_SIZE=1, QMMM_TAG_COORD=2, QMMM_TAG_FORCE=3, QMMM_TAG_FORCE2=4, QMMM_TAG_CELL=5, QMMM_TAG_RADII=6, QMMM_TAG_CHARGE=7, QMMM_TAG_TYPE=8, QMMM_TAG_MASS=9}; using namespace LAMMPS_NS; using namespace FixConst; // prototypes for local helper functions static int match_element(double mass, int search_isotopes, double &delta); /****************************************************************************/ /* re-usable integer hash table code with static linkage. */ /** hash table top level data structure */ typedef struct taginthash_t { struct taginthash_node_t **bucket; /* array of hash nodes */ tagint size; /* size of the array */ tagint entries; /* number of entries in table */ tagint downshift; /* shift cound, used in hash function */ tagint mask; /* used to select bits for hashing */ } taginthash_t; /** hash table node data structure */ typedef struct taginthash_node_t { tagint data; /* data in hash node */ tagint key; /* key for hash lookup */ struct taginthash_node_t *next; /* next node in hash chain */ } taginthash_node_t; #define HASH_FAIL -1 #define HASH_LIMIT 0.5 /* initialize new hash table */ static void taginthash_init(taginthash_t *tptr, tagint buckets); /* lookup entry in hash table */ static tagint taginthash_lookup(const taginthash_t *tptr, tagint key); /* generate list of keys for reverse lookups. */ static tagint *taginthash_keys(taginthash_t *tptr); /* insert an entry into hash table. */ static tagint taginthash_insert(taginthash_t *tptr, tagint key, tagint data); /* delete the hash table */ static void taginthash_destroy(taginthash_t *tptr); /* adapted sort for in-place sorting of map indices. */ static void id_sort(tagint *idmap, tagint left, tagint right); /************************************************************************ * integer hash code: ************************************************************************/ /* taginthash() - Hash function returns a hash number for a given key. * tptr: Pointer to a hash table, key: The key to create a hash number for */ static tagint taginthash(const taginthash_t *tptr, tagint key) { tagint hashvalue; hashvalue = (((key*1103515249)>>tptr->downshift) & tptr->mask); if (hashvalue < 0) { hashvalue = 0; } return hashvalue; } /* * rebuild_table_tagint() - Create new hash table when old one fills up. * * tptr: Pointer to a hash table */ static void rebuild_table_tagint(taginthash_t *tptr) { taginthash_node_t **old_bucket, *old_hash, *tmp; tagint old_size, h, i; old_bucket=tptr->bucket; old_size=tptr->size; /* create a new table and rehash old buckets */ taginthash_init(tptr, old_size<<1); for (i=0; inext; h=taginthash(tptr, tmp->key); tmp->next=tptr->bucket[h]; tptr->bucket[h]=tmp; tptr->entries++; } /* while */ } /* for */ /* free memory used by old table */ free(old_bucket); return; } /* * taginthash_init() - Initialize a new hash table. * * tptr: Pointer to the hash table to initialize * buckets: The number of initial buckets to create */ void taginthash_init(taginthash_t *tptr, tagint buckets) { /* make sure we allocate something */ if (buckets==0) buckets=16; /* initialize the table */ tptr->entries=0; tptr->size=2; tptr->mask=1; tptr->downshift=29; /* ensure buckets is a power of 2 */ while (tptr->sizesize<<=1; tptr->mask=(tptr->mask<<1)+1; tptr->downshift--; } /* while */ /* allocate memory for table */ tptr->bucket=(taginthash_node_t **) calloc(tptr->size, sizeof(taginthash_node_t *)); return; } /* * taginthash_lookup() - Lookup an entry in the hash table and return a pointer to * it or HASH_FAIL if it wasn't found. * * tptr: Pointer to the hash table * key: The key to lookup */ tagint taginthash_lookup(const taginthash_t *tptr, tagint key) { tagint h; taginthash_node_t *node; /* find the entry in the hash table */ h=taginthash(tptr, key); for (node=tptr->bucket[h]; node!=NULL; node=node->next) { if (node->key == key) break; } /* return the entry if it exists, or HASH_FAIL */ return(node ? node->data : HASH_FAIL); } /* * taginthash_keys() - Return a list of keys. * NOTE: the returned list must be freed with free(3). */ tagint *taginthash_keys(taginthash_t *tptr) { tagint *keys; taginthash_node_t *node; keys = (tagint *)calloc(tptr->entries, sizeof(tagint)); for (tagint i=0; i < tptr->size; ++i) { for (node=tptr->bucket[i]; node != NULL; node=node->next) { keys[node->data] = node->key; } } return keys; } /* * taginthash_insert() - Insert an entry into the hash table. If the entry already * exists return a pointer to it, otherwise return HASH_FAIL. * * tptr: A pointer to the hash table * key: The key to insert into the hash table * data: A pointer to the data to insert into the hash table */ tagint taginthash_insert(taginthash_t *tptr, tagint key, tagint data) { tagint tmp; taginthash_node_t *node; tagint h; /* check to see if the entry exists */ if ((tmp=taginthash_lookup(tptr, key)) != HASH_FAIL) return(tmp); /* expand the table if needed */ while (tptr->entries>=HASH_LIMIT*tptr->size) rebuild_table_tagint(tptr); /* insert the new entry */ h=taginthash(tptr, key); node=(struct taginthash_node_t *) malloc(sizeof(taginthash_node_t)); node->data=data; node->key=key; node->next=tptr->bucket[h]; tptr->bucket[h]=node; tptr->entries++; return HASH_FAIL; } /* * taginthash_destroy() - Delete the entire table, and all remaining entries. * */ void taginthash_destroy(taginthash_t *tptr) { taginthash_node_t *node, *last; tagint i; for (i=0; isize; i++) { node = tptr->bucket[i]; while (node != NULL) { last = node; node = node->next; free(last); } } /* free the entire array of buckets */ if (tptr->bucket != NULL) { free(tptr->bucket); memset(tptr, 0, sizeof(taginthash_t)); } } /************************************************************************ * integer list sort code: ************************************************************************/ /* sort for integer map. initial call id_sort(idmap, 0, natoms - 1); */ static void id_sort(tagint *idmap, tagint left, tagint right) { tagint pivot, l_hold, r_hold; l_hold = left; r_hold = right; pivot = idmap[left]; while (left < right) { while ((idmap[right] >= pivot) && (left < right)) right--; if (left != right) { idmap[left] = idmap[right]; left++; } while ((idmap[left] <= pivot) && (left < right)) left++; if (left != right) { idmap[right] = idmap[left]; right--; } } idmap[left] = pivot; pivot = left; left = l_hold; right = r_hold; if (left < pivot) id_sort(idmap, left, pivot-1); if (right > pivot) id_sort(idmap, pivot+1, right); } /****************************************************************************/ /* struct for packed data communication of coordinates and forces. */ struct commdata { tagint tag; float x,y,z; float q; }; /*************************************************************** * create class and parse arguments in LAMMPS script. Syntax: * fix ID group-ID qmmm [couple ] ***************************************************************/ FixQMMM::FixQMMM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { if (narg > 5) error->all(FLERR,"Illegal fix qmmm command"); if (strcmp(update->unit_style,"metal") == 0) { qmmm_fscale = 1.0/23.0609; } else if (strcmp(update->unit_style,"real") == 0) { qmmm_fscale = 1.0; } else error->all(FLERR,"Fix qmmm requires real or metal units"); if (atom->tag_enable == 0) error->all(FLERR,"Fix qmmm requires atom IDs"); if (atom->tag_consecutive() == 0) error->all(FLERR,"Fix qmmm requires consecutive atom IDs"); /* define ec coupling group */ mm_group = group->find("all"); if ((narg == 5) && (0 == strcmp(arg[0],"couple"))) { #if 0 /* ignore ES coupling group for now */ mm_group = group->find(arg[4]); #endif } else if (narg != 3) error->all(FLERR,"Illegal fix qmmm command"); if (mm_group == -1) error->all(FLERR,"Could not find fix qmmm couple group ID"); /* retrieve settings from global QM/MM configuration struct */ comm_mode = qmmmcfg.comm_mode; qmmm_mode = qmmmcfg.qmmm_mode; qmmm_role = qmmmcfg.role; verbose = qmmmcfg.verbose; if (comm_mode != QMMM_COMM_MPI) error->all(FLERR,"Only MPI communication mode is currently supported"); if ((qmmm_role != QMMM_ROLE_MASTER) && (qmmm_role != QMMM_ROLE_SLAVE)) error->all(FLERR,"LAMMPS can only function as MM master or MM slave"); qm_comm = MPI_Comm_f2c(qmmmcfg.qm_comm); mm_comm = MPI_Comm_f2c(qmmmcfg.mm_comm); /* initialize storage */ qm_idmap = mm_idmap = NULL; qm_remap = mm_remap = NULL; qm_coord = mm_coord = qm_force = mm_force = NULL; qm_charge =NULL; mm_type = NULL; do_init = 1; /* storage required to communicate a single coordinate or force. */ size_one = sizeof(struct commdata); maxbuf = -1; } /********************************* * Clean up on deleting the fix. * *********************************/ FixQMMM::~FixQMMM() { if (qm_idmap) { taginthash_t *hashtable = (taginthash_t *)qm_idmap; taginthash_destroy(hashtable); delete hashtable; free(qm_remap); } memory->destroy(comm_buf); memory->destroy(qm_coord); memory->destroy(qm_force); memory->destroy(qm_charge); } /* ---------------------------------------------------------------------- */ int FixQMMM::setmask() { int mask = 0; mask |= POST_INTEGRATE; mask |= POST_FORCE; return mask; } /* ---------------------------------------------------------------------- */ void FixQMMM::exchange_positions() { double **x = atom->x; double *charge = atom->q; - const int * const mask = atom->mask; - const int * const type = atom->type; + int * const mask = atom->mask; + int * const type = atom->type; double * const mass = atom->mass; tagint * const tag = atom->tag; const int nlocal = atom->nlocal; const int ntypes = atom->ntypes; const int natoms = (int) atom->natoms; if (atom->natoms > MAXSMALLINT) error->all(FLERR,"Too many MM atoms for fix qmmmm"); /* * CHECK * AK: this is not good. atom->natoms can be huge. instead: - collect list of atom tags (from local and remoted full MM procs) that match fix qmmm group - sort list -> master list of QM/MM interacting atoms - create hash table that connects master list index with tag - collect necessary data and get master list index via hash table */ if (comm->me == 0) { // Pack various cell dimension properties into one chunk. double celldata[9]; celldata[0] = domain->boxlo[0]; celldata[1] = domain->boxlo[1]; celldata[2] = domain->boxlo[2]; celldata[3] = domain->boxhi[0]; celldata[4] = domain->boxhi[1]; celldata[5] = domain->boxhi[2]; celldata[6] = domain->xy; celldata[7] = domain->xz; celldata[8] = domain->yz; if (qmmm_role == QMMM_ROLE_MASTER) { int isend_buf[4]; isend_buf[0] = natoms; isend_buf[1] = num_qm; isend_buf[2] = num_mm; isend_buf[3] = ntypes; MPI_Send(isend_buf, 4, MPI_INT, 1, QMMM_TAG_SIZE, qm_comm); MPI_Send(celldata, 9, MPI_DOUBLE, 1, QMMM_TAG_CELL, qm_comm); } if (verbose > 0) { if (screen) fputs("QMMM: exchange positions\n",screen); if (logfile) fputs("QMMM: exchange positions\n",logfile); } } if (qmmm_role == QMMM_ROLE_MASTER) { int i; double *mm_coord_all = (double *) calloc(3*natoms, sizeof(double)); double *mm_charge_all = (double *) calloc(natoms, sizeof(double)); int *mm_mask_all = (int *) calloc(natoms, sizeof(int)); /* check and potentially grow local communication buffers. */ if (atom->nmax*size_one > maxbuf) { memory->destroy(comm_buf); maxbuf = atom->nmax*size_one; comm_buf = memory->smalloc(maxbuf,"qmmm:comm_buf"); } if (comm->me == 0) { // insert local atoms into comm buffer and global arrays for (i=0; ione(FLERR,"Cannot handle parallel MM (yet)"); } } else if (qmmm_role == QMMM_ROLE_SLAVE) { MPI_Recv(qm_coord, 3*num_qm, MPI_DOUBLE, 0, QMMM_TAG_COORD, mm_comm, MPI_STATUS_IGNORE); // not needed for as long as we allow only one MPI task as slave MPI_Bcast(qm_coord, 3*num_qm, MPI_DOUBLE,0,world); /* update coordinates of (QM) atoms */ for (int i=0; i < nlocal; ++i) { if (mask[i] & groupbit) { for (int j=0; j < num_qm; ++j) { if (tag[i] == qm_remap[j]) { x[i][0] = qm_coord[3*j]; x[i][1] = qm_coord[3*j+1]; x[i][2] = qm_coord[3*j+2]; } } } } } return; } /* ---------------------------------------------------------------------- */ void FixQMMM::exchange_forces() { double **f = atom->f; const int * const mask = atom->mask; const tagint * const tag = atom->tag; const int nlocal = atom->nlocal; const int natoms = (int) atom->natoms; if ((comm->me) == 0 && (verbose > 0)) { if (screen) fputs("QMMM: exchange forces\n",screen); if (logfile) fputs("QMMM: exchange forces\n",logfile); } if (qmmm_role == QMMM_ROLE_MASTER) { struct commdata *buf = static_cast(comm_buf); double *mm_force_all = (double *) calloc(natoms*3, sizeof(double)); double *mm_force_on_qm_atoms = qm_coord; // use qm_coord as a buffer if (comm->me == 0) { // receive QM forces from QE MPI_Recv(qm_force,3*num_qm,MPI_DOUBLE,1,QMMM_TAG_FORCE,qm_comm,MPI_STATUS_IGNORE); // receive ec contribution to MM forces from QE MPI_Recv(mm_force_all,3*natoms,MPI_DOUBLE,1,QMMM_TAG_FORCE2,qm_comm,MPI_STATUS_IGNORE); // receive MM forces from LAMMPS MPI_Recv( mm_force_on_qm_atoms, 3*num_qm,MPI_DOUBLE,1,QMMM_TAG_FORCE,mm_comm,MPI_STATUS_IGNORE); // subtract MM forces from QM forces to get the delta // NOTE: QM forces are always sent in "real" units, // so we need to apply the scaling factor to get to the // supported internal units ("metal" or "real") for (int i=0; i < num_qm; ++i) { if (verbose > 1) { const char fmt[] = "[" TAGINT_FORMAT "]: QM(%g %g %g) MM(%g %g %g) /\\(%g %g %g)\n"; if (screen) fprintf(screen, fmt, qm_remap[i], qmmm_fscale*qm_force[3*i+0], qmmm_fscale*qm_force[3*i+1], qmmm_fscale*qm_force[3*i+2], mm_force_on_qm_atoms[3*i+0], mm_force_on_qm_atoms[3*i+1], mm_force_on_qm_atoms[3*i+2], qmmm_fscale*qm_force[3*i+0] - mm_force_on_qm_atoms[3*i+0], qmmm_fscale*qm_force[3*i+1] - mm_force_on_qm_atoms[3*i+1], qmmm_fscale*qm_force[3*i+2] - mm_force_on_qm_atoms[3*i+2]); if (logfile) fprintf(logfile, fmt, qm_remap[i], qmmm_fscale*qm_force[3*i+0], qmmm_fscale*qm_force[3*i+1], qmmm_fscale*qm_force[3*i+2], mm_force_on_qm_atoms[3*i+0], mm_force_on_qm_atoms[3*i+1], mm_force_on_qm_atoms[3*i+2], qmmm_fscale*qm_force[3*i+0] - mm_force_on_qm_atoms[3*i+0], qmmm_fscale*qm_force[3*i+1] - mm_force_on_qm_atoms[3*i+1], qmmm_fscale*qm_force[3*i+2] - mm_force_on_qm_atoms[3*i+2]); } buf[i].tag = qm_remap[i]; buf[i].x = qmmm_fscale*qm_force[3*i+0] - mm_force_on_qm_atoms[3*i+0]; buf[i].y = qmmm_fscale*qm_force[3*i+1] - mm_force_on_qm_atoms[3*i+1]; buf[i].z = qmmm_fscale*qm_force[3*i+2] - mm_force_on_qm_atoms[3*i+2]; } } MPI_Bcast(comm_buf,num_qm*size_one,MPI_BYTE,0,world); // Inefficient... use buffers. MPI_Bcast(mm_force_all,natoms*3,MPI_DOUBLE,0,world); /* apply forces resulting from QM/MM coupling */ if (qmmm_mode == QMMM_MODE_MECH) { for (int i=0; i < nlocal; ++i) { if (mask[i] & groupbit) { for (int j=0; j < num_qm; ++j) { if (tag[i] == buf[j].tag) { f[i][0] += buf[j].x; f[i][1] += buf[j].y; f[i][2] += buf[j].z; } } } } } else if (qmmm_mode == QMMM_MODE_ELEC) { for (int i=0; i < nlocal; ++i) { if (mask[i] & groupbit) { for (int j=0; j < num_qm; ++j) { if (tag[i] == buf[j].tag) { f[i][0] += buf[j].x; f[i][1] += buf[j].y; f[i][2] += buf[j].z; } } } else { const int k = (int) tag[i]-1; f[i][0] += qmmm_fscale * mm_force_all[ 3*k + 0 ]; f[i][1] += qmmm_fscale * mm_force_all[ 3*k + 1 ]; f[i][2] += qmmm_fscale * mm_force_all[ 3*k + 2 ]; } } } free(mm_force_all); } else if (qmmm_role == QMMM_ROLE_SLAVE) { // use qm_force and qm_coord as communication buffer double * mm_force_on_qm_atoms = qm_force; double * reduced_mm_force_on_qm_atoms = qm_coord; memset( mm_force_on_qm_atoms, 0, 3*num_qm*sizeof(double) ); for (int i=0; i < nlocal; ++i) { if (mask[i] & groupbit) { const int j = 3*taginthash_lookup((taginthash_t *)qm_idmap, tag[i]); if (j != 3*HASH_FAIL) { mm_force_on_qm_atoms[j] = f[i][0]; mm_force_on_qm_atoms[j+1] = f[i][1]; mm_force_on_qm_atoms[j+2] = f[i][2]; } } } // collect and send MM slave forces to MM master // the reduction is not really needed with only one rank (for now) MPI_Reduce(mm_force_on_qm_atoms, reduced_mm_force_on_qm_atoms, 3*num_qm, MPI_DOUBLE, MPI_SUM, 0, world); // use qm_coord array as a communication buffer MPI_Send(reduced_mm_force_on_qm_atoms, 3*num_qm, MPI_DOUBLE, 0, QMMM_TAG_FORCE, mm_comm); } return; } /* ---------------------------------------------------------------------- */ void FixQMMM::init() { if (strstr(update->integrate_style,"respa")) error->all(FLERR,"Fix qmmm does not currently support r-RESPA"); if (do_init) { int me = comm->me; do_init = 0; if (qmmm_role == QMMM_ROLE_MASTER) { MPI_Request req[2]; int nat[2]; if (me == 0) { // receive number of QM atoms from QE MPI_Irecv(nat, 1, MPI_INT, 1, QMMM_TAG_SIZE, qm_comm, req); // receive number of QM atoms from MM slave MPI_Irecv(nat+1, 1, MPI_INT, 1, QMMM_TAG_SIZE, mm_comm, req+1); MPI_Waitall(2,req,MPI_STATUS_IGNORE); } // broadcast across MM master processes MPI_Bcast(nat, 2, MPI_INT, 0, world); num_qm = group->count(igroup); num_mm = group->count(mm_group); // consistency check. the fix group and the QM and MM slave if ((num_qm != nat[0]) || (num_qm != nat[1])) error->all(FLERR,"Inconsistent number of QM/MM atoms"); memory->create(qm_coord,3*num_qm,"qmmm:qm_coord"); memory->create(qm_charge,num_qm,"qmmm:qm_charge"); memory->create(qm_force,3*num_qm,"qmmm:qm_force"); const char fmt1[] = "Initializing QM/MM master with %d QM atoms\n"; const char fmt2[] = "Initializing QM/MM master with %d MM atoms\n"; const char fmt3[] = "Electrostatic coupling with %d atoms\n"; if (screen) { fprintf(screen,fmt1,num_qm); fprintf(screen,fmt2,num_mm); if (qmmm_mode == QMMM_MODE_ELEC) fprintf(screen,fmt3,num_mm-num_qm); } if (logfile) { fprintf(logfile,fmt1,num_qm); fprintf(logfile,fmt2,num_mm); if (qmmm_mode == QMMM_MODE_ELEC) fprintf(logfile,fmt3,num_mm-num_qm); } } else if (qmmm_role == QMMM_ROLE_SLAVE) { num_qm = group->count(igroup); if (me == 0) { /* send number of QM atoms to MM-master for confirmation */ MPI_Send(&num_qm, 1, MPI_INT, 0, QMMM_TAG_SIZE, mm_comm); } memory->create(qm_coord,3*num_qm,"qmmm:qm_coord"); memory->create(qm_force,3*num_qm,"qmmm:qm_force"); const char fmt[] = "Initializing QM/MM slave with %d QM atoms\n"; if (screen) fprintf(screen,fmt,num_qm); if (logfile) fprintf(logfile,fmt,num_qm); } // communication buffer maxbuf = atom->nmax*size_one; comm_buf = (void *) memory->smalloc(maxbuf,"qmmm:comm_buf"); /* initialize and build hashtable to map QM atoms */ taginthash_t *qm_hash=new taginthash_t; taginthash_init(qm_hash, num_qm); qm_idmap = (void *)qm_hash; const int nlocal = atom->nlocal; int i, j, tmp, ndata, qm_ntag; tagint *tag = atom->tag; int *mask = atom->mask; struct commdata *buf = static_cast(comm_buf); if (me == 0) { MPI_Status status; MPI_Request request; tagint *qm_taglist = new tagint[num_qm]; qm_ntag = 0; for (i=0; i < nlocal; ++i) { if (mask[i] & groupbit) qm_taglist[qm_ntag++] = tag[i]; } /* loop over procs to receive remote data */ for (i=1; i < comm->nprocs; ++i) { MPI_Irecv(comm_buf, maxbuf, MPI_BYTE, i, 0, world, &request); MPI_Send(&tmp, 0, MPI_INT, i, 0, world); MPI_Wait(&request, &status); MPI_Get_count(&status, MPI_BYTE, &ndata); ndata /= size_one; for (j=0; j < ndata; ++j) { qm_taglist[qm_ntag++] = buf[j].tag; } } /* sort list of tags by value to have consistently the * same list when running in parallel and build hash table. */ id_sort(qm_taglist, 0, num_qm-1); for (i=0; i < num_qm; ++i) { taginthash_insert(qm_hash, qm_taglist[i], i); } delete[] qm_taglist; /* generate reverse index-to-tag map for communicating * qm/mm forces back to the proper atoms */ qm_remap=taginthash_keys(qm_hash); if (verbose > 1) { const char fmt[] = "qm_remap[%d]=" TAGINT_FORMAT " qm_hash[" TAGINT_FORMAT "]=" TAGINT_FORMAT "\n"; // print hashtable and reverse mapping for (i=0; i < num_qm; ++i) { if (screen) fprintf(screen,fmt,i,qm_remap[i],qm_remap[i], taginthash_lookup(qm_hash, qm_remap[i])); if (logfile) fprintf(logfile,fmt,i,qm_remap[i],qm_remap[i], taginthash_lookup(qm_hash, qm_remap[i])); } } } else { j = 0; for (i=0; i < nlocal; ++i) { if (mask[i] & groupbit) { buf[j].x = -1.0; buf[j].tag = tag[i]; ++j; } } /* blocking receive to wait until it is our turn to send data. */ MPI_Recv(&tmp, 0, MPI_INT, 0, 0, world, MPI_STATUS_IGNORE); MPI_Rsend(comm_buf, j*size_one, MPI_BYTE, 0, 0, world); } // finally, after all is set up, do a first position synchronization exchange_positions(); } } /* ---------------------------------------------------------------------- */ void FixQMMM::post_integrate() { exchange_positions(); } /* ---------------------------------------------------------------------- */ void FixQMMM::setup(int) { exchange_forces(); } /* ---------------------------------------------------------------------- */ void FixQMMM::post_force(int vflag) { exchange_forces(); } /* ---------------------------------------------------------------------- */ /* local memory usage. approximately. */ double FixQMMM::memory_usage(void) { double bytes; bytes = sizeof(FixQMMM); bytes += maxbuf; bytes += 6*num_qm*sizeof(double); return bytes; } // Local Variables: // mode: c++ // compile-command: "make -j4 openmpi" // c-basic-offset: 2 // fill-column: 76 // indent-tabs-mode: nil // End: diff --git a/src/fix_ave_histo.cpp b/src/fix_ave_histo.cpp index 9123a8561..1255aade3 100644 --- a/src/fix_ave_histo.cpp +++ b/src/fix_ave_histo.cpp @@ -1,1074 +1,1074 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator http://lammps.sandia.gov, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains certain rights in this software. This software is distributed under the GNU General Public License. See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ #include #include #include #include "fix_ave_histo.h" #include "atom.h" #include "update.h" #include "modify.h" #include "compute.h" #include "group.h" #include "input.h" #include "variable.h" #include "memory.h" #include "error.h" #include "force.h" using namespace LAMMPS_NS; using namespace FixConst; enum{X,V,F,COMPUTE,FIX,VARIABLE}; enum{ONE,RUNNING}; enum{SCALAR,VECTOR,WINDOW}; enum{GLOBAL,PERATOM,LOCAL}; enum{IGNORE,END,EXTRA}; #define INVOKED_SCALAR 1 #define INVOKED_VECTOR 2 #define INVOKED_ARRAY 4 #define INVOKED_PERATOM 8 #define INVOKED_LOCAL 16 #define BIG 1.0e20 /* ---------------------------------------------------------------------- */ FixAveHisto::FixAveHisto(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { if (narg < 10) error->all(FLERR,"Illegal fix ave/histo command"); MPI_Comm_rank(world,&me); nevery = force->inumeric(FLERR,arg[3]); nrepeat = force->inumeric(FLERR,arg[4]); nfreq = force->inumeric(FLERR,arg[5]); global_freq = nfreq; vector_flag = 1; size_vector = 4; extvector = 0; array_flag = 1; size_array_cols = 3; extarray = 0; dynamic_group_allow = 1; lo = force->numeric(FLERR,arg[6]); hi = force->numeric(FLERR,arg[7]); nbins = force->inumeric(FLERR,arg[8]); // scan values to count them // then read options so know mode = SCALAR/VECTOR before re-reading values nvalues = 0; int iarg = 9; while (iarg < narg) { if (strcmp(arg[iarg],"x") == 0 || strcmp(arg[iarg],"y") == 0 || strcmp(arg[iarg],"z") == 0 || strcmp(arg[iarg],"vx") == 0 || strcmp(arg[iarg],"vy") == 0 || strcmp(arg[iarg],"vz") == 0 || strcmp(arg[iarg],"fx") == 0 || strcmp(arg[iarg],"fy") == 0 || strcmp(arg[iarg],"fz") == 0 || strncmp(arg[iarg],"c_",2) == 0 || strncmp(arg[iarg],"f_",2) == 0 || strncmp(arg[iarg],"v_",2) == 0) { nvalues++; iarg++; } else break; } options(narg,arg); // parse values until one isn't recognized // if mode = VECTOR and value is a global array: // expand it as if columns listed one by one // adjust nvalues accordingly via maxvalues which = argindex = value2index = NULL; ids = NULL; int maxvalues = nvalues; allocate_values(maxvalues); nvalues = 0; iarg = 9; while (iarg < narg) { if (strcmp(arg[iarg],"x") == 0) { which[nvalues] = X; argindex[nvalues] = 0; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"y") == 0) { which[nvalues] = X; argindex[nvalues] = 1; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"z") == 0) { which[nvalues] = X; argindex[nvalues] = 2; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"vx") == 0) { which[nvalues] = V; argindex[nvalues] = 0; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"vy") == 0) { which[nvalues] = V; argindex[nvalues] = 1; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"vz") == 0) { which[nvalues] = V; argindex[nvalues] = 2; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"fx") == 0) { which[nvalues] = F; argindex[nvalues] = 0; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"fy") == 0) { which[nvalues] = F; argindex[nvalues] = 1; ids[nvalues] = NULL; nvalues++; iarg++; } else if (strcmp(arg[iarg],"fz") == 0) { which[nvalues] = F; argindex[nvalues] = 2; ids[nvalues] = NULL; nvalues++; iarg++; } else if ((strncmp(arg[iarg],"c_",2) == 0) || (strncmp(arg[iarg],"f_",2) == 0) || (strncmp(arg[iarg],"v_",2) == 0)) { if (arg[iarg][0] == 'c') which[nvalues] = COMPUTE; else if (arg[iarg][0] == 'f') which[nvalues] = FIX; else if (arg[iarg][0] == 'v') which[nvalues] = VARIABLE; int n = strlen(arg[iarg]); char *suffix = new char[n]; strcpy(suffix,&arg[iarg][2]); char *ptr = strchr(suffix,'['); if (ptr) { if (suffix[strlen(suffix)-1] != ']') error->all(FLERR,"Illegal fix ave/histo command"); argindex[nvalues] = atoi(ptr+1); *ptr = '\0'; } else argindex[nvalues] = 0; n = strlen(suffix) + 1; ids[nvalues] = new char[n]; strcpy(ids[nvalues],suffix); delete [] suffix; if (mode == VECTOR && which[nvalues] == COMPUTE && argindex[nvalues] == 0) { int icompute = modify->find_compute(ids[nvalues]); if (icompute < 0) error->all(FLERR,"Compute ID for fix ave/histo does not exist"); if (modify->compute[icompute]->array_flag) { int ncols = modify->compute[icompute]->size_array_cols; maxvalues += ncols-1; allocate_values(maxvalues); argindex[nvalues] = 1; for (int icol = 1; icol < ncols; icol++) { which[nvalues+icol] = which[nvalues]; argindex[nvalues+icol] = icol+1; n = strlen(ids[nvalues]) + 1; ids[nvalues+icol] = new char[n]; strcpy(ids[nvalues+icol],ids[nvalues]); } nvalues += ncols-1; } } else if (mode == VECTOR && which[nvalues] == FIX && argindex[nvalues] == 0) { int ifix = modify->find_fix(ids[nvalues]); if (ifix < 0) error->all(FLERR,"Fix ID for fix ave/histo does not exist"); if (modify->fix[ifix]->array_flag) { int ncols = modify->fix[ifix]->size_array_cols; maxvalues += ncols-1; allocate_values(maxvalues); argindex[nvalues] = 1; for (int icol = 1; icol < ncols; icol++) { which[nvalues+icol] = which[nvalues]; argindex[nvalues+icol] = icol+1; n = strlen(ids[nvalues]) + 1; ids[nvalues+icol] = new char[n]; strcpy(ids[nvalues+icol],ids[nvalues]); } nvalues += ncols-1; } } nvalues++; iarg++; } else break; } // setup and error check // kind = inputs are all global, or all per-atom, or all local // for fix inputs, check that fix frequency is acceptable if (nevery <= 0 || nrepeat <= 0 || nfreq <= 0) error->all(FLERR,"Illegal fix ave/histo command"); if (nfreq % nevery || nrepeat*nevery > nfreq) error->all(FLERR,"Illegal fix ave/histo command"); if (lo >= hi) error->all(FLERR,"Illegal fix ave/histo command"); if (nbins <= 0) error->all(FLERR,"Illegal fix ave/histo command"); if (ave != RUNNING && overwrite) error->all(FLERR,"Illegal fix ave/histo command"); int kindflag; for (int i = 0; i < nvalues; i++) { if (which[i] == X || which[i] == V || which[i] == F) kindflag = PERATOM; else if (which[i] == COMPUTE) { Compute *compute = modify->compute[modify->find_compute(ids[0])]; if (compute->scalar_flag || compute->vector_flag || compute->array_flag) kindflag = GLOBAL; else if (compute->peratom_flag) kindflag = PERATOM; else if (compute->local_flag) kindflag = LOCAL; else error->all(FLERR,"Fix ave/histo input is invalid compute"); } else if (which[i] == FIX) { Fix *fix = modify->fix[modify->find_fix(ids[0])]; if (fix->scalar_flag || fix->vector_flag || fix->array_flag) kindflag = GLOBAL; else if (fix->peratom_flag) kindflag = PERATOM; else if (fix->local_flag) kindflag = LOCAL; else error->all(FLERR,"Fix ave/histo input is invalid fix"); } else if (which[i] == VARIABLE) { int ivariable = input->variable->find(ids[i]); if (input->variable->equalstyle(ivariable)) kindflag = GLOBAL; else if (input->variable->atomstyle(ivariable)) kindflag = PERATOM; else error->all(FLERR,"Fix ave/histo input is invalid variable"); } if (i == 0) kind = kindflag; else if (kindflag != kind) error->all(FLERR, "Fix ave/histo inputs are not all global, peratom, or local"); } if (kind == PERATOM && mode == SCALAR) error->all(FLERR, "Fix ave/histo cannot input per-atom values in scalar mode"); if (kind == LOCAL && mode == SCALAR) error->all(FLERR,"Fix ave/histo cannot input local values in scalar mode"); for (int i = 0; i < nvalues; i++) { if (which[i] == COMPUTE && kind == GLOBAL && mode == SCALAR) { int icompute = modify->find_compute(ids[i]); if (icompute < 0) error->all(FLERR,"Compute ID for fix ave/histo does not exist"); if (argindex[i] == 0 && modify->compute[icompute]->scalar_flag == 0) error->all(FLERR, "Fix ave/histo compute does not calculate a global scalar"); if (argindex[i] && modify->compute[icompute]->vector_flag == 0) error->all(FLERR, "Fix ave/histo compute does not calculate a global vector"); if (argindex[i] && argindex[i] > modify->compute[icompute]->size_vector) error->all(FLERR, "Fix ave/histo compute vector is accessed out-of-range"); } else if (which[i] == COMPUTE && kind == GLOBAL && mode == VECTOR) { int icompute = modify->find_compute(ids[i]); if (icompute < 0) error->all(FLERR,"Compute ID for fix ave/histo does not exist"); if (argindex[i] == 0 && modify->compute[icompute]->vector_flag == 0) error->all(FLERR, "Fix ave/histo compute does not calculate a global vector"); if (argindex[i] && modify->compute[icompute]->array_flag == 0) error->all(FLERR, "Fix ave/histo compute does not calculate a global array"); if (argindex[i] && argindex[i] > modify->compute[icompute]->size_array_cols) error->all(FLERR, "Fix ave/histo compute array is accessed out-of-range"); } else if (which[i] == COMPUTE && kind == PERATOM) { int icompute = modify->find_compute(ids[i]); if (icompute < 0) error->all(FLERR,"Compute ID for fix ave/histo does not exist"); if (modify->compute[icompute]->peratom_flag == 0) error->all(FLERR, "Fix ave/histo compute does not calculate per-atom values"); if (argindex[i] == 0 && modify->compute[icompute]->size_peratom_cols != 0) error->all(FLERR,"Fix ave/histo compute does not " "calculate a per-atom vector"); if (argindex[i] && modify->compute[icompute]->size_peratom_cols == 0) error->all(FLERR,"Fix ave/histo compute does not " "calculate a per-atom array"); if (argindex[i] && argindex[i] > modify->compute[icompute]->size_peratom_cols) error->all(FLERR, "Fix ave/histo compute array is accessed out-of-range"); } else if (which[i] == COMPUTE && kind == LOCAL) { int icompute = modify->find_compute(ids[i]); if (icompute < 0) error->all(FLERR,"Compute ID for fix ave/histo does not exist"); if (modify->compute[icompute]->local_flag == 0) error->all(FLERR, "Fix ave/histo compute does not calculate local values"); if (argindex[i] == 0 && modify->compute[icompute]->size_local_cols != 0) error->all(FLERR,"Fix ave/histo compute does not " "calculate a local vector"); if (argindex[i] && modify->compute[icompute]->size_local_cols == 0) error->all(FLERR,"Fix ave/histo compute does not " "calculate a local array"); if (argindex[i] && argindex[i] > modify->compute[icompute]->size_local_cols) error->all(FLERR, "Fix ave/histo compute array is accessed out-of-range"); } else if (which[i] == FIX && kind == GLOBAL && mode == SCALAR) { int ifix = modify->find_fix(ids[i]); if (ifix < 0) error->all(FLERR,"Fix ID for fix ave/histo does not exist"); if (argindex[i] == 0 && modify->fix[ifix]->scalar_flag == 0) error->all(FLERR, "Fix ave/histo fix does not calculate a global scalar"); if (argindex[i] && modify->fix[ifix]->vector_flag == 0) error->all(FLERR, "Fix ave/histo fix does not calculate a global vector"); if (argindex[i] && argindex[i] > modify->fix[ifix]->size_vector) error->all(FLERR,"Fix ave/histo fix vector is accessed out-of-range"); if (nevery % modify->fix[ifix]->global_freq) error->all(FLERR, "Fix for fix ave/histo not computed at compatible time"); } else if (which[i] == FIX && kind == GLOBAL && mode == VECTOR) { int ifix = modify->find_fix(ids[i]); if (ifix < 0) error->all(FLERR,"Fix ID for fix ave/histo does not exist"); if (argindex[i] == 0 && modify->fix[ifix]->vector_flag == 0) error->all(FLERR, "Fix ave/histo fix does not calculate a global vector"); if (argindex[i] && modify->fix[ifix]->array_flag == 0) error->all(FLERR,"Fix ave/histo fix does not calculate a global array"); if (argindex[i] && argindex[i] > modify->fix[ifix]->size_array_cols) error->all(FLERR,"Fix ave/histo fix array is accessed out-of-range"); if (nevery % modify->fix[ifix]->global_freq) error->all(FLERR, "Fix for fix ave/histo not computed at compatible time"); } else if (which[i] == FIX && kind == PERATOM) { int ifix = modify->find_fix(ids[i]); if (ifix < 0) error->all(FLERR,"Fix ID for fix ave/histo does not exist"); if (modify->fix[ifix]->peratom_flag == 0) error->all(FLERR, "Fix ave/histo fix does not calculate per-atom values"); if (argindex[i] == 0 && modify->fix[ifix]->size_peratom_cols != 0) error->all(FLERR,"Fix ave/histo fix does not " "calculate a per-atom vector"); if (argindex[i] && modify->fix[ifix]->size_peratom_cols == 0) error->all(FLERR,"Fix ave/histo fix does not " "calculate a per-atom array"); if (argindex[i] && argindex[i] > modify->fix[ifix]->size_peratom_cols) error->all(FLERR,"Fix ave/histo fix array is accessed out-of-range"); if (nevery % modify->fix[ifix]->global_freq) error->all(FLERR, "Fix for fix ave/histo not computed at compatible time"); } else if (which[i] == FIX && kind == LOCAL) { int ifix = modify->find_fix(ids[i]); if (ifix < 0) error->all(FLERR,"Fix ID for fix ave/histo does not exist"); if (modify->fix[ifix]->local_flag == 0) error->all(FLERR,"Fix ave/histo fix does not calculate local values"); if (argindex[i] == 0 && modify->fix[ifix]->size_local_cols != 0) error->all(FLERR,"Fix ave/histo fix does not " "calculate a local vector"); if (argindex[i] && modify->fix[ifix]->size_local_cols == 0) error->all(FLERR,"Fix ave/histo fix does not " "calculate a local array"); if (argindex[i] && argindex[i] > modify->fix[ifix]->size_local_cols) error->all(FLERR,"Fix ave/histo fix array is accessed out-of-range"); if (nevery % modify->fix[ifix]->global_freq) error->all(FLERR, "Fix for fix ave/histo not computed at compatible time"); } else if (which[i] == VARIABLE && kind == GLOBAL && mode == SCALAR) { int ivariable = input->variable->find(ids[i]); if (ivariable < 0) error->all(FLERR,"Variable name for fix ave/histo does not exist"); if (argindex[i] == 0 && input->variable->equalstyle(ivariable) == 0) error->all(FLERR,"Fix ave/histo variable is not equal-style variable"); if (argindex[i] && input->variable->vectorstyle(ivariable) == 0) error->all(FLERR,"Fix ave/histo variable is not vector-style variable"); } else if (which[i] == VARIABLE && kind == GLOBAL && mode == VECTOR) { int ivariable = input->variable->find(ids[i]); if (ivariable < 0) error->all(FLERR,"Variable name for fix ave/histo does not exist"); if (argindex[i] == 0 && input->variable->vectorstyle(ivariable) == 0) error->all(FLERR,"Fix ave/histo variable is not vector-style variable"); if (argindex[i]) error->all(FLERR,"Fix ave/histo variable cannot be indexed"); } else if (which[i] == VARIABLE && kind == PERATOM) { int ivariable = input->variable->find(ids[i]); if (ivariable < 0) error->all(FLERR,"Variable name for fix ave/histo does not exist"); if (argindex[i] == 0 && input->variable->atomstyle(ivariable) == 0) error->all(FLERR,"Fix ave/histo variable is not atom-style variable"); if (argindex[i]) error->all(FLERR,"Fix ave/histo variable cannot be indexed"); } } // print file comment lines if (fp && me == 0) { clearerr(fp); if (title1) fprintf(fp,"%s\n",title1); else fprintf(fp,"# Histogrammed data for fix %s\n",id); if (title2) fprintf(fp,"%s\n",title2); else fprintf(fp,"# TimeStep Number-of-bins " "Total-counts Missing-counts Min-value Max-value\n"); if (title3) fprintf(fp,"%s\n",title3); else fprintf(fp,"# Bin Coord Count Count/Total\n"); if (ferror(fp)) error->one(FLERR,"Error writing file header"); filepos = ftell(fp); } delete [] title1; delete [] title2; delete [] title3; // allocate and initialize memory for averaging if (beyond == EXTRA) nbins += 2; size_array_rows = nbins; bin = new double[nbins]; bin_total = new double[nbins]; bin_all = new double[nbins]; coord = new double[nbins]; stats_list = NULL; bin_list = NULL; vector = NULL; maxatom = 0; if (ave == WINDOW) { - memory->create(stats_list,nwindow,4,"histo:stats_list"); + memory->create(stats_list,nwindow,4,"ave/histo:stats_list"); memory->create(bin_list,nwindow,nbins,"ave/histo:bin_list"); } // initializations // set coord to bin centers if (beyond == EXTRA) { binsize = (hi-lo)/(nbins-2); bininv = 1.0/binsize; } else { binsize = (hi-lo)/nbins; bininv = 1.0/binsize; } if (beyond == EXTRA) { coord[0] = lo; coord[nbins-1] = hi; for (int i = 1; i < nbins-1; i++) coord[i] = lo + (i-1+0.5)*binsize; } else { for (int i = 0; i < nbins; i++) coord[i] = lo + (i+0.5)*binsize; } irepeat = 0; iwindow = window_limit = 0; stats_total[0] = stats_total[1] = stats_total[2] = stats_total[3] = 0.0; for (int i = 0; i < nbins; i++) bin_total[i] = 0.0; // nvalid = next step on which end_of_step does something // add nvalid to all computes that store invocation times // since don't know a priori which are invoked by this fix // once in end_of_step() can set timestep for ones actually invoked nvalid_last = -1; nvalid = nextvalid(); modify->addstep_compute_all(nvalid); } /* ---------------------------------------------------------------------- */ FixAveHisto::~FixAveHisto() { memory->destroy(which); memory->destroy(argindex); memory->destroy(value2index); for (int i = 0; i < nvalues; i++) delete [] ids[i]; memory->sfree(ids); if (fp && me == 0) fclose(fp); delete [] bin; delete [] bin_total; delete [] bin_all; delete [] coord; memory->destroy(stats_list); memory->destroy(bin_list); memory->destroy(vector); } /* ---------------------------------------------------------------------- */ int FixAveHisto::setmask() { int mask = 0; mask |= END_OF_STEP; return mask; } /* ---------------------------------------------------------------------- */ void FixAveHisto::init() { // set current indices for all computes,fixes,variables for (int i = 0; i < nvalues; i++) { if (which[i] == COMPUTE) { int icompute = modify->find_compute(ids[i]); if (icompute < 0) error->all(FLERR,"Compute ID for fix ave/histo does not exist"); value2index[i] = icompute; } else if (which[i] == FIX) { int ifix = modify->find_fix(ids[i]); if (ifix < 0) error->all(FLERR,"Fix ID for fix ave/histo does not exist"); value2index[i] = ifix; } else if (which[i] == VARIABLE) { int ivariable = input->variable->find(ids[i]); if (ivariable < 0) error->all(FLERR,"Variable name for fix ave/histo does not exist"); value2index[i] = ivariable; } } // need to reset nvalid if nvalid < ntimestep b/c minimize was performed if (nvalid < update->ntimestep) { irepeat = 0; nvalid = nextvalid(); modify->addstep_compute_all(nvalid); } } /* ---------------------------------------------------------------------- only does something if nvalid = current timestep ------------------------------------------------------------------------- */ void FixAveHisto::setup(int vflag) { end_of_step(); } /* ---------------------------------------------------------------------- */ void FixAveHisto::end_of_step() { int i,j,m; // skip if not step which requires doing something // error check if timestep was reset in an invalid manner bigint ntimestep = update->ntimestep; if (ntimestep < nvalid_last || ntimestep > nvalid) error->all(FLERR,"Invalid timestep reset for fix ave/histo"); if (ntimestep != nvalid) return; nvalid_last = nvalid; // zero if first step if (irepeat == 0) { stats[0] = stats[1] = 0.0; stats[2] = BIG; stats[3] = -BIG; for (i = 0; i < nbins; i++) bin[i] = 0.0; } // accumulate results of computes,fixes,variables to local copy // compute/fix/variable may invoke computes so wrap with clear/add modify->clearstep_compute(); for (i = 0; i < nvalues; i++) { m = value2index[i]; j = argindex[i]; // atom attributes if (which[i] == X) bin_atoms(&atom->x[0][j],3); else if (which[i] == V) bin_atoms(&atom->v[0][j],3); else if (which[i] == F) bin_atoms(&atom->f[0][j],3); // invoke compute if not previously invoked if (which[i] == COMPUTE) { Compute *compute = modify->compute[m]; if (kind == GLOBAL && mode == SCALAR) { if (j == 0) { if (!(compute->invoked_flag & INVOKED_SCALAR)) { compute->compute_scalar(); compute->invoked_flag |= INVOKED_SCALAR; } bin_one(compute->scalar); } else { if (!(compute->invoked_flag & INVOKED_VECTOR)) { compute->compute_vector(); compute->invoked_flag |= INVOKED_VECTOR; } bin_one(compute->vector[j-1]); } } else if (kind == GLOBAL && mode == VECTOR) { if (j == 0) { if (!(compute->invoked_flag & INVOKED_VECTOR)) { compute->compute_vector(); compute->invoked_flag |= INVOKED_VECTOR; } bin_vector(compute->size_vector,compute->vector,1); } else { if (!(compute->invoked_flag & INVOKED_ARRAY)) { compute->compute_array(); compute->invoked_flag |= INVOKED_ARRAY; } if (compute->array) bin_vector(compute->size_array_rows,&compute->array[0][j-1], compute->size_array_cols); } } else if (kind == PERATOM) { if (!(compute->invoked_flag & INVOKED_PERATOM)) { compute->compute_peratom(); compute->invoked_flag |= INVOKED_PERATOM; } if (j == 0) bin_atoms(compute->vector_atom,1); else if (compute->array_atom) bin_atoms(&compute->array_atom[0][j-1],compute->size_peratom_cols); } else if (kind == LOCAL) { if (!(compute->invoked_flag & INVOKED_LOCAL)) { compute->compute_local(); compute->invoked_flag |= INVOKED_LOCAL; } if (j == 0) bin_vector(compute->size_local_rows,compute->vector_local,1); else if (compute->array_local) bin_vector(compute->size_local_rows,&compute->array_local[0][j-1], compute->size_local_cols); } // access fix fields, guaranteed to be ready } else if (which[i] == FIX) { Fix *fix = modify->fix[m]; if (kind == GLOBAL && mode == SCALAR) { if (j == 0) bin_one(fix->compute_scalar()); else bin_one(fix->compute_vector(j-1)); } else if (kind == GLOBAL && mode == VECTOR) { if (j == 0) { int n = fix->size_vector; for (i = 0; i < n; i++) bin_one(fix->compute_vector(i)); } else { int n = fix->size_vector; for (i = 0; i < n; i++) bin_one(fix->compute_array(i,j-1)); } } else if (kind == PERATOM) { if (j == 0) bin_atoms(fix->vector_atom,1); else if (fix->array_atom) bin_atoms(fix->array_atom[j-1],fix->size_peratom_cols); } else if (kind == LOCAL) { if (j == 0) bin_vector(fix->size_local_rows,fix->vector_local,1); else if (fix->array_local) bin_vector(fix->size_local_rows,&fix->array_local[0][j-1], fix->size_local_cols); } // evaluate equal-style or vector-style or atom-style variable } else if (which[i] == VARIABLE) { if (kind == GLOBAL && mode == SCALAR) { if (j == 0) bin_one(input->variable->compute_equal(m)); else { double *varvec; int nvec = input->variable->compute_vector(m,&varvec); if (nvec < j) bin_one(0.0); else bin_one(varvec[j-1]); } } else if (kind == GLOBAL && mode == VECTOR) { double *varvec; int nvec = input->variable->compute_vector(m,&varvec); bin_vector(nvec,varvec,1); } else if (which[i] == VARIABLE && kind == PERATOM) { if (atom->nmax > maxatom) { memory->destroy(vector); maxatom = atom->nmax; memory->create(vector,maxatom,"ave/histo:vector"); } input->variable->compute_atom(m,igroup,vector,1,0); bin_atoms(vector,1); } } } // done if irepeat < nrepeat // else reset irepeat and nvalid irepeat++; if (irepeat < nrepeat) { nvalid += nevery; modify->addstep_compute(nvalid); return; } irepeat = 0; nvalid = ntimestep + nfreq - (nrepeat-1)*nevery; modify->addstep_compute(nvalid); // merge histogram stats across procs if necessary if (kind == PERATOM || kind == LOCAL) { MPI_Allreduce(stats,stats_all,2,MPI_DOUBLE,MPI_SUM,world); MPI_Allreduce(&stats[2],&stats_all[2],1,MPI_DOUBLE,MPI_MIN,world); MPI_Allreduce(&stats[3],&stats_all[3],1,MPI_DOUBLE,MPI_MAX,world); MPI_Allreduce(bin,bin_all,nbins,MPI_DOUBLE,MPI_SUM,world); stats[0] = stats_all[0]; stats[1] = stats_all[1]; stats[2] = stats_all[2]; stats[3] = stats_all[3]; for (i = 0; i < nbins; i++) bin[i] = bin_all[i]; } // if ave = ONE, only single Nfreq timestep value is needed // if ave = RUNNING, combine with all previous Nfreq timestep values // if ave = WINDOW, combine with nwindow most recent Nfreq timestep values if (ave == ONE) { stats_total[0] = stats[0]; stats_total[1] = stats[1]; stats_total[2] = stats[2]; stats_total[3] = stats[3]; for (i = 0; i < nbins; i++) bin_total[i] = bin[i]; } else if (ave == RUNNING) { stats_total[0] += stats[0]; stats_total[1] += stats[1]; stats_total[2] = MIN(stats_total[2],stats[2]); stats_total[3] = MAX(stats_total[3],stats[3]); for (i = 0; i < nbins; i++) bin_total[i] += bin[i]; } else if (ave == WINDOW) { stats_total[0] += stats[0]; if (window_limit) stats_total[0] -= stats_list[iwindow][0]; stats_list[iwindow][0] = stats[0]; stats_total[1] += stats[1]; if (window_limit) stats_total[1] -= stats_list[iwindow][1]; stats_list[iwindow][1] = stats[1]; if (window_limit) m = nwindow; else m = iwindow+1; stats_list[iwindow][2] = stats[2]; stats_total[2] = stats_list[0][2]; for (i = 1; i < m; i++) stats_total[2] = MIN(stats_total[2],stats_list[i][2]); stats_list[iwindow][3] = stats[3]; stats_total[3] = stats_list[0][3]; for (i = 1; i < m; i++) stats_total[3] = MAX(stats_total[3],stats_list[i][3]); for (i = 0; i < nbins; i++) { bin_total[i] += bin[i]; if (window_limit) bin_total[i] -= bin_list[iwindow][i]; bin_list[iwindow][i] = bin[i]; } iwindow++; if (iwindow == nwindow) { iwindow = 0; window_limit = 1; } } // output result to file if (fp && me == 0) { clearerr(fp); if (overwrite) fseek(fp,filepos,SEEK_SET); fprintf(fp,BIGINT_FORMAT " %d %g %g %g %g\n",ntimestep,nbins, stats_total[0],stats_total[1],stats_total[2],stats_total[3]); if (stats_total[0] != 0.0) for (i = 0; i < nbins; i++) fprintf(fp,"%d %g %g %g\n", i+1,coord[i],bin_total[i],bin_total[i]/stats_total[0]); else for (i = 0; i < nbins; i++) fprintf(fp,"%d %g %g %g\n",i+1,coord[i],0.0,0.0); if (ferror(fp)) error->one(FLERR,"Error writing out histogram data"); fflush(fp); if (overwrite) { long fileend = ftell(fp); if (fileend > 0) ftruncate(fileno(fp),fileend); } } } /* ---------------------------------------------------------------------- return Ith vector value ------------------------------------------------------------------------- */ double FixAveHisto::compute_vector(int i) { return stats_total[i]; } /* ---------------------------------------------------------------------- return I,J array value ------------------------------------------------------------------------- */ double FixAveHisto::compute_array(int i, int j) { if (j == 0) return coord[i]; else if (j == 1) return bin_total[i]; else if (stats_total[0] != 0.0) return bin_total[i]/stats_total[0]; return 0.0; } /* ---------------------------------------------------------------------- bin a single value ------------------------------------------------------------------------- */ void FixAveHisto::bin_one(double value) { stats[2] = MIN(stats[2],value); stats[3] = MAX(stats[3],value); if (value < lo) { if (beyond == IGNORE) { stats[1] += 1.0; return; } else bin[0] += 1.0; } else if (value > hi) { if (beyond == IGNORE) { stats[1] += 1.0; return; } else bin[nbins-1] += 1.0; } else { int ibin = static_cast ((value-lo)*bininv); ibin = MIN(ibin,nbins-1); if (beyond == EXTRA) ibin++; bin[ibin] += 1.0; } stats[0] += 1.0; } /* ---------------------------------------------------------------------- bin a vector of values with stride ------------------------------------------------------------------------- */ void FixAveHisto::bin_vector(int n, double *values, int stride) { int m = 0; for (int i = 0; i < n; i++) { bin_one(values[m]); m += stride; } } /* ---------------------------------------------------------------------- bin a per-atom vector of values with stride only bin if atom is in group ------------------------------------------------------------------------- */ void FixAveHisto::bin_atoms(double *values, int stride) { int *mask = atom->mask; int nlocal = atom->nlocal; int m = 0; for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit) bin_one(values[m]); m += stride; } } /* ---------------------------------------------------------------------- parse optional args ------------------------------------------------------------------------- */ void FixAveHisto::options(int narg, char **arg) { // option defaults fp = NULL; ave = ONE; startstep = 0; mode = SCALAR; beyond = IGNORE; overwrite = 0; title1 = NULL; title2 = NULL; title3 = NULL; // optional args int iarg = 9 + nvalues; while (iarg < narg) { if (strcmp(arg[iarg],"file") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); if (me == 0) { fp = fopen(arg[iarg+1],"w"); if (fp == NULL) { char str[128]; sprintf(str,"Cannot open fix ave/histo file %s",arg[iarg+1]); error->one(FLERR,str); } } iarg += 2; } else if (strcmp(arg[iarg],"ave") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); if (strcmp(arg[iarg+1],"one") == 0) ave = ONE; else if (strcmp(arg[iarg+1],"running") == 0) ave = RUNNING; else if (strcmp(arg[iarg+1],"window") == 0) ave = WINDOW; else error->all(FLERR,"Illegal fix ave/histo command"); if (ave == WINDOW) { if (iarg+3 > narg) error->all(FLERR,"Illegal fix ave/histo command"); nwindow = force->inumeric(FLERR,arg[iarg+2]); if (nwindow <= 0) error->all(FLERR,"Illegal fix ave/histo command"); } iarg += 2; if (ave == WINDOW) iarg++; } else if (strcmp(arg[iarg],"start") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); startstep = force->inumeric(FLERR,arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"mode") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); if (strcmp(arg[iarg+1],"scalar") == 0) mode = SCALAR; else if (strcmp(arg[iarg+1],"vector") == 0) mode = VECTOR; else error->all(FLERR,"Illegal fix ave/histo command"); iarg += 2; } else if (strcmp(arg[iarg],"beyond") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); if (strcmp(arg[iarg+1],"ignore") == 0) beyond = IGNORE; else if (strcmp(arg[iarg+1],"end") == 0) beyond = END; else if (strcmp(arg[iarg+1],"extra") == 0) beyond = EXTRA; else error->all(FLERR,"Illegal fix ave/histo command"); iarg += 2; } else if (strcmp(arg[iarg],"overwrite") == 0) { overwrite = 1; iarg += 1; } else if (strcmp(arg[iarg],"title1") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); delete [] title1; int n = strlen(arg[iarg+1]) + 1; title1 = new char[n]; strcpy(title1,arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"title2") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); delete [] title2; int n = strlen(arg[iarg+1]) + 1; title2 = new char[n]; strcpy(title2,arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"title3") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix ave/histo command"); delete [] title3; int n = strlen(arg[iarg+1]) + 1; title3 = new char[n]; strcpy(title3,arg[iarg+1]); iarg += 2; } else error->all(FLERR,"Illegal fix ave/histo command"); } } /* ---------------------------------------------------------------------- reallocate vectors for each input value, of length N ------------------------------------------------------------------------- */ void FixAveHisto::allocate_values(int n) { - memory->grow(which,n,"ave/time:which"); - memory->grow(argindex,n,"ave/time:argindex"); - memory->grow(value2index,n,"ave/time:value2index"); - ids = (char **) memory->srealloc(ids,n*sizeof(char *),"ave/time:ids"); + memory->grow(which,n,"ave/hsito:which"); + memory->grow(argindex,n,"ave/histo:argindex"); + memory->grow(value2index,n,"ave/histo:value2index"); + ids = (char **) memory->srealloc(ids,n*sizeof(char *),"ave/histo:ids"); } /* ---------------------------------------------------------------------- calculate nvalid = next step on which end_of_step does something can be this timestep if multiple of nfreq and nrepeat = 1 else backup from next multiple of nfreq startstep is lower bound on nfreq multiple ------------------------------------------------------------------------- */ bigint FixAveHisto::nextvalid() { bigint nvalid = (update->ntimestep/nfreq)*nfreq + nfreq; while (nvalid < startstep) nvalid += nfreq; if (nvalid-nfreq == update->ntimestep && nrepeat == 1) nvalid = update->ntimestep; else nvalid -= (nrepeat-1)*nevery; if (nvalid < update->ntimestep) nvalid += nfreq; return nvalid; } diff --git a/src/fix_ave_histo_weight.cpp b/src/fix_ave_histo_weight.cpp index 8671a38a9..277a57a48 100644 --- a/src/fix_ave_histo_weight.cpp +++ b/src/fix_ave_histo_weight.cpp @@ -1,571 +1,570 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator http://lammps.sandia.gov, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains certain rights in this software. This software is distributed under the GNU General Public License. See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- Contributing author: Shawn Coleman (ARL) ------------------------------------------------------------------------- */ #include #include #include #include "fix_ave_histo_weight.h" #include "atom.h" #include "update.h" #include "modify.h" #include "compute.h" #include "group.h" #include "input.h" #include "variable.h" #include "memory.h" #include "error.h" #include "force.h" using namespace LAMMPS_NS; using namespace FixConst; enum{X,V,F,COMPUTE,FIX,VARIABLE}; enum{ONE,RUNNING}; enum{SCALAR,VECTOR,WINDOW}; enum{GLOBAL,PERATOM,LOCAL}; enum{IGNORE,END,EXTRA}; enum{SINGLE,VALUE}; #define INVOKED_SCALAR 1 #define INVOKED_VECTOR 2 #define INVOKED_ARRAY 4 #define INVOKED_PERATOM 8 #define INVOKED_LOCAL 16 #define BIG 1.0e20 /* ---------------------------------------------------------------------- */ FixAveHistoWeight::FixAveHistoWeight(LAMMPS *lmp, int narg, char **arg) : FixAveHisto(lmp, narg, arg) { // nvalues = 2 required for histo/weight if (nvalues != 2) error->all(FLERR,"Illegal fix ave/histo/weight command"); // check that length of 2 values is the same int size[2]; for (int i = 0; i < nvalues; i++) { if (which[i] == X || which[i] == V || which[i] == F) { size[i] = atom->nlocal; } else if (which[i] == COMPUTE && kind == GLOBAL && mode == SCALAR) { int icompute = modify->find_compute(ids[i]); size[i] = modify->compute[icompute]->size_vector; } else if (which[i] == COMPUTE && kind == GLOBAL && mode == VECTOR) { int icompute = modify->find_compute(ids[i]); size[i] = modify->compute[icompute]->size_array_rows; } else if (which[i] == COMPUTE && kind == PERATOM) { size[i] = atom->nlocal; } else if (which[i] == COMPUTE && kind == LOCAL) { int icompute = modify->find_compute(ids[i]); size[i] = modify->compute[icompute]->size_local_rows; } else if (which[i] == FIX && kind == GLOBAL && mode == SCALAR) { int ifix = modify->find_fix(ids[i]); size[i] = modify->fix[ifix]->size_vector; } else if (which[i] == FIX && kind == GLOBAL && mode == VECTOR) { int ifix = modify->find_fix(ids[i]); size[i]= modify->fix[ifix]->size_array_rows; } else if (which[i] == FIX && kind == PERATOM) { size[i] = atom->nlocal; } else if (which[i] == FIX && kind == LOCAL) { int ifix = modify->find_fix(ids[i]); size[i] = modify->fix[ifix]->size_local_rows; } else if (which[i] == VARIABLE && kind == PERATOM) { size[i] = atom->nlocal; } } if (size[0] != size[1]) error->all(FLERR,"Fix ave/histo/weight value and weight vector " "lengths do not match"); } /* ---------------------------------------------------------------------- */ void FixAveHistoWeight::end_of_step() { int i,j,m; // skip if not step which requires doing something // error check if timestep was reset in an invalid manner bigint ntimestep = update->ntimestep; if (ntimestep < nvalid_last || ntimestep > nvalid) error->all(FLERR,"Invalid timestep reset for fix ave/histo"); if (ntimestep != nvalid) return; nvalid_last = nvalid; // zero if first step if (irepeat == 0) { stats[0] = stats[1] = 0.0; stats[2] = BIG; stats[3] = -BIG; for (i = 0; i < nbins; i++) bin[i] = 0.0; } // first calculate weight factors, then bin single value // accumulate results of computes,fixes,variables to local copy // compute/fix/variable may invoke computes so wrap with clear/add modify->clearstep_compute(); // calcualte weight factors which are 2nd value (i = 1) double weight = 0.0; double *weights = NULL; int stride = 0; i = 1; m = value2index[i]; j = argindex[i]; // atom attributes if (which[i] == X) { weights = &atom->x[0][j]; stride = 3; } else if (which[i] == V){ weights = &atom->v[0][j]; stride = 3; bin_atoms(&atom->v[0][j],3); } else if (which[i] == F) { weights = &atom->f[0][j]; stride = 3; } // invoke compute if not previously invoked if (which[i] == COMPUTE) { + Compute *compute = modify->compute[m]; + if (kind == GLOBAL && mode == SCALAR) { if (j == 0) { if (!(compute->invoked_flag & INVOKED_SCALAR)) { compute->compute_scalar(); compute->invoked_flag |= INVOKED_SCALAR; } weight = compute->scalar; } else { if (!(compute->invoked_flag & INVOKED_VECTOR)) { compute->compute_vector(); compute->invoked_flag |= INVOKED_VECTOR; } weight = compute->vector[j-1]; } } else if (kind == GLOBAL && mode == VECTOR) { if (j == 0) { if (!(compute->invoked_flag & INVOKED_VECTOR)) { compute->compute_vector(); compute->invoked_flag |= INVOKED_VECTOR; } weights = compute->vector; stride = 1; } else { if (!(compute->invoked_flag & INVOKED_ARRAY)) { compute->compute_array(); compute->invoked_flag |= INVOKED_ARRAY; } if (compute->array) weights = &compute->array[0][j-1]; stride = compute->size_array_cols; } } else if (kind == PERATOM) { if (!(compute->invoked_flag & INVOKED_PERATOM)) { compute->compute_peratom(); compute->invoked_flag |= INVOKED_PERATOM; } if (j == 0) { weights = compute->vector_atom; stride = 1; } else if (compute->array_atom) { weights = &compute->array_atom[0][j-1]; stride = compute->size_peratom_cols; } } else if (kind == LOCAL) { if (!(compute->invoked_flag & INVOKED_LOCAL)) { compute->compute_local(); compute->invoked_flag |= INVOKED_LOCAL; } if (j == 0) { weights = compute->vector_local; stride = 1; } else if (compute->array_local) { weights = &compute->array_local[0][j-1]; stride = compute->size_local_cols; } } // access fix fields, guaranteed to be ready } else if (which[i] == FIX) { Fix *fix = modify->fix[m]; if (kind == GLOBAL && mode == SCALAR) { if (j == 0) weight = fix->compute_scalar(); else weight = fix->compute_vector(j-1); - } else if (kind == GLOBAL && mode == VECTOR) { - - error->all(FLERR,"Illegal fix ave/spatial command"); - + error->all(FLERR,"Fix ave/histo/weight option not yet supported"); + // NOTE: need to allocate local storage if (j == 0) { int n = fix->size_vector; for (i = 0; i < n; i++) weights[n] = fix->compute_vector(i); } else { int n = fix->size_vector; for (i = 0; i < n; i++) weights[n] = fix->compute_array(i,j-1); } - } else if (kind == PERATOM) { if (j == 0) { weights = fix->vector_atom; stride = 1; } else if (fix->array_atom) { weights = fix->array_atom[j-1]; stride = fix->size_peratom_cols; } } else if (kind == LOCAL) { if (j == 0) { weights = fix->vector_local; stride = 1; } else if (fix->array_local) { weights = &fix->array_local[0][j-1]; stride = fix->size_local_cols; } } // evaluate equal-style variable } else if (which[i] == VARIABLE && kind == GLOBAL) { weight = input->variable->compute_equal(m); } else if (which[i] == VARIABLE && kind == PERATOM) { if (atom->nmax > maxatom) { memory->destroy(vector); maxatom = atom->nmax; memory->create(vector,maxatom,"ave/histo/weight:vector"); } input->variable->compute_atom(m,igroup,vector,1,0); weights = vector; stride = 1; } // bin values using weights, values are 1st value (i = 0) i = 0; m = value2index[i]; j = argindex[i]; // atom attributes if (which[i] == X && weights != NULL) bin_atoms_weights(&atom->x[0][j],3,weights,stride); else if (which[i] == V && weights != NULL) bin_atoms_weights(&atom->v[0][j],3,weights,stride); else if (which[i] == F && weights != NULL) bin_atoms_weights(&atom->f[0][j],3,weights,stride); // invoke compute if not previously invoked if (which[i] == COMPUTE) { Compute *compute = modify->compute[m]; if (kind == GLOBAL && mode == SCALAR) { if (j == 0) { if (!(compute->invoked_flag & INVOKED_SCALAR)) { compute->compute_scalar(); compute->invoked_flag |= INVOKED_SCALAR; } bin_one_weights(compute->scalar,weight); } else { if (!(compute->invoked_flag & INVOKED_VECTOR)) { compute->compute_vector(); compute->invoked_flag |= INVOKED_VECTOR; } bin_one_weights(compute->vector[j-1],weight); } } else if (kind == GLOBAL && mode == VECTOR) { if (j == 0) { if (!(compute->invoked_flag & INVOKED_VECTOR)) { compute->compute_vector(); compute->invoked_flag |= INVOKED_VECTOR; } bin_vector_weights(compute->size_vector,compute->vector,1, weights,stride); } else { if (!(compute->invoked_flag & INVOKED_ARRAY)) { compute->compute_array(); compute->invoked_flag |= INVOKED_ARRAY; } if (compute->array) bin_vector_weights(compute->size_array_rows,&compute->array[0][j-1], compute->size_array_cols,weights,stride); } } else if (kind == PERATOM) { if (!(compute->invoked_flag & INVOKED_PERATOM)) { compute->compute_peratom(); compute->invoked_flag |= INVOKED_PERATOM; } if (j == 0) bin_atoms_weights(compute->vector_atom,1,weights, stride); else if (compute->array_atom) bin_atoms_weights(&compute->array_atom[0][j-1], compute->size_peratom_cols,weights,stride); } else if (kind == LOCAL) { if (!(compute->invoked_flag & INVOKED_LOCAL)) { compute->compute_local(); compute->invoked_flag |= INVOKED_LOCAL; } if (j == 0) bin_vector_weights(compute->size_local_rows, compute->vector_local,1,weights,stride); else if (compute->array_local) bin_vector_weights(compute->size_local_rows, &compute->array_local[0][j-1], compute->size_local_cols,weights,stride); } // access fix fields, guaranteed to be ready } else if (which[i] == FIX) { Fix *fix = modify->fix[m]; if (kind == GLOBAL && mode == SCALAR) { if (j == 0) bin_one_weights(fix->compute_scalar(),weight); else bin_one_weights(fix->compute_vector(j-1),weight); } else if (kind == GLOBAL && mode == VECTOR) { if (j == 0) { int n = fix->size_vector; for (i = 0; i < n; i++) bin_one_weights(fix->compute_vector(i),weights[i*stride]); } else { int n = fix->size_vector; for (i = 0; i < n; i++) bin_one_weights(fix->compute_array(i,j-1),weights[i*stride]); } } else if (kind == PERATOM) { if (j == 0) bin_atoms_weights(fix->vector_atom,1,weights,stride); else if (fix->array_atom) bin_atoms_weights(fix->array_atom[j-1],fix->size_peratom_cols, weights,stride); } else if (kind == LOCAL) { if (j == 0) bin_vector_weights(fix->size_local_rows,fix->vector_local,1, weights,stride); else if (fix->array_local) bin_vector_weights(fix->size_local_rows,&fix->array_local[0][j-1], fix->size_local_cols,weights,stride); } // evaluate equal-style variable } else if (which[i] == VARIABLE && kind == GLOBAL) { bin_one_weights(input->variable->compute_equal(m),weight); } else if (which[i] == VARIABLE && kind == PERATOM) { if (atom->nmax > maxatom) { memory->destroy(vector); maxatom = atom->nmax; memory->create(vector,maxatom,"ave/histo/weight:vector"); } input->variable->compute_atom(m,igroup,vector,1,0); bin_atoms_weights(vector,1,weights,stride); } // code beyond this point is identical to FixAveHisto // done if irepeat < nrepeat // else reset irepeat and nvalid irepeat++; if (irepeat < nrepeat) { nvalid += nevery; modify->addstep_compute(nvalid); return; } irepeat = 0; nvalid = ntimestep + nfreq - (nrepeat-1)*nevery; modify->addstep_compute(nvalid); // merge histogram stats across procs if necessary if (kind == PERATOM || kind == LOCAL) { MPI_Allreduce(stats,stats_all,2,MPI_DOUBLE,MPI_SUM,world); MPI_Allreduce(&stats[2],&stats_all[2],1,MPI_DOUBLE,MPI_MIN,world); MPI_Allreduce(&stats[3],&stats_all[3],1,MPI_DOUBLE,MPI_MAX,world); MPI_Allreduce(bin,bin_all,nbins,MPI_DOUBLE,MPI_SUM,world); stats[0] = stats_all[0]; stats[1] = stats_all[1]; stats[2] = stats_all[2]; stats[3] = stats_all[3]; for (i = 0; i < nbins; i++) bin[i] = bin_all[i]; } // if ave = ONE, only single Nfreq timestep value is needed // if ave = RUNNING, combine with all previous Nfreq timestep values // if ave = WINDOW, combine with nwindow most recent Nfreq timestep values if (ave == ONE) { stats_total[0] = stats[0]; stats_total[1] = stats[1]; stats_total[2] = stats[2]; stats_total[3] = stats[3]; for (i = 0; i < nbins; i++) bin_total[i] = bin[i]; } else if (ave == RUNNING) { stats_total[0] += stats[0]; stats_total[1] += stats[1]; stats_total[2] = MIN(stats_total[2],stats[2]); stats_total[3] = MAX(stats_total[3],stats[3]); for (i = 0; i < nbins; i++) bin_total[i] += bin[i]; } else if (ave == WINDOW) { stats_total[0] += stats[0]; if (window_limit) stats_total[0] -= stats_list[iwindow][0]; stats_list[iwindow][0] = stats[0]; stats_total[1] += stats[1]; if (window_limit) stats_total[1] -= stats_list[iwindow][1]; stats_list[iwindow][1] = stats[1]; if (window_limit) m = nwindow; else m = iwindow+1; stats_list[iwindow][2] = stats[2]; stats_total[2] = stats_list[0][2]; for (i = 1; i < m; i++) stats_total[2] = MIN(stats_total[2],stats_list[i][2]); stats_list[iwindow][3] = stats[3]; stats_total[3] = stats_list[0][3]; for (i = 1; i < m; i++) stats_total[3] = MAX(stats_total[3],stats_list[i][3]); for (i = 0; i < nbins; i++) { bin_total[i] += bin[i]; if (window_limit) bin_total[i] -= bin_list[iwindow][i]; bin_list[iwindow][i] = bin[i]; } iwindow++; if (iwindow == nwindow) { iwindow = 0; window_limit = 1; } } // output result to file if (fp && me == 0) { clearerr(fp); if (overwrite) fseek(fp,filepos,SEEK_SET); fprintf(fp,BIGINT_FORMAT " %d %g %g %g %g\n",ntimestep,nbins, stats_total[0],stats_total[1],stats_total[2],stats_total[3]); if (stats_total[0] != 0.0) for (i = 0; i < nbins; i++) fprintf(fp,"%d %g %g %g\n", i+1,coord[i],bin_total[i],bin_total[i]/stats_total[0]); else for (i = 0; i < nbins; i++) fprintf(fp,"%d %g %g %g\n",i+1,coord[i],0.0,0.0); if (ferror(fp)) error->one(FLERR,"Error writing out histogram data"); fflush(fp); if (overwrite) { long fileend = ftell(fp); if (fileend > 0) ftruncate(fileno(fp),fileend); } } } /* ---------------------------------------------------------------------- bin a single value with weight) ------------------------------------------------------------------------- */ void FixAveHistoWeight::bin_one_weights(double value, double weight) { stats[2] = MIN(stats[2],value); stats[3] = MAX(stats[3],value); if (value < lo) { if (beyond == IGNORE) { stats[1] += weight; return; } else bin[0] += weight; } else if (value > hi) { if (beyond == IGNORE) { stats[1] += weight; return; } else bin[nbins-1] += weight; } else { int ibin = static_cast ((value-lo)*bininv); ibin = MIN(ibin,nbins-1); if (beyond == EXTRA) ibin++; bin[ibin] += weight; } stats[0] += weight; } /* ---------------------------------------------------------------------- bin a vector of values with weights values and weights each have a stride ------------------------------------------------------------------------- */ void FixAveHistoWeight::bin_vector_weights(int n, double *values, int stride, double *weights, int stridewt) { int m = 0; int m2 = 0; for (int i = 0; i < n; i++) { bin_one_weights(values[m],weights[m2]); m += stride; m2 += stridewt; } } /* ---------------------------------------------------------------------- bin a per-atom vector of values with weights values and weights each have a stride only bin if atom is in group ------------------------------------------------------------------------- */ void FixAveHistoWeight::bin_atoms_weights(double *values, int stride, double *weights, int stridewt) { int *mask = atom->mask; int nlocal = atom->nlocal; int m = 0; int m2 = 0; for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit) bin_one_weights(values[m],weights[m2]); m += stride; m2 += stridewt; } } diff --git a/src/version.h b/src/version.h index 9aa19faf5..bcce3d4e3 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "28 Jul 2016" +#define LAMMPS_VERSION "30 Jul 2016"