diff --git a/doc/Section_errors.html b/doc/Section_errors.html index 159aeaf9a..911a2cba9 100644 --- a/doc/Section_errors.html +++ b/doc/Section_errors.html @@ -1,4523 +1,4583 @@ <HTML> <CENTER><A HREF = "Section_modify.html">Previous Section</A> - <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A> - <A HREF = "Manual.html">LAMMPS Documentation</A> - <A HREF = "Section_commands.html#comm">LAMMPS Commands</A> - <A HREF = "Section_history.html">Next Section</A> </CENTER> <HR> <H3>9. Errors </H3> <P>This section describes the various kinds of errors you can encounter when using LAMMPS. </P> 9.1 <A HREF = "#9_1">Common problems</A><BR> 9.2 <A HREF = "#9_2">Reporting bugs</A><BR> 9.3 <A HREF = "#9_3">Error & warning messages</A> <BR> <HR> <A NAME = "9_1"></A><H4>9.1 Common problems </H4> <P>If two LAMMPS runs do not produce the same answer on different machines or different numbers of processors, this is typically not a bug. In theory you should get identical answers on any number of processors and on any machine. In practice, numerical round-off can cause slight differences and eventual divergence of molecular dynamics phase space trajectories within a few 100s or few 1000s of timesteps. However, the statistical properties of the two runs (e.g. average energy or temperature) should still be the same. </P> <P>If the <A HREF = "velocity.html">velocity</A> command is used to set initial atom velocities, a particular atom can be assigned a different velocity when the problem on different machines. Obviously, this means the phase space trajectories of the two simulations will rapidly diverge. See the discussion of the <I>loop</I> option in the <A HREF = "velocity.html">velocity</A> command for details. </P> <P>Similarly, the <A HREF = "create_atoms.html">create_atoms</A> command generates a lattice of atoms. For the same physical system, the ordering and numbering of atoms by atom ID may be different depending on the number of processors. </P> <P>Some commands use random number generators which may be setup to produce different random number streams on each processor and hence will produce different effects when run on different numbers of processors. A commonly-used example is the <A HREF = "fix_langevin.html">fix langevin</A> command for thermostatting. </P> <P>A LAMMPS simulation typically has two stages, setup and run. Most LAMMPS errors are detected at setup time; others like a bond stretching too far may not occur until the middle of a run. </P> <P>LAMMPS tries to flag errors and print informative error messages so you can fix the problem. Of course LAMMPS cannot figure out your physics mistakes, like choosing too big a timestep, specifying invalid force field coefficients, or putting 2 atoms on top of each other! If you find errors that LAMMPS doesn't catch that you think it should flag, please send an email to the <A HREF = "http://lammps.sandia.gov/authors.html">developers</A>. </P> <P>If you get an error message about an invalid command in your input script, you can determine what command is causing the problem by looking in the log.lammps file or using the <A HREF = "echo.html">echo command</A> to see it on the screen. For a given command, LAMMPS expects certain arguments in a specified order. If you mess this up, LAMMPS will often flag the error, but it may read a bogus argument and assign a value that is valid, but not what you wanted. E.g. trying to read the string "abc" as an integer value and assigning the associated variable a value of 0. </P> <P>Generally, LAMMPS will print a message to the screen and exit gracefully when it encounters a fatal error. Sometimes it will print a WARNING and continue on; you can decide if the WARNING is important or not. If LAMMPS crashes or hangs without spitting out an error message first then it could be a bug (see <A HREF = "#9_2">this section</A>) or one of the following cases: </P> <P>LAMMPS runs in the available memory a processor allows to be allocated. Most reasonable MD runs are compute limited, not memory limited, so this shouldn't be a bottleneck on most platforms. Almost all large memory allocations in the code are done via C-style malloc's which will generate an error message if you run out of memory. Smaller chunks of memory are allocated via C++ "new" statements. If you are unlucky you could run out of memory just when one of these small requests is made, in which case the code will crash or hang (in parallel), since LAMMPS doesn't trap on those errors. </P> <P>Illegal arithmetic can cause LAMMPS to run slow or crash. This is typically due to invalid physics and numerics that your simulation is computing. If you see wild thermodynamic values or NaN values in your LAMMPS output, something is wrong with your simulation. </P> <P>In parallel, one way LAMMPS can hang is due to how different MPI implementations handle buffering of messages. If the code hangs without an error message, it may be that you need to specify an MPI setting or two (usually via an environment variable) to enable buffering or boost the sizes of messages that can be buffered. </P> <HR> <A NAME = "9_2"></A><H4>9.2 Reporting bugs </H4> <P>If you are confident that you have found a bug in LAMMPS, follow these steps. </P> <P>Check the <A HREF = "http://lammps.sandia.gov/bug.html">New features and bug fixes</A> section of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW site</A> to see if the bug has already been reported or fixed or the <A HREF = "http://lammps.sandia.gov/unbug.html">Unfixed bug</A> to see if a fix is pending. </P> <P>Check the <A HREF = "http://lammps.sandia.gov/mail.html">mailing list</A> to see if it has been discussed before. </P> <P>If not, send an email to the mailing list describing the problem with any ideas you have as to what is causing it or where in the code the problem might be. The developers will ask for more info if needed, such as an input script or data files. </P> <P>The most useful thing you can do to help us fix the bug is to isolate the problem. Run it on the smallest number of atoms and fewest number of processors and with the simplest input script that reproduces the bug and try to identify what command or combination of commands is causing the problem. </P> <P>As a last resort, you can send an email directly to the <A HREF = "http://lammps.sandia.gov/authors.html">developers</A>. </P> <HR> <H4><A NAME = "9_3"></A>9.3 Error & warning messages </H4> <P>These are two alphabetic lists of the <A HREF = "#error">ERROR</A> and <A HREF = "#warn">WARNING</A> messages LAMMPS prints out and the reason why. If the explanation here is not sufficient, the documentation for the offending command may help. Grepping the source files for the text of the error message and staring at the source code and comments is also not a bad idea! Note that sometimes the same message can be printed from multiple places in the code. </P> <P>Also note that error messages from <A HREF = "Section_start.html#2_3">user-contributed packages</A> are not listed here. Is such an error occurs and is not self-explanatory, you'll need to look in the source code or contact the author of the package. </P> <H4><A NAME = "error"></A>Errors: </H4> <DL> <DT><I>1-3 bond count is inconsistent</I> <DD>An inconsistency was detected when computing the number of 1-3 neighbors for each atom. This likely means something is wrong with the bond topologies you have defined. <DT><I>1-4 bond count is inconsistent</I> <DD>An inconsistency was detected when computing the number of 1-4 neighbors for each atom. This likely means something is wrong with the bond topologies you have defined. <DT><I>All angle coeffs are not set</I> <DD>All angle coefficients must be set in the data file or by the angle_coeff command before running a simulation. <DT><I>All bond coeffs are not set</I> <DD>All bond coefficients must be set in the data file or by the bond_coeff command before running a simulation. <DT><I>All dihedral coeffs are not set</I> <DD>All dihedral coefficients must be set in the data file or by the dihedral_coeff command before running a simulation. <DT><I>All dipole moments are not set</I> <DD>For atom styles that define dipole moments for each atom type, all moments must be set in the data file or by the dipole command before running a simulation. <DT><I>All improper coeffs are not set</I> <DD>All improper coefficients must be set in the data file or by the improper_coeff command before running a simulation. <DT><I>All masses are not set</I> <DD>For atom styles that define masses for each atom type, all masses must be set in the data file or by the mass command before running a simulation. They must also be set before using the velocity command. <DT><I>All pair coeffs are not set</I> <DD>All pair coefficients must be set in the data file or by the pair_coeff command before running a simulation. <DT><I>All shapes are not set</I> <DD>All atom types must have a shape setting, even if the particles are spherical. <DT><I>All universe/uloop variables must have same # of values</I> <DD>Self-explanatory. <DT><I>All variables in next command must be same style</I> <DD>Self-explanatory. <DT><I>Angle atom missing in delete_bonds</I> <DD>The delete_bonds command cannot find one or more atoms in a particular angle on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid angle. <DT><I>Angle atom missing in set command</I> <DD>The set command cannot find one or more atoms in a particular angle on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid angle. <DT><I>Angle atoms %d %d %d missing on proc %d at step %d</I> <DD>One or more of 3 atoms needed to compute a particular angle are missing on this processor. Typically this is because the pairwise cutoff is set too short or the angle has blown apart and an atom is too far away. <DT><I>Angle coeff for hybrid has invalid style</I> <DD>Angle style hybrid uses another angle style as one of its coefficients. The angle style used in the angle_coeff command or read from a restart file is not recognized. <DT><I>Angle coeffs are not set</I> <DD>No angle coefficients have been assigned in the data file or via the angle_coeff command. <DT><I>Angle potential must be defined for SHAKE</I> <DD>When shaking angles, an angle_style potential must be used. <DT><I>Angle style hybrid cannot have hybrid as an argument</I> <DD>Self-explanatory. <DT><I>Angle style hybrid cannot have none as an argument</I> <DD>Self-explanatory. <DT><I>Angle style hybrid cannot use same angle style twice</I> <DD>Self-explanatory. <DT><I>Angle_coeff command before angle_style is defined</I> <DD>Coefficients cannot be set in the data file or via the angle_coeff command until an angle_style has been assigned. <DT><I>Angle_coeff command before simulation box is defined</I> <DD>The angle_coeff command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Angle_coeff command when no angles allowed</I> <DD>The chosen atom style does not allow for angles to be defined. <DT><I>Angle_style command when no angles allowed</I> <DD>The chosen atom style does not allow for angles to be defined. <DT><I>Angles assigned incorrectly</I> <DD>Angles read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. <DT><I>Angles defined but no angle types</I> <DD>The data file header lists angles but no angle types. <DT><I>Another input script is already being processed</I> <DD>Cannot attempt to open a 2nd input script, when the original file is still being processed. <DT><I>Arccos of invalid value in variable formula</I> <DD>Argument of arccos() must be between -1 and 1. <DT><I>Arcsin of invalid value in variable formula</I> <DD>Argument of arcsin() must be between -1 and 1. <DT><I>Atom IDs must be consecutive for dump dcd</I> <DD>Self-explanatory. <DT><I>Atom IDs must be consecutive for dump xtc</I> <DD>Self-explanatory. <DT><I>Atom IDs must be consecutive for dump xyz</I> <DD>Self-explanatory. <DT><I>Atom IDs must be consecutive for velocity create loop all</I> <DD>Self-explanatory. <DT><I>Atom count is inconsistent, cannot write restart file</I> <DD>Sum of atoms across processors does not equal initial total count. This is probably because you have lost some atoms. <DT><I>Atom in too many rigid bodies - boost MAXBODY</I> <DD>Fix poems has a parameter MAXBODY (in fix_poems.cpp) which determines the maximum number of rigid bodies a single atom can belong to (i.e. a multibody joint). The bodies you have defined exceed this limit. <DT><I>Atom style hybrid cannot have hybrid as an argument</I> <DD>Self-explanatory. <DT><I>Atom style hybrid cannot use same atom style twice</I> <DD>Self-explanatory. <DT><I>Atom vector in equal-style variable formula</I> <DD>Atom vectors generate one value per atom which is not allowed in an equal-style variable. <DT><I>Atom-style variable in equal-style variable formula</I> <DD>Atom-style variables generate one value per atom which is not allowed in an equal-style variable. <DT><I>Atom_modify command after simulation box is defined</I> <DD>The atom_modify command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Atom_style command after simulation box is defined</I> <DD>The atom_style command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Attempting to rescale a 0.0 temperature</I> <DD>Cannot rescale a temperature that is already 0.0. <DT><I>Bad FENE bond</I> <DD>Two atoms in a FENE bond have become so far apart that the bond cannot be computed. <DT><I>Bad grid of processors</I> <DD>The 3d grid of processors defined by the processors command does not match the number of processors LAMMPS is being run on. <DT><I>Bad kspace_modify slab parameter</I> <DD>Kspace_modify value for the slab/volume keyword must be >= 2.0. <DT><I>Bad principal moments</I> <DD>Fix rigid did not compute the principal moments of inertia of a rigid group of atoms correctly. <DT><I>Bias compute does not calculate a velocity bias</I> <DD>The specified compute must compute a bias for temperature. <DT><I>Bias compute does not calculate temperature</I> <DD>The specified compute must compute temperature. <DT><I>Bias compute group does not match compute group</I> <DD>The specified compute must operate on the same group as the parent compute. <DT><I>Bitmapped lookup tables require int/float be same size</I> <DD>Cannot use pair tables on this machine, because of word sizes. Use the pair_modify command with table 0 instead. <DT><I>Bitmapped table in file does not match requested table</I> <DD>Setting for bitmapped table in pair_coeff command must match table in file exactly. <DT><I>Bitmapped table is incorrect length in table file</I> <DD>Number of table entries is not a correct power of 2. <DT><I>Bond and angle potentials must be defined for TIP4P</I> <DD>Cannot use TIP4P pair potential unless bond and angle potentials are defined. <DT><I>Bond atom missing in delete_bonds</I> <DD>The delete_bonds command cannot find one or more atoms in a particular bond on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid bond. <DT><I>Bond atom missing in set command</I> <DD>The set command cannot find one or more atoms in a particular bond on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid bond. <DT><I>Bond atoms %d %d missing on proc %d at step %d</I> <DD>One or both of 2 atoms needed to compute a particular bond are missing on this processor. Typically this is because the pairwise cutoff is set too short or the bond has blown apart and an atom is too far away. <DT><I>Bond coeff for hybrid has invalid style</I> <DD>Bond style hybrid uses another bond style as one of its coefficients. The bond style used in the bond_coeff command or read from a restart file is not recognized. <DT><I>Bond coeffs are not set</I> <DD>No bond coefficients have been assigned in the data file or via the bond_coeff command. <DT><I>Bond potential must be defined for SHAKE</I> <DD>Cannot use fix shake unless bond potential is defined. <DT><I>Bond style hybrid cannot have hybrid as an argument</I> <DD>Self-explanatory. <DT><I>Bond style hybrid cannot have none as an argument</I> <DD>Self-explanatory. <DT><I>Bond style hybrid cannot use same bond style twice</I> <DD>The sub-style arguments of bond_style hybrid cannot be duplicated. Check the input script. <DT><I>Bond style quartic cannot be used with 3,4-body interactions</I> <DD>No angle, dihedral, or improper styles can be defined when using bond style quartic. <DT><I>Bond style quartic requires special_bonds = 1,1,1</I> <DD>This is a restriction of the current bond quartic implementation. <DT><I>Bond_coeff command before bond_style is defined</I> <DD>Coefficients cannot be set in the data file or via the bond_coeff command until an bond_style has been assigned. <DT><I>Bond_coeff command before simulation box is defined</I> <DD>The bond_coeff command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Bond_coeff command when no bonds allowed</I> <DD>The chosen atom style does not allow for bonds to be defined. <DT><I>Bond_style command when no bonds allowed</I> <DD>The chosen atom style does not allow for bonds to be defined. <DT><I>Bonds assigned incorrectly</I> <DD>Bonds read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. <DT><I>Bonds defined but no bond types</I> <DD>The data file header lists bonds but no bond types. <DT><I>Both sides of boundary must be periodic</I> <DD>Cannot specify a boundary as periodic only on the lo or hi side. Must be periodic on both sides. <DT><I>Boundary command after simulation box is defined</I> <DD>The boundary command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Box bounds are invalid</I> <DD>The box boundaries specified in the read_data file are invalid. The lo value must be less than the hi value for all 3 dimensions. <DT><I>Cannot (yet) use PPPM with triclinic box</I> <DD>This feature is not yet supported. <DT><I>Cannot change box to orthogonal when tilt is non-zero</I> <DD>Self-explanatory <DT><I>Cannot change box with certain fixes defined</I> <DD>The change_box command cannot be used when fix ave/spatial or fix/deform are defined . <DT><I>Cannot change box with dumps defined</I> <DD>Self-explanatory. <DT><I>Cannot change dump_modify every for dump dcd</I> <DD>The frequency of writing dump dcd snapshots cannot be changed. <DT><I>Cannot change timestep with fix pour</I> <DD>This fix pre-computes some values based on the timestep, so it cannot be changed during a simulation run. <DT><I>Cannot compute PPPM G</I> <DD>LAMMPS failed to compute a valid approximation for the PPPM g_ewald factor that partitions the computation between real space and k-space. <DT><I>Cannot create an atom map unless atoms have IDs</I> <DD>The simulation requires a mapping from global atom IDs to local atoms, but the atoms that have been defined have no IDs. <DT><I>Cannot create atoms with undefined lattice</I> <DD>Must use the lattice command before using the create_atoms command. <DT><I>Cannot create_box after simulation box is defined</I> <DD>The create_box command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Cannot delete group all</I> <DD>Self-explanatory. <DT><I>Cannot delete group currently used by a compute</I> <DD>Self-explanatory. <DT><I>Cannot delete group currently used by a dump</I> <DD>Self-explanatory. <DT><I>Cannot delete group currently used by a fix</I> <DD>Self-explanatory. <DT><I>Cannot delete group currently used by atom_modify first</I> <DD>Self-explanatory. <DT><I>Cannot displace_box on a non-periodic boundary</I> <DD>Self-explanatory. <DT><I>Cannot evaporate atoms in atom_modify first group</I> <DD>This is a restriction due to the way atoms are organized in a list to enable the atom_modify first command. <DT><I>Cannot find delete_bonds group ID</I> <DD>Group ID used in the delete_bonds command does not exist. <DT><I>Cannot fix deform on a non-periodic boundary</I> <DD>Only a periodic boundary can be modified. <DT><I>Cannot have both pair_modify shift and tail set to yes</I> <DD>These 2 options are contradictory. <DT><I>Cannot open AIREBO potential file %s</I> <DD>Self-explanatory. <DT><I>Cannot open EAM potential file %s</I> <DD>The specified EAM potential file cannot be opened. Check that the path and name are correct. <DT><I>Cannot open MEAM potential file %s</I> <DD>The specified MEAM potential file cannot be opened. Check that the path and name are correct. <DT><I>Cannot open Stillinger-Weber potential file %s</I> <DD>The specified SW potential file cannot be opened. Check that the path and name are correct. <DT><I>Cannot open Tersoff potential file %s</I> <DD>The specified Tersoff potential file cannot be opened. Check that the path and name are correct. <DT><I>Cannot open dir to search for restart file</I> <DD>Using a "*" in the name of the restart file will open the current directory to search for matching file names. <DT><I>Cannot open dump file</I> <DD>The output file for the dump command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open file %s</I> <DD>The specified file cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix ave/spatial file %s</I> <DD>Self-explanatory. <DT><I>Cannot open fix ave/time file %s</I> <DD>Self-explanatory. <DT><I>Cannot open fix com file %s</I> <DD>The output file for the fix com command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix gyration file %s</I> <DD>Self-explanatory. <DT><I>Cannot open fix msd file %s</I> <DD>The output file for the fix msd command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix poems file %s</I> <DD>The specified file cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix print file %s</I> <DD>The output file generated by the fix print command cannot be opened <DT><I>Cannot open fix rdf file %s</I> <DD>The output file for the fix rdf command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix reax/bonds file %s</I> <DD>The output file for the fix reax/bonds command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix tmd file %s</I> <DD>The output file for the fix tmd command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open fix ttm file %s</I> <DD>The output file for the fix ttm command cannot be opened. Check that the path and name are correct. <DT><I>Cannot open gzipped file</I> <DD>LAMMPS is attempting to open a gzipped version of the specified file but was unsuccessful. Check that the path and name are correct. <DT><I>Cannot open input script %s</I> <DD>Self-explanatory. <DT><I>Cannot open log.lammps</I> <DD>The default LAMMPS log file cannot be opened. Check that the directory you are running in allows for files to be created. <DT><I>Cannot open logfile %s</I> <DD>The LAMMPS log file specified in the input script cannot be opened. Check that the path and name are correct. <DT><I>Cannot open logfile</I> <DD>The LAMMPS log file named in a command-line argument cannot be opened. Check that the path and name are correct. <DT><I>Cannot open pair_write file</I> <DD>The specified output file for pair energies and forces cannot be opened. Check that the path and name are correct. <DT><I>Cannot open restart file %s</I> <DD>Self-explanatory. <DT><I>Cannot open screen file</I> <DD>The screen file specified as a command-line argument cannot be opened. Check that the directory you are running in allows for files to be created. <DT><I>Cannot open universe log file</I> <DD>For a multi-partition run, the master log file cannot be opened. Check that the directory you are running in allows for files to be created. <DT><I>Cannot open universe screen file</I> <DD>For a multi-partition run, the master screen file cannot be opened. Check that the directory you are running in allows for files to be created. <DT><I>Cannot read_data after simulation box is defined</I> <DD>The read_data command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Cannot read_restart after simulation box is defined</I> <DD>The read_restart command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Cannot redefine variable as a different style</I> <DD>An equal-style variable can be re-defined but only if it was originally an equal-style variable. <DT><I>Cannot replicate 2d simulation in z dimension</I> <DD>The replicate command cannot replicate a 2d simulation in the z dimension. <DT><I>Cannot replicate with fixes that store atom quantities</I> <DD>Either fixes are defined that create and store atom-based vectors or a restart file was read which included atom-based vectors for fixes. The replicate command cannot duplicate that information for new atoms. You should use the replicate command before fixes are applied to the system. <DT><I>Cannot reset timestep with a time-dependent fix defined</I> <DD>You cannot reset the timestep when a fix that keeps track of elapsed time is in place. <DT><I>Cannot reset timestep with dump file already written to</I> <DD>Changing the timestep will confuse when a dump file is written. Use the undump command, then restart the dump file. <DT><I>Cannot reset timestep with restart file already written</I> <DD>Changing the timestep will confuse when a restart file is written. Use the "restart 0" command to turn off restarts, then start them again. <DT><I>Cannot run 2d simulation with nonperiodic Z dimension</I> <DD>Use the boundary command to make the z dimension periodic in order to run a 2d simulation. <DT><I>Cannot set both respa pair and inner/middle/outer</I> <DD>In the rRESPA integrator, you must compute pairwise potentials either all together (pair), or in pieces (inner/middle/outer). You can't do both. <DT><I>Cannot set dipole for this atom style</I> <DD>This atom style does not support dipole settings for each atom type. <DT><I>Cannot set dump_modify flush for dump xtc</I> <DD>Self-explanatory. <DT><I>Cannot set mass for this atom style</I> <DD>This atom style does not support mass settings for each atom type. Instead they are defined on a per-atom basis in the data file. <DT><I>Cannot set respa middle without inner/outer</I> <DD>In the rRESPA integrator, you must define both a inner and outer setting in order to use a middle setting. <DT><I>Cannot set shape for this atom style</I> <DD>The atom style does not support this setting. <DT><I>Cannot set this attribute for this atom style</I> <DD>The attribute being set does not exist for the defined atom style. <DT><I>Cannot skew triclinic box in z for 2d simulation</I> <DD>Self-explanatory. <DT><I>Cannot use Ewald with 2d simulation</I> <DD>The kspace style ewald cannot be used in 2d simulations. You can use 2d Ewald in a 3d simulation; see the kspace_modify command. <DT><I>Cannot use Ewald with triclinic box</I> <DD>This feature is not yet supported. <DT><I>Cannot use PPPM with 2d simulation</I> <DD>The kspace style pppm cannot be used in 2d simulations. You can use 2d PPPM in a 3d simulation; see the kspace_modify command. <DT><I>Cannot use delete_atoms unless atoms have IDs</I> <DD>Your atoms do not have IDs, so the delete_atoms command cannot be used. <DT><I>Cannot use delete_bonds with non-molecular system</I> <DD>Your choice of atom style does not have bonds. <DT><I>Cannot use dump bond with non-molecular system</I> <DD>Your choice of atom style does not have bonds. <DT><I>Cannot use fix TMD unless atom map exists</I> <DD>Using this fix requires the ability to lookup an atom index, which is provided by an atom map. An atom map does not exist (by default) for non-molecular problems. Using the atom_modify map command will force an atom map to be created. <DT><I>Cannot use fix bond/break with non-molecular systems</I> <DD>Self-explanatory. <DT><I>Cannot use fix bond/create with non-molecular systems</I> <DD>Self-explanatory. <DT><I>Cannot use fix box/relax on a non-periodic dimension</I> <DD>Only periodic dimensions can be controlled with this fix. <DT><I>Cannot use fix deform trate on a box with zero tilt</I> <DD>The trate style alters the current strain. <DT><I>Cannot use fix enforce2d with 3d simulation</I> <DD>Self-explanatory. <DT><I>Cannot use fix nph on a non-periodic dimension</I> <DD>Only periodic dimensions can be controlled with this fix. <DT><I>Cannot use fix nph with triclinic box</I> <DD>This feature is not yet supported. <DT><I>Cannot use fix npt and fix deform on same dimension</I> <DD>These commands both change the box size/shape, so you cannot use both together. <DT><I>Cannot use fix npt on a non-periodic dimension</I> <DD>Only periodic dimensions can be controlled with this fix. <DT><I>Cannot use fix npt with triclinic box</I> <DD>This feature is not yet supported. <DT><I>Cannot use fix pour with triclinic box</I> <DD>This feature is not yet supported. <DT><I>Cannot use fix press/berendsen and fix deform on same dimension</I> <DD>Self-explanatory. <DT><I>Cannot use fix press/berendsen on a non-periodic dimension</I> <DD>Self-explanatory. <DT><I>Cannot use fix press/berendsen with triclinic box</I> <DD>Self-explanatory. <DT><I>Cannot use fix reax/bonds without pair_style reax</I> <DD>Self-explantory. <DT><I>Cannot use fix shake with non-molecular system</I> <DD>Your choice of atom style does not have bonds. <DT><I>Cannot use fix ttm with 2d simulation</I> <DD>This is a current restriction of this fix due to the grid it creates. <DT><I>Cannot use fix ttm with triclinic box</I> <DD>This is a current restriction of this fix due to the grid it creates. <DT><I>Cannot use kspace solver on system with no charge</I> <DD>No atoms in system have a non-zero charge. <DT><I>Cannot use neighbor bins - box size << cutoff</I> <DD>Too many neighbor bins will be created. This typically happens when the simulation box is very small in some dimension, compared to the neighbor cutoff. Use the "nsq" style instead of "bin" style. <DT><I>Cannot use nonperiodic boundares with fix ttm</I> <DD>This fix requires a fully periodic simulation box. <DT><I>Cannot use nonperiodic boundaries with Ewald</I> <DD>For kspace style ewald, all 3 dimensions must have periodic boundaries unless you use the kspace_modify command to define a 2d slab with a non-periodic z dimension. <DT><I>Cannot use nonperiodic boundaries with PPPM</I> <DD>For kspace style pppm, all 3 dimensions must have periodic boundaries unless you use the kspace_modify command to define a 2d slab with a non-periodic z dimension. <DT><I>Cannot use pair tail corrections with 2d simulations</I> <DD>The correction factors are only currently defined for 3d systems. <DT><I>Cannot use region INF or EDGE when box does not exist</I> <DD>Regions that extend to the box boundaries can only be used after the create_box command has been used. <DT><I>Cannot use set atom with no atom IDs defined</I> <DD>Atom IDs are not defined, so they cannot be used to identify an atom. <DT><I>Cannot use velocity create loop all unless atoms have IDs</I> <DD>Atoms in the simulation to do not have IDs, so this style of velocity creation cannot be performed. <DT><I>Cannot use wall in periodic dimension</I> <DD>Self-explanatory. <DT><I>Cannot wiggle and shear fix wall/gran</I> <DD>Cannot specify both options at the same time. <DT><I>Cannot zero momentum of 0 atoms</I> <DD>The collection of atoms for which momentum is being computed has no atoms. <DT><I>Change_box command before simulation box is defined</I> <DD>Self-explanatory. <DT><I>Change_box operation is invalid</I> <DD>Cannot change orthogonal box to orthogonal or a triclinic box to triclinic. <DT><I>Communicate group != atom_modify first group</I> <DD>Self-explanatory. -<DT><I>Compute erotate/asphere requires extended particles</I> - -<DD>This quantity can only be calculated for particles with a shape -setting. +<DT><I>Compute ID for compute heat/flux does not exist</I> -<DT><I>Compute temp/asphere requires extended particles</I> - -<DD>This quantity can only be calculated for particles with a shape -setting. +<DD>Self-explanatory. <DT><I>Compute ID for compute reduce does not exist</I> <DD>Self-explanatory. <DT><I>Compute ID for fix ave/atom does not exist</I> <DD>Self-explanatory. <DT><I>Compute ID for fix ave/spatial does not exist</I> <DD>Self-explanatory. <DT><I>Compute ID for fix ave/time does not exist</I> <DD>Self-explanatory. <DT><I>Compute ID must be alphanumeric or underscore characters</I> <DD>Self-explanatory. <DT><I>Compute centro/atom requires a pair style be defined</I> <DD>This is because the computation of the centro-symmetry values uses a pairwise neighbor list. <DT><I>Compute cna/atom cutoff is longer than pairwise cutoff</I> <DD>Self-explantory. <DT><I>Compute cna/atom requires a pair style be defined</I> <DD>Self-explantory. <DT><I>Compute coord/atom cutoff is longer than pairwise cutoff</I> <DD>Cannot compute coordination at distances longer than the pair cutoff, since those atoms are not in the neighbor list. <DT><I>Compute coord/atom requires a pair style be defined</I> <DD>Self-explantory. <DT><I>Compute damage/atom requires peridynamic potential</I> <DD>Damage is a Peridynamic-specific metric. It requires you to be running a Peridynamics simulation. +<DT><I>Compute does not allow an extra compute to be reset</I> + +<DD>This is an internal LAMMPS error. Please report it to the +developers. + <DT><I>Compute erotate/asphere cannot be used with atom attributes diameter or rmass</I> <DD>These attributes override the shape and mass settings, so cannot be used. <DT><I>Compute erotate/asphere requires atom attributes angmom, quat, shape</I> <DD>An atom style that defines these attributes must be used. +<DT><I>Compute erotate/asphere requires extended particles</I> + +<DD>This compute cannot be used with point paritlces. + <DT><I>Compute erotate/sphere requires atom attribute omega</I> <DD>An atom style that defines this attribute must be used. <DT><I>Compute erotate/sphere requires atom attribute radius or shape</I> <DD>An atom style that defines these attributes must be used. <DT><I>Compute erotate/sphere requires spherical particle shapes</I> <DD>Self-explanatory. <DT><I>Compute group/group group ID does not exist</I> <DD>Self-explanatory. +<DT><I>Compute heat/flux compute ID does not compute pe/atom</I> + +<DD>Self-explanatory. + +<DT><I>Compute heat/flux requires ghost atoms store velocity</I> + +<DD>An atom style that stores this, like atom_style dpd, must be used. + <DT><I>Compute pe must use group all</I> <DD>Energies computed by potentials (pair, bond, etc) are computed on all atoms. <DT><I>Compute pressure must use group all</I> <DD>Virial contributions computed by potentials (pair, bond, etc) are computed on all atoms. -<DT><I>Compute pressure temp ID does not compute temperature</I> +<DT><I>Compute pressure temperature ID does not compute temperature</I> <DD>The compute ID assigned to a pressure computation must compute temperature. <DT><I>Compute reduce compute does not calculate a per-atom scalar</I> <DD>Self-explanatory. <DT><I>Compute reduce compute does not calculate a per-atom vector</I> <DD>Self-explanatory. <DT><I>Compute reduce compute does not calculate per-atom values</I> <DD>Self-explanatory. <DT><I>Compute reduce fix does not calculate a per-atom scalar</I> <DD>Self-explanatory. <DT><I>Compute reduce fix does not calculate a per-atom vector</I> <DD>Self-explanatory. <DT><I>Compute reduce fix does not calculate per-atom values</I> <DD>Self-explanatory. <DT><I>Compute reduce region ID does not exist</I> <DD>Self-explanatory. <DT><I>Compute reduce variable is not atom-style variable</I> <DD>Self-explanatory. <DT><I>Compute temp/asphere cannot be used with atom attributes diameter or rmass</I> <DD>These attributes override the shape and mass settings, so cannot be used. <DT><I>Compute temp/asphere requires atom attributes angmom, quat, shape</I> <DD>An atom style that defines these attributes must be used. -<DT><I>Compute temp/partial cannot use vz for 2d systems</I> +<DT><I>Compute temp/asphere requires extended particles</I> -<DD>Self-explanatory. +<DD>This compute cannot be used with point paritlces. -<DT><I>Compute temp/profile cannot use vz for 2d systems</I> +<DT><I>Compute temp/partial cannot use vz for 2d systemx</I> <DD>Self-explanatory. <DT><I>Compute temp/profile cannot bin z for 2d systems</I> <DD>Self-explanatory. +<DT><I>Compute temp/profile cannot use vz for 2d systemx</I> + +<DD>Self-explanatory. + <DT><I>Compute temp/sphere requires atom attribute omega</I> <DD>An atom style that defines this attribute must be used. <DT><I>Compute temp/sphere requires atom attribute radius or shape</I> <DD>An atom style that defines these attributes must be used. <DT><I>Compute temp/sphere requires spherical particle shapes</I> <DD>Self-explanatory. <DT><I>Compute used in variable between runs is not current</I> <DD>Computes cannot be invoked by a variable in between runs. Thus they must have been evaluated on the last timestep of the previous run in order for their value(s) to be accessed. See the doc page for the variable command for more info. <DT><I>Compute used in variable thermo keyword between runs is not current</I> <DD>Some thermo keywords rely on a compute to calculate their value(s). Computes cannot be invoked by a variable in between runs. Thus they must have been evaluated on the last timestep of the previous run in order for their value(s) to be accessed. See the doc page for the variable command for more info. <DT><I>Compute vector in variable formula is too small</I> <DD>The index to the vector is out of bounds. <DT><I>Computed temperature for fix temp/berendsen cannot be 0.0</I> <DD>Self-explanatory. <DT><I>Computed temperature for fix temp/rescale cannot be 0.0</I> <DD>Cannot rescale the temperature to a new value if the current temperature is 0.0. <DT><I>Could not count initial bonds in fix bond/create</I> <DD>Could not find one of the atoms in a bond on this processor. <DT><I>Could not create 3d FFT plan</I> <DD>The FFT setup in pppm failed. <DT><I>Could not create 3d remap plan</I> <DD>The FFT setup in pppm failed. <DT><I>Could not find atom_modify first group ID</I> <DD>Self-explanatory. <DT><I>Could not find compute ID for temperature bias</I> <DD>Self-explanatory. <DT><I>Could not find compute ID to delete</I> <DD>Self-explanatory. <DT><I>Could not find compute displace/atom fix ID</I> <DD>Self-explanatory. <DT><I>Could not find compute group ID</I> <DD>Self-explanatory. -<DT><I>Could not find compute pressure temp ID</I> +<DT><I>Could not find compute heat/flux compute ID</I> -<DD>The compute ID for calculating temperature does not exist. +<DD>Self-explanatory. -<DT><I>Could not find compute_modify ID</I> +<DT><I>Could not find compute pressure temperature ID</I> -<DD>Self-explanatory. +<DD>The compute ID for calculating temperature does not exist. -<DT><I>Could not find group delete ID</I> +<DT><I>Could not find compute_modify ID</I> <DD>Self-explanatory. <DT><I>Could not find delete_atoms group ID</I> <DD>Group ID used in the delete_atoms command does not exist. <DT><I>Could not find delete_atoms region ID</I> <DD>Region ID used in the delete_atoms command does not exist. <DT><I>Could not find displace_atoms group ID</I> <DD>Group ID used in the displace_atoms command does not exist. <DT><I>Could not find displace_box group ID</I> <DD>Group ID used in the displace_box command does not exist. <DT><I>Could not find dump custom compute ID</I> <DD>The compute ID needed by dump custom to compute a per-atom quantity does not exist. <DT><I>Could not find dump custom fix ID</I> <DD>Self-explanatory. <DT><I>Could not find dump custom variable name</I> <DD>Self-explanatory. <DT><I>Could not find dump group ID</I> <DD>A group ID used in the dump command does not exist. <DT><I>Could not find fix ID to delete</I> <DD>Self-explanatory. <DT><I>Could not find fix group ID</I> <DD>A group ID used in the fix command does not exist. <DT><I>Could not find fix poems group ID</I> <DD>A group ID used in the fix poems command does not exist. <DT><I>Could not find fix recenter group ID</I> <DD>A group ID used in the fix recenter command does not exist. <DT><I>Could not find fix rigid group ID</I> <DD>A group ID used in the fix rigid command does not exist. <DT><I>Could not find fix_modify ID</I> <DD>A fix ID used in the fix_modify command does not exist. <DT><I>Could not find fix_modify pressure ID</I> <DD>The compute ID for computing pressure does not exist. -<DT><I>Could not find fix_modify temp ID</I> +<DT><I>Could not find fix_modify temperature ID</I> <DD>The compute ID for computing temperature does not exist. +<DT><I>Could not find group delete group ID</I> + +<DD>Self-explanatory. + <DT><I>Could not find set group ID</I> <DD>Group ID specified in set command does not exist. <DT><I>Could not find thermo compute ID</I> <DD>Compute ID specified in thermo_style command does not exist. <DT><I>Could not find thermo custom compute ID</I> <DD>The compute ID needed by thermo style custom to compute a requested quantity does not exist. <DT><I>Could not find thermo custom fix ID</I> <DD>The fix ID needed by thermo style custom to compute a requested quantity does not exist. <DT><I>Could not find thermo custom variable name</I> <DD>Self-explanatory. <DT><I>Could not find thermo fix ID</I> <DD>Fix ID specified in thermo_style command does not exist. -<DT><I>Could not find thermo_modify press ID</I> +<DT><I>Could not find thermo_modify pressure ID</I> <DD>The compute ID needed by thermo style custom to compute pressure does not exist. -<DT><I>Could not find thermo_modify temp ID</I> +<DT><I>Could not find thermo_modify temperature ID</I> <DD>The compute ID needed by thermo style custom to compute temperature does not exist. <DT><I>Could not find undump ID</I> <DD>A dump ID used in the undump command does not exist. <DT><I>Could not find velocity group ID</I> <DD>A group ID used in the velocity command does not exist. -<DT><I>Could not find velocity temp ID</I> +<DT><I>Could not find velocity temperature ID</I> <DD>The compute ID needed by the velocity command to compute temperature does not exist. <DT><I>Could not set finite-size particle attribute in fix rigid</I> <DD>The particle has a finite size but its attributes could not be determined. <DT><I>Coulomb cutoffs of pair hybrid sub-styles do not match</I> <DD>If using a Kspace solver, all Coulomb cutoffs of long pair styles must be the same. <DT><I>Cound not find dump_modify ID</I> <DD>Self-explanatory. <DT><I>Create_atoms command before simulation box is defined</I> <DD>The create_atoms command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Create_atoms region ID does not exist</I> <DD>A region ID used in the create_atoms command does not exist. <DT><I>Create_box region ID does not exist</I> <DD>A region ID used in the create_box command does not exist. <DT><I>Create_box region must be of type inside</I> <DD>The region used in the create_box command must not be an "outside" region. See the region command for details. <DT><I>Cyclic loop in joint connections</I> <DD>Fix poems cannot (yet) work with coupled bodies whose joints connect the bodies in a ring (or cycle). <DT><I>Degenerate lattice primitive vectors</I> <DD>Invalid set of 3 lattice vectors for lattice command. <DT><I>Delete_atoms command before simulation box is defined</I> <DD>The delete_atoms command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Delete_atoms cutoff > neighbor cutoff</I> <DD>Cannot delete atoms further away than a processor knows about. <DT><I>Delete_atoms requires a pair style be defined</I> <DD>This is because atom deletion within a cutoff uses a pairwise neighbor list. <DT><I>Delete_bonds command before simulation box is defined</I> <DD>The delete_bonds command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Delete_bonds command with no atoms existing</I> <DD>No atoms are yet defined so the delete_bonds command cannot be used. <DT><I>Deposition region extends outside simulation box</I> <DD>Self-explanatory. <DT><I>Did not assign all atoms correctly</I> <DD>Atoms read in from a data file were not assigned correctly to processors. This is likely due to some atom coordinates being outside a non-periodic simulation box. <DT><I>Did not find all elements in MEAM library file</I> <DD>The requested elements were not found in the MEAM file. <DT><I>Did not find fix shake partner info</I> <DD>Could not find bond partners implied by fix shake command. This error can be triggered if the delete_bonds command was used before fix shake, and it removed bonds without resetting the 1-2, 1-3, 1-4 weighting list via the special keyword. <DT><I>Did not find keyword in table file</I> <DD>Keyword used in pair_coeff command was not found in table file. <DT><I>Dihedral atom missing in delete_bonds</I> <DD>The delete_bonds command cannot find one or more atoms in a particular dihedral on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid dihedral. <DT><I>Dihedral atom missing in set command</I> <DD>The set command cannot find one or more atoms in a particular dihedral on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid dihedral. <DT><I>Dihedral atoms %d %d %d %d missing on proc %d at step %d</I> <DD>One or more of 4 atoms needed to compute a particular dihedral are missing on this processor. Typically this is because the pairwise cutoff is set too short or the dihedral has blown apart and an atom is too far away. <DT><I>Dihedral charmm is incompatible with Pair style</I> <DD>Dihedral style charmm must be used with a pair style charmm in order for the 1-4 epsilon/sigma parameters to be defined. <DT><I>Dihedral coeff for hybrid has invalid style</I> <DD>Dihedral style hybrid uses another dihedral style as one of its coefficients. The dihedral style used in the dihedral_coeff command or read from a restart file is not recognized. <DT><I>Dihedral coeffs are not set</I> <DD>No dihedral coefficients have been assigned in the data file or via the dihedral_coeff command. <DT><I>Dihedral style hybrid cannot have hybrid as an argument</I> <DD>Self-explanatory. <DT><I>Dihedral style hybrid cannot have none as an argument</I> <DD>Self-explanatory. <DT><I>Dihedral style hybrid cannot use same dihedral style twice</I> <DD>Self-explanatory. <DT><I>Dihedral_coeff command before dihedral_style is defined</I> <DD>Coefficients cannot be set in the data file or via the dihedral_coeff command until an dihedral_style has been assigned. <DT><I>Dihedral_coeff command before simulation box is defined</I> <DD>The dihedral_coeff command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Dihedral_coeff command when no dihedrals allowed</I> <DD>The chosen atom style does not allow for dihedrals to be defined. <DT><I>Dihedral_style command when no dihedrals allowed</I> <DD>The chosen atom style does not allow for dihedrals to be defined. <DT><I>Dihedrals assigned incorrectly</I> <DD>Dihedrals read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. <DT><I>Dihedrals defined but no dihedral types</I> <DD>The data file header lists dihedrals but no dihedral types. <DT><I>Dimension command after simulation box is defined</I> <DD>The dimension command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Dipole command before simulation box is defined</I> <DD>The dipole command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Displace_atoms command before simulation box is defined</I> <DD>The displace_atoms command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Displace_box command before simulation box is defined</I> <DD>Self-explanatory. <DT><I>Displace_box tilt factors require triclinic box</I> <DD>Cannot use tilt factors unless the simulation box is non-orthogonal. <DT><I>Divide by 0 in variable formula</I> <DD>Self-explanatory. <DT><I>Domain too large for neighbor bins</I> <DD>The domain has become extremely large so that neighbor bins cannot be used. Most likely, one or more atoms have been blown out of the simulation box to a great distance. <DT><I>Dump custom and fix not computed at compatible times</I> <DD>The fix must produce per-atom quantities on timesteps that dump custom needs them. <DT><I>Dump custom compute ID does not compute peratom info</I> <DD>The compute ID used must compute peratom info, not a global scalar or vector quantity. <DT><I>Dump custom compute ID does not compute scalar per atom</I> <DD>The compute ID used must compute a single peratom datum. <DT><I>Dump custom compute ID does not compute vector per atom</I> <DD>The compute ID used must compute a vector of peratom data. <DT><I>Dump custom compute ID vector is not large enough</I> <DD>The compute ID vector of peratom data is not as large as is being accessed. <DT><I>Dump custom fix ID does not compute peratom info</I> <DD>The specified fix does not calculate per-atom values. <DT><I>Dump custom fix ID does not compute scalar per atom</I> <DD>The dump custom command is attempting to access a scalar quantity. <DT><I>Dump custom fix ID does not compute vector per atom</I> <DD>The dump custom command is attempting to access a vector quantity. <DT><I>Dump custom fix ID vector is not large enough</I> <DD>The dump custom command is attempting to access an out-of-range vector value. <DT><I>Dump custom variable is not atom-style variable</I> <DD>Only atom-style variables generate per-atom quantities, needed for dump output. <DT><I>Dump dcd cannot dump unwrapped coords with triclinic box</I> <DD>Cannot use unwrap option with non-orthogonal simulation box. <DT><I>Dump dcd must use group all</I> <DD>Self-explanatory. <DT><I>Dump dcd of non-matching # of atoms</I> <DD>Every snapshot written by dump dcd must contain the same # of atoms. <DT><I>Dump xtc must use group all</I> <DD>Self-explanatory. <DT><I>Dump xtc must use group all</I> <DD>Self-explanatory. <DT><I>Dump_modify region ID does not exist</I> <DD>Self-explanatory. <DT><I>Dumping an atom quantity that isn't allocated</I> <DD>The chosen atom style does not define the per-atom vector being dumped. <DT><I>Electronic temperature dropped below zero</I> <DD>Something has gone wrong with the fix ttm electron temperature model. <DT><I>Empty brackets in variable formula</I> <DD>A value inside the brackets is required for this formula element. <DT><I>Energy was not tallied on needed timestep</I> <DD>You are using a thermo keyword that requires potentials to have tallied energy, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. <DT><I>Failed to allocate %d bytes for array %s</I> <DD>Your LAMMPS simulation has run out of memory. You need to run a smaller simulation or on more processors. <DT><I>Failed to reallocate %d bytes for array %s</I> <DD>Your LAMMPS simulation has run out of memory. You need to run a smaller simulation or on more processors. <DT><I>Final box dimension due to fix deform is < 0.0</I> <DD>Self-explanatory. <DT><I>Fix ID for compute reduce does not exist</I> <DD>Self-explanatory. <DT><I>Fix ID for fix ave/atom does not exist</I> <DD>Self-explanatory. <DT><I>Fix ID for fix ave/spatial does not exist</I> <DD>Self-explanatory. <DT><I>Fix ID for fix ave/time does not exist</I> <DD>Self-explanatory. <DT><I>Fix ID must be alphanumeric or underscore characters</I> <DD>Self-explanatory. <DT><I>Fix ave/atom compute does not calculate a per-atom scalar</I> <DD>A compute used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/atom compute does not calculate a per-atom vector</I> <DD>A compute used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/atom compute does not calculate per-atom values</I> <DD>A compute used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/atom compute vector is accessed out-of-range</I> <DD>The index for the vector is out of bounds. <DT><I>Fix ave/atom fix does not calculate a per-atom scalar</I> <DD>A fix used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/atom fix does not calculate a per-atom vector</I> <DD>A fix used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/atom fix does not calculate per-atom values</I> <DD>A fix used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/atom fix vector is accessed out-of-range</I> <DD>The index for the vector is out of bounds. <DT><I>Fix ave/atom variable is not atom-style variable</I> <DD>A variable used by fix ave/atom must generate per-atom values. <DT><I>Fix ave/spatial compute does not calculate a per-atom scalar</I> <DD>A compute used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/spatial compute does not calculate a per-atom vector</I> <DD>A compute used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/spatial compute does not calculate per-atom values</I> <DD>A compute used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/spatial compute vector is accessed out-of-range</I> <DD>The index for the vector is out of bounds. <DT><I>Fix ave/spatial fix does not calculate a per-atom scalar</I> <DD>A fix used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/spatial fix does not calculate a per-atom vector</I> <DD>A fix used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/spatial fix does not calculate per-atom values</I> <DD>A fix used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/spatial fix vector is accessed out-of-range</I> <DD>The index for the vector is out of bounds. <DT><I>Fix ave/spatial for triclinic boxes requires units reduced</I> <DD>Self-explanatory. <DT><I>Fix ave/spatial settings invalid with changing box</I> <DD>If the ave setting is "running" or "window" and the box size/shape changes during the simulation, then the units setting must be "reduced", else the number of bins may change. <DT><I>Fix ave/spatial variable is not atom-style variable</I> <DD>A variable used by fix ave/spatial must generate per-atom values. <DT><I>Fix ave/time compute does not calculate a scalar</I> <DD>Only computes that calculate a scalar or vector quantity (not a per-atom quantity) can be used with fix ave/time. <DT><I>Fix ave/time compute does not calculate a vector</I> <DD>Only computes that calculate a scalar or vector quantity (not a per-atom quantity) can be used with fix ave/time. <DT><I>Fix ave/time compute vector is accessed out-of-range</I> <DD>The index for the vector is out of bounds. <DT><I>Fix ave/time fix does not calculate a scalar</I> <DD>A fix used by fix ave/time must generate global values. <DT><I>Fix ave/time fix does not calculate a vector</I> <DD>A fix used by fix ave/time must generate global values. <DT><I>Fix ave/time fix vector is accessed out-of-range</I> <DD>The index for the vector is out of bounds. <DT><I>Fix ave/time variable is not equal-style variable</I> <DD>A variable used by fix ave/time must generate a global value. <DT><I>Fix bond/break requires special_bonds = 0,1,1</I> <DD>This is a restriction of the current fix bond/break implementation. <DT><I>Fix bond/create cutoff is longer than pairwise cutoff</I> <DD>This is not allowed because bond creation is done using the pairwise neighbor list. <DT><I>Fix bond/create requires special_bonds = 0,1,1</I> <DD>This is a restriction of the current fix bond/break implementation. <DT><I>Fix bond/swap cannot use dihedral or improper styles</I> <DD>These styles cannot be defined when using this fix. <DT><I>Fix bond/swap requires pair and bond styles</I> <DD>Self-explanatory. <DT><I>Fix bond/swap requires special_bonds = 0,1,1</I> <DD>Self-explanatory. <DT><I>Fix command before simulation box is defined</I> <DD>The fix command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Fix deform is changing yz by too much with changing xy</I> <DD>When both yz and xy are changing, it induces changes in xz if the box must flip from one tilt extreme to another. Thus it is not allowed for yz to grow so much that a flip is induced. <DT><I>Fix deform tilt factors require triclinic box</I> <DD>Cannot deform the tilt factors of a simulation box unless it is a triclinic (non-orthogonal) box. <DT><I>Fix deform volume setting is invalid</I> <DD>Cannot use volume style unless other dimensions are being controlled. <DT><I>Fix deposit region ID does not exist</I> <DD>Self-explanatory <DT><I>Fix evaporate region ID does not exist</I> <DD>Self-explanatory <DT><I>Fix for fix ave/atom not computed at compatible time</I> <DD>Fixes generate their values on specific timesteps. Fix ave/atom is requesting a value on a non-allowed timestep. <DT><I>Fix for fix ave/spatial not computed at compatible time</I> <DD>Fixes generate their values on specific timesteps. Fix ave/spatial is requesting a value on a non-allowed timestep. <DT><I>Fix for fix ave/time not computed at compatible time</I> <DD>Fixes generate their values on specific timesteps. Fix ave/time is requesting a value on a non-allowed timestep. <DT><I>Fix freeze requires atom attribute torque</I> <DD>The atom style defined does not have this attribute. <DT><I>Fix heat group has no atoms</I> <DD>Self-explanatory. <DT><I>Fix heat kinetic energy went negative</I> <DD>This will cause the velocity rescaling about to be performed by fix heat to be invalid. <DT><I>Fix in variable not computed at compatible time</I> <DD>Fixes generate their values on specific timesteps. The variable is requesting the values on a non-allowed timestep. <DT><I>Fix langevin period must be > 0.0</I> <DD>The time window for temperature relaxation must be > 0 <DT><I>Fix momentum group has no atoms</I> <DD>Self-explanatory. <DT><I>Fix msd group has no atoms</I> <DD>Cannot compute diffusion for no atoms. <DT><I>Fix nph periods must be > 0.0</I> <DD>The time window for pressure relaxation must be > 0 <DT><I>Fix npt periods must be > 0.0</I> <DD>The time window for temperature or pressure relaxation must be > 0 <DT><I>Fix npt/asphere cannot be used with atom attributes diameter or rmass</I> <DD>An atom style that defines these attributes must be used. <DT><I>Fix npt/asphere requires atom attributes quat, angmom, torque, shape</I> <DD>An atom style that specifies these quantities is needed. <DT><I>Fix npt/sphere requires atom attribute radius or shape</I> <DD>An atom style that defines these attributes must be used. <DT><I>Fix npt/sphere requires atom attributes omega, torque</I> <DD>An atom style that specifies these quantities is needed. <DT><I>Fix nve/asphere cannot be used with atom attributes diameter or rmass</I> <DD>These attributes override the shape and mass settings, so cannot be used. <DT><I>Fix nve/asphere requires atom attributes angmom, quat, torque, shape</I> <DD>An atom style that specifies these quantities is needed. <DT><I>Fix nve/asphere requires extended particles</I> <DD>This fix can only be used for particles with a shape setting. <DT><I>Fix nve/sphere requires atom attribute mu</I> <DD>An atom style with this attribute is needed. <DT><I>Fix nve/sphere requires atom attribute radius or shape</I> <DD>An atom style that specifies these quantities is needed. <DT><I>Fix nve/sphere requires atom attributes omega, torque</I> <DD>An atom style with these attributes is needed. <DT><I>Fix nve/sphere requires extended particles</I> <DD>This fix can only be used for particles of a finite size. <DT><I>Fix nve/sphere requires spherical particle shapes</I> <DD>Self-explanatory. <DT><I>Fix nvt period must be > 0.0</I> <DD>The time window for temperature relaxation must be > 0 <DT><I>Fix nvt/asphere cannot be used with atom attributes diameter or rmass</I> <DD>These attributes override the shape and mass settings, so cannot be used. <DT><I>Fix nvt/asphere requires atom attributes quat, angmom, torque, shape</I> <DD>An atom style that specifies these quantities is needed. <DT><I>Fix nvt/asphere requires extended particles</I> <DD>This fix can only be used for particles of a finite size. <DT><I>Fix nvt/sphere requires atom attribute radius or shape</I> <DD>An atom style with these attributes is needed. <DT><I>Fix nvt/sphere requires atom attributes omega, torque</I> <DD>An atom style with these attributes is needed. <DT><I>Fix nvt/sphere requires extended particles</I> <DD>This fix can only be used for particles of a finite size. <DT><I>Fix nvt/sphere requires spherical particle shapes</I> <DD>Self-explanatory. <DT><I>Fix orient/fcc file open failed</I> <DD>The fix orient/fcc command could not open a specified file. <DT><I>Fix orient/fcc file read failed</I> <DD>The fix orient/fcc command could not read the needed parameters from a specified file. <DT><I>Fix orient/fcc found self twice</I> <DD>The neighbor lists used by fix orient/fcc are messed up. If this error occurs, it is likely a bug, so send an email to the <A HREF = "http://lammps.sandia.gov/authors.html">developers</A>. <DT><I>Fix pour region ID does not exist</I> <DD>Self-explanatory. <DT><I>Fix pour requires atom attributes radius, rmass</I> <DD>The atom style defined does not have these attributes. <DT><I>Fix press/berendsen period must be > 0.0</I> <DD>Self-explanatory. <DT><I>Fix rdf requires a pair style be defined</I> <DD>Cannot use the rdf fix unless a pair style with a cutoff has been defined. +<DT><I>Fix reax/bonds numbonds > nsbmax_most</I> + +<DD>The limit of the number of bonds expected by the ReaxFF force field +was exceeded. + <DT><I>Fix recenter group has no atoms</I> <DD>Self-explanatory. <DT><I>Fix rigid: Bad principal moments</I> <DD>The principal moments of inertia computed for a rigid body are not within the required tolerances. <DT><I>Fix shake cannot be used with minimization</I> <DD>Cannot use fix shake while doing an energy minimization since it turns off bonds that should contribute to the energy. <DT><I>Fix spring couple group ID does not exist</I> <DD>Self-explanatory. <DT><I>Fix temp/berendsen period must be > 0.0</I> <DD>Self-explanatory. <DT><I>Fix thermal/conductivity swap value must be positive</I> <DD>Self-explanatory. <DT><I>Fix tmd must come after integration fixes</I> <DD>Any fix tmd command must appear in the input script after all time integration fixes (nve, nvt, npt). See the fix tmd documentation for details. <DT><I>Fix ttm electron temperatures must be > 0.0</I> <DD>Self-explanatory. <DT><I>Fix ttm electronic_density must be > 0.0</I> <DD>Self-explanatory. <DT><I>Fix ttm electronic_specific_heat must be > 0.0</I> <DD>Self-explanatory. <DT><I>Fix ttm electronic_thermal_conductivity must be >= 0.0</I> <DD>Self-explanatory. <DT><I>Fix ttm gamma_p must be > 0.0</I> <DD>Self-explanatory. <DT><I>Fix ttm gamma_s must be >= 0.0</I> <DD>Self-explanatory. <DT><I>Fix ttm number of nodes must be > 0</I> <DD>Self-explanatory. -<DT><I>Invalid random number seed in fix ttm command</I> - -<DD>Random number seed must be > 0. - <DT><I>Fix ttm v_0 must be >= 0.0</I> <DD>Self-explanatory. <DT><I>Fix used in compute reduce not computed at compatible time</I> <DD>Fixes generate their values on specific timesteps. Compute sum is requesting a value on a non-allowed timestep. <DT><I>Fix vector in variable formula is too small</I> <DD>Index into vector is out of bounds. <DT><I>Fix viscosity swap value must be positive</I> <DD>Self-explanatory. <DT><I>Fix viscosity vtarget value must be positive</I> <DD>Self-explanatory. <DT><I>Fix wall/gran is incompatible with Pair style</I> <DD>Must use a granular pair style to define the parameters needed for this fix. <DT><I>Fix wall/gran requires atom attributes radius, omega, torque</I> <DD>The atom style defined does not have these attributes. <DT><I>Fix_modify pressure ID does not compute pressure</I> <DD>The compute ID assigned to the fix must compute pressure. -<DT><I>Fix_modify temp ID does not compute temperature</I> +<DT><I>Fix_modify temperature ID does not compute temperature</I> <DD>The compute ID assigned to the fix must compute temperature. <DT><I>Found no restart file matching pattern</I> <DD>When using a "*" in the restart file name, no matching file was found. <DT><I>Gravity must point in -y to use with fix pour in 2d</I> <DD>Gravity must be pointing "down" in a 2d box. <DT><I>Gravity must point in -z to use with fix pour in 3d</I> <DD>Gravity must be pointing "down" in a 3d box, i.e. theta = 180.0. <DT><I>Group ID does not exist</I> <DD>A group ID used in the group command does not exist. <DT><I>Group ID in variable formula does not exist</I> <DD>Self-explanatory. <DT><I>Group command before simulation box is defined</I> <DD>The group command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Group region ID does not exist</I> <DD>A region ID used in the group command does not exist. <DT><I>Illegal ... command</I> <DD>Self-explanatory. Check the input script syntax and compare to the documentation for the command. You can use -echo screen as a command-line option when running LAMMPS to see the offending line. <DT><I>Illegal Stillinger-Weber parameter</I> <DD>One or more of the coefficients defined in the potential file is invalid. <DT><I>Illegal Tersoff parameter</I> <DD>One or more of the coefficients defined in the potential file is invalid. <DT><I>Illegal simulation box</I> <DD>The lower bound of the simulation box is greater than the upper bound. <DT><I>Improper atom missing in delete_bonds</I> <DD>The delete_bonds command cannot find one or more atoms in a particular improper on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid improper. <DT><I>Improper atom missing in set command</I> <DD>The set command cannot find one or more atoms in a particular improper on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid improper. <DT><I>Improper atoms %d %d %d %d missing on proc %d at step %d</I> <DD>One or more of 4 atoms needed to compute a particular improper are missing on this processor. Typically this is because the pairwise cutoff is set too short or the improper has blown apart and an atom is too far away. <DT><I>Improper coeff for hybrid has invalid style</I> <DD>Improper style hybrid uses another improper style as one of its coefficients. The improper style used in the improper_coeff command or read from a restart file is not recognized. <DT><I>Improper coeffs are not set</I> <DD>No improper coefficients have been assigned in the data file or via the improper_coeff command. <DT><I>Improper style hybrid cannot have hybrid as an argument</I> <DD>Self-explanatory. <DT><I>Improper style hybrid cannot have none as an argument</I> <DD>Self-explanatory. <DT><I>Improper style hybrid cannot use same improper style twice</I> <DD>Self-explanatory. <DT><I>Improper_coeff command before improper_style is defined</I> <DD>Coefficients cannot be set in the data file or via the improper_coeff command until an improper_style has been assigned. <DT><I>Improper_coeff command before simulation box is defined</I> <DD>The improper_coeff command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Improper_coeff command when no impropers allowed</I> <DD>The chosen atom style does not allow for impropers to be defined. <DT><I>Improper_style command when no impropers allowed</I> <DD>The chosen atom style does not allow for impropers to be defined. <DT><I>Impropers assigned incorrectly</I> <DD>Impropers read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. <DT><I>Impropers defined but no improper types</I> <DD>The data file header lists improper but no improper types. <DT><I>Inconsistent new atom types in fix bond/create command</I> <DD>If the two atom types forming a bond are the same type, then the two new atom types specified by the iparam and jparam keywords also need to be the same type. <DT><I>Incorrect args for angle coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect args for bond coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect args for dihedral coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect args for improper coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect args for pair coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect args in pair_style command</I> <DD>Self-explanatory. <DT><I>Incorrect atom format in data file</I> <DD>Number of values per atom line in the data file is not consistent with the atom style. <DT><I>Incorrect boundaries with slab Ewald</I> <DD>Must have periodic x,y dimensions and non-periodic z dimension to use 2d slab option with Ewald. <DT><I>Incorrect boundaries with slab PPPM</I> <DD>Must have periodic x,y dimensions and non-periodic z dimension to use 2d slab option with PPPM. <DT><I>Incorrect element names in EAM potential file</I> <DD>The element names in the EAM file do not match those requested. <DT><I>Incorrect format in MEAM potential file</I> <DD>Incorrect number of words per line in the potential file. <DT><I>Incorrect format in Stillinger-Weber potential file</I> <DD>Incorrect number of words per line in the potential file. <DT><I>Incorrect format in TMD target file</I> <DD>Format of file read by fix tmd command is incorrect. <DT><I>Incorrect format in Tersoff potential file</I> <DD>Incorrect number of words per line in the potential file. <DT><I>Incorrect multiplicity arg for dihedral coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect sign arg for dihedral coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Incorrect velocity format in data file</I> <DD>Each atom style defines a format for the Velocity section of the data file. The read-in lines do not match. <DT><I>Incorrect weight arg for dihedral coefficients</I> <DD>Self-explanatory. Check the input script or data file. <DT><I>Indexed per-atom vector in variable formula without atom map</I> <DD>Accessing a value from an atom vector requires the ability to lookup an atom index, which is provided by an atom map. An atom map does not exist (by default) for non-molecular problems. Using the atom_modify map command will force an atom map to be created. <DT><I>Induced tilt by displace_box is too large</I> <DD>The final tilt value must be between -1/2 and 1/2 of the perpendicular box length. <DT><I>Initial temperatures not all set in fix ttm</I> <DD>Self-explantory. <DT><I>Input line too long after variable substitution</I> <DD>This is a hard (very large) limit defined in the input.cpp file. <DT><I>Input line too long: %s</I> <DD>This is a hard (very large) limit defined in the input.cpp file. <DT><I>Insertion region extends outside simulation box</I> <DD>Region specified with fix insert command extends outside the global simulation box. <DT><I>Insufficient Jacobi rotations for POEMS body</I> <DD>Eigensolve for rigid body was not sufficiently accurate. <DT><I>Insufficient Jacobi rotations for rigid body</I> <DD>Eigensolve for rigid body was not sufficiently accurate. +<DT><I>Invalid REAX atom type</I> + +<DD>There is a mis-match between LAMMPS atom types and the elements +listed in the ReaxFF force field file. + <DT><I>Invalid angle style</I> <DD>The choice of angle style is unknown. <DT><I>Invalid angle type in Angles section of data file</I> <DD>Angle type must be positive integer and within range of specified angle types. <DT><I>Invalid angle type index for fix shake</I> <DD>Self-explanatory. <DT><I>Invalid atom ID in Angles section of data file</I> <DD>Atom IDs must be positive integers and within range of defined atoms. <DT><I>Invalid atom ID in Atoms section of data file</I> <DD>Atom IDs must be positive integers. <DT><I>Invalid atom ID in Bonds section of data file</I> <DD>Atom IDs must be positive integers and within range of defined atoms. <DT><I>Invalid atom ID in Dihedrals section of data file</I> <DD>Atom IDs must be positive integers and within range of defined atoms. <DT><I>Invalid atom ID in Impropers section of data file</I> <DD>Atom IDs must be positive integers and within range of defined atoms. <DT><I>Invalid atom ID in Velocities section of data file</I> <DD>Atom IDs must be positive integers and within range of defined atoms. <DT><I>Invalid atom mass for fix shake</I> <DD>Mass specified in fix shake command must be > 0.0. <DT><I>Invalid atom style</I> <DD>The choice of atom style is unknown. <DT><I>Invalid atom type in Atoms section of data file</I> <DD>Atom types must range from 1 to specified # of types. <DT><I>Invalid atom type in create_atoms command</I> <DD>The create_box command specified the range of valid atom types. An invalid type is being requested. <DT><I>Invalid atom type in fix bond/create command</I> <DD>Self-explanatory. <DT><I>Invalid atom type in neighbor exclusion list</I> <DD>Atom types must range from 1 to Ntypes inclusive. <DT><I>Invalid atom type index for fix shake</I> <DD>Atom types must range from 1 to Ntypes inclusive. <DT><I>Invalid atom types in fix rdf command</I> <DD>Atom types must range from 1 to Ntypes inclusive. <DT><I>Invalid atom types in pair_write command</I> <DD>Atom types must range from 1 to Ntypes inclusive. <DT><I>Invalid atom vector in variable formula</I> <DD>The atom vector is not recognized. <DT><I>Invalid bond style</I> <DD>The choice of bond style is unknown. <DT><I>Invalid bond type in Bonds section of data file</I> <DD>Bond type must be positive integer and within range of specified bond types. <DT><I>Invalid bond type in fix bond/break command</I> <DD>Self-explanatory. <DT><I>Invalid bond type in fix bond/create command</I> <DD>Self-explanatory. <DT><I>Invalid bond type index for fix shake</I> <DD>Self-explanatory. Check the fix shake command in the input script. <DT><I>Invalid coeffs for this angle style</I> <DD>Cannot set class 2 coeffs in data file for this angle style. <DT><I>Invalid coeffs for this dihedral style</I> <DD>Cannot set class 2 coeffs in data file for this dihedral style. <DT><I>Invalid coeffs for this improper style</I> <DD>Cannot set class 2 coeffs in data file for this improper style. <DT><I>Invalid command-line argument</I> <DD>One or more command-line arguments is invalid. Check the syntax of the command you are using to launch LAMMPS. <DT><I>Invalid compute ID in variable formula</I> <DD>The compute is not recognized. <DT><I>Invalid compute style</I> <DD>Self-explanatory. <DT><I>Invalid cutoff in communicate command</I> <DD>Specified cutoff must be >= 0.0. <DT><I>Invalid cutoffs in pair_write command</I> <DD>Inner cutoff must be larger than 0.0 and less than outer cutoff. <DT><I>Invalid d1 or d2 value for pair colloid coeff</I> <DD>Neither d1 or d2 can be < 0. <DT><I>Invalid data file section: Angle Coeffs</I> <DD>Atom style does not allow angles. <DT><I>Invalid data file section: AngleAngle Coeffs</I> <DD>Atom style does not allow impropers. <DT><I>Invalid data file section: AngleAngleTorsion Coeffs</I> <DD>Atom style does not allow dihedrals. <DT><I>Invalid data file section: AngleTorsion Coeffs</I> <DD>Atom style does not allow dihedrals. <DT><I>Invalid data file section: Angles</I> <DD>Atom style does not allow angles. <DT><I>Invalid data file section: Bond Coeffs</I> <DD>Atom style does not allow bonds. <DT><I>Invalid data file section: BondAngle Coeffs</I> <DD>Atom style does not allow angles. <DT><I>Invalid data file section: BondBond Coeffs</I> <DD>Atom style does not allow angles. <DT><I>Invalid data file section: BondBond13 Coeffs</I> <DD>Atom style does not allow dihedrals. <DT><I>Invalid data file section: Bonds</I> <DD>Atom style does not allow bonds. <DT><I>Invalid data file section: Dihedral Coeffs</I> <DD>Atom style does not allow dihedrals. <DT><I>Invalid data file section: Dihedrals</I> <DD>Atom style does not allow dihedrals. <DT><I>Invalid data file section: EndBondTorsion Coeffs</I> <DD>Atom style does not allow dihedrals. <DT><I>Invalid data file section: Improper Coeffs</I> <DD>Atom style does not allow impropers. <DT><I>Invalid data file section: Impropers</I> <DD>Atom style does not allow impropers. <DT><I>Invalid data file section: MiddleBondTorsion Coeffs</I> <DD>Atom style does not allow dihedrals. +<DT><I>Invalid density in Atoms section of data file</I> + +<DD>Density value cannot be <= 0.0. + <DT><I>Invalid dihedral style</I> <DD>The choice of dihedral style is unknown. <DT><I>Invalid dihedral type in Dihedrals section of data file</I> <DD>Dihedral type must be positive integer and within range of specified dihedral types. <DT><I>Invalid dipole line in data file</I> <DD>Self-explanatory. <DT><I>Invalid dipole value</I> <DD>Self-explanatory. <DT><I>Invalid dump dcd filename</I> <DD>Filenames used with the dump dcd style cannot be binary or compressed or cause multiple files to be written. <DT><I>Invalid dump frequency</I> <DD>Dump frequency must be 1 or greater. <DT><I>Invalid dump style</I> <DD>The choice of dump style is unknown. <DT><I>Invalid dump xtc filename</I> <DD>Filenames used with the dump xtc style cannot be binary or compressed or cause multiple files to be written. <DT><I>Invalid dump xyz filename</I> <DD>Filenames used with the dump xyz style cannot be binary or cause files to be written by each processor. <DT><I>Invalid dump_modify threshhold operator</I> <DD>Operator keyword used for threshold specification in not recognized. <DT><I>Invalid fix ID in variable formula</I> <DD>The fix is not recognized. +<DT><I>Invalid fix box/relax command for a 2d simulation</I> + +<DD>Fix box/relax styles involving the z dimension cannot be used in +a 2d simulation. + <DT><I>Invalid fix nph command for a 2d simulation</I> <DD>Cannot use style xy, yz, or xz for a 2d simulation. <DT><I>Invalid fix nph command pressure settings</I> <DD>Pressure settings for different components must be the same if the components are coupled. <DT><I>Invalid fix npt command for a 2d simulation</I> <DD>Cannot use style xy, yz, or xz for a 2d simulation. <DT><I>Invalid fix npt command pressure settings</I> <DD>Pressure settings for different components must be the same if the components are coupled. <DT><I>Invalid fix press/berendsen command for a 2d simulation</I> <DD>Can only use xyz or aniso styles in 2d. <DT><I>Invalid fix press/berendsen command pressure settings</I> <DD>Pressure settings for different components must be the same if the components are coupled. <DT><I>Invalid fix style used in compute displace/atom command</I> <DD>Only a fix of style coord/original can be used with this compute. <DT><I>Invalid fix style</I> <DD>The choice of fix style is unknown. <DT><I>Invalid flag in force field section of restart file</I> <DD>Unrecognized entry in restart file. <DT><I>Invalid flag in header section of restart file</I> <DD>Unrecognized entry in restart file. <DT><I>Invalid flag in type arrays section of restart file</I> <DD>Unrecognized entry in restart file. <DT><I>Invalid frequency in temper command</I> <DD>Nevery must be > 0. <DT><I>Invalid group ID in neigh_modify command</I> <DD>A group ID used in the neigh_modify command does not exist. <DT><I>Invalid group function in variable formula</I> <DD>Group function is not recognized. <DT><I>Invalid group in communicate command</I> <DD>Self-explanatory. <DT><I>Invalid improper style</I> <DD>The choice of improper style is unknown. <DT><I>Invalid improper type in Impropers section of data file</I> <DD>Improper type must be positive integer and within range of specified improper types. <DT><I>Invalid index in variable formula</I> <DD>The index between brackets is less than or equal to 0. <DT><I>Invalid keyword in dump custom command</I> <DD>One or more attribute keywords are not recognized. <DT><I>Invalid keyword in pair table parameters</I> <DD>Keyword used in list of table parameters is not recognized. <DT><I>Invalid keyword in thermo_style custom command</I> <DD>One or more specified keywords are not recognized. <DT><I>Invalid kspace style</I> <DD>The choice of kspace style is unknown. <DT><I>Invalid mass line in data file</I> <DD>Self-explanatory. <DT><I>Invalid mass value</I> <DD>Self-explanatory. <DT><I>Invalid math or group function in variable formula</I> <DD>The math or group function is not recognized. <DT><I>Invalid natoms for dump dcd</I> <DD>Natoms is initially 0 which is not valid for the dump dcd style. Natoms must be constant for the duration of the simulation. <DT><I>Invalid natoms for dump xtc</I> <DD>Natoms is initially 0 which is not valid for the dump xtc style. <DT><I>Invalid natoms for dump xyz</I> <DD>Natoms is initially 0 which is not valid for the dump xyz style. <DT><I>Invalid option in lattice command for non-custom style</I> <DD>Certain lattice keywords are not supported unless the lattice style is "custom". <DT><I>Invalid order of forces within respa levels</I> <DD>For respa, ordering of force computations within respa levels must obey certain rules. E.g. bonds cannot be compute less frequently than angles, pairwise forces cannot be computed less frequently than kspace, etc. <DT><I>Invalid pair style</I> <DD>The choice of pair style is unknown. <DT><I>Invalid pair table cutoff</I> <DD>Cutoffs in pair_coeff command are not valid with read-in pair table. <DT><I>Invalid pair table length</I> <DD>Length of read-in pair table is invalid <DT><I>Invalid radius in Atoms section of data file</I> <DD>Radius must be >= 0.0. +<DT><I>Invalid random number seed in fix ttm command</I> + +<DD>Random number seed must be > 0. + <DT><I>Invalid random number seed in set command</I> <DD>Random number seed must be > 0. <DT><I>Invalid region in group function in variable formula</I> <DD>Self-explanatory. <DT><I>Invalid region style</I> <DD>The choice of region style is unknown. <DT><I>Invalid seed for Marsaglia random # generator</I> <DD>The initial seed for this random number generator must be a positive integer less than or equal to 900 million. <DT><I>Invalid seed for Park random # generator</I> <DD>The initial seed for this random number generator must be a positive integer. <DT><I>Invalid shape line in data file</I> <DD>Self-explanatory. <DT><I>Invalid shape line in data file</I> <DD>Self-explanatory. <DT><I>Invalid shape value</I> <DD>Self-explanatory. <DT><I>Invalid shear direction for fix wall/gran</I> <DD>Self-explanatory. <DT><I>Invalid style in pair_write command</I> <DD>Self-explanatory. Check the input script. <DT><I>Invalid syntax in variable formula</I> <DD>Self-explanatory. <DT><I>Invalid thermo keyword in variable formula</I> <DD>The keyword is not recognized. <DT><I>Invalid type for dipole set</I> <DD>Dipole command must set a type from 1-N where N is the number of atom types. <DT><I>Invalid type for mass set</I> <DD>Mass command must set a type from 1-N where N is the number of atom types. <DT><I>Invalid type for shape set</I> <DD>Atom type is out of bounds. <DT><I>Invalid value in set command</I> <DD>The value specified for the setting is invalid, likely because it is too small or too large. <DT><I>Invalid variable evaluation in variable formula</I> <DD>A variable used in a formula could not be evaluated. <DT><I>Invalid variable in next command</I> <DD>Self-explanatory. <DT><I>Invalid variable name in variable formula</I> <DD>Variable name is not recognized. <DT><I>Invalid variable name</I> <DD>Variable name used in an input script line is invalid. <DT><I>Invalid variable style with next command</I> <DD>Variable styles <I>equal</I> and <I>world</I> cannot be used in a next command. <DT><I>Invalid wiggle direction for fix wall/gran</I> <DD>Self-explanatory. <DT><I>Invoked angle equil angle on angle style none</I> <DD>Self-explanatory. <DT><I>Invoked angle single on angle style none</I> <DD>Self-explanatory. <DT><I>Invoked bond equil distance on bond style none</I> <DD>Self-explanatory. <DT><I>Invoked bond single on bond style none</I> <DD>Self-explanatory. <DT><I>Invoked pair single on pair style none</I> <DD>A command (e.g. a dump) attempted to invoke the single() function on a pair style none, which is illegal. You are probably attempting to compute per-atom quantities with an undefined pair style. <DT><I>KSpace style has not yet been set</I> <DD>Cannot use kspace_modify command until a kspace style is set. <DT><I>KSpace style is incompatible with Pair style</I> <DD>Setting a kspace style requires that a pair style with a long-range Coulombic component be selected. <DT><I>Keyword %s in MEAM parameter file not recognized</I> <DD>Self-explanatory. <DT><I>Kspace style requires atom attribute q</I> <DD>The atom style defined does not have these attributes. <DT><I>Label wasn't found in input script</I> <DD>Self-explanatory. <DT><I>Lattice orient vectors are not orthogonal</I> <DD>The three specified lattice orientation vectors must be mutually orthogonal. <DT><I>Lattice orient vectors are not right-handed</I> <DD>The three specified lattice orientation vectors must create a right-handed coordinate system such that a1 cross a2 = a3. <DT><I>Lattice primitive vectors are collinear</I> <DD>The specified lattice primitive vectors do not for a unit cell with non-zero volume. <DT><I>Lattice settings are not compatible with 2d simulation</I> <DD>One or more of the specified lattice vectors has a non-zero z component. <DT><I>Lattice spacings are invalid</I> <DD>Each x,y,z spacing must be > 0. <DT><I>Lattice style incompatible with simulation dimension</I> <DD>2d simulation can use sq, sq2, or hex lattice. 3d simulation can use sc, bcc, or fcc lattice. <DT><I>Log of zero/negative in variable formula</I> <DD>Self-explanatory. <DT><I>Lost atoms via displace_atoms: original %.15g current %.15g</I> <DD>The displace_atoms command lost one or more atoms. <DT><I>Lost atoms via displace_box: original %.15g current %.15g</I> <DD>The displace_box command lost one or more atoms. <DT><I>Lost atoms: original %.15g current %.15g</I> <DD>A thermodynamic computation has detected lost atoms. <DT><I>MEAM library error %d</I> <DD>A call to the MEAM Fortran library returned an error. <DT><I>Mass command before simulation box is defined</I> <DD>The mass command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Min_style command before simulation box is defined</I> <DD>The min_style command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Minimization could not find thermo_pe compute</I> <DD>This compute is created by the thermo command. It must have been explicitly deleted by a uncompute command. <DT><I>Minimize command before simulation box is defined</I> <DD>The minimize command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Mismatched compute in variable formula</I> <DD>A compute is referenced incorrectly or a compute that produces per-atom values is used in an equal-style variable formula. <DT><I>Mismatched fix in variable formula</I> <DD>A fix is referenced incorrectly or a fix that produces per-atom values is used in an equal-style variable formula. <DT><I>Mismatched variable in variable formula</I> <DD>A variable is referenced incorrectly or an atom-style variable that produces per-atom values is used in an equal-style variable formula. <DT><I>More than one fix deform</I> <DD>Only one fix deform can be defined at a time. <DT><I>More than one fix freeze</I> <DD>Only one of these fixes can be defined, since the granular pair potentials access it. <DT><I>More than one fix shake</I> <DD>Only one fix shake can be defined. <DT><I>Must define angle_style before Angle Coeffs</I> <DD>Must use an angle_style command before reading a data file that defines Angle Coeffs. <DT><I>Must define angle_style before BondAngle Coeffs</I> <DD>Must use an angle_style command before reading a data file that defines Angle Coeffs. <DT><I>Must define angle_style before BondBond Coeffs</I> <DD>Must use an angle_style command before reading a data file that defines Angle Coeffs. <DT><I>Must define bond_style before Bond Coeffs</I> <DD>Must use a bond_style command before reading a data file that defines Bond Coeffs. <DT><I>Must define dihedral_style before AngleAngleTorsion Coeffs</I> <DD>Must use a dihedral_style command before reading a data file that defines AngleAngleTorsion Coeffs. <DT><I>Must define dihedral_style before AngleTorsion Coeffs</I> <DD>Must use a dihedral_style command before reading a data file that defines AngleTorsion Coeffs. <DT><I>Must define dihedral_style before BondBond13 Coeffs</I> <DD>Must use a dihedral_style command before reading a data file that defines BondBond13 Coeffs. <DT><I>Must define dihedral_style before Dihedral Coeffs</I> <DD>Must use a dihedral_style command before reading a data file that defines Dihedral Coeffs. <DT><I>Must define dihedral_style before EndBondTorsion Coeffs</I> <DD>Must use a dihedral_style command before reading a data file that defines EndBondTorsion Coeffs. <DT><I>Must define dihedral_style before MiddleBondTorsion Coeffs</I> <DD>Must use a dihedral_style command before reading a data file that defines MiddleBondTorsion Coeffs. <DT><I>Must define improper_style before AngleAngle Coeffs</I> <DD>Must use an improper_style command before reading a data file that defines AngleAngle Coeffs. <DT><I>Must define improper_style before Improper Coeffs</I> <DD>Must use an improper_style command before reading a data file that defines Improper Coeffs. <DT><I>Must define pair_style before Pair Coeffs</I> <DD>Must use a pair_style command before reading a data file that defines Pair Coeffs. <DT><I>Must have more than one processor partition to temper</I> <DD>Cannot use the temper command with only one processor partition. Use the -partition command-line option. <DT><I>Must read Atoms before Angles</I> <DD>The Atoms section of a data file must come before an Angles section. <DT><I>Must read Atoms before Bonds</I> <DD>The Atoms section of a data file must come before a Bonds section. <DT><I>Must read Atoms before Dihedrals</I> <DD>The Atoms section of a data file must come before a Dihedrals section. <DT><I>Must read Atoms before Impropers</I> <DD>The Atoms section of a data file must come before an Impropers section. <DT><I>Must read Atoms before Velocities</I> <DD>The Atoms section of a data file must come before a Velocities section. <DT><I>Must set both respa inner and outer</I> <DD>Cannot use just the inner or outer option with respa without using the other. <DT><I>Must specify a region in fix deposit</I> <DD>The region keyword must be specified with this fix. <DT><I>Must specify a region in fix pour</I> <DD>The region keyword must be specified with this fix. <DT><I>Must use -in switch with multiple partitions</I> <DD>A multi-partition simulation cannot read the input script from stdin. The -in command-line option must be used to specify a file. <DT><I>Must use a block or cylinder region with fix pour</I> <DD>Self-explanatory. <DT><I>Must use a block region with fix pour for 2d simulations</I> <DD>Self-explanatory. <DT><I>Must use a bond style with TIP4P potential</I> <DD>TIP4P potentials assume bond lengths in water are constrained by a fix shake command. <DT><I>Must use a molecular atom style with fix poems molecule</I> <DD>Self-explanatory. <DT><I>Must use a molecular atom style with fix rigid molecule</I> <DD>Self-explanatory. <DT><I>Must use a z-axis cylinder with fix pour</I> <DD>The axis of the cylinder region used with the fix insert command must be oriented along the z dimension. <DT><I>Must use an angle style with TIP4P potential</I> <DD>TIP4P potentials assume angles in water are constrained by a fix shake command. <DT><I>Must use atom style with molecule IDs with fix bond/swap</I> <DD>Self-explanatory. <DT><I>Must use charged atom style with fix efield</I> <DD>The atom style being used does not allow atoms to have assigned charges. Hence it will not work with this fix which generates a force due to an E-field acting on charge. <DT><I>Must use fix gravity with fix pour</I> <DD>Insertion of granular particles must be done under the influence of gravity. <DT><I>Must use molecular atom style with neigh_modify exclude molecule</I> <DD>The atom style must define a molecule ID to use the exclude option. <DT><I>Must use region with side = in with fix deposit</I> <DD>Self-explanatory <DT><I>Must use region with side = in with fix pour</I> <DD>Self-explanatory. <DT><I>Needed topology not in data file</I> <DD>The header of the data file indicated that bonds or angles or dihedrals or impropers would be included, but they were not present. <DT><I>Neigh_modify include group != atom_modify first group</I> <DD>Self-explanatory. <DT><I>Neighbor delay must be 0 or multiple of every setting</I> <DD>The delay and every parameters set via the neigh_modify command are inconsistent. If the delay setting is non-zero, then it must be a multiple of the every setting. <DT><I>Neighbor list overflow, boost neigh_modify one or page</I> <DD>There are too many neighbors of a single atom. Use the neigh_modify command to increase the neighbor page size and the max number of neighbors allowed for one atom. <DT><I>Neighbor multi not yet enabled for granular</I> <DD>Self-explanatory. <DT><I>Neighbor multi not yet enabled for rRESPA</I> <DD>Self-explanatory. <DT><I>Neighbor page size must be >= 10x the one atom setting</I> <DD>This is required to prevent wasting too much memory. <DT><I>New bond exceeded bonds per atom in fix bond/create</I> <DD>See the read_data command for info on setting the "extra bond per atom" header value to allow for additional bonds to be formed. <DT><I>New bond exceeded special list size in fix bond/create</I> <DD>See the special_bonds extra command for info on how to leave space in the special bonds list to allow for additional bonds to be formed. <DT><I>Newton bond change after simulation box is defined</I> <DD>The newton command cannot be used to change the newton bond value after a read_data, read_restart, or create_box command. <DT><I>No angles allowed with this atom style</I> <DD>Self-explanatory. Check data file. <DT><I>No atoms in data file</I> <DD>The header of the data file indicated that atoms would be included, but they were not present. <DT><I>No basis atoms in lattice</I> <DD>Basis atoms must be defined for lattice style user. <DT><I>No bonds allowed with this atom style</I> <DD>Self-explanatory. Check data file. <DT><I>No dihedrals allowed with this atom style</I> <DD>Self-explanatory. Check data file. <DT><I>No dump custom arguments specified</I> <DD>The dump custom command requires that atom quantities be specified to output to dump file. <DT><I>No impropers allowed with this atom style</I> <DD>Self-explanatory. Check data file. <DT><I>No matching element in EAM potential file</I> <DD>The EAM potential file does not contain elements that match the requested elements. <DT><I>No rigid bodies defined</I> <DD>The fix specification did not end up defining any rigid bodies. <DT><I>Non integer # of swaps in temper command</I> <DD>Swap frequency in temper command must evenly divide the total # of timesteps. <DT><I>One or more atoms belong to multiple rigid bodies</I> <DD>Two or more rigid bodies defined by the fix rigid command cannot contain the same atom. <DT><I>One or zero atoms in rigid body</I> <DD>Any rigid body defined by the fix rigid command must contain 2 or more atoms. <DT><I>Out of range atoms - cannot compute PPPM</I> <DD>One or more atoms are attempting to map their charge to a PPPM grid point that is not owned by a processor. This is likely for one of two reasons, both of them bad. First, it may mean that an atom near the boundary of a processor's sub-domain has moved more than 1/2 the <A HREF = "neighbor.html">neighbor skin distance</A> without neighbor lists being rebuilt and atoms being migrated to new processors. This also means you may be missing pairwise interactions that need to be computed. The solution is to change the re-neighboring criteria via the <A HREF = "neigh_modify">neigh_modify</A> command. The safest settings are "delay 0 every 1 check yes". Second, it may mean that an atom has moved far outside a processor's sub-domain or even the entire simulation box. This indicates bad physics, e.g. due to highly overlapping atoms, too large a timestep, etc. <DT><I>POEMS fix must come before NPT/NPH fix</I> <DD>NPT/NPH fix must be defined in input script after all poems fixes, else the fix contribution to the pressure virial is incorrect. <DT><I>PPPM grid is too large</I> <DD>The global PPPM grid is larger than OFFSET in one or more dimensions. OFFSET is currently set to 4096. You likely need to decrease the requested precision. <DT><I>PPPM order cannot be greater than %d</I> <DD>Self-explanatory. <DT><I>PPPM order has been reduced to 0</I> <DD>LAMMPS has attempted to reduce the PPPM order to enable the simulation to run, but can reduce the order no further. Try increasing the accuracy of PPPM by reducing the tolerance size, thus inducing a larger PPPM grid. <DT><I>Pair coeff for hybrid has invalid style</I> <DD>Style in pair coeff must have been listed in pair_style command. <DT><I>Pair cutoff < Respa interior cutoff</I> <DD>One or more pairwise cutoffs are too short to use with the specified rRESPA cutoffs. <DT><I>Pair dipole/cut requires atom attributes q, mu, torque, dipole</I> <DD>An atom style that specifies these quantities is needed. <DT><I>Pair distance < table inner cutoff</I> <DD>Two atoms are closer together than the pairwise table allows. <DT><I>Pair distance > table outer cutoff</I> <DD>Two atoms are further apart than the pairwise table allows. <DT><I>Pair dpd requires ghost atoms store velocity</I> <DD>An atom style that stores this, like atom_style dpd, must be used. <DT><I>Pair gayberne cannot be used with atom attribute diameter</I> <DD>Finite-size particles must be defined with the shape command. <DT><I>Pair gayberne epsilon a,b,c coeffs are not all set</I> <DD>Each atom type involved in pair_style gayberne must have these 3 coefficients set at least once. <DT><I>Pair gayberne requires atom attributes quat, torque, shape</I> <DD>An atom style that defines these attributes must be used. <DT><I>Pair granular requires atom attributes radius, omega, torque</I> <DD>The atom style defined does not have these attributes. <DT><I>Pair granular requires ghost atoms store velocity</I> <DD>An atom style that stores this, like atom_style granular, must be used. <DT><I>Pair granular with shear history requires newton pair off</I> <DD>This is a current restriction of the implementation of pair granular styles with history. <DT><I>Pair hybrid sub-style is not used</I> <DD>No pair_coeff command used a sub-style specified in the pair_style command. <DT><I>Pair inner cutoff < Respa interior cutoff</I> <DD>One or more pairwise cutoffs are too short to use with the specified rRESPA cutoffs. <DT><I>Pair inner cutoff >= Pair outer cutoff</I> <DD>The specified cutoffs for the pair style are inconsistent. <DT><I>Pair lubricate cannot be used with atom attributes diameter or rmass</I> <DD>These attributes override the shape and mass settings, so cannot be used. <DT><I>Pair lubricate requires atom attributes quat, torque, shape</I> <DD>An atom style that defines these attributes must be used. <DT><I>Pair lubricate requires extended particles</I> <DD>This pair style can only be used for particles with a shape setting. <DT><I>Pair lubricate requires mono-disperse particles</I> <DD>This is a current restriction of this pair style. <DT><I>Pair lubricate requires spherical, mono-disperse particles</I> <DD>This is a current restriction of this pair style. <DT><I>Pair peri lattice is not identical in x, y, and z</I> <DD>The lattice defined by the lattice command must be cubic. <DT><I>Pair peri requires a lattice be defined</I> <DD>Use the lattice command for this purpose. <DT><I>Pair peri requires an atom map, see atom_modify</I> <DD>Even for atomic systems, an atom map is required to find Peridynamic bonds. Use the atom_modify command to define one. <DT><I>Pair resquared cannot be used with atom attribute diameter</I> <DD>This attribute overrides the shape settings, so cannot be used. <DT><I>Pair resquared epsilon a,b,c coeffs are not all set</I> <DD>Self-explanatory. <DT><I>Pair resquared epsilon and sigma coeffs are not all set</I> <DD>Self-explanatory. <DT><I>Pair resquared requires atom attributes quat, torque, shape</I> <DD>An atom style that defines these attributes must be used. <DT><I>Pair style AIREBO requires atom IDs</I> <DD>This is a requirement to use the AIREBO potential. <DT><I>Pair style AIREBO requires newton pair on</I> <DD>Self-explanatory. <DT><I>Pair style MEAM requires newton pair on</I> <DD>See the newton command. This is a restriction to use the MEAM potential. <DT><I>Pair style Stillinger-Weber requires atom IDs</I> <DD>This is a requirement to use the SW potential. <DT><I>Pair style Stillinger-Weber requires newton pair on</I> <DD>See the newton command. This is a restriction to use the SW potential. <DT><I>Pair style Tersoff requires atom IDs</I> <DD>This is a requirement to use the Tersoff potential. <DT><I>Pair style Tersoff requires newton pair on</I> <DD>See the newton command. This is a restriction to use the Tersoff potential. <DT><I>Pair style born/coul/long requires atom attribute q</I> <DD>An atom style that defines this attribute must be used. <DT><I>Pair style buck/coul/cut requires atom attribute q</I> <DD>The atom style defined does not have this attribute. <DT><I>Pair style buck/coul/long requires atom attribute q</I> <DD>The atom style defined does not have these attributes. <DT><I>Pair style coul/cut requires atom attribute q</I> <DD>The atom style defined does not have these attributes. <DT><I>Pair style does not support bond_style quartic</I> <DD>The pair style does not have a single() function, so it can not be invoked by bond_style quartic. <DT><I>Pair style does not support compute group/group</I> -<P>The pair_style does not have a single() function, so it cannot be -invokded by the compute group/group command. -</P> +<DD>The pair_style does not have a single() function, so it cannot be +invokded by the compute group/group command. + +<DT><I>Pair style does not support compute heat/flux</I> + +<DD>The pair style does not have a single() function, so it can +not be invoked by compute heat/flux. + <DT><I>Pair style does not support fix bond/swap</I> -<P>The pair_style does not have a single() function, so it cannot be -invokded by the fix bond/swap command. -</P> +<DD>The pair style does not have a single() function, so it can +not be invoked by fix bond/swap. + <DT><I>Pair style does not support pair_write</I> -<DD>The pair style does not have a single() function, so it cannot be -invoked by the pair_write command. +<DD>The pair style does not have a single() function, so it can +not be invoked by pair write. <DT><I>Pair style does not support rRESPA inner/middle/outer</I> <DD>You are attempting to use rRESPA options with a pair style that does not support them. <DT><I>Pair style granular with history requires atoms have IDs</I> <DD>Atoms in the simulation do not have IDs, so history effects cannot be tracked by the granular pair potential. <DT><I>Pair style hybrid cannot have hybrid as an argument</I> <DD>Self-explanatory. <DT><I>Pair style hybrid cannot have none as an argument</I> <DD>Self-explanatory. <DT><I>Pair style hybrid cannot use same pair style twice</I> <DD>The sub-style arguments of pair_style hybrid cannot be duplicated. Check the input script. <DT><I>Pair style is incompatible with KSpace style</I> <DD>If a pair style with a long-range Coulombic component is selected, then a kspace style must also be used. <DT><I>Pair style lj/charmm/coul/charmm requires atom attribute q</I> <DD>The atom style defined does not have these attributes. <DT><I>Pair style lj/charmm/coul/long requires atom attribute q</I> <DD>The atom style defined does not have these attributes. <DT><I>Pair style lj/class2/coul/cut requires atom attribute q</I> <DD>The atom style defined does not have this attribute. <DT><I>Pair style lj/class2/coul/long requires atom attribute q</I> <DD>The atom style defined does not have this attribute. <DT><I>Pair style lj/cut/coul/cut requires atom attribute q</I> <DD>The atom style defined does not have this attribute. <DT><I>Pair style lj/cut/coul/long requires atom attribute q</I> <DD>The atom style defined does not have this attribute. <DT><I>Pair style lj/cut/coul/long/tip4p requires atom IDs</I> <DD>There are no atom IDs defined in the system and the TIP4P potential requires them to find O,H atoms with a water molecule. <DT><I>Pair style lj/cut/coul/long/tip4p requires atom attribute q</I> <DD>The atom style defined does not have these attributes. <DT><I>Pair style lj/cut/coul/long/tip4p requires newton pair on</I> <DD>This is because the computation of constraint forces within a water molecule adds forces to atoms owned by other processors. <DT><I>Pair style lj/gromacs/coul/gromacs requires atom attribute q</I> <DD>An atom_style with this attribute is needed. <DT><I>Pair style peri_pmb requires atom style peri</I> <DD>This is because atom style peri stores quantities needed by the peridynamic potential. <DT><I>Pair style reax requires atom IDs</I> <DD>This is a requirement to use the ReaxFF potential. <DT><I>Pair style reax requires newton pair on</I> <DD>This is a requirement to use the ReaxFF potential. <DT><I>Pair table cutoffs must all be equal to use with KSpace</I> <DD>When using pair style table with a long-range KSpace solver, the cutoffs for all atom type pairs must all be the same, since the long-range solver starts at that cutoff. <DT><I>Pair table parameters did not set N</I> <DD>List of pair table parameters must include N setting. <DT><I>Pair tersoff/zbl requires metal or real units</I> <DD>This is a current restriction of this pair potential. <DT><I>Pair_coeff command before pair_style is defined</I> <DD>Self-explanatory. <DT><I>Pair_coeff command before simulation box is defined</I> <DD>The pair_coeff command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Pair_modify command before pair_style is defined</I> <DD>Self-explanatory. <DT><I>Pair_write command before pair_style is defined</I> <DD>Self-explanatory. <DT><I>Per-atom compute in equal-style variable formula</I> <DD>Equal-style variables cannot use per-atom quantities. <DT><I>Per-atom energy was not tallied on needed timestep</I> <DD>You are using a thermo keyword that requires potentials to have tallied energy, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. <DT><I>Per-atom fix in equal-style variable formula</I> <DD>Equal-style variables cannot use per-atom quantities. <DT><I>Per-atom virial was not tallied on needed timestep</I> <DD>You are using a thermo keyword that requires potentials to have tallied the virial, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. <DT><I>Potential file has duplicate entry</I> <DD>The potential file for a SW or Tersoff potential has more than one entry for the same 3 ordered elements. <DT><I>Potential file is missing an entry</I> <DD>The potential file for a SW or Tersoff potential does not have a needed entry. <DT><I>Power by 0 in variable formula</I> <DD>Self-explanatory. <DT><I>Pressure ID for fix box/relax does not exist</I> <DD>The compute ID needed to compute pressure for the fix does not exist. +<DT><I>Pressure ID for fix modify does not exist</I> + +<DD>Self-explanatory. + <DT><I>Pressure ID for fix nph does not exist</I> <DD>The compute ID needed to compute pressure for the fix does not exist. <DT><I>Pressure ID for fix npt does not exist</I> <DD>The compute ID needed to compute pressure for the fix does not exist. <DT><I>Pressure ID for fix press/berendsen does not exist</I> <DD>The compute ID needed to compute pressure for the fix does not exist. <DT><I>Pressure ID for thermo does not exist</I> <DD>The compute ID needed to compute pressure for thermodynamics does not exist. -<DT><I>Pressure ID for fix modify does not exist</I> - -<DD>Self-explanatory. - <DT><I>Proc grid in z != 1 for 2d simulation</I> <DD>There cannot be more than 1 processor in the z dimension of a 2d simulation. <DT><I>Processor partitions are inconsistent</I> <DD>The total number of processors in all partitions must match the number of processors LAMMPS is running on. <DT><I>Processors command after simulation box is defined</I> <DD>The processors command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Quaternion creation numeric error</I> <DD>A numeric error occurred in the creation of a rigid body by the fix rigid command. <DT><I>R0 < 0 for fix spring command</I> <DD>Equilibrium spring length is invalid. <DT><I>Region intersect region ID does not exist</I> <DD>Self-explanatory. <DT><I>Region union region ID does not exist</I> <DD>One or more of the region IDs specified by the region union command does not exist. <DT><I>Replacing a fix, but new style != old style</I> <DD>A fix ID can be used a 2nd time, but only if the style matches the previous fix. In this case it is assumed you with to reset a fix's parameters. This error may mean you are mistakenly re-using a fix ID when you do not intend to. <DT><I>Replicate command before simulation box is defined</I> <DD>The replicate command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Replicate did not assign all atoms correctly</I> <DD>Atoms replicated by the replicate command were not assigned correctly to processors. This is likely due to some atom coordinates being outside a non-periodic simulation box. <DT><I>Respa inner cutoffs are invalid</I> <DD>The first cutoff must be <= the second cutoff. <DT><I>Respa levels must be >= 1</I> <DD>Self-explanatory. <DT><I>Respa middle cutoffs are invalid</I> <DD>The first cutoff must be <= the second cutoff. <DT><I>Reuse of compute ID</I> <DD>A compute ID cannot be used twice. <DT><I>Reuse of dump ID</I> <DD>A dump ID cannot be used twice. <DT><I>Reuse of region ID</I> <DD>A region ID cannot be used twice. <DT><I>Rigid body has degenerate moment of inertia</I> <DD>Fix poems will only work with bodies (collections of atoms) that have non-zero principal moments of inertia. This means they must be 3 or more non-collinear atoms, even with joint atoms removed. <DT><I>Rigid fix must come before NPT/NPH fix</I> <DD>NPT/NPH fix must be defined in input script after all rigid fixes, else the rigid fix contribution to the pressure virial is incorrect. <DT><I>Run command before simulation box is defined</I> <DD>The run command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Run command start value is after start of run</I> <DD>Self-explanatory. <DT><I>Run command stop value is before end of run</I> <DD>Self-explanatory. <DT><I>Run command upto value is before current timestep</I> <DD>Self-explanatory. <DT><I>Run_style command before simulation box is defined</I> <DD>The run_style command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Set command before simulation box is defined</I> <DD>The set command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Set command with no atoms existing</I> <DD>No atoms are yet defined so the set command cannot be used. <DT><I>Set region ID does not exist</I> <DD>Region ID specified in set command does not exist. <DT><I>Shake angles have different bond types</I> <DD>All 3-atom angle-constrained SHAKE clusters specified by the fix shake command that are the same angle type, must also have the same bond types for the 2 bonds in the angle. <DT><I>Shake atoms %d %d %d %d missing on proc %d at step %d</I> <DD>The 4 atoms in a single shake cluster specified by the fix shake command are not all accessible to a processor. This probably means an atom has moved too far. <DT><I>Shake atoms %d %d %d missing on proc %d at step %d</I> <DD>The 3 atoms in a single shake cluster specified by the fix shake command are not all accessible to a processor. This probably means an atom has moved too far. <DT><I>Shake atoms %d %d missing on proc %d at step %d</I> <DD>The 2 atoms in a single shake cluster specified by the fix shake command are not all accessible to a processor. This probably means an atom has moved too far. <DT><I>Shake cluster of more than 4 atoms</I> <DD>A single cluster specified by the fix shake command can have no more than 4 atoms. <DT><I>Shake clusters are connected</I> <DD>A single cluster specified by the fix shake command must have a single central atom with up to 3 other atoms bonded to it. <DT><I>Shake determinant = 0.0</I> <DD>The determinant of the matrix being solved for a single cluster specified by the fix shake command is numerically invalid. <DT><I>Shake fix must come before NPT/NPH fix</I> <DD>NPT fix must be defined in input script after SHAKE fix, else the SHAKE fix contribution to the pressure virial is incorrect. <DT><I>Shape command before simulation box is defined</I> <DD>Self-explanatory. <DT><I>Sqrt of negative in variable formula</I> <DD>Self-explanatory. <DT><I>Substitution for illegal variable</I> <DD>Input script line contained a variable that could not be substituted for. <DT><I>TIP4P hydrogen has incorrect atom type</I> <DD>The TIP4P pairwise computation found an H atom whose type does not agree with the specified H type. <DT><I>TIP4P hydrogen is missing</I> <DD>The TIP4P pairwise computation failed to find the correct H atom within a water molecule. <DT><I>TMD target file did not list all group atoms</I> <DD>The target file for the fix tmd command did not list all atoms in the fix group. <DT><I>Target T for fix npt cannot be 0.0</I> <DD>Self-explanatory. <DT><I>Target T for fix nvt cannot be 0.0</I> <DD>Self-explanatory. -<DT><I>Temp ID for fix bond/swap does not exist</I> +<DT><I>Temper command before simulation box is defined</I> + +<DD>The temper command cannot be used before a read_data, read_restart, or +create_box command. + +<DT><I>Temperature ID for fix bond/swap does not exist</I> <DD>Self-explanatory. <DT><I>Temperature ID for fix box/relax does not exist</I> -<DD>The compute ID needed to compute temperature for the fix does not -exist. +<DD>Self-explanatory. <DT><I>Temperature ID for fix nph does not exist</I> -<DD>The compute ID needed to compute temperature for the fix does not -exist. +<DD>Self-explanatory. <DT><I>Temperature ID for fix npt does not exist</I> -<DD>The compute ID needed to compute temperature for the fix does not -exist. +<DD>Self-explanatory. <DT><I>Temperature ID for fix nvt does not exist</I> -<DD>The compute ID needed to compute temperature for the fix does not -exist. +<DD>Self-explanatory. <DT><I>Temperature ID for fix press/berendsen does not exist</I> <DD>Self-explanatory. <DT><I>Temperature ID for fix temp/berendsen does not exist</I> <DD>Self-explanatory. <DT><I>Temperature ID for fix temp/rescale does not exist</I> -<DD>The compute ID needed to compute temperature for the fix does not -exist. - -<DT><I>Temper command before simulation box is defined</I> - -<DD>The temper command cannot be used before a read_data, read_restart, or -create_box command. +<DD>Self-explanatory. <DT><I>Temperature for fix nvt/sllod does not have a bias</I> <DD>The specified compute must compute temperature with a bias. <DT><I>Temperature region ID does not exist</I> <DD>The region ID specified in the temperature command does not exist. <DT><I>Tempering could not find thermo_pe compute</I> <DD>This compute is created by the thermo command. It must have been explicitly deleted by a uncompute command. <DT><I>Tempering fix ID is not defined</I> <DD>The fix ID specified by the temper command does not exist. <DT><I>Tempering temperature fix is not valid</I> <DD>The fix specified by the temper command is not one that controls temperature (nvt or langevin). <DT><I>Thermo and fix not computed at compatible times</I> <DD>Fixes generate values on specific timesteps. The thermo output does not match these timesteps. <DT><I>Thermo compute ID does not compute scalar info</I> <DD>The specified compute ID does not compute a scalar quantity as requested. <DT><I>Thermo compute ID does not compute vector info</I> <DD>The specified compute ID does not compute a vector quantity as requested. <DT><I>Thermo compute ID vector is not large enough</I> <DD>The specified compute ID does not compute a large enough vector quantity for the requested index. <DT><I>Thermo custom variable is not equal-style variable</I> <DD>Only equal-style variables can be output with thermodynamics, not atom-style variables. <DT><I>Thermo fix ID does not compute scalar info</I> <DD>Only fixes that compute global values can be output with thermodynamics. <DT><I>Thermo fix ID does not compute vector info</I> <DD>Only fixes that compute global values can be output with thermodynamics. <DT><I>Thermo fix ID vector is not large enough</I> <DD>Index into vector is out of bounds. <DT><I>Thermo keyword in variable requires thermo to use/init pe</I> <DD>You are using a thermo keyword in a variable that requires potential energy to be calculated, but your thermo output does not use it. Add it to your thermo output. <DT><I>Thermo keyword in variable requires thermo to use/init press</I> <DD>You are using a thermo keyword in a variable that requires pressure to be calculated, but your thermo output does not use it. Add it to your thermo output. <DT><I>Thermo keyword in variable requires thermo to use/init temp</I> <DD>You are using a thermo keyword in a variable that requires temperature to be calculated, but your thermo output does not use it. Add it to your thermo output. <DT><I>Thermo style does not use press</I> <DD>Cannot use thermo_modify to set this parameter since the thermo_style is not computing this quantity. <DT><I>Thermo style does not use temp</I> <DD>Cannot use thermo_modify to set this parameter since the thermo_style is not computing this quantity. -<DT><I>Thermo_modify press ID does not compute pressure</I> +<DT><I>Thermo_modify pressure ID does not compute pressure</I> <DD>The specified compute ID does not compute pressure. -<DT><I>Thermo_modify temp ID does not compute temperature</I> +<DT><I>Thermo_modify temperature ID does not compute temperature</I> <DD>The specified compute ID does not compute temperature. <DT><I>Thermo_style command before simulation box is defined</I> <DD>The thermo_style command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Threshhold for an atom quantity that isn't allocated</I> <DD>A dump threshhold has been requested on a quantity that is not defined by the atom style used in this simulation. <DT><I>Timestep must be >= 0</I> <DD>Specified timestep size is invalid. <DT><I>Too big a problem to replicate with molecular atom style</I> <DD>Molecular problems cannot become bigger than 2^31 atoms (or bonds, etc) when replicated, else the atom IDs and other quantities cannot be stored in 32-bit quantities. <DT><I>Too few bits for lookup table</I> <DD>Table size specified via pair_modify command does not work with your machine's floating point representation. <DT><I>Too many exponent bits for lookup table</I> <DD>Table size specified via pair_modify command does not work with your machine's floating point representation. <DT><I>Too many groups</I> <DD>The maximum number of atom groups (including the "all" group) is given by MAX_GROUP in group.cpp and is 32. <DT><I>Too many mantissa bits for lookup table</I> <DD>Table size specified via pair_modify command does not work with your machine's floating point representation. <DT><I>Too many masses for fix shake</I> <DD>The fix shake command cannot list more masses than there are atom types. <DT><I>Too many total bits for bitmapped lookup table</I> <DD>Table size specified via pair_modify command is too large. Note that a value of N generates a 2^N size table. <DT><I>Too many touching neighbors - boost MAXTOUCH</I> <DD>A granular simulation has too many neighbors touching one atom. The MAXTOUCH parameter in fix_shear_history.cpp must be set larger and LAMMPS must be re-built. <DT><I>Tree structure in joint connections</I> <DD>Fix poems cannot (yet) work with coupled bodies whose joints connect the bodies in a tree structure. <DT><I>Triclinic box must be periodic in skewed dimensions</I> <DD>This is a requirement for using a non-orthogonal box. E.g. to set a non-zero xy tilt, both x and y must be periodic dimensions. <DT><I>Triclinic box skew is too large</I> <DD>The displacement in a skewed direction must be less than half the box length in that dimension. E.g. the xy tilt must be between -half and +half of the x box length. <DT><I>Two groups cannot be the same in fix spring couple</I> <DD>Self-explanatory. <DT><I>Unbalanced quotes in input line</I> <DD>No matching end double quote was found following a leading double quote. <DT><I>Unexpected end of data file</I> <DD>LAMMPS hit the end of the data file while attempting to read a section. Something is wrong with the format of the data file. <DT><I>Units command after simulation box is defined</I> <DD>The units command cannot be used after a read_data, read_restart, or create_box command. <DT><I>Universe/uloop variable count < # of partitions</I> <DD>A universe or uloop style variable must specify a number of values >= to the number of processor partitions. <DT><I>Unknown command: %s</I> <DD>The command is not known to LAMMPS. Check the input script. <DT><I>Unknown identifier in data file: %s</I> <DD>A section of the data file cannot be read by LAMMPS. <DT><I>Unknown table style in pair_style command</I> <DD>Style of table is invalid for use with pair_style table command. <DT><I>Unrecognized lattice type in MEAM file 1</I> <DD>The lattice type in an entry of the MEAM library file is not valid. <DT><I>Unrecognized lattice type in MEAM file 2</I> <DD>The lattice type in an entry of the MEAM parameter file is not valid. <DT><I>Use of compute temp/ramp with undefined lattice</I> <DD>Must use lattice command with compute temp/ramp command if units option is set to lattice. <DT><I>Use of displace_atoms with undefined lattice</I> <DD>Must use lattice command with displace_atoms command if units option is set to lattice. <DT><I>Use of displace_box with undefined lattice</I> <DD>Must use lattice command with displace_box command if units option is set to lattice. <DT><I>Use of fix ave/spatial with undefined lattice</I> <DD>A lattice must be defined to use fix ave/spatial with units = lattice. <DT><I>Use of fix deform with undefined lattice</I> <DD>A lattice must be defined to use fix deform with units = lattice. <DT><I>Use of fix deposit with undefined lattice</I> <DD>Must use lattice command with compute fix deposit command if units option is set to lattice. <DT><I>Use of fix dt/reset with undefined lattice</I> <DD>Must use lattice command with fix dt/reset command if units option is set to lattice. <DT><I>Use of fix indent with undefined lattice</I> <DD>The lattice command must be used to define a lattice before using the fix indent command. <DT><I>Use of fix recenter with undefined lattice</I> <DD>Must use lattice command with fix recenter command if units option is set to lattice. <DT><I>Use of region with undefined lattice</I> <DD>If scale = lattice (the default) for the region command, then a lattice must first be defined via the lattice command. <DT><I>Use of velocity with undefined lattice</I> <DD>If scale = lattice (the default) for the velocity set or velocity ramp command, then a lattice must first be defined via the lattice command. <DT><I>Using fix nvt/sllod with inconsistent fix deform remap option</I> <DD>Fix nvt/sllod requires that deforming atoms have a velocity profile provided by "remap v" as a fix deform option. <DT><I>Using fix nvt/sllod with no fix deform defined</I> <DD>Self-explanatory. <DT><I>Variable evaluation before simulation box is defined</I> <DD>Cannot evaluate a compute or fix or atom-based value in a variable before the simulation has been setup. <DT><I>Variable name for compute reduce does not exist</I> <DD>Self-explanatory. <DT><I>Variable name for fix ave/atom does not exist</I> <DD>Self-explanatory. <DT><I>Variable name for fix ave/spatial does not exist</I> <DD>Self-explanatory. <DT><I>Variable name for fix ave/time does not exist</I> <DD>Self-explanatory. <DT><I>Variable name must be alphanumeric or underscore characters</I> <DD>Self-explanatory. <DT><I>Velocity command before simulation box is defined</I> <DD>The velocity command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Velocity command with no atoms existing</I> <DD>A velocity command has been used, but no atoms yet exist. <DT><I>Velocity ramp in z for a 2d problem</I> <DD>Self-explanatory. -<DT><I>Velocity temp ID does not compute temperature</I> +<DT><I>Velocity temperature ID does not compute temperature</I> <DD>The compute ID given to the velocity command must compute temperature. <DT><I>Virial was not tallied on needed timestep</I> <DD>You are using a thermo keyword that requires potentials to have tallied the virial, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. <DT><I>World variable count doesn't match # of partitions</I> <DD>A world-style variable must specify a number of values equal to the number of processor partitions. <DT><I>Write_restart command before simulation box is defined</I> <DD>The write_restart command cannot be used before a read_data, read_restart, or create_box command. <DT><I>Zero-length lattice orient vector</I> <DD>Self-explanatory. </DL> <H4><A NAME = "warn"></A>Warnings: </H4> <DL> <DT><I>Broken bonds will not alter angles, dihedrals, or impropers</I> <DD>See the doc page for fix bond/break for more info on this restriction. +<DT><I>Compute cna/atom cutoff may be too large to find ghost atom neighbors</I> + +<DD>The neighbor cutoff used may not encompass enough ghost atoms +to perform this operation correctly. + +<DT><I>Computing temperature of portions of rigid bodies</I> + +<DD>The group defined by the temperature compute does not encompass all +the atoms in one or more rigid bodies, so the change in +degrees-of-freedom for the atoms in those partial rigid bodies will +not be accounted for. + <DT><I>Created bonds will not create angles, dihedrals, or impropers</I> <DD>See the doc page for fix bond/create for more info on this restriction. <DT><I>Dihedral problem: %d %d %d %d %d %d</I> <DD>Conformation of the 4 listed dihedral atoms is extreme; you may want to check your simulation geometry. <DT><I>Dump dcd/xtc timestamp may be wrong with fix dt/reset</I> <DD>If the fix changes the timestep, the dump dcd file will not reflect the change. <DT><I>FENE bond too long: %d %d %d %g</I> <DD>A FENE bond has stretched dangerously far. It's interaction strength will be truncated to attempt to prevent the bond from blowing up. <DT><I>FENE bond too long: %d %g</I> <DD>A FENE bond has stretched dangerously far. It's interaction strength will be truncated to attempt to prevent the bond from blowing up. <DT><I>Fix bond/swap will ignore defined angles</I> <DD>See the doc page for fix bond/swap for more info on this restriction. <DT><I>Fix recenter should come after all other integration fixes</I> <DD>Other fixes may change the position of the center-of-mass, so fix recenter should come last. <DT><I>Fix thermal/conductivity comes before fix ave/spatial</I> <DD>The order of these 2 fixes in your input script is such that fix thermal/conductivity comes first. If you are using fix ave/spatial to measure the temperature profile induced by fix viscosity, then this may cause a glitch in the profile since you are averaging immediately after swaps have occurred. Flipping the order of the 2 fixes typically helps. <DT><I>Fix viscosity comes before fix ave/spatial</I> <DD>The order of these 2 fixes in your input script is such that fix viscosity comes first. If you are using fix ave/spatial to measure the velocity profile induced by fix viscosity, then this may cause a glitch in the profile since you are averaging immediately after swaps have occurred. Flipping the order of the 2 fixes typically helps. <DT><I>Group for fix_modify temp != fix group</I> <DD>The fix_modify command is specifying a temperature computation that computes a temperature on a different group of atoms than the fix itself operates on. This is probably not what you want to do. <DT><I>Improper problem: %d %d %d %d %d %d</I> <DD>Conformation of the 4 listed improper atoms is extreme; you may want to check your simulation geometry. <DT><I>Kspace_modify slab param < 2.0 may cause unphysical behavior</I> <DD>The kspace_modify slab parameter should be larger to insure periodic grids padded with empty space do not overlap. <DT><I>Less insertions than requested</I> <DD>Less atom insertions occurred on this timestep due to the fix insert command than were scheduled. This is probably because there were too many overlaps detected. <DT><I>Lost atoms: original %.15g current %.15g</I> <DD>A thermodynamic computation has detected lost atoms. <DT><I>Mismatch between velocity and compute groups</I> <DD>The temperature computation used by the velocity command will not be on the same group of atoms that velocities are being set for. <DT><I>More than one compute centro/atom</I> <DD>It is not efficient to use compute centro/atom more than once. <DT><I>More than one compute cna/atom defined</I> <DD>It is not efficient to use compute cna/atom more than once. <DT><I>More than one compute coord/atom</I> <DD>It is not efficient to use compute coord/atom more than once. <DT><I>More than one compute damage/atom</I> <DD>It is not efficient to use compute ke/atom more than once. <DT><I>More than one compute ke/atom</I> <DD>It is not efficient to use compute ke/atom more than once. <DT><I>More than one fix msd</I> <DD>It is not efficient to use fix msd more than once. <DT><I>More than one fix poems</I> <DD>It is not efficient to use fix poems more than once. <DT><I>More than one fix rigid</I> <DD>It is not efficient to use fix rigid more than once. <DT><I>New thermo_style command, previous thermo_modify settings will be lost</I> <DD>If a thermo_style command is used after a thermo_modify command, the settings changed by the thermo_modify command will be reset to their default values. This is because the thermo_modify commmand acts on the currently defined thermo style, and a thermo_style command creates a new style. <DT><I>No fixes defined, atoms won't move</I> <DD>If you are not using a fix like nve, nvt, npt then atom velocities and coordinates will not be updated during timestepping. <DT><I>No joints between rigid bodies, use fix rigid instead</I> <DD>The bodies defined by fix poems are not connected by joints. POEMS will integrate the body motion, but it would be more efficient to use fix rigid. <DT><I>Not using real units with pair reax</I> <DD>This is most likely an error, unless you have created your own ReaxFF parameter file in a different set of units. <DT><I>One or more atoms are time integrated more than once</I> <DD>This is probably an error since you typically do not want to advance the positions or velocities of an atom more than once per timestep. <DT><I>One or more respa levels compute no forces</I> <DD>This is computationally inefficient. <DT><I>Particle deposition was unsuccessful</I> <DD>The fix deposit command was not able to insert as many atoms as needed. The requested volume fraction may be too high, or other atoms may be in the insertion region. <DT><I>Reducing PPPM order b/c stencil extends beyond neighbor processor</I> <DD>LAMMPS is attempting this in order to allow the simulation to run. It should not effect the PPPM accuracy. <DT><I>Replacing a fix, but new group != old group</I> <DD>The ID and style of a fix match for a fix you are changing with a fix command, but the new group you are specifying does not match the old group. <DT><I>Replicating in a non-periodic dimension</I> <DD>The parameters for a replicate command will cause a non-periodic dimension to be replicated; this may cause unwanted behavior. <DT><I>Resetting reneighboring criteria during minimization</I> <DD>Minimization requires that neigh_modify settings be delay = 0, every = 1, check = yes. Since these settings were not in place, LAMMPS changed them and will restore them to their original values after the minimization. <DT><I>Restart file used different # of processors</I> <DD>The restart file was written out by a LAMMPS simulation running on a different number of processors. Due to round-off, the trajectories of your restarted simulation may diverge a little more quickly than if you ran on the same # of processors. <DT><I>Restart file used different 3d processor grid</I> <DD>The restart file was written out by a LAMMPS simulation running on a different 3d grid of processors. Due to round-off, the trajectories of your restarted simulation may diverge a little more quickly than if you ran on the same # of processors. <DT><I>Restart file used different boundary settings, using restart file values</I> -<P>Your input script cannot change these settings in the restart file. -</P> +<DD>Your input script cannot change these restart file settings. + <DT><I>Restart file used different newton bond setting, using restart file value</I> -<P>Your input script cannot change this setting in the restart file. -</P> +<DD>The restart file value will override the setting in the input script. + <DT><I>Restart file used different newton pair setting, using input script value</I> -<P>Your input script can change this setting in the restart file, but you -may not wish to do so. -</P> +<DD>The input script value will override the setting in the restart file. + <DT><I>Restart file version does not match LAMMPS version</I> -<DD>The version of LAMMPS that wrote the restart file does not match the -version of LAMMPS that is reading the restart file. Generally this -shouldn't be a problem, since restart file formats won't change very -often if at all. But if they do, the code will probably crash trying -to read the file. Versions of LAMMPS are specified by a date. +<DD>This may cause problems when reading the restart file. <DT><I>Shake determinant < 0.0</I> <DD>The determinant of the quadratic equation being solved for a single cluster specified by the fix shake command is numerically suspect. LAMMPS will set it to 0.0 and continue. <DT><I>System is not charge neutral, net charge = %g</I> <DD>The total charge on all atoms on the system is not 0.0, which is not valid for Ewald or PPPM. <DT><I>Table inner cutoff >= outer cutoff</I> <DD>You specified an inner cutoff for a Coulombic table that is longer than the global cutoff. Probably not what you wanted. <DT><I>Temperature for NPH is not for group all</I> <DD>User-assigned temperature to NPH fix does not compute temperature for all atoms. Since NPH computes a global pressure, the kinetic energy contribution from the temperature is assumed to also be for all atoms. Thus the pressure used by NPH could be inaccurate. <DT><I>Temperature for NPT is not for group all</I> <DD>User-assigned temperature to NPT fix does not compute temperature for all atoms. Since NPT computes a global pressure, the kinetic energy contribution from the temperature is assumed to also be for all atoms. Thus the pressure used by NPT could be inaccurate. +<DT><I>Temperature for fix modify is not for group all</I> + +<DD>The temperature compute is being used with a pressure calculation +which does operate on group all, so this may be inconsistent. + <DT><I>Temperature for thermo pressure is not for group all</I> <DD>User-assigned temperature to thermo via the thermo_modify command does not compute temperature for all atoms. Since thermo computes a global pressure, the kinetic energy contribution from the temperature is assumed to also be for all atoms. Thus the pressure printed by thermo could be inaccurate. +<DT><I>Too many common neighbors in CNA %d times</I> + +<DD>More than the maximum # of neighbors was found multiple times. This +was unexpected. + <DT><I>Too many inner timesteps in fix ttm</I> <DD>Self-explanatory. +<DT><I>Too many neighbors in CNA for %d atoms</I> + +<DD>More than the maximum # of neighbors was found multiple times. This +was unexpected. + <DT><I>Use special bonds = 0,1,1 with bond style fene/expand</I> <DD>Most FENE models need this setting for the special_bonds command. <DT><I>Use special bonds = 0,1,1 with bond style fene</I> <DD>Most FENE models need this setting for the special_bonds command. <DT><I>Using compute temp/deform with inconsistent fix deform remap option</I> <DD>Fix nvt/sllod assumes deforming atoms have a velocity profile provided by "remap v" or "remap none" as a fix deform option. <DT><I>Using compute temp/deform with no fix deform defined</I> <DD>This is probably an error, since it makes little sense to use compute temp/deform in this case. <DT><I>Using pair tail corrections with nonperiodic system</I> <DD>This is probably a bogus thing to do, since tail corrections are computed by integrating the density of a periodic system out to infinity. </DL> </HTML> diff --git a/doc/Section_errors.txt b/doc/Section_errors.txt index 53e1d87d5..cfc93cdf8 100644 --- a/doc/Section_errors.txt +++ b/doc/Section_errors.txt @@ -1,4518 +1,4578 @@ "Previous Section"_Section_modify.html - "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc - "Next Section"_Section_history.html :c :link(lws,http://lammps.sandia.gov) :link(ld,Manual.html) :link(lc,Section_commands.html#comm) :line 9. Errors :h3 This section describes the various kinds of errors you can encounter when using LAMMPS. 9.1 "Common problems"_#9_1 9.2 "Reporting bugs"_#9_2 9.3 "Error & warning messages"_#9_3 :all(b) :line 9.1 Common problems :link(9_1),h4 If two LAMMPS runs do not produce the same answer on different machines or different numbers of processors, this is typically not a bug. In theory you should get identical answers on any number of processors and on any machine. In practice, numerical round-off can cause slight differences and eventual divergence of molecular dynamics phase space trajectories within a few 100s or few 1000s of timesteps. However, the statistical properties of the two runs (e.g. average energy or temperature) should still be the same. If the "velocity"_velocity.html command is used to set initial atom velocities, a particular atom can be assigned a different velocity when the problem on different machines. Obviously, this means the phase space trajectories of the two simulations will rapidly diverge. See the discussion of the {loop} option in the "velocity"_velocity.html command for details. Similarly, the "create_atoms"_create_atoms.html command generates a lattice of atoms. For the same physical system, the ordering and numbering of atoms by atom ID may be different depending on the number of processors. Some commands use random number generators which may be setup to produce different random number streams on each processor and hence will produce different effects when run on different numbers of processors. A commonly-used example is the "fix langevin"_fix_langevin.html command for thermostatting. A LAMMPS simulation typically has two stages, setup and run. Most LAMMPS errors are detected at setup time; others like a bond stretching too far may not occur until the middle of a run. LAMMPS tries to flag errors and print informative error messages so you can fix the problem. Of course LAMMPS cannot figure out your physics mistakes, like choosing too big a timestep, specifying invalid force field coefficients, or putting 2 atoms on top of each other! If you find errors that LAMMPS doesn't catch that you think it should flag, please send an email to the "developers"_http://lammps.sandia.gov/authors.html. If you get an error message about an invalid command in your input script, you can determine what command is causing the problem by looking in the log.lammps file or using the "echo command"_echo.html to see it on the screen. For a given command, LAMMPS expects certain arguments in a specified order. If you mess this up, LAMMPS will often flag the error, but it may read a bogus argument and assign a value that is valid, but not what you wanted. E.g. trying to read the string "abc" as an integer value and assigning the associated variable a value of 0. Generally, LAMMPS will print a message to the screen and exit gracefully when it encounters a fatal error. Sometimes it will print a WARNING and continue on; you can decide if the WARNING is important or not. If LAMMPS crashes or hangs without spitting out an error message first then it could be a bug (see "this section"_#9_2) or one of the following cases: LAMMPS runs in the available memory a processor allows to be allocated. Most reasonable MD runs are compute limited, not memory limited, so this shouldn't be a bottleneck on most platforms. Almost all large memory allocations in the code are done via C-style malloc's which will generate an error message if you run out of memory. Smaller chunks of memory are allocated via C++ "new" statements. If you are unlucky you could run out of memory just when one of these small requests is made, in which case the code will crash or hang (in parallel), since LAMMPS doesn't trap on those errors. Illegal arithmetic can cause LAMMPS to run slow or crash. This is typically due to invalid physics and numerics that your simulation is computing. If you see wild thermodynamic values or NaN values in your LAMMPS output, something is wrong with your simulation. In parallel, one way LAMMPS can hang is due to how different MPI implementations handle buffering of messages. If the code hangs without an error message, it may be that you need to specify an MPI setting or two (usually via an environment variable) to enable buffering or boost the sizes of messages that can be buffered. :line 9.2 Reporting bugs :link(9_2),h4 If you are confident that you have found a bug in LAMMPS, follow these steps. Check the "New features and bug fixes"_http://lammps.sandia.gov/bug.html section of the "LAMMPS WWW site"_lws to see if the bug has already been reported or fixed or the "Unfixed bug"_http://lammps.sandia.gov/unbug.html to see if a fix is pending. Check the "mailing list"_http://lammps.sandia.gov/mail.html to see if it has been discussed before. If not, send an email to the mailing list describing the problem with any ideas you have as to what is causing it or where in the code the problem might be. The developers will ask for more info if needed, such as an input script or data files. The most useful thing you can do to help us fix the bug is to isolate the problem. Run it on the smallest number of atoms and fewest number of processors and with the simplest input script that reproduces the bug and try to identify what command or combination of commands is causing the problem. As a last resort, you can send an email directly to the "developers"_http://lammps.sandia.gov/authors.html. :line 9.3 Error & warning messages :h4,link(9_3) These are two alphabetic lists of the "ERROR"_#error and "WARNING"_#warn messages LAMMPS prints out and the reason why. If the explanation here is not sufficient, the documentation for the offending command may help. Grepping the source files for the text of the error message and staring at the source code and comments is also not a bad idea! Note that sometimes the same message can be printed from multiple places in the code. Also note that error messages from "user-contributed packages"_Section_start.html#2_3 are not listed here. Is such an error occurs and is not self-explanatory, you'll need to look in the source code or contact the author of the package. Errors: :h4,link(error) :dlb {1-3 bond count is inconsistent} :dt An inconsistency was detected when computing the number of 1-3 neighbors for each atom. This likely means something is wrong with the bond topologies you have defined. :dd {1-4 bond count is inconsistent} :dt An inconsistency was detected when computing the number of 1-4 neighbors for each atom. This likely means something is wrong with the bond topologies you have defined. :dd {All angle coeffs are not set} :dt All angle coefficients must be set in the data file or by the angle_coeff command before running a simulation. :dd {All bond coeffs are not set} :dt All bond coefficients must be set in the data file or by the bond_coeff command before running a simulation. :dd {All dihedral coeffs are not set} :dt All dihedral coefficients must be set in the data file or by the dihedral_coeff command before running a simulation. :dd {All dipole moments are not set} :dt For atom styles that define dipole moments for each atom type, all moments must be set in the data file or by the dipole command before running a simulation. :dd {All improper coeffs are not set} :dt All improper coefficients must be set in the data file or by the improper_coeff command before running a simulation. :dd {All masses are not set} :dt For atom styles that define masses for each atom type, all masses must be set in the data file or by the mass command before running a simulation. They must also be set before using the velocity command. :dd {All pair coeffs are not set} :dt All pair coefficients must be set in the data file or by the pair_coeff command before running a simulation. :dd {All shapes are not set} :dt All atom types must have a shape setting, even if the particles are spherical. :dd {All universe/uloop variables must have same # of values} :dt Self-explanatory. :dd {All variables in next command must be same style} :dt Self-explanatory. :dd {Angle atom missing in delete_bonds} :dt The delete_bonds command cannot find one or more atoms in a particular angle on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid angle. :dd {Angle atom missing in set command} :dt The set command cannot find one or more atoms in a particular angle on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid angle. :dd {Angle atoms %d %d %d missing on proc %d at step %d} :dt One or more of 3 atoms needed to compute a particular angle are missing on this processor. Typically this is because the pairwise cutoff is set too short or the angle has blown apart and an atom is too far away. :dd {Angle coeff for hybrid has invalid style} :dt Angle style hybrid uses another angle style as one of its coefficients. The angle style used in the angle_coeff command or read from a restart file is not recognized. :dd {Angle coeffs are not set} :dt No angle coefficients have been assigned in the data file or via the angle_coeff command. :dd {Angle potential must be defined for SHAKE} :dt When shaking angles, an angle_style potential must be used. :dd {Angle style hybrid cannot have hybrid as an argument} :dt Self-explanatory. :dd {Angle style hybrid cannot have none as an argument} :dt Self-explanatory. :dd {Angle style hybrid cannot use same angle style twice} :dt Self-explanatory. :dd {Angle_coeff command before angle_style is defined} :dt Coefficients cannot be set in the data file or via the angle_coeff command until an angle_style has been assigned. :dd {Angle_coeff command before simulation box is defined} :dt The angle_coeff command cannot be used before a read_data, read_restart, or create_box command. :dd {Angle_coeff command when no angles allowed} :dt The chosen atom style does not allow for angles to be defined. :dd {Angle_style command when no angles allowed} :dt The chosen atom style does not allow for angles to be defined. :dd {Angles assigned incorrectly} :dt Angles read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. :dd {Angles defined but no angle types} :dt The data file header lists angles but no angle types. :dd {Another input script is already being processed} :dt Cannot attempt to open a 2nd input script, when the original file is still being processed. :dd {Arccos of invalid value in variable formula} :dt Argument of arccos() must be between -1 and 1. :dd {Arcsin of invalid value in variable formula} :dt Argument of arcsin() must be between -1 and 1. :dd {Atom IDs must be consecutive for dump dcd} :dt Self-explanatory. :dd {Atom IDs must be consecutive for dump xtc} :dt Self-explanatory. :dd {Atom IDs must be consecutive for dump xyz} :dt Self-explanatory. :dd {Atom IDs must be consecutive for velocity create loop all} :dt Self-explanatory. :dd {Atom count is inconsistent, cannot write restart file} :dt Sum of atoms across processors does not equal initial total count. This is probably because you have lost some atoms. :dd {Atom in too many rigid bodies - boost MAXBODY} :dt Fix poems has a parameter MAXBODY (in fix_poems.cpp) which determines the maximum number of rigid bodies a single atom can belong to (i.e. a multibody joint). The bodies you have defined exceed this limit. :dd {Atom style hybrid cannot have hybrid as an argument} :dt Self-explanatory. :dd {Atom style hybrid cannot use same atom style twice} :dt Self-explanatory. :dd {Atom vector in equal-style variable formula} :dt Atom vectors generate one value per atom which is not allowed in an equal-style variable. :dd {Atom-style variable in equal-style variable formula} :dt Atom-style variables generate one value per atom which is not allowed in an equal-style variable. :dd {Atom_modify command after simulation box is defined} :dt The atom_modify command cannot be used after a read_data, read_restart, or create_box command. :dd {Atom_style command after simulation box is defined} :dt The atom_style command cannot be used after a read_data, read_restart, or create_box command. :dd {Attempting to rescale a 0.0 temperature} :dt Cannot rescale a temperature that is already 0.0. :dd {Bad FENE bond} :dt Two atoms in a FENE bond have become so far apart that the bond cannot be computed. :dd {Bad grid of processors} :dt The 3d grid of processors defined by the processors command does not match the number of processors LAMMPS is being run on. :dd {Bad kspace_modify slab parameter} :dt Kspace_modify value for the slab/volume keyword must be >= 2.0. :dd {Bad principal moments} :dt Fix rigid did not compute the principal moments of inertia of a rigid group of atoms correctly. :dd {Bias compute does not calculate a velocity bias} :dt The specified compute must compute a bias for temperature. :dd {Bias compute does not calculate temperature} :dt The specified compute must compute temperature. :dd {Bias compute group does not match compute group} :dt The specified compute must operate on the same group as the parent compute. :dd {Bitmapped lookup tables require int/float be same size} :dt Cannot use pair tables on this machine, because of word sizes. Use the pair_modify command with table 0 instead. :dd {Bitmapped table in file does not match requested table} :dt Setting for bitmapped table in pair_coeff command must match table in file exactly. :dd {Bitmapped table is incorrect length in table file} :dt Number of table entries is not a correct power of 2. :dd {Bond and angle potentials must be defined for TIP4P} :dt Cannot use TIP4P pair potential unless bond and angle potentials are defined. :dd {Bond atom missing in delete_bonds} :dt The delete_bonds command cannot find one or more atoms in a particular bond on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid bond. :dd {Bond atom missing in set command} :dt The set command cannot find one or more atoms in a particular bond on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid bond. :dd {Bond atoms %d %d missing on proc %d at step %d} :dt One or both of 2 atoms needed to compute a particular bond are missing on this processor. Typically this is because the pairwise cutoff is set too short or the bond has blown apart and an atom is too far away. :dd {Bond coeff for hybrid has invalid style} :dt Bond style hybrid uses another bond style as one of its coefficients. The bond style used in the bond_coeff command or read from a restart file is not recognized. :dd {Bond coeffs are not set} :dt No bond coefficients have been assigned in the data file or via the bond_coeff command. :dd {Bond potential must be defined for SHAKE} :dt Cannot use fix shake unless bond potential is defined. :dd {Bond style hybrid cannot have hybrid as an argument} :dt Self-explanatory. :dd {Bond style hybrid cannot have none as an argument} :dt Self-explanatory. :dd {Bond style hybrid cannot use same bond style twice} :dt The sub-style arguments of bond_style hybrid cannot be duplicated. Check the input script. :dd {Bond style quartic cannot be used with 3,4-body interactions} :dt No angle, dihedral, or improper styles can be defined when using bond style quartic. :dd {Bond style quartic requires special_bonds = 1,1,1} :dt This is a restriction of the current bond quartic implementation. :dd {Bond_coeff command before bond_style is defined} :dt Coefficients cannot be set in the data file or via the bond_coeff command until an bond_style has been assigned. :dd {Bond_coeff command before simulation box is defined} :dt The bond_coeff command cannot be used before a read_data, read_restart, or create_box command. :dd {Bond_coeff command when no bonds allowed} :dt The chosen atom style does not allow for bonds to be defined. :dd {Bond_style command when no bonds allowed} :dt The chosen atom style does not allow for bonds to be defined. :dd {Bonds assigned incorrectly} :dt Bonds read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. :dd {Bonds defined but no bond types} :dt The data file header lists bonds but no bond types. :dd {Both sides of boundary must be periodic} :dt Cannot specify a boundary as periodic only on the lo or hi side. Must be periodic on both sides. :dd {Boundary command after simulation box is defined} :dt The boundary command cannot be used after a read_data, read_restart, or create_box command. :dd {Box bounds are invalid} :dt The box boundaries specified in the read_data file are invalid. The lo value must be less than the hi value for all 3 dimensions. :dd {Cannot (yet) use PPPM with triclinic box} :dt This feature is not yet supported. :dd {Cannot change box to orthogonal when tilt is non-zero} :dt Self-explanatory :dd {Cannot change box with certain fixes defined} :dt The change_box command cannot be used when fix ave/spatial or fix/deform are defined . :dd {Cannot change box with dumps defined} :dt Self-explanatory. :dd {Cannot change dump_modify every for dump dcd} :dt The frequency of writing dump dcd snapshots cannot be changed. :dd {Cannot change timestep with fix pour} :dt This fix pre-computes some values based on the timestep, so it cannot be changed during a simulation run. :dd {Cannot compute PPPM G} :dt LAMMPS failed to compute a valid approximation for the PPPM g_ewald factor that partitions the computation between real space and k-space. :dd {Cannot create an atom map unless atoms have IDs} :dt The simulation requires a mapping from global atom IDs to local atoms, but the atoms that have been defined have no IDs. :dd {Cannot create atoms with undefined lattice} :dt Must use the lattice command before using the create_atoms command. :dd {Cannot create_box after simulation box is defined} :dt The create_box command cannot be used after a read_data, read_restart, or create_box command. :dd {Cannot delete group all} :dt Self-explanatory. :dd {Cannot delete group currently used by a compute} :dt Self-explanatory. :dd {Cannot delete group currently used by a dump} :dt Self-explanatory. :dd {Cannot delete group currently used by a fix} :dt Self-explanatory. :dd {Cannot delete group currently used by atom_modify first} :dt Self-explanatory. :dd {Cannot displace_box on a non-periodic boundary} :dt Self-explanatory. :dd {Cannot evaporate atoms in atom_modify first group} :dt This is a restriction due to the way atoms are organized in a list to enable the atom_modify first command. :dd {Cannot find delete_bonds group ID} :dt Group ID used in the delete_bonds command does not exist. :dd {Cannot fix deform on a non-periodic boundary} :dt Only a periodic boundary can be modified. :dd {Cannot have both pair_modify shift and tail set to yes} :dt These 2 options are contradictory. :dd {Cannot open AIREBO potential file %s} :dt Self-explanatory. :dd {Cannot open EAM potential file %s} :dt The specified EAM potential file cannot be opened. Check that the path and name are correct. :dd {Cannot open MEAM potential file %s} :dt The specified MEAM potential file cannot be opened. Check that the path and name are correct. :dd {Cannot open Stillinger-Weber potential file %s} :dt The specified SW potential file cannot be opened. Check that the path and name are correct. :dd {Cannot open Tersoff potential file %s} :dt The specified Tersoff potential file cannot be opened. Check that the path and name are correct. :dd {Cannot open dir to search for restart file} :dt Using a "*" in the name of the restart file will open the current directory to search for matching file names. :dd {Cannot open dump file} :dt The output file for the dump command cannot be opened. Check that the path and name are correct. :dd {Cannot open file %s} :dt The specified file cannot be opened. Check that the path and name are correct. :dd {Cannot open fix ave/spatial file %s} :dt Self-explanatory. :dd {Cannot open fix ave/time file %s} :dt Self-explanatory. :dd {Cannot open fix com file %s} :dt The output file for the fix com command cannot be opened. Check that the path and name are correct. :dd {Cannot open fix gyration file %s} :dt Self-explanatory. :dd {Cannot open fix msd file %s} :dt The output file for the fix msd command cannot be opened. Check that the path and name are correct. :dd {Cannot open fix poems file %s} :dt The specified file cannot be opened. Check that the path and name are correct. :dd {Cannot open fix print file %s} :dt The output file generated by the fix print command cannot be opened :dd {Cannot open fix rdf file %s} :dt The output file for the fix rdf command cannot be opened. Check that the path and name are correct. :dd {Cannot open fix reax/bonds file %s} :dt The output file for the fix reax/bonds command cannot be opened. Check that the path and name are correct. :dd {Cannot open fix tmd file %s} :dt The output file for the fix tmd command cannot be opened. Check that the path and name are correct. :dd {Cannot open fix ttm file %s} :dt The output file for the fix ttm command cannot be opened. Check that the path and name are correct. :dd {Cannot open gzipped file} :dt LAMMPS is attempting to open a gzipped version of the specified file but was unsuccessful. Check that the path and name are correct. :dd {Cannot open input script %s} :dt Self-explanatory. :dd {Cannot open log.lammps} :dt The default LAMMPS log file cannot be opened. Check that the directory you are running in allows for files to be created. :dd {Cannot open logfile %s} :dt The LAMMPS log file specified in the input script cannot be opened. Check that the path and name are correct. :dd {Cannot open logfile} :dt The LAMMPS log file named in a command-line argument cannot be opened. Check that the path and name are correct. :dd {Cannot open pair_write file} :dt The specified output file for pair energies and forces cannot be opened. Check that the path and name are correct. :dd {Cannot open restart file %s} :dt Self-explanatory. :dd {Cannot open screen file} :dt The screen file specified as a command-line argument cannot be opened. Check that the directory you are running in allows for files to be created. :dd {Cannot open universe log file} :dt For a multi-partition run, the master log file cannot be opened. Check that the directory you are running in allows for files to be created. :dd {Cannot open universe screen file} :dt For a multi-partition run, the master screen file cannot be opened. Check that the directory you are running in allows for files to be created. :dd {Cannot read_data after simulation box is defined} :dt The read_data command cannot be used after a read_data, read_restart, or create_box command. :dd {Cannot read_restart after simulation box is defined} :dt The read_restart command cannot be used after a read_data, read_restart, or create_box command. :dd {Cannot redefine variable as a different style} :dt An equal-style variable can be re-defined but only if it was originally an equal-style variable. :dd {Cannot replicate 2d simulation in z dimension} :dt The replicate command cannot replicate a 2d simulation in the z dimension. :dd {Cannot replicate with fixes that store atom quantities} :dt Either fixes are defined that create and store atom-based vectors or a restart file was read which included atom-based vectors for fixes. The replicate command cannot duplicate that information for new atoms. You should use the replicate command before fixes are applied to the system. :dd {Cannot reset timestep with a time-dependent fix defined} :dt You cannot reset the timestep when a fix that keeps track of elapsed time is in place. :dd {Cannot reset timestep with dump file already written to} :dt Changing the timestep will confuse when a dump file is written. Use the undump command, then restart the dump file. :dd {Cannot reset timestep with restart file already written} :dt Changing the timestep will confuse when a restart file is written. Use the "restart 0" command to turn off restarts, then start them again. :dd {Cannot run 2d simulation with nonperiodic Z dimension} :dt Use the boundary command to make the z dimension periodic in order to run a 2d simulation. :dd {Cannot set both respa pair and inner/middle/outer} :dt In the rRESPA integrator, you must compute pairwise potentials either all together (pair), or in pieces (inner/middle/outer). You can't do both. :dd {Cannot set dipole for this atom style} :dt This atom style does not support dipole settings for each atom type. :dd {Cannot set dump_modify flush for dump xtc} :dt Self-explanatory. :dd {Cannot set mass for this atom style} :dt This atom style does not support mass settings for each atom type. Instead they are defined on a per-atom basis in the data file. :dd {Cannot set respa middle without inner/outer} :dt In the rRESPA integrator, you must define both a inner and outer setting in order to use a middle setting. :dd {Cannot set shape for this atom style} :dt The atom style does not support this setting. :dd {Cannot set this attribute for this atom style} :dt The attribute being set does not exist for the defined atom style. :dd {Cannot skew triclinic box in z for 2d simulation} :dt Self-explanatory. :dd {Cannot use Ewald with 2d simulation} :dt The kspace style ewald cannot be used in 2d simulations. You can use 2d Ewald in a 3d simulation; see the kspace_modify command. :dd {Cannot use Ewald with triclinic box} :dt This feature is not yet supported. :dd {Cannot use PPPM with 2d simulation} :dt The kspace style pppm cannot be used in 2d simulations. You can use 2d PPPM in a 3d simulation; see the kspace_modify command. :dd {Cannot use delete_atoms unless atoms have IDs} :dt Your atoms do not have IDs, so the delete_atoms command cannot be used. :dd {Cannot use delete_bonds with non-molecular system} :dt Your choice of atom style does not have bonds. :dd {Cannot use dump bond with non-molecular system} :dt Your choice of atom style does not have bonds. :dd {Cannot use fix TMD unless atom map exists} :dt Using this fix requires the ability to lookup an atom index, which is provided by an atom map. An atom map does not exist (by default) for non-molecular problems. Using the atom_modify map command will force an atom map to be created. :dd {Cannot use fix bond/break with non-molecular systems} :dt Self-explanatory. :dd {Cannot use fix bond/create with non-molecular systems} :dt Self-explanatory. :dd {Cannot use fix box/relax on a non-periodic dimension} :dt Only periodic dimensions can be controlled with this fix. :dd {Cannot use fix deform trate on a box with zero tilt} :dt The trate style alters the current strain. :dd {Cannot use fix enforce2d with 3d simulation} :dt Self-explanatory. :dd {Cannot use fix nph on a non-periodic dimension} :dt Only periodic dimensions can be controlled with this fix. :dd {Cannot use fix nph with triclinic box} :dt This feature is not yet supported. :dd {Cannot use fix npt and fix deform on same dimension} :dt These commands both change the box size/shape, so you cannot use both together. :dd {Cannot use fix npt on a non-periodic dimension} :dt Only periodic dimensions can be controlled with this fix. :dd {Cannot use fix npt with triclinic box} :dt This feature is not yet supported. :dd {Cannot use fix pour with triclinic box} :dt This feature is not yet supported. :dd {Cannot use fix press/berendsen and fix deform on same dimension} :dt Self-explanatory. :dd {Cannot use fix press/berendsen on a non-periodic dimension} :dt Self-explanatory. :dd {Cannot use fix press/berendsen with triclinic box} :dt Self-explanatory. :dd {Cannot use fix reax/bonds without pair_style reax} :dt Self-explantory. :dd {Cannot use fix shake with non-molecular system} :dt Your choice of atom style does not have bonds. :dd {Cannot use fix ttm with 2d simulation} :dt This is a current restriction of this fix due to the grid it creates. :dd {Cannot use fix ttm with triclinic box} :dt This is a current restriction of this fix due to the grid it creates. :dd {Cannot use kspace solver on system with no charge} :dt No atoms in system have a non-zero charge. :dd {Cannot use neighbor bins - box size << cutoff} :dt Too many neighbor bins will be created. This typically happens when the simulation box is very small in some dimension, compared to the neighbor cutoff. Use the "nsq" style instead of "bin" style. :dd {Cannot use nonperiodic boundares with fix ttm} :dt This fix requires a fully periodic simulation box. :dd {Cannot use nonperiodic boundaries with Ewald} :dt For kspace style ewald, all 3 dimensions must have periodic boundaries unless you use the kspace_modify command to define a 2d slab with a non-periodic z dimension. :dd {Cannot use nonperiodic boundaries with PPPM} :dt For kspace style pppm, all 3 dimensions must have periodic boundaries unless you use the kspace_modify command to define a 2d slab with a non-periodic z dimension. :dd {Cannot use pair tail corrections with 2d simulations} :dt The correction factors are only currently defined for 3d systems. :dd {Cannot use region INF or EDGE when box does not exist} :dt Regions that extend to the box boundaries can only be used after the create_box command has been used. :dd {Cannot use set atom with no atom IDs defined} :dt Atom IDs are not defined, so they cannot be used to identify an atom. :dd {Cannot use velocity create loop all unless atoms have IDs} :dt Atoms in the simulation to do not have IDs, so this style of velocity creation cannot be performed. :dd {Cannot use wall in periodic dimension} :dt Self-explanatory. :dd {Cannot wiggle and shear fix wall/gran} :dt Cannot specify both options at the same time. :dd {Cannot zero momentum of 0 atoms} :dt The collection of atoms for which momentum is being computed has no atoms. :dd {Change_box command before simulation box is defined} :dt Self-explanatory. :dd {Change_box operation is invalid} :dt Cannot change orthogonal box to orthogonal or a triclinic box to triclinic. :dd {Communicate group != atom_modify first group} :dt Self-explanatory. :dd -{Compute erotate/asphere requires extended particles} :dt - -This quantity can only be calculated for particles with a shape -setting. :dd +{Compute ID for compute heat/flux does not exist} :dt -{Compute temp/asphere requires extended particles} :dt - -This quantity can only be calculated for particles with a shape -setting. :dd +Self-explanatory. :dd {Compute ID for compute reduce does not exist} :dt Self-explanatory. :dd {Compute ID for fix ave/atom does not exist} :dt Self-explanatory. :dd {Compute ID for fix ave/spatial does not exist} :dt Self-explanatory. :dd {Compute ID for fix ave/time does not exist} :dt Self-explanatory. :dd {Compute ID must be alphanumeric or underscore characters} :dt Self-explanatory. :dd {Compute centro/atom requires a pair style be defined} :dt This is because the computation of the centro-symmetry values uses a pairwise neighbor list. :dd {Compute cna/atom cutoff is longer than pairwise cutoff} :dt Self-explantory. :dd {Compute cna/atom requires a pair style be defined} :dt Self-explantory. :dd {Compute coord/atom cutoff is longer than pairwise cutoff} :dt Cannot compute coordination at distances longer than the pair cutoff, since those atoms are not in the neighbor list. :dd {Compute coord/atom requires a pair style be defined} :dt Self-explantory. :dd {Compute damage/atom requires peridynamic potential} :dt Damage is a Peridynamic-specific metric. It requires you to be running a Peridynamics simulation. :dd +{Compute does not allow an extra compute to be reset} :dt + +This is an internal LAMMPS error. Please report it to the +developers. :dd + {Compute erotate/asphere cannot be used with atom attributes diameter or rmass} :dt These attributes override the shape and mass settings, so cannot be used. :dd {Compute erotate/asphere requires atom attributes angmom, quat, shape} :dt An atom style that defines these attributes must be used. :dd +{Compute erotate/asphere requires extended particles} :dt + +This compute cannot be used with point paritlces. :dd + {Compute erotate/sphere requires atom attribute omega} :dt An atom style that defines this attribute must be used. :dd {Compute erotate/sphere requires atom attribute radius or shape} :dt An atom style that defines these attributes must be used. :dd {Compute erotate/sphere requires spherical particle shapes} :dt Self-explanatory. :dd {Compute group/group group ID does not exist} :dt Self-explanatory. :dd +{Compute heat/flux compute ID does not compute pe/atom} :dt + +Self-explanatory. :dd + +{Compute heat/flux requires ghost atoms store velocity} :dt + +An atom style that stores this, like atom_style dpd, must be used. :dd + {Compute pe must use group all} :dt Energies computed by potentials (pair, bond, etc) are computed on all atoms. :dd {Compute pressure must use group all} :dt Virial contributions computed by potentials (pair, bond, etc) are computed on all atoms. :dd -{Compute pressure temp ID does not compute temperature} :dt +{Compute pressure temperature ID does not compute temperature} :dt The compute ID assigned to a pressure computation must compute temperature. :dd {Compute reduce compute does not calculate a per-atom scalar} :dt Self-explanatory. :dd {Compute reduce compute does not calculate a per-atom vector} :dt Self-explanatory. :dd {Compute reduce compute does not calculate per-atom values} :dt Self-explanatory. :dd {Compute reduce fix does not calculate a per-atom scalar} :dt Self-explanatory. :dd {Compute reduce fix does not calculate a per-atom vector} :dt Self-explanatory. :dd {Compute reduce fix does not calculate per-atom values} :dt Self-explanatory. :dd {Compute reduce region ID does not exist} :dt Self-explanatory. :dd {Compute reduce variable is not atom-style variable} :dt Self-explanatory. :dd {Compute temp/asphere cannot be used with atom attributes diameter or rmass} :dt These attributes override the shape and mass settings, so cannot be used. :dd {Compute temp/asphere requires atom attributes angmom, quat, shape} :dt An atom style that defines these attributes must be used. :dd -{Compute temp/partial cannot use vz for 2d systems} :dt +{Compute temp/asphere requires extended particles} :dt -Self-explanatory. :dd +This compute cannot be used with point paritlces. :dd -{Compute temp/profile cannot use vz for 2d systems} :dt +{Compute temp/partial cannot use vz for 2d systemx} :dt Self-explanatory. :dd {Compute temp/profile cannot bin z for 2d systems} :dt Self-explanatory. :dd +{Compute temp/profile cannot use vz for 2d systemx} :dt + +Self-explanatory. :dd + {Compute temp/sphere requires atom attribute omega} :dt An atom style that defines this attribute must be used. :dd {Compute temp/sphere requires atom attribute radius or shape} :dt An atom style that defines these attributes must be used. :dd {Compute temp/sphere requires spherical particle shapes} :dt Self-explanatory. :dd {Compute used in variable between runs is not current} :dt Computes cannot be invoked by a variable in between runs. Thus they must have been evaluated on the last timestep of the previous run in order for their value(s) to be accessed. See the doc page for the variable command for more info. :dd {Compute used in variable thermo keyword between runs is not current} :dt Some thermo keywords rely on a compute to calculate their value(s). Computes cannot be invoked by a variable in between runs. Thus they must have been evaluated on the last timestep of the previous run in order for their value(s) to be accessed. See the doc page for the variable command for more info. :dd {Compute vector in variable formula is too small} :dt The index to the vector is out of bounds. :dd {Computed temperature for fix temp/berendsen cannot be 0.0} :dt Self-explanatory. :dd {Computed temperature for fix temp/rescale cannot be 0.0} :dt Cannot rescale the temperature to a new value if the current temperature is 0.0. :dd {Could not count initial bonds in fix bond/create} :dt Could not find one of the atoms in a bond on this processor. :dd {Could not create 3d FFT plan} :dt The FFT setup in pppm failed. :dd {Could not create 3d remap plan} :dt The FFT setup in pppm failed. :dd {Could not find atom_modify first group ID} :dt Self-explanatory. :dd {Could not find compute ID for temperature bias} :dt Self-explanatory. :dd {Could not find compute ID to delete} :dt Self-explanatory. :dd {Could not find compute displace/atom fix ID} :dt Self-explanatory. :dd {Could not find compute group ID} :dt Self-explanatory. :dd -{Could not find compute pressure temp ID} :dt +{Could not find compute heat/flux compute ID} :dt -The compute ID for calculating temperature does not exist. :dd +Self-explanatory. :dd -{Could not find compute_modify ID} :dt +{Could not find compute pressure temperature ID} :dt -Self-explanatory. :dd +The compute ID for calculating temperature does not exist. :dd -{Could not find group delete ID} :dt +{Could not find compute_modify ID} :dt Self-explanatory. :dd {Could not find delete_atoms group ID} :dt Group ID used in the delete_atoms command does not exist. :dd {Could not find delete_atoms region ID} :dt Region ID used in the delete_atoms command does not exist. :dd {Could not find displace_atoms group ID} :dt Group ID used in the displace_atoms command does not exist. :dd {Could not find displace_box group ID} :dt Group ID used in the displace_box command does not exist. :dd {Could not find dump custom compute ID} :dt The compute ID needed by dump custom to compute a per-atom quantity does not exist. :dd {Could not find dump custom fix ID} :dt Self-explanatory. :dd {Could not find dump custom variable name} :dt Self-explanatory. :dd {Could not find dump group ID} :dt A group ID used in the dump command does not exist. :dd {Could not find fix ID to delete} :dt Self-explanatory. :dd {Could not find fix group ID} :dt A group ID used in the fix command does not exist. :dd {Could not find fix poems group ID} :dt A group ID used in the fix poems command does not exist. :dd {Could not find fix recenter group ID} :dt A group ID used in the fix recenter command does not exist. :dd {Could not find fix rigid group ID} :dt A group ID used in the fix rigid command does not exist. :dd {Could not find fix_modify ID} :dt A fix ID used in the fix_modify command does not exist. :dd {Could not find fix_modify pressure ID} :dt The compute ID for computing pressure does not exist. :dd -{Could not find fix_modify temp ID} :dt +{Could not find fix_modify temperature ID} :dt The compute ID for computing temperature does not exist. :dd +{Could not find group delete group ID} :dt + +Self-explanatory. :dd + {Could not find set group ID} :dt Group ID specified in set command does not exist. :dd {Could not find thermo compute ID} :dt Compute ID specified in thermo_style command does not exist. :dd {Could not find thermo custom compute ID} :dt The compute ID needed by thermo style custom to compute a requested quantity does not exist. :dd {Could not find thermo custom fix ID} :dt The fix ID needed by thermo style custom to compute a requested quantity does not exist. :dd {Could not find thermo custom variable name} :dt Self-explanatory. :dd {Could not find thermo fix ID} :dt Fix ID specified in thermo_style command does not exist. :dd -{Could not find thermo_modify press ID} :dt +{Could not find thermo_modify pressure ID} :dt The compute ID needed by thermo style custom to compute pressure does not exist. :dd -{Could not find thermo_modify temp ID} :dt +{Could not find thermo_modify temperature ID} :dt The compute ID needed by thermo style custom to compute temperature does not exist. :dd {Could not find undump ID} :dt A dump ID used in the undump command does not exist. :dd {Could not find velocity group ID} :dt A group ID used in the velocity command does not exist. :dd -{Could not find velocity temp ID} :dt +{Could not find velocity temperature ID} :dt The compute ID needed by the velocity command to compute temperature does not exist. :dd {Could not set finite-size particle attribute in fix rigid} :dt The particle has a finite size but its attributes could not be determined. :dd {Coulomb cutoffs of pair hybrid sub-styles do not match} :dt If using a Kspace solver, all Coulomb cutoffs of long pair styles must be the same. :dd {Cound not find dump_modify ID} :dt Self-explanatory. :dd {Create_atoms command before simulation box is defined} :dt The create_atoms command cannot be used before a read_data, read_restart, or create_box command. :dd {Create_atoms region ID does not exist} :dt A region ID used in the create_atoms command does not exist. :dd {Create_box region ID does not exist} :dt A region ID used in the create_box command does not exist. :dd {Create_box region must be of type inside} :dt The region used in the create_box command must not be an "outside" region. See the region command for details. :dd {Cyclic loop in joint connections} :dt Fix poems cannot (yet) work with coupled bodies whose joints connect the bodies in a ring (or cycle). :dd {Degenerate lattice primitive vectors} :dt Invalid set of 3 lattice vectors for lattice command. :dd {Delete_atoms command before simulation box is defined} :dt The delete_atoms command cannot be used before a read_data, read_restart, or create_box command. :dd {Delete_atoms cutoff > neighbor cutoff} :dt Cannot delete atoms further away than a processor knows about. :dd {Delete_atoms requires a pair style be defined} :dt This is because atom deletion within a cutoff uses a pairwise neighbor list. :dd {Delete_bonds command before simulation box is defined} :dt The delete_bonds command cannot be used before a read_data, read_restart, or create_box command. :dd {Delete_bonds command with no atoms existing} :dt No atoms are yet defined so the delete_bonds command cannot be used. :dd {Deposition region extends outside simulation box} :dt Self-explanatory. :dd {Did not assign all atoms correctly} :dt Atoms read in from a data file were not assigned correctly to processors. This is likely due to some atom coordinates being outside a non-periodic simulation box. :dd {Did not find all elements in MEAM library file} :dt The requested elements were not found in the MEAM file. :dd {Did not find fix shake partner info} :dt Could not find bond partners implied by fix shake command. This error can be triggered if the delete_bonds command was used before fix shake, and it removed bonds without resetting the 1-2, 1-3, 1-4 weighting list via the special keyword. :dd {Did not find keyword in table file} :dt Keyword used in pair_coeff command was not found in table file. :dd {Dihedral atom missing in delete_bonds} :dt The delete_bonds command cannot find one or more atoms in a particular dihedral on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid dihedral. :dd {Dihedral atom missing in set command} :dt The set command cannot find one or more atoms in a particular dihedral on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid dihedral. :dd {Dihedral atoms %d %d %d %d missing on proc %d at step %d} :dt One or more of 4 atoms needed to compute a particular dihedral are missing on this processor. Typically this is because the pairwise cutoff is set too short or the dihedral has blown apart and an atom is too far away. :dd {Dihedral charmm is incompatible with Pair style} :dt Dihedral style charmm must be used with a pair style charmm in order for the 1-4 epsilon/sigma parameters to be defined. :dd {Dihedral coeff for hybrid has invalid style} :dt Dihedral style hybrid uses another dihedral style as one of its coefficients. The dihedral style used in the dihedral_coeff command or read from a restart file is not recognized. :dd {Dihedral coeffs are not set} :dt No dihedral coefficients have been assigned in the data file or via the dihedral_coeff command. :dd {Dihedral style hybrid cannot have hybrid as an argument} :dt Self-explanatory. :dd {Dihedral style hybrid cannot have none as an argument} :dt Self-explanatory. :dd {Dihedral style hybrid cannot use same dihedral style twice} :dt Self-explanatory. :dd {Dihedral_coeff command before dihedral_style is defined} :dt Coefficients cannot be set in the data file or via the dihedral_coeff command until an dihedral_style has been assigned. :dd {Dihedral_coeff command before simulation box is defined} :dt The dihedral_coeff command cannot be used before a read_data, read_restart, or create_box command. :dd {Dihedral_coeff command when no dihedrals allowed} :dt The chosen atom style does not allow for dihedrals to be defined. :dd {Dihedral_style command when no dihedrals allowed} :dt The chosen atom style does not allow for dihedrals to be defined. :dd {Dihedrals assigned incorrectly} :dt Dihedrals read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. :dd {Dihedrals defined but no dihedral types} :dt The data file header lists dihedrals but no dihedral types. :dd {Dimension command after simulation box is defined} :dt The dimension command cannot be used after a read_data, read_restart, or create_box command. :dd {Dipole command before simulation box is defined} :dt The dipole command cannot be used before a read_data, read_restart, or create_box command. :dd {Displace_atoms command before simulation box is defined} :dt The displace_atoms command cannot be used before a read_data, read_restart, or create_box command. :dd {Displace_box command before simulation box is defined} :dt Self-explanatory. :dd {Displace_box tilt factors require triclinic box} :dt Cannot use tilt factors unless the simulation box is non-orthogonal. :dd {Divide by 0 in variable formula} :dt Self-explanatory. :dd {Domain too large for neighbor bins} :dt The domain has become extremely large so that neighbor bins cannot be used. Most likely, one or more atoms have been blown out of the simulation box to a great distance. :dd {Dump custom and fix not computed at compatible times} :dt The fix must produce per-atom quantities on timesteps that dump custom needs them. :dd {Dump custom compute ID does not compute peratom info} :dt The compute ID used must compute peratom info, not a global scalar or vector quantity. :dd {Dump custom compute ID does not compute scalar per atom} :dt The compute ID used must compute a single peratom datum. :dd {Dump custom compute ID does not compute vector per atom} :dt The compute ID used must compute a vector of peratom data. :dd {Dump custom compute ID vector is not large enough} :dt The compute ID vector of peratom data is not as large as is being accessed. :dd {Dump custom fix ID does not compute peratom info} :dt The specified fix does not calculate per-atom values. :dd {Dump custom fix ID does not compute scalar per atom} :dt The dump custom command is attempting to access a scalar quantity. :dd {Dump custom fix ID does not compute vector per atom} :dt The dump custom command is attempting to access a vector quantity. :dd {Dump custom fix ID vector is not large enough} :dt The dump custom command is attempting to access an out-of-range vector value. :dd {Dump custom variable is not atom-style variable} :dt Only atom-style variables generate per-atom quantities, needed for dump output. :dd {Dump dcd cannot dump unwrapped coords with triclinic box} :dt Cannot use unwrap option with non-orthogonal simulation box. :dd {Dump dcd must use group all} :dt Self-explanatory. :dd {Dump dcd of non-matching # of atoms} :dt Every snapshot written by dump dcd must contain the same # of atoms. :dd {Dump xtc must use group all} :dt Self-explanatory. :dd {Dump xtc must use group all} :dt Self-explanatory. :dd {Dump_modify region ID does not exist} :dt Self-explanatory. :dd {Dumping an atom quantity that isn't allocated} :dt The chosen atom style does not define the per-atom vector being dumped. :dd {Electronic temperature dropped below zero} :dt Something has gone wrong with the fix ttm electron temperature model. :dd {Empty brackets in variable formula} :dt A value inside the brackets is required for this formula element. :dd {Energy was not tallied on needed timestep} :dt You are using a thermo keyword that requires potentials to have tallied energy, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. :dd {Failed to allocate %d bytes for array %s} :dt Your LAMMPS simulation has run out of memory. You need to run a smaller simulation or on more processors. :dd {Failed to reallocate %d bytes for array %s} :dt Your LAMMPS simulation has run out of memory. You need to run a smaller simulation or on more processors. :dd {Final box dimension due to fix deform is < 0.0} :dt Self-explanatory. :dd {Fix ID for compute reduce does not exist} :dt Self-explanatory. :dd {Fix ID for fix ave/atom does not exist} :dt Self-explanatory. :dd {Fix ID for fix ave/spatial does not exist} :dt Self-explanatory. :dd {Fix ID for fix ave/time does not exist} :dt Self-explanatory. :dd {Fix ID must be alphanumeric or underscore characters} :dt Self-explanatory. :dd {Fix ave/atom compute does not calculate a per-atom scalar} :dt A compute used by fix ave/atom must generate per-atom values. :dd {Fix ave/atom compute does not calculate a per-atom vector} :dt A compute used by fix ave/atom must generate per-atom values. :dd {Fix ave/atom compute does not calculate per-atom values} :dt A compute used by fix ave/atom must generate per-atom values. :dd {Fix ave/atom compute vector is accessed out-of-range} :dt The index for the vector is out of bounds. :dd {Fix ave/atom fix does not calculate a per-atom scalar} :dt A fix used by fix ave/atom must generate per-atom values. :dd {Fix ave/atom fix does not calculate a per-atom vector} :dt A fix used by fix ave/atom must generate per-atom values. :dd {Fix ave/atom fix does not calculate per-atom values} :dt A fix used by fix ave/atom must generate per-atom values. :dd {Fix ave/atom fix vector is accessed out-of-range} :dt The index for the vector is out of bounds. :dd {Fix ave/atom variable is not atom-style variable} :dt A variable used by fix ave/atom must generate per-atom values. :dd {Fix ave/spatial compute does not calculate a per-atom scalar} :dt A compute used by fix ave/spatial must generate per-atom values. :dd {Fix ave/spatial compute does not calculate a per-atom vector} :dt A compute used by fix ave/spatial must generate per-atom values. :dd {Fix ave/spatial compute does not calculate per-atom values} :dt A compute used by fix ave/spatial must generate per-atom values. :dd {Fix ave/spatial compute vector is accessed out-of-range} :dt The index for the vector is out of bounds. :dd {Fix ave/spatial fix does not calculate a per-atom scalar} :dt A fix used by fix ave/spatial must generate per-atom values. :dd {Fix ave/spatial fix does not calculate a per-atom vector} :dt A fix used by fix ave/spatial must generate per-atom values. :dd {Fix ave/spatial fix does not calculate per-atom values} :dt A fix used by fix ave/spatial must generate per-atom values. :dd {Fix ave/spatial fix vector is accessed out-of-range} :dt The index for the vector is out of bounds. :dd {Fix ave/spatial for triclinic boxes requires units reduced} :dt Self-explanatory. :dd {Fix ave/spatial settings invalid with changing box} :dt If the ave setting is "running" or "window" and the box size/shape changes during the simulation, then the units setting must be "reduced", else the number of bins may change. :dd {Fix ave/spatial variable is not atom-style variable} :dt A variable used by fix ave/spatial must generate per-atom values. :dd {Fix ave/time compute does not calculate a scalar} :dt Only computes that calculate a scalar or vector quantity (not a per-atom quantity) can be used with fix ave/time. :dd {Fix ave/time compute does not calculate a vector} :dt Only computes that calculate a scalar or vector quantity (not a per-atom quantity) can be used with fix ave/time. :dd {Fix ave/time compute vector is accessed out-of-range} :dt The index for the vector is out of bounds. :dd {Fix ave/time fix does not calculate a scalar} :dt A fix used by fix ave/time must generate global values. :dd {Fix ave/time fix does not calculate a vector} :dt A fix used by fix ave/time must generate global values. :dd {Fix ave/time fix vector is accessed out-of-range} :dt The index for the vector is out of bounds. :dd {Fix ave/time variable is not equal-style variable} :dt A variable used by fix ave/time must generate a global value. :dd {Fix bond/break requires special_bonds = 0,1,1} :dt This is a restriction of the current fix bond/break implementation. :dd {Fix bond/create cutoff is longer than pairwise cutoff} :dt This is not allowed because bond creation is done using the pairwise neighbor list. :dd {Fix bond/create requires special_bonds = 0,1,1} :dt This is a restriction of the current fix bond/break implementation. :dd {Fix bond/swap cannot use dihedral or improper styles} :dt These styles cannot be defined when using this fix. :dd {Fix bond/swap requires pair and bond styles} :dt Self-explanatory. :dd {Fix bond/swap requires special_bonds = 0,1,1} :dt Self-explanatory. :dd {Fix command before simulation box is defined} :dt The fix command cannot be used before a read_data, read_restart, or create_box command. :dd {Fix deform is changing yz by too much with changing xy} :dt When both yz and xy are changing, it induces changes in xz if the box must flip from one tilt extreme to another. Thus it is not allowed for yz to grow so much that a flip is induced. :dd {Fix deform tilt factors require triclinic box} :dt Cannot deform the tilt factors of a simulation box unless it is a triclinic (non-orthogonal) box. :dd {Fix deform volume setting is invalid} :dt Cannot use volume style unless other dimensions are being controlled. :dd {Fix deposit region ID does not exist} :dt Self-explanatory :dd {Fix evaporate region ID does not exist} :dt Self-explanatory :dd {Fix for fix ave/atom not computed at compatible time} :dt Fixes generate their values on specific timesteps. Fix ave/atom is requesting a value on a non-allowed timestep. :dd {Fix for fix ave/spatial not computed at compatible time} :dt Fixes generate their values on specific timesteps. Fix ave/spatial is requesting a value on a non-allowed timestep. :dd {Fix for fix ave/time not computed at compatible time} :dt Fixes generate their values on specific timesteps. Fix ave/time is requesting a value on a non-allowed timestep. :dd {Fix freeze requires atom attribute torque} :dt The atom style defined does not have this attribute. :dd {Fix heat group has no atoms} :dt Self-explanatory. :dd {Fix heat kinetic energy went negative} :dt This will cause the velocity rescaling about to be performed by fix heat to be invalid. :dd {Fix in variable not computed at compatible time} :dt Fixes generate their values on specific timesteps. The variable is requesting the values on a non-allowed timestep. :dd {Fix langevin period must be > 0.0} :dt The time window for temperature relaxation must be > 0 :dd {Fix momentum group has no atoms} :dt Self-explanatory. :dd {Fix msd group has no atoms} :dt Cannot compute diffusion for no atoms. :dd {Fix nph periods must be > 0.0} :dt The time window for pressure relaxation must be > 0 :dd {Fix npt periods must be > 0.0} :dt The time window for temperature or pressure relaxation must be > 0 :dd {Fix npt/asphere cannot be used with atom attributes diameter or rmass} :dt An atom style that defines these attributes must be used. :dd {Fix npt/asphere requires atom attributes quat, angmom, torque, shape} :dt An atom style that specifies these quantities is needed. :dd {Fix npt/sphere requires atom attribute radius or shape} :dt An atom style that defines these attributes must be used. :dd {Fix npt/sphere requires atom attributes omega, torque} :dt An atom style that specifies these quantities is needed. :dd {Fix nve/asphere cannot be used with atom attributes diameter or rmass} :dt These attributes override the shape and mass settings, so cannot be used. :dd {Fix nve/asphere requires atom attributes angmom, quat, torque, shape} :dt An atom style that specifies these quantities is needed. :dd {Fix nve/asphere requires extended particles} :dt This fix can only be used for particles with a shape setting. :dd {Fix nve/sphere requires atom attribute mu} :dt An atom style with this attribute is needed. :dd {Fix nve/sphere requires atom attribute radius or shape} :dt An atom style that specifies these quantities is needed. :dd {Fix nve/sphere requires atom attributes omega, torque} :dt An atom style with these attributes is needed. :dd {Fix nve/sphere requires extended particles} :dt This fix can only be used for particles of a finite size. :dd {Fix nve/sphere requires spherical particle shapes} :dt Self-explanatory. :dd {Fix nvt period must be > 0.0} :dt The time window for temperature relaxation must be > 0 :dd {Fix nvt/asphere cannot be used with atom attributes diameter or rmass} :dt These attributes override the shape and mass settings, so cannot be used. :dd {Fix nvt/asphere requires atom attributes quat, angmom, torque, shape} :dt An atom style that specifies these quantities is needed. :dd {Fix nvt/asphere requires extended particles} :dt This fix can only be used for particles of a finite size. :dd {Fix nvt/sphere requires atom attribute radius or shape} :dt An atom style with these attributes is needed. :dd {Fix nvt/sphere requires atom attributes omega, torque} :dt An atom style with these attributes is needed. :dd {Fix nvt/sphere requires extended particles} :dt This fix can only be used for particles of a finite size. :dd {Fix nvt/sphere requires spherical particle shapes} :dt Self-explanatory. :dd {Fix orient/fcc file open failed} :dt The fix orient/fcc command could not open a specified file. :dd {Fix orient/fcc file read failed} :dt The fix orient/fcc command could not read the needed parameters from a specified file. :dd {Fix orient/fcc found self twice} :dt The neighbor lists used by fix orient/fcc are messed up. If this error occurs, it is likely a bug, so send an email to the "developers"_http://lammps.sandia.gov/authors.html. :dd {Fix pour region ID does not exist} :dt Self-explanatory. :dd {Fix pour requires atom attributes radius, rmass} :dt The atom style defined does not have these attributes. :dd {Fix press/berendsen period must be > 0.0} :dt Self-explanatory. :dd {Fix rdf requires a pair style be defined} :dt Cannot use the rdf fix unless a pair style with a cutoff has been defined. :dd +{Fix reax/bonds numbonds > nsbmax_most} :dt + +The limit of the number of bonds expected by the ReaxFF force field +was exceeded. :dd + {Fix recenter group has no atoms} :dt Self-explanatory. :dd {Fix rigid: Bad principal moments} :dt The principal moments of inertia computed for a rigid body are not within the required tolerances. :dd {Fix shake cannot be used with minimization} :dt Cannot use fix shake while doing an energy minimization since it turns off bonds that should contribute to the energy. :dd {Fix spring couple group ID does not exist} :dt Self-explanatory. :dd {Fix temp/berendsen period must be > 0.0} :dt Self-explanatory. :dd {Fix thermal/conductivity swap value must be positive} :dt Self-explanatory. :dd {Fix tmd must come after integration fixes} :dt Any fix tmd command must appear in the input script after all time integration fixes (nve, nvt, npt). See the fix tmd documentation for details. :dd {Fix ttm electron temperatures must be > 0.0} :dt Self-explanatory. :dd {Fix ttm electronic_density must be > 0.0} :dt Self-explanatory. :dd {Fix ttm electronic_specific_heat must be > 0.0} :dt Self-explanatory. :dd {Fix ttm electronic_thermal_conductivity must be >= 0.0} :dt Self-explanatory. :dd {Fix ttm gamma_p must be > 0.0} :dt Self-explanatory. :dd {Fix ttm gamma_s must be >= 0.0} :dt Self-explanatory. :dd {Fix ttm number of nodes must be > 0} :dt Self-explanatory. :dd -{Invalid random number seed in fix ttm command} :dt - -Random number seed must be > 0. :dd - {Fix ttm v_0 must be >= 0.0} :dt Self-explanatory. :dd {Fix used in compute reduce not computed at compatible time} :dt Fixes generate their values on specific timesteps. Compute sum is requesting a value on a non-allowed timestep. :dd {Fix vector in variable formula is too small} :dt Index into vector is out of bounds. :dd {Fix viscosity swap value must be positive} :dt Self-explanatory. :dd {Fix viscosity vtarget value must be positive} :dt Self-explanatory. :dd {Fix wall/gran is incompatible with Pair style} :dt Must use a granular pair style to define the parameters needed for this fix. :dd {Fix wall/gran requires atom attributes radius, omega, torque} :dt The atom style defined does not have these attributes. :dd {Fix_modify pressure ID does not compute pressure} :dt The compute ID assigned to the fix must compute pressure. :dd -{Fix_modify temp ID does not compute temperature} :dt +{Fix_modify temperature ID does not compute temperature} :dt The compute ID assigned to the fix must compute temperature. :dd {Found no restart file matching pattern} :dt When using a "*" in the restart file name, no matching file was found. :dd {Gravity must point in -y to use with fix pour in 2d} :dt Gravity must be pointing "down" in a 2d box. :dd {Gravity must point in -z to use with fix pour in 3d} :dt Gravity must be pointing "down" in a 3d box, i.e. theta = 180.0. :dd {Group ID does not exist} :dt A group ID used in the group command does not exist. :dd {Group ID in variable formula does not exist} :dt Self-explanatory. :dd {Group command before simulation box is defined} :dt The group command cannot be used before a read_data, read_restart, or create_box command. :dd {Group region ID does not exist} :dt A region ID used in the group command does not exist. :dd {Illegal ... command} :dt Self-explanatory. Check the input script syntax and compare to the documentation for the command. You can use -echo screen as a command-line option when running LAMMPS to see the offending line. :dd {Illegal Stillinger-Weber parameter} :dt One or more of the coefficients defined in the potential file is invalid. :dd {Illegal Tersoff parameter} :dt One or more of the coefficients defined in the potential file is invalid. :dd {Illegal simulation box} :dt The lower bound of the simulation box is greater than the upper bound. :dd {Improper atom missing in delete_bonds} :dt The delete_bonds command cannot find one or more atoms in a particular improper on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid improper. :dd {Improper atom missing in set command} :dt The set command cannot find one or more atoms in a particular improper on a particular processor. The pairwise cutoff is too short or the atoms are too far apart to make a valid improper. :dd {Improper atoms %d %d %d %d missing on proc %d at step %d} :dt One or more of 4 atoms needed to compute a particular improper are missing on this processor. Typically this is because the pairwise cutoff is set too short or the improper has blown apart and an atom is too far away. :dd {Improper coeff for hybrid has invalid style} :dt Improper style hybrid uses another improper style as one of its coefficients. The improper style used in the improper_coeff command or read from a restart file is not recognized. :dd {Improper coeffs are not set} :dt No improper coefficients have been assigned in the data file or via the improper_coeff command. :dd {Improper style hybrid cannot have hybrid as an argument} :dt Self-explanatory. :dd {Improper style hybrid cannot have none as an argument} :dt Self-explanatory. :dd {Improper style hybrid cannot use same improper style twice} :dt Self-explanatory. :dd {Improper_coeff command before improper_style is defined} :dt Coefficients cannot be set in the data file or via the improper_coeff command until an improper_style has been assigned. :dd {Improper_coeff command before simulation box is defined} :dt The improper_coeff command cannot be used before a read_data, read_restart, or create_box command. :dd {Improper_coeff command when no impropers allowed} :dt The chosen atom style does not allow for impropers to be defined. :dd {Improper_style command when no impropers allowed} :dt The chosen atom style does not allow for impropers to be defined. :dd {Impropers assigned incorrectly} :dt Impropers read in from the data file were not assigned correctly to atoms. This means there is something invalid about the topology definitions. :dd {Impropers defined but no improper types} :dt The data file header lists improper but no improper types. :dd {Inconsistent new atom types in fix bond/create command} :dt If the two atom types forming a bond are the same type, then the two new atom types specified by the iparam and jparam keywords also need to be the same type. :dd {Incorrect args for angle coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect args for bond coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect args for dihedral coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect args for improper coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect args for pair coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect args in pair_style command} :dt Self-explanatory. :dd {Incorrect atom format in data file} :dt Number of values per atom line in the data file is not consistent with the atom style. :dd {Incorrect boundaries with slab Ewald} :dt Must have periodic x,y dimensions and non-periodic z dimension to use 2d slab option with Ewald. :dd {Incorrect boundaries with slab PPPM} :dt Must have periodic x,y dimensions and non-periodic z dimension to use 2d slab option with PPPM. :dd {Incorrect element names in EAM potential file} :dt The element names in the EAM file do not match those requested. :dd {Incorrect format in MEAM potential file} :dt Incorrect number of words per line in the potential file. :dd {Incorrect format in Stillinger-Weber potential file} :dt Incorrect number of words per line in the potential file. :dd {Incorrect format in TMD target file} :dt Format of file read by fix tmd command is incorrect. :dd {Incorrect format in Tersoff potential file} :dt Incorrect number of words per line in the potential file. :dd {Incorrect multiplicity arg for dihedral coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect sign arg for dihedral coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Incorrect velocity format in data file} :dt Each atom style defines a format for the Velocity section of the data file. The read-in lines do not match. :dd {Incorrect weight arg for dihedral coefficients} :dt Self-explanatory. Check the input script or data file. :dd {Indexed per-atom vector in variable formula without atom map} :dt Accessing a value from an atom vector requires the ability to lookup an atom index, which is provided by an atom map. An atom map does not exist (by default) for non-molecular problems. Using the atom_modify map command will force an atom map to be created. :dd {Induced tilt by displace_box is too large} :dt The final tilt value must be between -1/2 and 1/2 of the perpendicular box length. :dd {Initial temperatures not all set in fix ttm} :dt Self-explantory. :dd {Input line too long after variable substitution} :dt This is a hard (very large) limit defined in the input.cpp file. :dd {Input line too long: %s} :dt This is a hard (very large) limit defined in the input.cpp file. :dd {Insertion region extends outside simulation box} :dt Region specified with fix insert command extends outside the global simulation box. :dd {Insufficient Jacobi rotations for POEMS body} :dt Eigensolve for rigid body was not sufficiently accurate. :dd {Insufficient Jacobi rotations for rigid body} :dt Eigensolve for rigid body was not sufficiently accurate. :dd +{Invalid REAX atom type} :dt + +There is a mis-match between LAMMPS atom types and the elements +listed in the ReaxFF force field file. :dd + {Invalid angle style} :dt The choice of angle style is unknown. :dd {Invalid angle type in Angles section of data file} :dt Angle type must be positive integer and within range of specified angle types. :dd {Invalid angle type index for fix shake} :dt Self-explanatory. :dd {Invalid atom ID in Angles section of data file} :dt Atom IDs must be positive integers and within range of defined atoms. :dd {Invalid atom ID in Atoms section of data file} :dt Atom IDs must be positive integers. :dd {Invalid atom ID in Bonds section of data file} :dt Atom IDs must be positive integers and within range of defined atoms. :dd {Invalid atom ID in Dihedrals section of data file} :dt Atom IDs must be positive integers and within range of defined atoms. :dd {Invalid atom ID in Impropers section of data file} :dt Atom IDs must be positive integers and within range of defined atoms. :dd {Invalid atom ID in Velocities section of data file} :dt Atom IDs must be positive integers and within range of defined atoms. :dd {Invalid atom mass for fix shake} :dt Mass specified in fix shake command must be > 0.0. :dd {Invalid atom style} :dt The choice of atom style is unknown. :dd {Invalid atom type in Atoms section of data file} :dt Atom types must range from 1 to specified # of types. :dd {Invalid atom type in create_atoms command} :dt The create_box command specified the range of valid atom types. An invalid type is being requested. :dd {Invalid atom type in fix bond/create command} :dt Self-explanatory. :dd {Invalid atom type in neighbor exclusion list} :dt Atom types must range from 1 to Ntypes inclusive. :dd {Invalid atom type index for fix shake} :dt Atom types must range from 1 to Ntypes inclusive. :dd {Invalid atom types in fix rdf command} :dt Atom types must range from 1 to Ntypes inclusive. :dd {Invalid atom types in pair_write command} :dt Atom types must range from 1 to Ntypes inclusive. :dd {Invalid atom vector in variable formula} :dt The atom vector is not recognized. :dd {Invalid bond style} :dt The choice of bond style is unknown. :dd {Invalid bond type in Bonds section of data file} :dt Bond type must be positive integer and within range of specified bond types. :dd {Invalid bond type in fix bond/break command} :dt Self-explanatory. :dd {Invalid bond type in fix bond/create command} :dt Self-explanatory. :dd {Invalid bond type index for fix shake} :dt Self-explanatory. Check the fix shake command in the input script. :dd {Invalid coeffs for this angle style} :dt Cannot set class 2 coeffs in data file for this angle style. :dd {Invalid coeffs for this dihedral style} :dt Cannot set class 2 coeffs in data file for this dihedral style. :dd {Invalid coeffs for this improper style} :dt Cannot set class 2 coeffs in data file for this improper style. :dd {Invalid command-line argument} :dt One or more command-line arguments is invalid. Check the syntax of the command you are using to launch LAMMPS. :dd {Invalid compute ID in variable formula} :dt The compute is not recognized. :dd {Invalid compute style} :dt Self-explanatory. :dd {Invalid cutoff in communicate command} :dt Specified cutoff must be >= 0.0. :dd {Invalid cutoffs in pair_write command} :dt Inner cutoff must be larger than 0.0 and less than outer cutoff. :dd {Invalid d1 or d2 value for pair colloid coeff} :dt Neither d1 or d2 can be < 0. :dd {Invalid data file section: Angle Coeffs} :dt Atom style does not allow angles. :dd {Invalid data file section: AngleAngle Coeffs} :dt Atom style does not allow impropers. :dd {Invalid data file section: AngleAngleTorsion Coeffs} :dt Atom style does not allow dihedrals. :dd {Invalid data file section: AngleTorsion Coeffs} :dt Atom style does not allow dihedrals. :dd {Invalid data file section: Angles} :dt Atom style does not allow angles. :dd {Invalid data file section: Bond Coeffs} :dt Atom style does not allow bonds. :dd {Invalid data file section: BondAngle Coeffs} :dt Atom style does not allow angles. :dd {Invalid data file section: BondBond Coeffs} :dt Atom style does not allow angles. :dd {Invalid data file section: BondBond13 Coeffs} :dt Atom style does not allow dihedrals. :dd {Invalid data file section: Bonds} :dt Atom style does not allow bonds. :dd {Invalid data file section: Dihedral Coeffs} :dt Atom style does not allow dihedrals. :dd {Invalid data file section: Dihedrals} :dt Atom style does not allow dihedrals. :dd {Invalid data file section: EndBondTorsion Coeffs} :dt Atom style does not allow dihedrals. :dd {Invalid data file section: Improper Coeffs} :dt Atom style does not allow impropers. :dd {Invalid data file section: Impropers} :dt Atom style does not allow impropers. :dd {Invalid data file section: MiddleBondTorsion Coeffs} :dt Atom style does not allow dihedrals. :dd +{Invalid density in Atoms section of data file} :dt + +Density value cannot be <= 0.0. :dd + {Invalid dihedral style} :dt The choice of dihedral style is unknown. :dd {Invalid dihedral type in Dihedrals section of data file} :dt Dihedral type must be positive integer and within range of specified dihedral types. :dd {Invalid dipole line in data file} :dt Self-explanatory. :dd {Invalid dipole value} :dt Self-explanatory. :dd {Invalid dump dcd filename} :dt Filenames used with the dump dcd style cannot be binary or compressed or cause multiple files to be written. :dd {Invalid dump frequency} :dt Dump frequency must be 1 or greater. :dd {Invalid dump style} :dt The choice of dump style is unknown. :dd {Invalid dump xtc filename} :dt Filenames used with the dump xtc style cannot be binary or compressed or cause multiple files to be written. :dd {Invalid dump xyz filename} :dt Filenames used with the dump xyz style cannot be binary or cause files to be written by each processor. :dd {Invalid dump_modify threshhold operator} :dt Operator keyword used for threshold specification in not recognized. :dd {Invalid fix ID in variable formula} :dt The fix is not recognized. :dd +{Invalid fix box/relax command for a 2d simulation} :dt + +Fix box/relax styles involving the z dimension cannot be used in +a 2d simulation. :dd + {Invalid fix nph command for a 2d simulation} :dt Cannot use style xy, yz, or xz for a 2d simulation. :dd {Invalid fix nph command pressure settings} :dt Pressure settings for different components must be the same if the components are coupled. :dd {Invalid fix npt command for a 2d simulation} :dt Cannot use style xy, yz, or xz for a 2d simulation. :dd {Invalid fix npt command pressure settings} :dt Pressure settings for different components must be the same if the components are coupled. :dd {Invalid fix press/berendsen command for a 2d simulation} :dt Can only use xyz or aniso styles in 2d. :dd {Invalid fix press/berendsen command pressure settings} :dt Pressure settings for different components must be the same if the components are coupled. :dd {Invalid fix style used in compute displace/atom command} :dt Only a fix of style coord/original can be used with this compute. :dd {Invalid fix style} :dt The choice of fix style is unknown. :dd {Invalid flag in force field section of restart file} :dt Unrecognized entry in restart file. :dd {Invalid flag in header section of restart file} :dt Unrecognized entry in restart file. :dd {Invalid flag in type arrays section of restart file} :dt Unrecognized entry in restart file. :dd {Invalid frequency in temper command} :dt Nevery must be > 0. :dd {Invalid group ID in neigh_modify command} :dt A group ID used in the neigh_modify command does not exist. :dd {Invalid group function in variable formula} :dt Group function is not recognized. :dd {Invalid group in communicate command} :dt Self-explanatory. :dd {Invalid improper style} :dt The choice of improper style is unknown. :dd {Invalid improper type in Impropers section of data file} :dt Improper type must be positive integer and within range of specified improper types. :dd {Invalid index in variable formula} :dt The index between brackets is less than or equal to 0. :dd {Invalid keyword in dump custom command} :dt One or more attribute keywords are not recognized. :dd {Invalid keyword in pair table parameters} :dt Keyword used in list of table parameters is not recognized. :dd {Invalid keyword in thermo_style custom command} :dt One or more specified keywords are not recognized. :dd {Invalid kspace style} :dt The choice of kspace style is unknown. :dd {Invalid mass line in data file} :dt Self-explanatory. :dd {Invalid mass value} :dt Self-explanatory. :dd {Invalid math or group function in variable formula} :dt The math or group function is not recognized. :dd {Invalid natoms for dump dcd} :dt Natoms is initially 0 which is not valid for the dump dcd style. Natoms must be constant for the duration of the simulation. :dd {Invalid natoms for dump xtc} :dt Natoms is initially 0 which is not valid for the dump xtc style. :dd {Invalid natoms for dump xyz} :dt Natoms is initially 0 which is not valid for the dump xyz style. :dd {Invalid option in lattice command for non-custom style} :dt Certain lattice keywords are not supported unless the lattice style is "custom". :dd {Invalid order of forces within respa levels} :dt For respa, ordering of force computations within respa levels must obey certain rules. E.g. bonds cannot be compute less frequently than angles, pairwise forces cannot be computed less frequently than kspace, etc. :dd {Invalid pair style} :dt The choice of pair style is unknown. :dd {Invalid pair table cutoff} :dt Cutoffs in pair_coeff command are not valid with read-in pair table. :dd {Invalid pair table length} :dt Length of read-in pair table is invalid :dd {Invalid radius in Atoms section of data file} :dt Radius must be >= 0.0. :dd +{Invalid random number seed in fix ttm command} :dt + +Random number seed must be > 0. :dd + {Invalid random number seed in set command} :dt Random number seed must be > 0. :dd {Invalid region in group function in variable formula} :dt Self-explanatory. :dd {Invalid region style} :dt The choice of region style is unknown. :dd {Invalid seed for Marsaglia random # generator} :dt The initial seed for this random number generator must be a positive integer less than or equal to 900 million. :dd {Invalid seed for Park random # generator} :dt The initial seed for this random number generator must be a positive integer. :dd {Invalid shape line in data file} :dt Self-explanatory. :dd {Invalid shape line in data file} :dt Self-explanatory. :dd {Invalid shape value} :dt Self-explanatory. :dd {Invalid shear direction for fix wall/gran} :dt Self-explanatory. :dd {Invalid style in pair_write command} :dt Self-explanatory. Check the input script. :dd {Invalid syntax in variable formula} :dt Self-explanatory. :dd {Invalid thermo keyword in variable formula} :dt The keyword is not recognized. :dd {Invalid type for dipole set} :dt Dipole command must set a type from 1-N where N is the number of atom types. :dd {Invalid type for mass set} :dt Mass command must set a type from 1-N where N is the number of atom types. :dd {Invalid type for shape set} :dt Atom type is out of bounds. :dd {Invalid value in set command} :dt The value specified for the setting is invalid, likely because it is too small or too large. :dd {Invalid variable evaluation in variable formula} :dt A variable used in a formula could not be evaluated. :dd {Invalid variable in next command} :dt Self-explanatory. :dd {Invalid variable name in variable formula} :dt Variable name is not recognized. :dd {Invalid variable name} :dt Variable name used in an input script line is invalid. :dd {Invalid variable style with next command} :dt Variable styles {equal} and {world} cannot be used in a next command. :dd {Invalid wiggle direction for fix wall/gran} :dt Self-explanatory. :dd {Invoked angle equil angle on angle style none} :dt Self-explanatory. :dd {Invoked angle single on angle style none} :dt Self-explanatory. :dd {Invoked bond equil distance on bond style none} :dt Self-explanatory. :dd {Invoked bond single on bond style none} :dt Self-explanatory. :dd {Invoked pair single on pair style none} :dt A command (e.g. a dump) attempted to invoke the single() function on a pair style none, which is illegal. You are probably attempting to compute per-atom quantities with an undefined pair style. :dd {KSpace style has not yet been set} :dt Cannot use kspace_modify command until a kspace style is set. :dd {KSpace style is incompatible with Pair style} :dt Setting a kspace style requires that a pair style with a long-range Coulombic component be selected. :dd {Keyword %s in MEAM parameter file not recognized} :dt Self-explanatory. :dd {Kspace style requires atom attribute q} :dt The atom style defined does not have these attributes. :dd {Label wasn't found in input script} :dt Self-explanatory. :dd {Lattice orient vectors are not orthogonal} :dt The three specified lattice orientation vectors must be mutually orthogonal. :dd {Lattice orient vectors are not right-handed} :dt The three specified lattice orientation vectors must create a right-handed coordinate system such that a1 cross a2 = a3. :dd {Lattice primitive vectors are collinear} :dt The specified lattice primitive vectors do not for a unit cell with non-zero volume. :dd {Lattice settings are not compatible with 2d simulation} :dt One or more of the specified lattice vectors has a non-zero z component. :dd {Lattice spacings are invalid} :dt Each x,y,z spacing must be > 0. :dd {Lattice style incompatible with simulation dimension} :dt 2d simulation can use sq, sq2, or hex lattice. 3d simulation can use sc, bcc, or fcc lattice. :dd {Log of zero/negative in variable formula} :dt Self-explanatory. :dd {Lost atoms via displace_atoms: original %.15g current %.15g} :dt The displace_atoms command lost one or more atoms. :dd {Lost atoms via displace_box: original %.15g current %.15g} :dt The displace_box command lost one or more atoms. :dd {Lost atoms: original %.15g current %.15g} :dt A thermodynamic computation has detected lost atoms. :dd {MEAM library error %d} :dt A call to the MEAM Fortran library returned an error. :dd {Mass command before simulation box is defined} :dt The mass command cannot be used before a read_data, read_restart, or create_box command. :dd {Min_style command before simulation box is defined} :dt The min_style command cannot be used before a read_data, read_restart, or create_box command. :dd {Minimization could not find thermo_pe compute} :dt This compute is created by the thermo command. It must have been explicitly deleted by a uncompute command. :dd {Minimize command before simulation box is defined} :dt The minimize command cannot be used before a read_data, read_restart, or create_box command. :dd {Mismatched compute in variable formula} :dt A compute is referenced incorrectly or a compute that produces per-atom values is used in an equal-style variable formula. :dd {Mismatched fix in variable formula} :dt A fix is referenced incorrectly or a fix that produces per-atom values is used in an equal-style variable formula. :dd {Mismatched variable in variable formula} :dt A variable is referenced incorrectly or an atom-style variable that produces per-atom values is used in an equal-style variable formula. :dd {More than one fix deform} :dt Only one fix deform can be defined at a time. :dd {More than one fix freeze} :dt Only one of these fixes can be defined, since the granular pair potentials access it. :dd {More than one fix shake} :dt Only one fix shake can be defined. :dd {Must define angle_style before Angle Coeffs} :dt Must use an angle_style command before reading a data file that defines Angle Coeffs. :dd {Must define angle_style before BondAngle Coeffs} :dt Must use an angle_style command before reading a data file that defines Angle Coeffs. :dd {Must define angle_style before BondBond Coeffs} :dt Must use an angle_style command before reading a data file that defines Angle Coeffs. :dd {Must define bond_style before Bond Coeffs} :dt Must use a bond_style command before reading a data file that defines Bond Coeffs. :dd {Must define dihedral_style before AngleAngleTorsion Coeffs} :dt Must use a dihedral_style command before reading a data file that defines AngleAngleTorsion Coeffs. :dd {Must define dihedral_style before AngleTorsion Coeffs} :dt Must use a dihedral_style command before reading a data file that defines AngleTorsion Coeffs. :dd {Must define dihedral_style before BondBond13 Coeffs} :dt Must use a dihedral_style command before reading a data file that defines BondBond13 Coeffs. :dd {Must define dihedral_style before Dihedral Coeffs} :dt Must use a dihedral_style command before reading a data file that defines Dihedral Coeffs. :dd {Must define dihedral_style before EndBondTorsion Coeffs} :dt Must use a dihedral_style command before reading a data file that defines EndBondTorsion Coeffs. :dd {Must define dihedral_style before MiddleBondTorsion Coeffs} :dt Must use a dihedral_style command before reading a data file that defines MiddleBondTorsion Coeffs. :dd {Must define improper_style before AngleAngle Coeffs} :dt Must use an improper_style command before reading a data file that defines AngleAngle Coeffs. :dd {Must define improper_style before Improper Coeffs} :dt Must use an improper_style command before reading a data file that defines Improper Coeffs. :dd {Must define pair_style before Pair Coeffs} :dt Must use a pair_style command before reading a data file that defines Pair Coeffs. :dd {Must have more than one processor partition to temper} :dt Cannot use the temper command with only one processor partition. Use the -partition command-line option. :dd {Must read Atoms before Angles} :dt The Atoms section of a data file must come before an Angles section. :dd {Must read Atoms before Bonds} :dt The Atoms section of a data file must come before a Bonds section. :dd {Must read Atoms before Dihedrals} :dt The Atoms section of a data file must come before a Dihedrals section. :dd {Must read Atoms before Impropers} :dt The Atoms section of a data file must come before an Impropers section. :dd {Must read Atoms before Velocities} :dt The Atoms section of a data file must come before a Velocities section. :dd {Must set both respa inner and outer} :dt Cannot use just the inner or outer option with respa without using the other. :dd {Must specify a region in fix deposit} :dt The region keyword must be specified with this fix. :dd {Must specify a region in fix pour} :dt The region keyword must be specified with this fix. :dd {Must use -in switch with multiple partitions} :dt A multi-partition simulation cannot read the input script from stdin. The -in command-line option must be used to specify a file. :dd {Must use a block or cylinder region with fix pour} :dt Self-explanatory. :dd {Must use a block region with fix pour for 2d simulations} :dt Self-explanatory. :dd {Must use a bond style with TIP4P potential} :dt TIP4P potentials assume bond lengths in water are constrained by a fix shake command. :dd {Must use a molecular atom style with fix poems molecule} :dt Self-explanatory. :dd {Must use a molecular atom style with fix rigid molecule} :dt Self-explanatory. :dd {Must use a z-axis cylinder with fix pour} :dt The axis of the cylinder region used with the fix insert command must be oriented along the z dimension. :dd {Must use an angle style with TIP4P potential} :dt TIP4P potentials assume angles in water are constrained by a fix shake command. :dd {Must use atom style with molecule IDs with fix bond/swap} :dt Self-explanatory. :dd {Must use charged atom style with fix efield} :dt The atom style being used does not allow atoms to have assigned charges. Hence it will not work with this fix which generates a force due to an E-field acting on charge. :dd {Must use fix gravity with fix pour} :dt Insertion of granular particles must be done under the influence of gravity. :dd {Must use molecular atom style with neigh_modify exclude molecule} :dt The atom style must define a molecule ID to use the exclude option. :dd {Must use region with side = in with fix deposit} :dt Self-explanatory :dd {Must use region with side = in with fix pour} :dt Self-explanatory. :dd {Needed topology not in data file} :dt The header of the data file indicated that bonds or angles or dihedrals or impropers would be included, but they were not present. :dd {Neigh_modify include group != atom_modify first group} :dt Self-explanatory. :dd {Neighbor delay must be 0 or multiple of every setting} :dt The delay and every parameters set via the neigh_modify command are inconsistent. If the delay setting is non-zero, then it must be a multiple of the every setting. :dd {Neighbor list overflow, boost neigh_modify one or page} :dt There are too many neighbors of a single atom. Use the neigh_modify command to increase the neighbor page size and the max number of neighbors allowed for one atom. :dd {Neighbor multi not yet enabled for granular} :dt Self-explanatory. :dd {Neighbor multi not yet enabled for rRESPA} :dt Self-explanatory. :dd {Neighbor page size must be >= 10x the one atom setting} :dt This is required to prevent wasting too much memory. :dd {New bond exceeded bonds per atom in fix bond/create} :dt See the read_data command for info on setting the "extra bond per atom" header value to allow for additional bonds to be formed. :dd {New bond exceeded special list size in fix bond/create} :dt See the special_bonds extra command for info on how to leave space in the special bonds list to allow for additional bonds to be formed. :dd {Newton bond change after simulation box is defined} :dt The newton command cannot be used to change the newton bond value after a read_data, read_restart, or create_box command. :dd {No angles allowed with this atom style} :dt Self-explanatory. Check data file. :dd {No atoms in data file} :dt The header of the data file indicated that atoms would be included, but they were not present. :dd {No basis atoms in lattice} :dt Basis atoms must be defined for lattice style user. :dd {No bonds allowed with this atom style} :dt Self-explanatory. Check data file. :dd {No dihedrals allowed with this atom style} :dt Self-explanatory. Check data file. :dd {No dump custom arguments specified} :dt The dump custom command requires that atom quantities be specified to output to dump file. :dd {No impropers allowed with this atom style} :dt Self-explanatory. Check data file. :dd {No matching element in EAM potential file} :dt The EAM potential file does not contain elements that match the requested elements. :dd {No rigid bodies defined} :dt The fix specification did not end up defining any rigid bodies. :dd {Non integer # of swaps in temper command} :dt Swap frequency in temper command must evenly divide the total # of timesteps. :dd {One or more atoms belong to multiple rigid bodies} :dt Two or more rigid bodies defined by the fix rigid command cannot contain the same atom. :dd {One or zero atoms in rigid body} :dt Any rigid body defined by the fix rigid command must contain 2 or more atoms. :dd {Out of range atoms - cannot compute PPPM} :dt One or more atoms are attempting to map their charge to a PPPM grid point that is not owned by a processor. This is likely for one of two reasons, both of them bad. First, it may mean that an atom near the boundary of a processor's sub-domain has moved more than 1/2 the "neighbor skin distance"_neighbor.html without neighbor lists being rebuilt and atoms being migrated to new processors. This also means you may be missing pairwise interactions that need to be computed. The solution is to change the re-neighboring criteria via the "neigh_modify"_neigh_modify command. The safest settings are "delay 0 every 1 check yes". Second, it may mean that an atom has moved far outside a processor's sub-domain or even the entire simulation box. This indicates bad physics, e.g. due to highly overlapping atoms, too large a timestep, etc. :dd {POEMS fix must come before NPT/NPH fix} :dt NPT/NPH fix must be defined in input script after all poems fixes, else the fix contribution to the pressure virial is incorrect. :dd {PPPM grid is too large} :dt The global PPPM grid is larger than OFFSET in one or more dimensions. OFFSET is currently set to 4096. You likely need to decrease the requested precision. :dd {PPPM order cannot be greater than %d} :dt Self-explanatory. :dd {PPPM order has been reduced to 0} :dt LAMMPS has attempted to reduce the PPPM order to enable the simulation to run, but can reduce the order no further. Try increasing the accuracy of PPPM by reducing the tolerance size, thus inducing a larger PPPM grid. :dd {Pair coeff for hybrid has invalid style} :dt Style in pair coeff must have been listed in pair_style command. :dd {Pair cutoff < Respa interior cutoff} :dt One or more pairwise cutoffs are too short to use with the specified rRESPA cutoffs. :dd {Pair dipole/cut requires atom attributes q, mu, torque, dipole} :dt An atom style that specifies these quantities is needed. :dd {Pair distance < table inner cutoff} :dt Two atoms are closer together than the pairwise table allows. :dd {Pair distance > table outer cutoff} :dt Two atoms are further apart than the pairwise table allows. :dd {Pair dpd requires ghost atoms store velocity} :dt An atom style that stores this, like atom_style dpd, must be used. :dd {Pair gayberne cannot be used with atom attribute diameter} :dt Finite-size particles must be defined with the shape command. :dd {Pair gayberne epsilon a,b,c coeffs are not all set} :dt Each atom type involved in pair_style gayberne must have these 3 coefficients set at least once. :dd {Pair gayberne requires atom attributes quat, torque, shape} :dt An atom style that defines these attributes must be used. :dd {Pair granular requires atom attributes radius, omega, torque} :dt The atom style defined does not have these attributes. :dd {Pair granular requires ghost atoms store velocity} :dt An atom style that stores this, like atom_style granular, must be used. :dd {Pair granular with shear history requires newton pair off} :dt This is a current restriction of the implementation of pair granular styles with history. :dd {Pair hybrid sub-style is not used} :dt No pair_coeff command used a sub-style specified in the pair_style command. :dd {Pair inner cutoff < Respa interior cutoff} :dt One or more pairwise cutoffs are too short to use with the specified rRESPA cutoffs. :dd {Pair inner cutoff >= Pair outer cutoff} :dt The specified cutoffs for the pair style are inconsistent. :dd {Pair lubricate cannot be used with atom attributes diameter or rmass} :dt These attributes override the shape and mass settings, so cannot be used. :dd {Pair lubricate requires atom attributes quat, torque, shape} :dt An atom style that defines these attributes must be used. :dd {Pair lubricate requires extended particles} :dt This pair style can only be used for particles with a shape setting. :dd {Pair lubricate requires mono-disperse particles} :dt This is a current restriction of this pair style. :dd {Pair lubricate requires spherical, mono-disperse particles} :dt This is a current restriction of this pair style. :dd {Pair peri lattice is not identical in x, y, and z} :dt The lattice defined by the lattice command must be cubic. :dd {Pair peri requires a lattice be defined} :dt Use the lattice command for this purpose. :dd {Pair peri requires an atom map, see atom_modify} :dt Even for atomic systems, an atom map is required to find Peridynamic bonds. Use the atom_modify command to define one. :dd {Pair resquared cannot be used with atom attribute diameter} :dt This attribute overrides the shape settings, so cannot be used. :dd {Pair resquared epsilon a,b,c coeffs are not all set} :dt Self-explanatory. :dd {Pair resquared epsilon and sigma coeffs are not all set} :dt Self-explanatory. :dd {Pair resquared requires atom attributes quat, torque, shape} :dt An atom style that defines these attributes must be used. :dd {Pair style AIREBO requires atom IDs} :dt This is a requirement to use the AIREBO potential. :dd {Pair style AIREBO requires newton pair on} :dt Self-explanatory. :dd {Pair style MEAM requires newton pair on} :dt See the newton command. This is a restriction to use the MEAM potential. :dd {Pair style Stillinger-Weber requires atom IDs} :dt This is a requirement to use the SW potential. :dd {Pair style Stillinger-Weber requires newton pair on} :dt See the newton command. This is a restriction to use the SW potential. :dd {Pair style Tersoff requires atom IDs} :dt This is a requirement to use the Tersoff potential. :dd {Pair style Tersoff requires newton pair on} :dt See the newton command. This is a restriction to use the Tersoff potential. :dd {Pair style born/coul/long requires atom attribute q} :dt An atom style that defines this attribute must be used. :dd {Pair style buck/coul/cut requires atom attribute q} :dt The atom style defined does not have this attribute. :dd {Pair style buck/coul/long requires atom attribute q} :dt The atom style defined does not have these attributes. :dd {Pair style coul/cut requires atom attribute q} :dt The atom style defined does not have these attributes. :dd {Pair style does not support bond_style quartic} :dt The pair style does not have a single() function, so it can not be invoked by bond_style quartic. :dd {Pair style does not support compute group/group} :dt The pair_style does not have a single() function, so it cannot be -invokded by the compute group/group command. +invokded by the compute group/group command. :dd + +{Pair style does not support compute heat/flux} :dt + +The pair style does not have a single() function, so it can +not be invoked by compute heat/flux. :dd {Pair style does not support fix bond/swap} :dt -The pair_style does not have a single() function, so it cannot be -invokded by the fix bond/swap command. +The pair style does not have a single() function, so it can +not be invoked by fix bond/swap. :dd {Pair style does not support pair_write} :dt -The pair style does not have a single() function, so it cannot be -invoked by the pair_write command. :dd +The pair style does not have a single() function, so it can +not be invoked by pair write. :dd {Pair style does not support rRESPA inner/middle/outer} :dt You are attempting to use rRESPA options with a pair style that does not support them. :dd {Pair style granular with history requires atoms have IDs} :dt Atoms in the simulation do not have IDs, so history effects cannot be tracked by the granular pair potential. :dd {Pair style hybrid cannot have hybrid as an argument} :dt Self-explanatory. :dd {Pair style hybrid cannot have none as an argument} :dt Self-explanatory. :dd {Pair style hybrid cannot use same pair style twice} :dt The sub-style arguments of pair_style hybrid cannot be duplicated. Check the input script. :dd {Pair style is incompatible with KSpace style} :dt If a pair style with a long-range Coulombic component is selected, then a kspace style must also be used. :dd {Pair style lj/charmm/coul/charmm requires atom attribute q} :dt The atom style defined does not have these attributes. :dd {Pair style lj/charmm/coul/long requires atom attribute q} :dt The atom style defined does not have these attributes. :dd {Pair style lj/class2/coul/cut requires atom attribute q} :dt The atom style defined does not have this attribute. :dd {Pair style lj/class2/coul/long requires atom attribute q} :dt The atom style defined does not have this attribute. :dd {Pair style lj/cut/coul/cut requires atom attribute q} :dt The atom style defined does not have this attribute. :dd {Pair style lj/cut/coul/long requires atom attribute q} :dt The atom style defined does not have this attribute. :dd {Pair style lj/cut/coul/long/tip4p requires atom IDs} :dt There are no atom IDs defined in the system and the TIP4P potential requires them to find O,H atoms with a water molecule. :dd {Pair style lj/cut/coul/long/tip4p requires atom attribute q} :dt The atom style defined does not have these attributes. :dd {Pair style lj/cut/coul/long/tip4p requires newton pair on} :dt This is because the computation of constraint forces within a water molecule adds forces to atoms owned by other processors. :dd {Pair style lj/gromacs/coul/gromacs requires atom attribute q} :dt An atom_style with this attribute is needed. :dd {Pair style peri_pmb requires atom style peri} :dt This is because atom style peri stores quantities needed by the peridynamic potential. :dd {Pair style reax requires atom IDs} :dt This is a requirement to use the ReaxFF potential. :dd {Pair style reax requires newton pair on} :dt This is a requirement to use the ReaxFF potential. :dd {Pair table cutoffs must all be equal to use with KSpace} :dt When using pair style table with a long-range KSpace solver, the cutoffs for all atom type pairs must all be the same, since the long-range solver starts at that cutoff. :dd {Pair table parameters did not set N} :dt List of pair table parameters must include N setting. :dd {Pair tersoff/zbl requires metal or real units} :dt This is a current restriction of this pair potential. :dd {Pair_coeff command before pair_style is defined} :dt Self-explanatory. :dd {Pair_coeff command before simulation box is defined} :dt The pair_coeff command cannot be used before a read_data, read_restart, or create_box command. :dd {Pair_modify command before pair_style is defined} :dt Self-explanatory. :dd {Pair_write command before pair_style is defined} :dt Self-explanatory. :dd {Per-atom compute in equal-style variable formula} :dt Equal-style variables cannot use per-atom quantities. :dd {Per-atom energy was not tallied on needed timestep} :dt You are using a thermo keyword that requires potentials to have tallied energy, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. :dd {Per-atom fix in equal-style variable formula} :dt Equal-style variables cannot use per-atom quantities. :dd {Per-atom virial was not tallied on needed timestep} :dt You are using a thermo keyword that requires potentials to have tallied the virial, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. :dd {Potential file has duplicate entry} :dt The potential file for a SW or Tersoff potential has more than one entry for the same 3 ordered elements. :dd {Potential file is missing an entry} :dt The potential file for a SW or Tersoff potential does not have a needed entry. :dd {Power by 0 in variable formula} :dt Self-explanatory. :dd {Pressure ID for fix box/relax does not exist} :dt The compute ID needed to compute pressure for the fix does not exist. :dd +{Pressure ID for fix modify does not exist} :dt + +Self-explanatory. :dd + {Pressure ID for fix nph does not exist} :dt The compute ID needed to compute pressure for the fix does not exist. :dd {Pressure ID for fix npt does not exist} :dt The compute ID needed to compute pressure for the fix does not exist. :dd {Pressure ID for fix press/berendsen does not exist} :dt The compute ID needed to compute pressure for the fix does not exist. :dd {Pressure ID for thermo does not exist} :dt The compute ID needed to compute pressure for thermodynamics does not exist. :dd -{Pressure ID for fix modify does not exist} :dt - -Self-explanatory. :dd - {Proc grid in z != 1 for 2d simulation} :dt There cannot be more than 1 processor in the z dimension of a 2d simulation. :dd {Processor partitions are inconsistent} :dt The total number of processors in all partitions must match the number of processors LAMMPS is running on. :dd {Processors command after simulation box is defined} :dt The processors command cannot be used after a read_data, read_restart, or create_box command. :dd {Quaternion creation numeric error} :dt A numeric error occurred in the creation of a rigid body by the fix rigid command. :dd {R0 < 0 for fix spring command} :dt Equilibrium spring length is invalid. :dd {Region intersect region ID does not exist} :dt Self-explanatory. :dd {Region union region ID does not exist} :dt One or more of the region IDs specified by the region union command does not exist. :dd {Replacing a fix, but new style != old style} :dt A fix ID can be used a 2nd time, but only if the style matches the previous fix. In this case it is assumed you with to reset a fix's parameters. This error may mean you are mistakenly re-using a fix ID when you do not intend to. :dd {Replicate command before simulation box is defined} :dt The replicate command cannot be used before a read_data, read_restart, or create_box command. :dd {Replicate did not assign all atoms correctly} :dt Atoms replicated by the replicate command were not assigned correctly to processors. This is likely due to some atom coordinates being outside a non-periodic simulation box. :dd {Respa inner cutoffs are invalid} :dt The first cutoff must be <= the second cutoff. :dd {Respa levels must be >= 1} :dt Self-explanatory. :dd {Respa middle cutoffs are invalid} :dt The first cutoff must be <= the second cutoff. :dd {Reuse of compute ID} :dt A compute ID cannot be used twice. :dd {Reuse of dump ID} :dt A dump ID cannot be used twice. :dd {Reuse of region ID} :dt A region ID cannot be used twice. :dd {Rigid body has degenerate moment of inertia} :dt Fix poems will only work with bodies (collections of atoms) that have non-zero principal moments of inertia. This means they must be 3 or more non-collinear atoms, even with joint atoms removed. :dd {Rigid fix must come before NPT/NPH fix} :dt NPT/NPH fix must be defined in input script after all rigid fixes, else the rigid fix contribution to the pressure virial is incorrect. :dd {Run command before simulation box is defined} :dt The run command cannot be used before a read_data, read_restart, or create_box command. :dd {Run command start value is after start of run} :dt Self-explanatory. :dd {Run command stop value is before end of run} :dt Self-explanatory. :dd {Run command upto value is before current timestep} :dt Self-explanatory. :dd {Run_style command before simulation box is defined} :dt The run_style command cannot be used before a read_data, read_restart, or create_box command. :dd {Set command before simulation box is defined} :dt The set command cannot be used before a read_data, read_restart, or create_box command. :dd {Set command with no atoms existing} :dt No atoms are yet defined so the set command cannot be used. :dd {Set region ID does not exist} :dt Region ID specified in set command does not exist. :dd {Shake angles have different bond types} :dt All 3-atom angle-constrained SHAKE clusters specified by the fix shake command that are the same angle type, must also have the same bond types for the 2 bonds in the angle. :dd {Shake atoms %d %d %d %d missing on proc %d at step %d} :dt The 4 atoms in a single shake cluster specified by the fix shake command are not all accessible to a processor. This probably means an atom has moved too far. :dd {Shake atoms %d %d %d missing on proc %d at step %d} :dt The 3 atoms in a single shake cluster specified by the fix shake command are not all accessible to a processor. This probably means an atom has moved too far. :dd {Shake atoms %d %d missing on proc %d at step %d} :dt The 2 atoms in a single shake cluster specified by the fix shake command are not all accessible to a processor. This probably means an atom has moved too far. :dd {Shake cluster of more than 4 atoms} :dt A single cluster specified by the fix shake command can have no more than 4 atoms. :dd {Shake clusters are connected} :dt A single cluster specified by the fix shake command must have a single central atom with up to 3 other atoms bonded to it. :dd {Shake determinant = 0.0} :dt The determinant of the matrix being solved for a single cluster specified by the fix shake command is numerically invalid. :dd {Shake fix must come before NPT/NPH fix} :dt NPT fix must be defined in input script after SHAKE fix, else the SHAKE fix contribution to the pressure virial is incorrect. :dd {Shape command before simulation box is defined} :dt Self-explanatory. :dd {Sqrt of negative in variable formula} :dt Self-explanatory. :dd {Substitution for illegal variable} :dt Input script line contained a variable that could not be substituted for. :dd {TIP4P hydrogen has incorrect atom type} :dt The TIP4P pairwise computation found an H atom whose type does not agree with the specified H type. :dd {TIP4P hydrogen is missing} :dt The TIP4P pairwise computation failed to find the correct H atom within a water molecule. :dd {TMD target file did not list all group atoms} :dt The target file for the fix tmd command did not list all atoms in the fix group. :dd {Target T for fix npt cannot be 0.0} :dt Self-explanatory. :dd {Target T for fix nvt cannot be 0.0} :dt Self-explanatory. :dd -{Temp ID for fix bond/swap does not exist} :dt +{Temper command before simulation box is defined} :dt + +The temper command cannot be used before a read_data, read_restart, or +create_box command. :dd + +{Temperature ID for fix bond/swap does not exist} :dt Self-explanatory. :dd {Temperature ID for fix box/relax does not exist} :dt -The compute ID needed to compute temperature for the fix does not -exist. :dd +Self-explanatory. :dd {Temperature ID for fix nph does not exist} :dt -The compute ID needed to compute temperature for the fix does not -exist. :dd +Self-explanatory. :dd {Temperature ID for fix npt does not exist} :dt -The compute ID needed to compute temperature for the fix does not -exist. :dd +Self-explanatory. :dd {Temperature ID for fix nvt does not exist} :dt -The compute ID needed to compute temperature for the fix does not -exist. :dd +Self-explanatory. :dd {Temperature ID for fix press/berendsen does not exist} :dt Self-explanatory. :dd {Temperature ID for fix temp/berendsen does not exist} :dt Self-explanatory. :dd {Temperature ID for fix temp/rescale does not exist} :dt -The compute ID needed to compute temperature for the fix does not -exist. :dd - -{Temper command before simulation box is defined} :dt - -The temper command cannot be used before a read_data, read_restart, or -create_box command. :dd +Self-explanatory. :dd {Temperature for fix nvt/sllod does not have a bias} :dt The specified compute must compute temperature with a bias. :dd {Temperature region ID does not exist} :dt The region ID specified in the temperature command does not exist. :dd {Tempering could not find thermo_pe compute} :dt This compute is created by the thermo command. It must have been explicitly deleted by a uncompute command. :dd {Tempering fix ID is not defined} :dt The fix ID specified by the temper command does not exist. :dd {Tempering temperature fix is not valid} :dt The fix specified by the temper command is not one that controls temperature (nvt or langevin). :dd {Thermo and fix not computed at compatible times} :dt Fixes generate values on specific timesteps. The thermo output does not match these timesteps. :dd {Thermo compute ID does not compute scalar info} :dt The specified compute ID does not compute a scalar quantity as requested. :dd {Thermo compute ID does not compute vector info} :dt The specified compute ID does not compute a vector quantity as requested. :dd {Thermo compute ID vector is not large enough} :dt The specified compute ID does not compute a large enough vector quantity for the requested index. :dd {Thermo custom variable is not equal-style variable} :dt Only equal-style variables can be output with thermodynamics, not atom-style variables. :dd {Thermo fix ID does not compute scalar info} :dt Only fixes that compute global values can be output with thermodynamics. :dd {Thermo fix ID does not compute vector info} :dt Only fixes that compute global values can be output with thermodynamics. :dd {Thermo fix ID vector is not large enough} :dt Index into vector is out of bounds. :dd {Thermo keyword in variable requires thermo to use/init pe} :dt You are using a thermo keyword in a variable that requires potential energy to be calculated, but your thermo output does not use it. Add it to your thermo output. :dd {Thermo keyword in variable requires thermo to use/init press} :dt You are using a thermo keyword in a variable that requires pressure to be calculated, but your thermo output does not use it. Add it to your thermo output. :dd {Thermo keyword in variable requires thermo to use/init temp} :dt You are using a thermo keyword in a variable that requires temperature to be calculated, but your thermo output does not use it. Add it to your thermo output. :dd {Thermo style does not use press} :dt Cannot use thermo_modify to set this parameter since the thermo_style is not computing this quantity. :dd {Thermo style does not use temp} :dt Cannot use thermo_modify to set this parameter since the thermo_style is not computing this quantity. :dd -{Thermo_modify press ID does not compute pressure} :dt +{Thermo_modify pressure ID does not compute pressure} :dt The specified compute ID does not compute pressure. :dd -{Thermo_modify temp ID does not compute temperature} :dt +{Thermo_modify temperature ID does not compute temperature} :dt The specified compute ID does not compute temperature. :dd {Thermo_style command before simulation box is defined} :dt The thermo_style command cannot be used before a read_data, read_restart, or create_box command. :dd {Threshhold for an atom quantity that isn't allocated} :dt A dump threshhold has been requested on a quantity that is not defined by the atom style used in this simulation. :dd {Timestep must be >= 0} :dt Specified timestep size is invalid. :dd {Too big a problem to replicate with molecular atom style} :dt Molecular problems cannot become bigger than 2^31 atoms (or bonds, etc) when replicated, else the atom IDs and other quantities cannot be stored in 32-bit quantities. :dd {Too few bits for lookup table} :dt Table size specified via pair_modify command does not work with your machine's floating point representation. :dd {Too many exponent bits for lookup table} :dt Table size specified via pair_modify command does not work with your machine's floating point representation. :dd {Too many groups} :dt The maximum number of atom groups (including the "all" group) is given by MAX_GROUP in group.cpp and is 32. :dd {Too many mantissa bits for lookup table} :dt Table size specified via pair_modify command does not work with your machine's floating point representation. :dd {Too many masses for fix shake} :dt The fix shake command cannot list more masses than there are atom types. :dd {Too many total bits for bitmapped lookup table} :dt Table size specified via pair_modify command is too large. Note that a value of N generates a 2^N size table. :dd {Too many touching neighbors - boost MAXTOUCH} :dt A granular simulation has too many neighbors touching one atom. The MAXTOUCH parameter in fix_shear_history.cpp must be set larger and LAMMPS must be re-built. :dd {Tree structure in joint connections} :dt Fix poems cannot (yet) work with coupled bodies whose joints connect the bodies in a tree structure. :dd {Triclinic box must be periodic in skewed dimensions} :dt This is a requirement for using a non-orthogonal box. E.g. to set a non-zero xy tilt, both x and y must be periodic dimensions. :dd {Triclinic box skew is too large} :dt The displacement in a skewed direction must be less than half the box length in that dimension. E.g. the xy tilt must be between -half and +half of the x box length. :dd {Two groups cannot be the same in fix spring couple} :dt Self-explanatory. :dd {Unbalanced quotes in input line} :dt No matching end double quote was found following a leading double quote. :dd {Unexpected end of data file} :dt LAMMPS hit the end of the data file while attempting to read a section. Something is wrong with the format of the data file. :dd {Units command after simulation box is defined} :dt The units command cannot be used after a read_data, read_restart, or create_box command. :dd {Universe/uloop variable count < # of partitions} :dt A universe or uloop style variable must specify a number of values >= to the number of processor partitions. :dd {Unknown command: %s} :dt The command is not known to LAMMPS. Check the input script. :dd {Unknown identifier in data file: %s} :dt A section of the data file cannot be read by LAMMPS. :dd {Unknown table style in pair_style command} :dt Style of table is invalid for use with pair_style table command. :dd {Unrecognized lattice type in MEAM file 1} :dt The lattice type in an entry of the MEAM library file is not valid. :dd {Unrecognized lattice type in MEAM file 2} :dt The lattice type in an entry of the MEAM parameter file is not valid. :dd {Use of compute temp/ramp with undefined lattice} :dt Must use lattice command with compute temp/ramp command if units option is set to lattice. :dd {Use of displace_atoms with undefined lattice} :dt Must use lattice command with displace_atoms command if units option is set to lattice. :dd {Use of displace_box with undefined lattice} :dt Must use lattice command with displace_box command if units option is set to lattice. :dd {Use of fix ave/spatial with undefined lattice} :dt A lattice must be defined to use fix ave/spatial with units = lattice. :dd {Use of fix deform with undefined lattice} :dt A lattice must be defined to use fix deform with units = lattice. :dd {Use of fix deposit with undefined lattice} :dt Must use lattice command with compute fix deposit command if units option is set to lattice. :dd {Use of fix dt/reset with undefined lattice} :dt Must use lattice command with fix dt/reset command if units option is set to lattice. :dd {Use of fix indent with undefined lattice} :dt The lattice command must be used to define a lattice before using the fix indent command. :dd {Use of fix recenter with undefined lattice} :dt Must use lattice command with fix recenter command if units option is set to lattice. :dd {Use of region with undefined lattice} :dt If scale = lattice (the default) for the region command, then a lattice must first be defined via the lattice command. :dd {Use of velocity with undefined lattice} :dt If scale = lattice (the default) for the velocity set or velocity ramp command, then a lattice must first be defined via the lattice command. :dd {Using fix nvt/sllod with inconsistent fix deform remap option} :dt Fix nvt/sllod requires that deforming atoms have a velocity profile provided by "remap v" as a fix deform option. :dd {Using fix nvt/sllod with no fix deform defined} :dt Self-explanatory. :dd {Variable evaluation before simulation box is defined} :dt Cannot evaluate a compute or fix or atom-based value in a variable before the simulation has been setup. :dd {Variable name for compute reduce does not exist} :dt Self-explanatory. :dd {Variable name for fix ave/atom does not exist} :dt Self-explanatory. :dd {Variable name for fix ave/spatial does not exist} :dt Self-explanatory. :dd {Variable name for fix ave/time does not exist} :dt Self-explanatory. :dd {Variable name must be alphanumeric or underscore characters} :dt Self-explanatory. :dd {Velocity command before simulation box is defined} :dt The velocity command cannot be used before a read_data, read_restart, or create_box command. :dd {Velocity command with no atoms existing} :dt A velocity command has been used, but no atoms yet exist. :dd {Velocity ramp in z for a 2d problem} :dt Self-explanatory. :dd -{Velocity temp ID does not compute temperature} :dt +{Velocity temperature ID does not compute temperature} :dt The compute ID given to the velocity command must compute temperature. :dd {Virial was not tallied on needed timestep} :dt You are using a thermo keyword that requires potentials to have tallied the virial, but they didn't on this timestep. See the variable doc page for ideas on how to make this work. :dd {World variable count doesn't match # of partitions} :dt A world-style variable must specify a number of values equal to the number of processor partitions. :dd {Write_restart command before simulation box is defined} :dt The write_restart command cannot be used before a read_data, read_restart, or create_box command. :dd {Zero-length lattice orient vector} :dt Self-explanatory. :dd :dle Warnings: :h4,link(warn) :dlb {Broken bonds will not alter angles, dihedrals, or impropers} :dt See the doc page for fix bond/break for more info on this restriction. :dd +{Compute cna/atom cutoff may be too large to find ghost atom neighbors} :dt + +The neighbor cutoff used may not encompass enough ghost atoms +to perform this operation correctly. :dd + +{Computing temperature of portions of rigid bodies} :dt + +The group defined by the temperature compute does not encompass all +the atoms in one or more rigid bodies, so the change in +degrees-of-freedom for the atoms in those partial rigid bodies will +not be accounted for. :dd + {Created bonds will not create angles, dihedrals, or impropers} :dt See the doc page for fix bond/create for more info on this restriction. :dd {Dihedral problem: %d %d %d %d %d %d} :dt Conformation of the 4 listed dihedral atoms is extreme; you may want to check your simulation geometry. :dd {Dump dcd/xtc timestamp may be wrong with fix dt/reset} :dt If the fix changes the timestep, the dump dcd file will not reflect the change. :dd {FENE bond too long: %d %d %d %g} :dt A FENE bond has stretched dangerously far. It's interaction strength will be truncated to attempt to prevent the bond from blowing up. :dd {FENE bond too long: %d %g} :dt A FENE bond has stretched dangerously far. It's interaction strength will be truncated to attempt to prevent the bond from blowing up. :dd {Fix bond/swap will ignore defined angles} :dt See the doc page for fix bond/swap for more info on this restriction. :dd {Fix recenter should come after all other integration fixes} :dt Other fixes may change the position of the center-of-mass, so fix recenter should come last. :dd {Fix thermal/conductivity comes before fix ave/spatial} :dt The order of these 2 fixes in your input script is such that fix thermal/conductivity comes first. If you are using fix ave/spatial to measure the temperature profile induced by fix viscosity, then this may cause a glitch in the profile since you are averaging immediately after swaps have occurred. Flipping the order of the 2 fixes typically helps. :dd {Fix viscosity comes before fix ave/spatial} :dt The order of these 2 fixes in your input script is such that fix viscosity comes first. If you are using fix ave/spatial to measure the velocity profile induced by fix viscosity, then this may cause a glitch in the profile since you are averaging immediately after swaps have occurred. Flipping the order of the 2 fixes typically helps. :dd {Group for fix_modify temp != fix group} :dt The fix_modify command is specifying a temperature computation that computes a temperature on a different group of atoms than the fix itself operates on. This is probably not what you want to do. :dd {Improper problem: %d %d %d %d %d %d} :dt Conformation of the 4 listed improper atoms is extreme; you may want to check your simulation geometry. :dd {Kspace_modify slab param < 2.0 may cause unphysical behavior} :dt The kspace_modify slab parameter should be larger to insure periodic grids padded with empty space do not overlap. :dd {Less insertions than requested} :dt Less atom insertions occurred on this timestep due to the fix insert command than were scheduled. This is probably because there were too many overlaps detected. :dd {Lost atoms: original %.15g current %.15g} :dt A thermodynamic computation has detected lost atoms. :dd {Mismatch between velocity and compute groups} :dt The temperature computation used by the velocity command will not be on the same group of atoms that velocities are being set for. :dd {More than one compute centro/atom} :dt It is not efficient to use compute centro/atom more than once. :dd {More than one compute cna/atom defined} :dt It is not efficient to use compute cna/atom more than once. :dd {More than one compute coord/atom} :dt It is not efficient to use compute coord/atom more than once. :dd {More than one compute damage/atom} :dt It is not efficient to use compute ke/atom more than once. :dd {More than one compute ke/atom} :dt It is not efficient to use compute ke/atom more than once. :dd {More than one fix msd} :dt It is not efficient to use fix msd more than once. :dd {More than one fix poems} :dt It is not efficient to use fix poems more than once. :dd {More than one fix rigid} :dt It is not efficient to use fix rigid more than once. :dd {New thermo_style command, previous thermo_modify settings will be lost} :dt If a thermo_style command is used after a thermo_modify command, the settings changed by the thermo_modify command will be reset to their default values. This is because the thermo_modify commmand acts on the currently defined thermo style, and a thermo_style command creates a new style. :dd {No fixes defined, atoms won't move} :dt If you are not using a fix like nve, nvt, npt then atom velocities and coordinates will not be updated during timestepping. :dd {No joints between rigid bodies, use fix rigid instead} :dt The bodies defined by fix poems are not connected by joints. POEMS will integrate the body motion, but it would be more efficient to use fix rigid. :dd {Not using real units with pair reax} :dt This is most likely an error, unless you have created your own ReaxFF parameter file in a different set of units. :dd {One or more atoms are time integrated more than once} :dt This is probably an error since you typically do not want to advance the positions or velocities of an atom more than once per timestep. :dd {One or more respa levels compute no forces} :dt This is computationally inefficient. :dd {Particle deposition was unsuccessful} :dt The fix deposit command was not able to insert as many atoms as needed. The requested volume fraction may be too high, or other atoms may be in the insertion region. :dd {Reducing PPPM order b/c stencil extends beyond neighbor processor} :dt LAMMPS is attempting this in order to allow the simulation to run. It should not effect the PPPM accuracy. :dd {Replacing a fix, but new group != old group} :dt The ID and style of a fix match for a fix you are changing with a fix command, but the new group you are specifying does not match the old group. :dd {Replicating in a non-periodic dimension} :dt The parameters for a replicate command will cause a non-periodic dimension to be replicated; this may cause unwanted behavior. :dd {Resetting reneighboring criteria during minimization} :dt Minimization requires that neigh_modify settings be delay = 0, every = 1, check = yes. Since these settings were not in place, LAMMPS changed them and will restore them to their original values after the minimization. :dd {Restart file used different # of processors} :dt The restart file was written out by a LAMMPS simulation running on a different number of processors. Due to round-off, the trajectories of your restarted simulation may diverge a little more quickly than if you ran on the same # of processors. :dd {Restart file used different 3d processor grid} :dt The restart file was written out by a LAMMPS simulation running on a different 3d grid of processors. Due to round-off, the trajectories of your restarted simulation may diverge a little more quickly than if you ran on the same # of processors. :dd {Restart file used different boundary settings, using restart file values} :dt -Your input script cannot change these settings in the restart file. +Your input script cannot change these restart file settings. :dd {Restart file used different newton bond setting, using restart file value} :dt -Your input script cannot change this setting in the restart file. +The restart file value will override the setting in the input script. :dd {Restart file used different newton pair setting, using input script value} :dt -Your input script can change this setting in the restart file, but you -may not wish to do so. +The input script value will override the setting in the restart file. :dd {Restart file version does not match LAMMPS version} :dt -The version of LAMMPS that wrote the restart file does not match the -version of LAMMPS that is reading the restart file. Generally this -shouldn't be a problem, since restart file formats won't change very -often if at all. But if they do, the code will probably crash trying -to read the file. Versions of LAMMPS are specified by a date. :dd +This may cause problems when reading the restart file. :dd {Shake determinant < 0.0} :dt The determinant of the quadratic equation being solved for a single cluster specified by the fix shake command is numerically suspect. LAMMPS will set it to 0.0 and continue. :dd {System is not charge neutral, net charge = %g} :dt The total charge on all atoms on the system is not 0.0, which is not valid for Ewald or PPPM. :dd {Table inner cutoff >= outer cutoff} :dt You specified an inner cutoff for a Coulombic table that is longer than the global cutoff. Probably not what you wanted. :dd {Temperature for NPH is not for group all} :dt User-assigned temperature to NPH fix does not compute temperature for all atoms. Since NPH computes a global pressure, the kinetic energy contribution from the temperature is assumed to also be for all atoms. Thus the pressure used by NPH could be inaccurate. :dd {Temperature for NPT is not for group all} :dt User-assigned temperature to NPT fix does not compute temperature for all atoms. Since NPT computes a global pressure, the kinetic energy contribution from the temperature is assumed to also be for all atoms. Thus the pressure used by NPT could be inaccurate. :dd +{Temperature for fix modify is not for group all} :dt + +The temperature compute is being used with a pressure calculation +which does operate on group all, so this may be inconsistent. :dd + {Temperature for thermo pressure is not for group all} :dt User-assigned temperature to thermo via the thermo_modify command does not compute temperature for all atoms. Since thermo computes a global pressure, the kinetic energy contribution from the temperature is assumed to also be for all atoms. Thus the pressure printed by thermo could be inaccurate. :dd +{Too many common neighbors in CNA %d times} :dt + +More than the maximum # of neighbors was found multiple times. This +was unexpected. :dd + {Too many inner timesteps in fix ttm} :dt Self-explanatory. :dd +{Too many neighbors in CNA for %d atoms} :dt + +More than the maximum # of neighbors was found multiple times. This +was unexpected. :dd + {Use special bonds = 0,1,1 with bond style fene/expand} :dt Most FENE models need this setting for the special_bonds command. :dd {Use special bonds = 0,1,1 with bond style fene} :dt Most FENE models need this setting for the special_bonds command. :dd {Using compute temp/deform with inconsistent fix deform remap option} :dt Fix nvt/sllod assumes deforming atoms have a velocity profile provided by "remap v" or "remap none" as a fix deform option. :dd {Using compute temp/deform with no fix deform defined} :dt This is probably an error, since it makes little sense to use compute temp/deform in this case. :dd {Using pair tail corrections with nonperiodic system} :dt This is probably a bogus thing to do, since tail corrections are computed by integrating the density of a periodic system out to infinity. :dd :dle diff --git a/doc/Section_intro.html b/doc/Section_intro.html index fae88987c..3c1b78aae 100644 --- a/doc/Section_intro.html +++ b/doc/Section_intro.html @@ -1,570 +1,571 @@ <HTML> <CENTER><A HREF = "Manual.html">Previous Section</A> - <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A> - <A HREF = "Manual.html">LAMMPS Documentation</A> - <A HREF = "Section_commands.html#comm">LAMMPS Commands</A> - <A HREF = "Section_start.html">Next Section</A> </CENTER> <HR> <H3>1. Introduction </H3> <P>These sections provide an overview of what LAMMPS can and can't do, describe what it means for LAMMPS to be an open-source code, and acknowledge the funding and people who have contributed to LAMMPS over the years. </P> 1.1 <A HREF = "#1_1">What is LAMMPS</A><BR> 1.2 <A HREF = "#1_2">LAMMPS features</A><BR> 1.3 <A HREF = "#1_3">LAMMPS non-features</A><BR> 1.4 <A HREF = "#1_4">Open source distribution</A><BR> 1.5 <A HREF = "#1_5">Acknowledgments and citations</A> <BR> <HR> <A NAME = "1_1"></A><H4>1.1 What is LAMMPS </H4> <P>LAMMPS is a classical molecular dynamics code that models an ensemble of particles in a liquid, solid, or gaseous state. It can model atomic, polymeric, biological, metallic, granular, and coarse-grained systems using a variety of force fields and boundary conditions. </P> <P>For examples of LAMMPS simulations, see the Publications page of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>. </P> <P>LAMMPS runs efficiently on single-processor desktop or laptop machines, but is designed for parallel computers. It will run on any parallel machine that compiles C++ and supports the <A HREF = "http://www-unix.mcs.anl.gov/mpi">MPI</A> message-passing library. This includes distributed- or shared-memory parallel machines and Beowulf-style clusters. </P> <P>LAMMPS can model systems with only a few particles up to millions or billions. See <A HREF = "Section_perf.html">this section</A> for information on LAMMPS performance and scalability, or the Benchmarks section of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>. </P> <P>LAMMPS is a freely-available open-source code, distributed under the terms of the <A HREF = "http://www.gnu.org/copyleft/gpl.html">GNU Public License</A>, which means you can use or modify the code however you wish. See <A HREF = "#1_4">this section</A> for a brief discussion of the open-source philosophy. </P> <P>LAMMPS is designed to be easy to modify or extend with new capabilities, such as new force fields, atom types, boundary conditions, or diagnostics. See <A HREF = "Section_modify.html">this section</A> for more details. </P> <P>The current version of LAMMPS is written in C++. Earlier versions were written in F77 and F90. See <A HREF = "Section_history.html">this section</A> for more information on different versions. All versions can be downloaded from the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>. </P> <P>LAMMPS was originally developed under a US Department of Energy CRADA (Cooperative Research and Development Agreement) between two DOE labs and 3 companies. It is distributed by <A HREF = "http://www.sandia.gov">Sandia National Labs</A>. See <A HREF = "#1_5">this section</A> for more information on LAMMPS funding and individuals who have contributed to LAMMPS. </P> <P>In the most general sense, LAMMPS integrates Newton's equations of motion for collections of atoms, molecules, or macroscopic particles that interact via short- or long-range forces with a variety of initial and/or boundary conditions. For computational efficiency LAMMPS uses neighbor lists to keep track of nearby particles. The lists are optimized for systems with particles that are repulsive at short distances, so that the local density of particles never becomes too large. On parallel machines, LAMMPS uses spatial-decomposition techniques to partition the simulation domain into small 3d sub-domains, one of which is assigned to each processor. Processors communicate and store "ghost" atom information for atoms that border their sub-domain. LAMMPS is most efficient (in a parallel sense) for systems whose particles fill a 3d rectangular box with roughly uniform density. Papers with technical details of the algorithms used in LAMMPS are listed in <A HREF = "#1_5">this section</A>. </P> <HR> <A NAME = "1_2"></A><H4>1.2 LAMMPS features </H4> <P>This section highlights LAMMPS features, with pointers to specific commands which give more details. If LAMMPS doesn't have your favorite interatomic potential, boundary condition, or atom type, see <A HREF = "Section_modify.html">this section</A>, which describes how you can add it to LAMMPS. </P> <H4>General features </H4> <UL><LI> runs on a single processor or in parallel <LI> distributed-memory message-passing parallelism (MPI) <LI> spatial-decomposition of simulation domain for parallelism <LI> open-source distribution <LI> highly portable C++ <LI> optional libraries needed: MPI and single-processor FFT <LI> easy to extend with new features and functionality <LI> in parallel, run one or multiple simulations simultaneously <LI> runs from an input script <LI> syntax for defining and using variables and formulas <LI> syntax for looping over runs and breaking out of loops <LI> run a series of simluations from one script </UL> <H4>Kinds of systems LAMMPS can simulate </H4> <P>(<A HREF = "atom_style.html">atom style</A> command) </P> <UL><LI> atomic (e.g. box of Lennard-Jonesium) <LI> bead-spring polymers <LI> united-atom polymers or organic molecules <LI> all-atom polymers, organic molecules, proteins, DNA <LI> metals <LI> granular materials <LI> coarse-grained mesoscale models <LI> ellipsoidal particles <LI> point dipolar particles <LI> hybrid combinations of these </UL> <H4>Force fields </H4> <P>(<A HREF = "pair_style.html">pair style</A>, <A HREF = "bond_style.html">bond style</A>, <A HREF = "angle_style.html">angle style</A>, <A HREF = "dihedral_style.html">dihedral style</A>, <A HREF = "improper_style.html">improper style</A>, <A HREF = "kspace_style.html">kspace style</A> commands) </P> <UL><LI> pairwise potentials: Lennard-Jones, Buckingham, Morse, Yukawa, soft, class 2 (COMPASS), tabulated <LI> charged pairwise potentials: Coulombic, point-dipole <LI> manybody potentials: EAM, Finnis/Sinclair EAM, modified EAM (MEAM), Stillinger-Weber, Tersoff, AI-REBO, ReaxFF <LI> coarse-grain potentials: DPD, GayBerne, REsquared, colloidal <LI> mesoscopic potentials: granular, Peridynamics <LI> bond potentials: harmonic, FENE, Morse, nonlinear, class 2, quartic (breakable) <LI> angle potentials: harmonic, CHARMM, cosine, cosine/squared, class 2 (COMPASS) <LI> dihedral potentials: harmonic, CHARMM, multi-harmonic, helix, class 2 (COMPASS), OPLS <LI> improper potentials: harmonic, cvff, class 2 (COMPASS) <LI> hybrid potentials: multiple pair, bond, angle, dihedral, improper potentials can be used in one simulation <LI> overlaid potentials: superposition of multiple pair potentials <LI> polymer potentials: all-atom, united-atom, bead-spring, breakable <LI> water potentials: TIP3P, TIP4P, SPC <LI> implicit solvent potentials: hydrodynamic lubrication, Debye <LI> long-range Coulombics and dispersion: Ewald, PPPM (similar to particle-mesh Ewald), Ewald/N for long-range Lennard-Jones <LI> force-field compatibility with common CHARMM, AMBER, OPLS, GROMACS options </UL> <H4>Creation of atoms </H4> <P>(<A HREF = "read_data.html">read_data</A>, <A HREF = "lattice.html">lattice</A>, <A HREF = "create_atoms.html">create_atoms</A>, <A HREF = "delete_atoms.html">delete_atoms</A>, <A HREF = "displace_atoms.html">displace_atoms</A> commands) </P> <UL><LI> read in atom coords from files <LI> create atoms on one or more lattices (e.g. grain boundaries) <LI> delete geometric or logical groups of atoms (e.g. voids) <LI> displace atoms </UL> <H4>Ensembles, constraints, and boundary conditions </H4> <P>(<A HREF = "fix.html">fix</A> command) </P> <UL><LI> 2d or 3d systems <LI> orthogonal or non-orthogonal (triclinic symmetry) simulation domains <LI> constant NVE, NVT, NPT, NPH integrators <LI> thermostatting options for groups and geometric regions of atoms <LI> pressure control via Nose/Hoover or Berendsen barostatting in 1 to 3 dimensions <LI> simulation box deformation (tensile and shear) <LI> harmonic (umbrella) constraint forces <LI> independent or coupled rigid body integration <LI> SHAKE bond and angle constraints <LI> bond breaking, formation, swapping <LI> walls of various kinds <LI> targeted molecular dynamics (TMD) and steered molecule dynamics (SMD) constraints <LI> non-equilibrium molecular dynamics (NEMD) <LI> variety of additional boundary conditions and constraints </UL> <H4>Integrators </H4> <P>(<A HREF = "run.html">run</A>, <A HREF = "run_style.html">run_style</A>, <A HREF = "temper.html">temper</A> commands) </P> <UL><LI> velocity-Verlet integrator <LI> Brownian dynamics <LI> energy minimization via conjugate gradient or steepest descent relaxation <LI> rRESPA hierarchical timestepping <LI> parallel tempering (replica exchange) </UL> -<P>Diagnostics: h4 -(<A HREF = "fix.html">fix</A> command, <A HREF = "compute.html">compute</A> command) -</P> -<P> see the various flavors of the fix and compute commands +<H4>Diagnostics +</H4> +<P>(<A HREF = "fix.html">fix</A> command, <A HREF = "compute.html">compute</A> command) </P> +<UL><LI> see the various flavors of the fix and compute commands +</UL> <H4>Output </H4> <P>(<A HREF = "dump.html">dump</A>, <A HREF = "restart.html">restart</A> commands) </P> <UL><LI> log file of thermodynamic info <LI> text dump files of atom coords, velocities, other per-atom quantities <LI> binary restart files <LI> per-atom quantities (energy, stress, centro-symmetry parameter, CNA, etc) <LI> user-defined system-wide (log file) or per-atom (dump file) calculations <LI> spatial and time averaging of per-atom quantities <LI> time averaging of system-wide quantities <LI> atom snapshots in native, XYZ, XTC, DCD formats </UL> <H4>Pre- and post-processing </H4> <P>Our group has also written and released a separate toolkit called <A HREF = "http://www.sandia.gov/~sjplimp/pizza.html">Pizza.py</A> which provides tools for doing setup, analysis, plotting, and visualization for LAMMPS simulations. Pizza.py is written in <A HREF = "http://www.python.org">Python</A> and is available for download from <A HREF = "http://www.sandia.gov/~sjplimp/pizza.html">the Pizza.py WWW site</A>. </P> <HR> <A NAME = "1_3"></A><H4>1.3 LAMMPS non-features </H4> <P>LAMMPS is designed to efficiently compute Newton's equations of motion for a system of interacting particles. Many of the tools needed to pre- and post-process the data for such simulations are not included in the LAMMPS kernel for several reasons: </P> <UL><LI>the desire to keep LAMMPS simple <LI>they are not parallel operations <LI>other codes already do them <LI>limited development resources </UL> <P>Specifically, LAMMPS itself does not: </P> <UL><LI>run thru a GUI <LI>build molecular systems <LI>assign force-field coefficients automagically <LI>perform sophisticated analyses of your MD simulation <LI>visualize your MD simulation <LI>plot your output data </UL> <P>A few tools for pre- and post-processing tasks are provided as part of the LAMMPS package; they are described in <A HREF = "Section_tools.html">this section</A>. However, many people use other codes or write their own tools for these tasks. </P> <P>As noted above, our group has also written and released a separate toolkit called <A HREF = "http://www.sandia.gov/~sjplimp/pizza.html">Pizza.py</A> which addresses some of the listed bullets. It provides tools for doing setup, analysis, plotting, and visualization for LAMMPS simulations. Pizza.py is written in <A HREF = "http://www.python.org">Python</A> and is available for download from <A HREF = "http://www.sandia.gov/~sjplimp/pizza.html">the Pizza.py WWW site</A>. </P> <P>LAMMPS requires as input a list of initial atom coordinates and types, molecular topology information, and force-field coefficients assigned to all atoms and bonds. LAMMPS will not build molecular systems and assign force-field parameters for you. </P> <P>For atomic systems LAMMPS provides a <A HREF = "create_atoms.html">create_atoms</A> command which places atoms on solid-state lattices (fcc, bcc, user-defined, etc). Assigning small numbers of force field coefficients can be done via the <A HREF = "pair_coeff.html">pair coeff</A>, <A HREF = "bond_coeff.html">bond coeff</A>, <A HREF = "angle_coeff.html">angle coeff</A>, etc commands. For molecular systems or more complicated simulation geometries, users typically use another code as a builder and convert its output to LAMMPS input format, or write their own code to generate atom coordinate and molecular topology for LAMMPS to read in. </P> <P>For complicated molecular systems (e.g. a protein), a multitude of topology information and hundreds of force-field coefficients must typically be specified. We suggest you use a program like <A HREF = "http://www.scripps.edu/brooks">CHARMM</A> or <A HREF = "http://amber.scripps.edu">AMBER</A> or other molecular builders to setup such problems and dump its information to a file. You can then reformat the file as LAMMPS input. Some of the tools in <A HREF = "Section_tools.html">this section</A> can assist in this process. </P> <P>Similarly, LAMMPS creates output files in a simple format. Most users post-process these files with their own analysis tools or re-format them for input into other programs, including visualization packages. If you are convinced you need to compute something on-the-fly as LAMMPS runs, see <A HREF = "Section_modify.html">this section</A> for a discussion of how you can use the <A HREF = "dump.html">dump</A> and <A HREF = "compute.html">compute</A> and <A HREF = "fix.html">fix</A> commands to print out data of your choosing. Keep in mind that complicated computations can slow down the molecular dynamics timestepping, particularly if the computations are not parallel, so it is often better to leave such analysis to post-processing codes. </P> <P>A very simple (yet fast) visualizer is provided with the LAMMPS package - see the <A HREF = "Section_tools.html#xmovie">xmovie</A> tool in <A HREF = "Section_tools.html">this section</A>. It creates xyz projection views of atomic coordinates and animates them. We find it very useful for debugging purposes. For high-quality visualization we recommend the following packages: </P> <UL><LI><A HREF = "http://www.ks.uiuc.edu/Research/vmd">VMD</A> <LI><A HREF = "http://164.107.79.177/Archive/Graphics/A">AtomEye</A> <LI><A HREF = "http://pymol.sourceforge.net">PyMol</A> <LI><A HREF = "http://www.bmsc.washington.edu/raster3d/raster3d.html">Raster3d</A> <LI><A HREF = "http://www.openrasmol.org">RasMol</A> </UL> <P>Other features that LAMMPS does not yet (and may never) support are discussed in <A HREF = "Section_history.html">this section</A>. </P> <P>Finally, these are freely-available molecular dynamics codes, most of them parallel, which may be well-suited to the problems you want to model. They can also be used in conjunction with LAMMPS to perform complementary modeling tasks. </P> <UL><LI><A HREF = "http://www.scripps.edu/brooks">CHARMM</A> <LI><A HREF = "http://amber.scripps.edu">AMBER</A> <LI><A HREF = "http://www.ks.uiuc.edu/Research/namd/">NAMD</A> <LI><A HREF = "http://www.emsl.pnl.gov/docs/nwchem/nwchem.html">NWCHEM</A> <LI><A HREF = "http://www.cse.clrc.ac.uk/msi/software/DL_POLY">DL_POLY</A> <LI><A HREF = "http://dasher.wustl.edu/tinker">Tinker</A> </UL> <P>CHARMM, AMBER, NAMD, NWCHEM, and Tinker are designed primarily for modeling biological molecules. CHARMM and AMBER use atom-decomposition (replicated-data) strategies for parallelism; NAMD and NWCHEM use spatial-decomposition approaches, similar to LAMMPS. Tinker is a serial code. DL_POLY includes potentials for a variety of biological and non-biological materials; both a replicated-data and spatial-decomposition version exist. </P> <HR> <A NAME = "1_4"></A><H4>1.4 Open source distribution </H4> <P>LAMMPS comes with no warranty of any kind. As each source file states in its header, it is a copyrighted code that is distributed free-of- charge, under the terms of the <A HREF = "http://www.gnu.org/copyleft/gpl.html">GNU Public License</A> (GPL). This is often referred to as open-source distribution - see <A HREF = "http://www.gnu.org">www.gnu.org</A> or <A HREF = "http://www.opensource.org">www.opensource.org</A> for more details. The legal text of the GPL is in the LICENSE file that is included in the LAMMPS distribution. </P> <P>Here is a summary of what the GPL means for LAMMPS users: </P> <P>(1) Anyone is free to use, modify, or extend LAMMPS in any way they choose, including for commercial purposes. </P> <P>(2) If you distribute a modified version of LAMMPS, it must remain open-source, meaning you distribute it under the terms of the GPL. You should clearly annotate such a code as a derivative version of LAMMPS. </P> <P>(3) If you release any code that includes LAMMPS source code, then it must also be open-sourced, meaning you distribute it under the terms of the GPL. </P> <P>(4) If you give LAMMPS files to someone else, the GPL LICENSE file and source file headers (including the copyright and GPL notices) should remain part of the code. </P> <P>In the spirit of an open-source code, these are various ways you can contribute to making LAMMPS better. You can send email to the <A HREF = "http://lammps.sandia.gov/authors.html">developers</A> on any of these items. </P> <UL><LI>Point prospective users to the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>. Mention it in talks or link to it from your WWW site. <LI>If you find an error or omission in this manual or on the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>, or have a suggestion for something to clarify or include, send an email to the <A HREF = "http://lammps.sandia.gov/authors.html">developers</A>. <LI>If you find a bug, <A HREF = "Section_errors.html#9_2">this section</A> describes how to report it. <LI>If you publish a paper using LAMMPS results, send the citation (and any cool pictures or movies if you like) to add to the Publications, Pictures, and Movies pages of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>, with links and attributions back to you. <LI>Create a new Makefile.machine that can be added to the src/MAKE directory. <LI>The tools sub-directory of the LAMMPS distribution has various stand-alone codes for pre- and post-processing of LAMMPS data. More details are given in <A HREF = "Section_tools.html">this section</A>. If you write a new tool that users will find useful, it can be added to the LAMMPS distribution. <LI>LAMMPS is designed to be easy to extend with new code for features like potentials, boundary conditions, diagnostic computations, etc. <A HREF = "Section_modify.html">This section</A> gives details. If you add a feature of general interest, it can be added to the LAMMPS distribution. <LI>The Benchmark page of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A> lists LAMMPS performance on various platforms. The files needed to run the benchmarks are part of the LAMMPS distribution. If your machine is sufficiently different from those listed, your timing data can be added to the page. <LI>You can send feedback for the User Comments page of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>. It might be added to the page. No promises. <LI>Cash. Small denominations, unmarked bills preferred. Paper sack OK. Leave on desk. VISA also accepted. Chocolate chip cookies encouraged. </UL> <HR> <H4><A NAME = "1_5"></A>1.5 Acknowledgments and citations </H4> <P>LAMMPS development has been funded by the <A HREF = "http://www.doe.gov">US Department of Energy</A> (DOE), through its CRADA, LDRD, ASCI, and Genomes-to-Life programs and its <A HREF = "http://www.sc.doe.gov/ascr/home.html">OASCR</A> and <A HREF = "http://www.er.doe.gov/production/ober/ober_top.html">OBER</A> offices. </P> <P>Specifically, work on the latest version was funded in part by the US Department of Energy's Genomics:GTL program (<A HREF = "http://www.doegenomestolife.org">www.doegenomestolife.org</A>) under the <A HREF = "http://www.genomes2life.org">project</A>, "Carbon Sequestration in Synechococcus Sp.: From Molecular Machines to Hierarchical Modeling". </P> <P>The following papers describe the parallel algorithms used in LAMMPS. </P> <P>S. J. Plimpton, <B>Fast Parallel Algorithms for Short-Range Molecular Dynamics</B>, J Comp Phys, 117, 1-19 (1995). </P> <P>S. J. Plimpton, R. Pollock, M. Stevens, <B>Particle-Mesh Ewald and rRESPA for Parallel Molecular Dynamics Simulations</B>, in Proc of the Eighth SIAM Conference on Parallel Processing for Scientific Computing, Minneapolis, MN (March 1997). </P> <P>If you use LAMMPS results in your published work, please cite the J Comp Phys reference and include a pointer to the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A> (http://lammps.sandia.gov). </P> <P>If you send is information about your publication, we'll be pleased to add it to the Publications page of the <A HREF = "http://lammps.sandia.gov">LAMMPS WWW Site</A>. Ditto for a picture or movie for the Pictures or Movies pages. </P> <P>The core group of LAMMPS developers is at Sandia National Labs. They include <A HREF = "http://www.cs.sandia.gov/~sjplimp">Steve Plimpton</A>, Paul Crozier, and Aidan Thompson and can be contacted via email: sjplimp, pscrozi, athomps at sandia.gov. </P> <P>Here are various folks who have made significant contributions to features in LAMMPS. The most recent contributions are at the top of the list. </P> <DIV ALIGN=center><TABLE BORDER=1 > <TR><TD >compute heat/flux for Green-Kubo </TD><TD > Reese Jones (Sandia), Philip Howell (Siemens), Vikas Varsney (AFRL)</TD></TR> <TR><TD >region cone </TD><TD > Pim Schravendijk</TD></TR> <TR><TD >fix reax/bonds </TD><TD > Aidan Thompson (Sandia)</TD></TR> <TR><TD >pair born/coul/long </TD><TD > Ahmed Ismail (Sandia)</TD></TR> <TR><TD >fix ttm </TD><TD > Paul Crozier (Sandia) and Carolyn Phillips (U Michigan)</TD></TR> <TR><TD >fix box/relax </TD><TD > Aidan Thompson and David Olmsted (Sandia)</TD></TR> <TR><TD >ReaxFF potential </TD><TD > Aidan Thompson (Sandia) and Hansohl Cho (MIT)</TD></TR> <TR><TD >compute cna/atom </TD><TD > Wan Liang (Chinese Academy of Sciences)</TD></TR> <TR><TD >Tersoff/ZBL potential </TD><TD > Dave Farrell (Northwestern U)</TD></TR> <TR><TD >peridynamics </TD><TD > Mike Parks (Sandia)</TD></TR> <TR><TD >fix smd for steered MD </TD><TD > Axel Kohlmeyer (U Penn)</TD></TR> <TR><TD >GROMACS pair potentials </TD><TD > Mark Stevens (Sandia)</TD></TR> <TR><TD >lmp2vmd tool </TD><TD > Axel Kohlmeyer (U Penn)</TD></TR> <TR><TD >compute group/group </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U)</TD></TR> <TR><TD >CG-CMM user package for coarse-graining </TD><TD > Axel Kohlmeyer (U Penn)</TD></TR> <TR><TD >cosine/delta angle potential </TD><TD > Axel Kohlmeyer (U Penn)</TD></TR> <TR><TD >VIM editor add-ons for LAMMPS input scripts </TD><TD > Gerolf Ziegenhain</TD></TR> <TR><TD >pair lubricate </TD><TD > Randy Schunk (Sandia)</TD></TR> <TR><TD >compute ackland/atom </TD><TD > Gerolf Zeigenhain</TD></TR> <TR><TD >kspace_style ewald/n, pair_style lj/coul, pair_style buck/coul </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >AI-REBO bond-order potential </TD><TD > Ase Henry (MIT)</TD></TR> <TR><TD >making LAMMPS a true "object" that can be instantiated multiple times, e.g. as a library </TD><TD > Ben FrantzDale (RPI)</TD></TR> <TR><TD >pymol_asphere viz tool </TD><TD > Mike Brown (Sandia)</TD></TR> <TR><TD >NEMD SLLOD integration </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >tensile and shear deformations </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >GayBerne potential </TD><TD > Mike Brown (Sandia)</TD></TR> <TR><TD >ellipsoidal particles </TD><TD > Mike Brown (Sandia)</TD></TR> <TR><TD >colloid potentials </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >fix heat </TD><TD > Paul Crozier and Ed Webb (Sandia)</TD></TR> <TR><TD >neighbor multi and communicate multi </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >MATLAB post-processing scripts </TD><TD > Arun Subramaniyan (Purdue)</TD></TR> <TR><TD >triclinic (non-orthogonal) simulation domains </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >thermo_extract tool</TD><TD > Vikas Varshney (Wright Patterson AFB)</TD></TR> <TR><TD >fix ave/time and fix ave/spatial </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >MEAM potential </TD><TD > Greg Wagner (Sandia)</TD></TR> <TR><TD >optimized pair potentials for lj/cut, charmm/long, eam, morse </TD><TD > James Fischer (High Performance Technologies), David Richie and Vincent Natoli (Stone Ridge Technologies)</TD></TR> <TR><TD >fix wall/lj126 </TD><TD > Mark Stevens (Sandia)</TD></TR> <TR><TD >Stillinger-Weber and Tersoff potentials </TD><TD > Aidan Thompson and Xiaowang Zhou (Sandia)</TD></TR> <TR><TD >region prism </TD><TD > Pieter in 't Veld (Sandia)</TD></TR> <TR><TD >LJ tail corrections for energy/pressure </TD><TD > Paul Crozier (Sandia)</TD></TR> <TR><TD >fix momentum and recenter </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U)</TD></TR> <TR><TD >multi-letter variable names </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U)</TD></TR> <TR><TD >OPLS dihedral potential</TD><TD > Mark Stevens (Sandia)</TD></TR> <TR><TD >POEMS coupled rigid body integrator</TD><TD > Rudranarayan Mukherjee (RPI)</TD></TR> <TR><TD >faster pair hybrid potential</TD><TD > James Fischer (High Performance Technologies, Inc), Vincent Natoli and David Richie (Stone Ridge Technology)</TD></TR> <TR><TD >breakable bond quartic potential</TD><TD > Chris Lorenz and Mark Stevens (Sandia)</TD></TR> <TR><TD >DCD and XTC dump styles</TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U)</TD></TR> <TR><TD >grain boundary orientation fix </TD><TD > Koenraad Janssens and David Olmsted (Sandia)</TD></TR> <TR><TD >lj/smooth pair potential </TD><TD > Craig Maloney (UCSB) </TD></TR> <TR><TD >radius-of-gyration spring fix </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U) and Paul Crozier (Sandia)</TD></TR> <TR><TD >self spring fix </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U)</TD></TR> <TR><TD >EAM CoAl and AlCu potentials </TD><TD > Kwang-Reoul Lee (KIST, Korea)</TD></TR> <TR><TD >cosine/squared angle potential </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U)</TD></TR> <TR><TD >helix dihedral potential </TD><TD > Naveen Michaud-Agrawal (Johns Hopkins U) and Mark Stevens (Sandia)</TD></TR> <TR><TD >Finnis/Sinclair EAM</TD><TD > Tim Lau (MIT)</TD></TR> <TR><TD >dissipative particle dynamics (DPD) potentials</TD><TD > Kurt Smith (U Pitt) and Frank van Swol (Sandia)</TD></TR> <TR><TD >TIP4P potential (4-site water)</TD><TD > Ahmed Ismail and Amalie Frischknecht (Sandia)</TD></TR> <TR><TD >uniaxial strain fix</TD><TD > Carsten Svaneborg (Max Planck Institute)</TD></TR> <TR><TD >thermodynamics enhanced by fix quantities</TD><TD > Aidan Thompson (Sandia)</TD></TR> <TR><TD >compressed dump files</TD><TD > Erik Luijten (U Illinois)</TD></TR> <TR><TD >cylindrical indenter fix</TD><TD > Ravi Agrawal (Northwestern U)</TD></TR> <TR><TD >electric field fix</TD><TD > Christina Payne (Vanderbilt U)</TD></TR> <TR><TD >AMBER <-> LAMMPS tool</TD><TD > Keir Novik (Univ College London) and Vikas Varshney (U Akron)</TD></TR> <TR><TD >CHARMM <-> LAMMPS tool</TD><TD > Pieter in 't Veld and Paul Crozier (Sandia)</TD></TR> <TR><TD >Morse bond potential</TD><TD > Jeff Greathouse (Sandia)</TD></TR> <TR><TD >radial distribution functions</TD><TD > Paul Crozier & Jeff Greathouse (Sandia)</TD></TR> <TR><TD >force tables for long-range Coulombics</TD><TD > Paul Crozier (Sandia)</TD></TR> <TR><TD >targeted molecular dynamics (TMD)</TD><TD > Paul Crozier (Sandia) and Christian Burisch (Bochum University, Germany)</TD></TR> <TR><TD >FFT support for SGI SCSL (Altix)</TD><TD > Jim Shepherd (Ga Tech)</TD></TR> <TR><TD >lmp2cfg and lmp2traj tools</TD><TD > Ara Kooser, Jeff Greathouse, Andrey Kalinichev (Sandia)</TD></TR> <TR><TD >parallel tempering</TD><TD > Mark Sears (Sandia)</TD></TR> <TR><TD >embedded atom method (EAM) potential</TD><TD > Stephen Foiles (Sandia)</TD></TR> <TR><TD >multi-harmonic dihedral potential</TD><TD > Mathias Puetz (Sandia)</TD></TR> <TR><TD >granular force fields and BC</TD><TD > Leo Silbert & Gary Grest (Sandia)</TD></TR> <TR><TD >2d Ewald/PPPM</TD><TD > Paul Crozier (Sandia)</TD></TR> <TR><TD >CHARMM force fields</TD><TD > Paul Crozier (Sandia)</TD></TR> <TR><TD >msi2lmp tool</TD><TD > Steve Lustig (Dupont), Mike Peachey & John Carpenter (Cray)</TD></TR> <TR><TD >HTFN energy minimizer</TD><TD > Todd Plantenga (Sandia)</TD></TR> <TR><TD >class 2 force fields</TD><TD > Eric Simon (Cray)</TD></TR> <TR><TD >NVT/NPT integrators</TD><TD > Mark Stevens (Sandia)</TD></TR> <TR><TD >rRESPA</TD><TD > Mark Stevens & Paul Crozier (Sandia)</TD></TR> <TR><TD >Ewald and PPPM solvers</TD><TD > Roy Pollock (LLNL) </TD><TD > </TD></TR></TABLE></DIV> <P>Other CRADA partners involved in the design and testing of LAMMPS were </P> <UL><LI>John Carpenter (Mayo Clinic, formerly at Cray Research) <LI>Terry Stouch (Lexicon Pharmaceuticals, formerly at Bristol Myers Squibb) <LI>Steve Lustig (Dupont) <LI>Jim Belak (LLNL) </UL> </HTML> diff --git a/doc/Section_intro.txt b/doc/Section_intro.txt index 4c9546b2f..a86c2cd2a 100644 --- a/doc/Section_intro.txt +++ b/doc/Section_intro.txt @@ -1,565 +1,565 @@ "Previous Section"_Manual.html - "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc - "Next Section"_Section_start.html :c :link(lws,http://lammps.sandia.gov) :link(ld,Manual.html) :link(lc,Section_commands.html#comm) :line 1. Introduction :h3 These sections provide an overview of what LAMMPS can and can't do, describe what it means for LAMMPS to be an open-source code, and acknowledge the funding and people who have contributed to LAMMPS over the years. 1.1 "What is LAMMPS"_#1_1 1.2 "LAMMPS features"_#1_2 1.3 "LAMMPS non-features"_#1_3 1.4 "Open source distribution"_#1_4 1.5 "Acknowledgments and citations"_#1_5 :all(b) :line 1.1 What is LAMMPS :link(1_1),h4 LAMMPS is a classical molecular dynamics code that models an ensemble of particles in a liquid, solid, or gaseous state. It can model atomic, polymeric, biological, metallic, granular, and coarse-grained systems using a variety of force fields and boundary conditions. For examples of LAMMPS simulations, see the Publications page of the "LAMMPS WWW Site"_lws. LAMMPS runs efficiently on single-processor desktop or laptop machines, but is designed for parallel computers. It will run on any parallel machine that compiles C++ and supports the "MPI"_mpi message-passing library. This includes distributed- or shared-memory parallel machines and Beowulf-style clusters. :link(mpi,http://www-unix.mcs.anl.gov/mpi) LAMMPS can model systems with only a few particles up to millions or billions. See "this section"_Section_perf.html for information on LAMMPS performance and scalability, or the Benchmarks section of the "LAMMPS WWW Site"_lws. LAMMPS is a freely-available open-source code, distributed under the terms of the "GNU Public License"_gnu, which means you can use or modify the code however you wish. See "this section"_#1_4 for a brief discussion of the open-source philosophy. :link(gnu,http://www.gnu.org/copyleft/gpl.html) LAMMPS is designed to be easy to modify or extend with new capabilities, such as new force fields, atom types, boundary conditions, or diagnostics. See "this section"_Section_modify.html for more details. The current version of LAMMPS is written in C++. Earlier versions were written in F77 and F90. See "this section"_Section_history.html for more information on different versions. All versions can be downloaded from the "LAMMPS WWW Site"_lws. LAMMPS was originally developed under a US Department of Energy CRADA (Cooperative Research and Development Agreement) between two DOE labs and 3 companies. It is distributed by "Sandia National Labs"_snl. See "this section"_#1_5 for more information on LAMMPS funding and individuals who have contributed to LAMMPS. :link(snl,http://www.sandia.gov) In the most general sense, LAMMPS integrates Newton's equations of motion for collections of atoms, molecules, or macroscopic particles that interact via short- or long-range forces with a variety of initial and/or boundary conditions. For computational efficiency LAMMPS uses neighbor lists to keep track of nearby particles. The lists are optimized for systems with particles that are repulsive at short distances, so that the local density of particles never becomes too large. On parallel machines, LAMMPS uses spatial-decomposition techniques to partition the simulation domain into small 3d sub-domains, one of which is assigned to each processor. Processors communicate and store "ghost" atom information for atoms that border their sub-domain. LAMMPS is most efficient (in a parallel sense) for systems whose particles fill a 3d rectangular box with roughly uniform density. Papers with technical details of the algorithms used in LAMMPS are listed in "this section"_#1_5. :line 1.2 LAMMPS features :link(1_2),h4 This section highlights LAMMPS features, with pointers to specific commands which give more details. If LAMMPS doesn't have your favorite interatomic potential, boundary condition, or atom type, see "this section"_Section_modify.html, which describes how you can add it to LAMMPS. General features :h4 runs on a single processor or in parallel distributed-memory message-passing parallelism (MPI) spatial-decomposition of simulation domain for parallelism open-source distribution highly portable C++ optional libraries needed: MPI and single-processor FFT easy to extend with new features and functionality in parallel, run one or multiple simulations simultaneously runs from an input script syntax for defining and using variables and formulas syntax for looping over runs and breaking out of loops run a series of simluations from one script :ul Kinds of systems LAMMPS can simulate :h4 ("atom style"_atom_style.html command) atomic (e.g. box of Lennard-Jonesium) bead-spring polymers united-atom polymers or organic molecules all-atom polymers, organic molecules, proteins, DNA metals granular materials coarse-grained mesoscale models ellipsoidal particles point dipolar particles hybrid combinations of these :ul Force fields :h4 ("pair style"_pair_style.html, "bond style"_bond_style.html, "angle style"_angle_style.html, "dihedral style"_dihedral_style.html, "improper style"_improper_style.html, "kspace style"_kspace_style.html commands) pairwise potentials: Lennard-Jones, Buckingham, Morse, \ Yukawa, soft, class 2 (COMPASS), tabulated charged pairwise potentials: Coulombic, point-dipole manybody potentials: EAM, Finnis/Sinclair EAM, modified EAM (MEAM), \ Stillinger-Weber, Tersoff, AI-REBO, ReaxFF coarse-grain potentials: DPD, GayBerne, REsquared, colloidal mesoscopic potentials: granular, Peridynamics bond potentials: harmonic, FENE, Morse, nonlinear, class 2, \ quartic (breakable) angle potentials: harmonic, CHARMM, cosine, cosine/squared, \ class 2 (COMPASS) dihedral potentials: harmonic, CHARMM, multi-harmonic, helix, \ class 2 (COMPASS), OPLS improper potentials: harmonic, cvff, class 2 (COMPASS) hybrid potentials: multiple pair, bond, angle, dihedral, improper \ potentials can be used in one simulation overlaid potentials: superposition of multiple pair potentials polymer potentials: all-atom, united-atom, bead-spring, breakable water potentials: TIP3P, TIP4P, SPC implicit solvent potentials: hydrodynamic lubrication, Debye long-range Coulombics and dispersion: Ewald, \ PPPM (similar to particle-mesh Ewald), Ewald/N for long-range Lennard-Jones force-field compatibility with common CHARMM, AMBER, OPLS, GROMACS options :ul Creation of atoms :h4 ("read_data"_read_data.html, "lattice"_lattice.html, "create_atoms"_create_atoms.html, "delete_atoms"_delete_atoms.html, "displace_atoms"_displace_atoms.html commands) read in atom coords from files create atoms on one or more lattices (e.g. grain boundaries) delete geometric or logical groups of atoms (e.g. voids) displace atoms :ul Ensembles, constraints, and boundary conditions :h4 ("fix"_fix.html command) 2d or 3d systems orthogonal or non-orthogonal (triclinic symmetry) simulation domains constant NVE, NVT, NPT, NPH integrators thermostatting options for groups and geometric regions of atoms pressure control via Nose/Hoover or Berendsen barostatting in 1 to 3 dimensions simulation box deformation (tensile and shear) harmonic (umbrella) constraint forces independent or coupled rigid body integration SHAKE bond and angle constraints bond breaking, formation, swapping walls of various kinds targeted molecular dynamics (TMD) and steered molecule dynamics (SMD) constraints non-equilibrium molecular dynamics (NEMD) variety of additional boundary conditions and constraints :ul Integrators :h4 ("run"_run.html, "run_style"_run_style.html, "temper"_temper.html commands) velocity-Verlet integrator Brownian dynamics energy minimization via conjugate gradient or steepest descent relaxation rRESPA hierarchical timestepping parallel tempering (replica exchange) :ul -Diagnostics: h4 +Diagnostics :h4 ("fix"_fix.html command, "compute"_compute.html command) - see the various flavors of the fix and compute commands + see the various flavors of the fix and compute commands :ul Output :h4 ("dump"_dump.html, "restart"_restart.html commands) log file of thermodynamic info text dump files of atom coords, velocities, other per-atom quantities binary restart files per-atom quantities (energy, stress, centro-symmetry parameter, CNA, etc) user-defined system-wide (log file) or per-atom (dump file) calculations spatial and time averaging of per-atom quantities time averaging of system-wide quantities atom snapshots in native, XYZ, XTC, DCD formats :ul Pre- and post-processing :h4 Our group has also written and released a separate toolkit called "Pizza.py"_pizza which provides tools for doing setup, analysis, plotting, and visualization for LAMMPS simulations. Pizza.py is written in "Python"_python and is available for download from "the Pizza.py WWW site"_pizza. :link(pizza,http://www.sandia.gov/~sjplimp/pizza.html) :link(python,http://www.python.org) :line 1.3 LAMMPS non-features :link(1_3),h4 LAMMPS is designed to efficiently compute Newton's equations of motion for a system of interacting particles. Many of the tools needed to pre- and post-process the data for such simulations are not included in the LAMMPS kernel for several reasons: the desire to keep LAMMPS simple they are not parallel operations other codes already do them limited development resources :ul Specifically, LAMMPS itself does not: run thru a GUI build molecular systems assign force-field coefficients automagically perform sophisticated analyses of your MD simulation visualize your MD simulation plot your output data :ul A few tools for pre- and post-processing tasks are provided as part of the LAMMPS package; they are described in "this section"_Section_tools.html. However, many people use other codes or write their own tools for these tasks. As noted above, our group has also written and released a separate toolkit called "Pizza.py"_pizza which addresses some of the listed bullets. It provides tools for doing setup, analysis, plotting, and visualization for LAMMPS simulations. Pizza.py is written in "Python"_python and is available for download from "the Pizza.py WWW site"_pizza. LAMMPS requires as input a list of initial atom coordinates and types, molecular topology information, and force-field coefficients assigned to all atoms and bonds. LAMMPS will not build molecular systems and assign force-field parameters for you. For atomic systems LAMMPS provides a "create_atoms"_create_atoms.html command which places atoms on solid-state lattices (fcc, bcc, user-defined, etc). Assigning small numbers of force field coefficients can be done via the "pair coeff"_pair_coeff.html, "bond coeff"_bond_coeff.html, "angle coeff"_angle_coeff.html, etc commands. For molecular systems or more complicated simulation geometries, users typically use another code as a builder and convert its output to LAMMPS input format, or write their own code to generate atom coordinate and molecular topology for LAMMPS to read in. For complicated molecular systems (e.g. a protein), a multitude of topology information and hundreds of force-field coefficients must typically be specified. We suggest you use a program like "CHARMM"_charmm or "AMBER"_amber or other molecular builders to setup such problems and dump its information to a file. You can then reformat the file as LAMMPS input. Some of the tools in "this section"_Section_tools.html can assist in this process. Similarly, LAMMPS creates output files in a simple format. Most users post-process these files with their own analysis tools or re-format them for input into other programs, including visualization packages. If you are convinced you need to compute something on-the-fly as LAMMPS runs, see "this section"_Section_modify.html for a discussion of how you can use the "dump"_dump.html and "compute"_compute.html and "fix"_fix.html commands to print out data of your choosing. Keep in mind that complicated computations can slow down the molecular dynamics timestepping, particularly if the computations are not parallel, so it is often better to leave such analysis to post-processing codes. A very simple (yet fast) visualizer is provided with the LAMMPS package - see the "xmovie"_Section_tools.html#xmovie tool in "this section"_Section_tools.html. It creates xyz projection views of atomic coordinates and animates them. We find it very useful for debugging purposes. For high-quality visualization we recommend the following packages: "VMD"_http://www.ks.uiuc.edu/Research/vmd "AtomEye"_http://164.107.79.177/Archive/Graphics/A "PyMol"_http://pymol.sourceforge.net "Raster3d"_http://www.bmsc.washington.edu/raster3d/raster3d.html "RasMol"_http://www.openrasmol.org :ul Other features that LAMMPS does not yet (and may never) support are discussed in "this section"_Section_history.html. Finally, these are freely-available molecular dynamics codes, most of them parallel, which may be well-suited to the problems you want to model. They can also be used in conjunction with LAMMPS to perform complementary modeling tasks. "CHARMM"_charmm "AMBER"_amber "NAMD"_namd "NWCHEM"_nwchem "DL_POLY"_dlpoly "Tinker"_tinker :ul :link(charmm,http://www.scripps.edu/brooks) :link(amber,http://amber.scripps.edu) :link(namd,http://www.ks.uiuc.edu/Research/namd/) :link(nwchem,http://www.emsl.pnl.gov/docs/nwchem/nwchem.html) :link(dlpoly,http://www.cse.clrc.ac.uk/msi/software/DL_POLY) :link(tinker,http://dasher.wustl.edu/tinker) CHARMM, AMBER, NAMD, NWCHEM, and Tinker are designed primarily for modeling biological molecules. CHARMM and AMBER use atom-decomposition (replicated-data) strategies for parallelism; NAMD and NWCHEM use spatial-decomposition approaches, similar to LAMMPS. Tinker is a serial code. DL_POLY includes potentials for a variety of biological and non-biological materials; both a replicated-data and spatial-decomposition version exist. :line 1.4 Open source distribution :link(1_4),h4 LAMMPS comes with no warranty of any kind. As each source file states in its header, it is a copyrighted code that is distributed free-of- charge, under the terms of the "GNU Public License"_gnu (GPL). This is often referred to as open-source distribution - see "www.gnu.org"_gnuorg or "www.opensource.org"_opensource for more details. The legal text of the GPL is in the LICENSE file that is included in the LAMMPS distribution. :link(gnuorg,http://www.gnu.org) :link(opensource,http://www.opensource.org) Here is a summary of what the GPL means for LAMMPS users: (1) Anyone is free to use, modify, or extend LAMMPS in any way they choose, including for commercial purposes. (2) If you distribute a modified version of LAMMPS, it must remain open-source, meaning you distribute it under the terms of the GPL. You should clearly annotate such a code as a derivative version of LAMMPS. (3) If you release any code that includes LAMMPS source code, then it must also be open-sourced, meaning you distribute it under the terms of the GPL. (4) If you give LAMMPS files to someone else, the GPL LICENSE file and source file headers (including the copyright and GPL notices) should remain part of the code. In the spirit of an open-source code, these are various ways you can contribute to making LAMMPS better. You can send email to the "developers"_http://lammps.sandia.gov/authors.html on any of these items. Point prospective users to the "LAMMPS WWW Site"_lws. Mention it in talks or link to it from your WWW site. :ulb,l If you find an error or omission in this manual or on the "LAMMPS WWW Site"_lws, or have a suggestion for something to clarify or include, send an email to the "developers"_http://lammps.sandia.gov/authors.html. :l If you find a bug, "this section"_Section_errors.html#9_2 describes how to report it. :l If you publish a paper using LAMMPS results, send the citation (and any cool pictures or movies if you like) to add to the Publications, Pictures, and Movies pages of the "LAMMPS WWW Site"_lws, with links and attributions back to you. :l Create a new Makefile.machine that can be added to the src/MAKE directory. :l The tools sub-directory of the LAMMPS distribution has various stand-alone codes for pre- and post-processing of LAMMPS data. More details are given in "this section"_Section_tools.html. If you write a new tool that users will find useful, it can be added to the LAMMPS distribution. :l LAMMPS is designed to be easy to extend with new code for features like potentials, boundary conditions, diagnostic computations, etc. "This section"_Section_modify.html gives details. If you add a feature of general interest, it can be added to the LAMMPS distribution. :l The Benchmark page of the "LAMMPS WWW Site"_lws lists LAMMPS performance on various platforms. The files needed to run the benchmarks are part of the LAMMPS distribution. If your machine is sufficiently different from those listed, your timing data can be added to the page. :l You can send feedback for the User Comments page of the "LAMMPS WWW Site"_lws. It might be added to the page. No promises. :l Cash. Small denominations, unmarked bills preferred. Paper sack OK. Leave on desk. VISA also accepted. Chocolate chip cookies encouraged. :ule,l :line 1.5 Acknowledgments and citations :h4,link(1_5) LAMMPS development has been funded by the "US Department of Energy"_doe (DOE), through its CRADA, LDRD, ASCI, and Genomes-to-Life programs and its "OASCR"_oascr and "OBER"_ober offices. Specifically, work on the latest version was funded in part by the US Department of Energy's Genomics:GTL program ("www.doegenomestolife.org"_gtl) under the "project"_ourgtl, "Carbon Sequestration in Synechococcus Sp.: From Molecular Machines to Hierarchical Modeling". :link(doe,http://www.doe.gov) :link(gtl,http://www.doegenomestolife.org) :link(ourgtl,http://www.genomes2life.org) :link(oascr,http://www.sc.doe.gov/ascr/home.html) :link(ober,http://www.er.doe.gov/production/ober/ober_top.html) The following papers describe the parallel algorithms used in LAMMPS. S. J. Plimpton, [Fast Parallel Algorithms for Short-Range Molecular Dynamics], J Comp Phys, 117, 1-19 (1995). S. J. Plimpton, R. Pollock, M. Stevens, [Particle-Mesh Ewald and rRESPA for Parallel Molecular Dynamics Simulations], in Proc of the Eighth SIAM Conference on Parallel Processing for Scientific Computing, Minneapolis, MN (March 1997). If you use LAMMPS results in your published work, please cite the J Comp Phys reference and include a pointer to the "LAMMPS WWW Site"_lws (http://lammps.sandia.gov). If you send is information about your publication, we'll be pleased to add it to the Publications page of the "LAMMPS WWW Site"_lws. Ditto for a picture or movie for the Pictures or Movies pages. The core group of LAMMPS developers is at Sandia National Labs. They include "Steve Plimpton"_sjp, Paul Crozier, and Aidan Thompson and can be contacted via email: sjplimp, pscrozi, athomps at sandia.gov. Here are various folks who have made significant contributions to features in LAMMPS. The most recent contributions are at the top of the list. :link(sjp,http://www.cs.sandia.gov/~sjplimp) compute heat/flux for Green-Kubo : Reese Jones (Sandia), Philip Howell (Siemens), Vikas Varsney (AFRL) region cone : Pim Schravendijk fix reax/bonds : Aidan Thompson (Sandia) pair born/coul/long : Ahmed Ismail (Sandia) fix ttm : Paul Crozier (Sandia) and Carolyn Phillips (U Michigan) fix box/relax : Aidan Thompson and David Olmsted (Sandia) ReaxFF potential : Aidan Thompson (Sandia) and Hansohl Cho (MIT) compute cna/atom : Wan Liang (Chinese Academy of Sciences) Tersoff/ZBL potential : Dave Farrell (Northwestern U) peridynamics : Mike Parks (Sandia) fix smd for steered MD : Axel Kohlmeyer (U Penn) GROMACS pair potentials : Mark Stevens (Sandia) lmp2vmd tool : Axel Kohlmeyer (U Penn) compute group/group : Naveen Michaud-Agrawal (Johns Hopkins U) CG-CMM user package for coarse-graining : Axel Kohlmeyer (U Penn) cosine/delta angle potential : Axel Kohlmeyer (U Penn) VIM editor add-ons for LAMMPS input scripts : Gerolf Ziegenhain pair lubricate : Randy Schunk (Sandia) compute ackland/atom : Gerolf Zeigenhain kspace_style ewald/n, pair_style lj/coul, pair_style buck/coul : \ Pieter in 't Veld (Sandia) AI-REBO bond-order potential : Ase Henry (MIT) making LAMMPS a true "object" that can be instantiated multiple times, \ e.g. as a library : Ben FrantzDale (RPI) pymol_asphere viz tool : Mike Brown (Sandia) NEMD SLLOD integration : Pieter in 't Veld (Sandia) tensile and shear deformations : Pieter in 't Veld (Sandia) GayBerne potential : Mike Brown (Sandia) ellipsoidal particles : Mike Brown (Sandia) colloid potentials : Pieter in 't Veld (Sandia) fix heat : Paul Crozier and Ed Webb (Sandia) neighbor multi and communicate multi : Pieter in 't Veld (Sandia) MATLAB post-processing scripts : Arun Subramaniyan (Purdue) triclinic (non-orthogonal) simulation domains : Pieter in 't Veld (Sandia) thermo_extract tool: Vikas Varshney (Wright Patterson AFB) fix ave/time and fix ave/spatial : Pieter in 't Veld (Sandia) MEAM potential : Greg Wagner (Sandia) optimized pair potentials for lj/cut, charmm/long, eam, morse : \ James Fischer (High Performance Technologies), \ David Richie and Vincent Natoli (Stone Ridge Technologies) fix wall/lj126 : Mark Stevens (Sandia) Stillinger-Weber and Tersoff potentials : Aidan Thompson and Xiaowang Zhou (Sandia) region prism : Pieter in 't Veld (Sandia) LJ tail corrections for energy/pressure : Paul Crozier (Sandia) fix momentum and recenter : Naveen Michaud-Agrawal (Johns Hopkins U) multi-letter variable names : Naveen Michaud-Agrawal (Johns Hopkins U) OPLS dihedral potential: Mark Stevens (Sandia) POEMS coupled rigid body integrator: Rudranarayan Mukherjee (RPI) faster pair hybrid potential: James Fischer \ (High Performance Technologies, Inc), Vincent Natoli and \ David Richie (Stone Ridge Technology) breakable bond quartic potential: Chris Lorenz and Mark Stevens (Sandia) DCD and XTC dump styles: Naveen Michaud-Agrawal (Johns Hopkins U) grain boundary orientation fix : Koenraad Janssens and David Olmsted (Sandia) lj/smooth pair potential : Craig Maloney (UCSB) radius-of-gyration spring fix : Naveen Michaud-Agrawal (Johns Hopkins U) and \ Paul Crozier (Sandia) self spring fix : Naveen Michaud-Agrawal (Johns Hopkins U) EAM CoAl and AlCu potentials : Kwang-Reoul Lee (KIST, Korea) cosine/squared angle potential : Naveen Michaud-Agrawal (Johns Hopkins U) helix dihedral potential : Naveen Michaud-Agrawal (Johns Hopkins U) and \ Mark Stevens (Sandia) Finnis/Sinclair EAM: Tim Lau (MIT) dissipative particle dynamics (DPD) potentials: Kurt Smith (U Pitt) and \ Frank van Swol (Sandia) TIP4P potential (4-site water): Ahmed Ismail and Amalie Frischknecht (Sandia) uniaxial strain fix: Carsten Svaneborg (Max Planck Institute) thermodynamics enhanced by fix quantities: Aidan Thompson (Sandia) compressed dump files: Erik Luijten (U Illinois) cylindrical indenter fix: Ravi Agrawal (Northwestern U) electric field fix: Christina Payne (Vanderbilt U) AMBER <-> LAMMPS tool: Keir Novik (Univ College London) and \ Vikas Varshney (U Akron) CHARMM <-> LAMMPS tool: Pieter in 't Veld and Paul Crozier (Sandia) Morse bond potential: Jeff Greathouse (Sandia) radial distribution functions: Paul Crozier & Jeff Greathouse (Sandia) force tables for long-range Coulombics: Paul Crozier (Sandia) targeted molecular dynamics (TMD): Paul Crozier (Sandia) and \ Christian Burisch (Bochum University, Germany) FFT support for SGI SCSL (Altix): Jim Shepherd (Ga Tech) lmp2cfg and lmp2traj tools: Ara Kooser, Jeff Greathouse, \ Andrey Kalinichev (Sandia) parallel tempering: Mark Sears (Sandia) embedded atom method (EAM) potential: Stephen Foiles (Sandia) multi-harmonic dihedral potential: Mathias Puetz (Sandia) granular force fields and BC: Leo Silbert & Gary Grest (Sandia) 2d Ewald/PPPM: Paul Crozier (Sandia) CHARMM force fields: Paul Crozier (Sandia) msi2lmp tool: Steve Lustig (Dupont), Mike Peachey & John Carpenter (Cray) HTFN energy minimizer: Todd Plantenga (Sandia) class 2 force fields: Eric Simon (Cray) NVT/NPT integrators: Mark Stevens (Sandia) rRESPA: Mark Stevens & Paul Crozier (Sandia) Ewald and PPPM solvers: Roy Pollock (LLNL) : :tb(s=:) Other CRADA partners involved in the design and testing of LAMMPS were John Carpenter (Mayo Clinic, formerly at Cray Research) Terry Stouch (Lexicon Pharmaceuticals, formerly at Bristol Myers Squibb) Steve Lustig (Dupont) Jim Belak (LLNL) :ul