diff --git a/doc/Section_commands.txt b/doc/Section_commands.txt
index b5bede8e7..90a4020af 100644
--- a/doc/Section_commands.txt
+++ b/doc/Section_commands.txt
@@ -1,1257 +1,1259 @@
 "Previous Section"_Section_start.html - "LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc - "Next Section"_Section_packages.html :c
 
 :link(lws,http://lammps.sandia.gov)
 :link(ld,Manual.html)
 :link(lc,Section_commands.html#comm)
 
 :line
 
 3. Commands :h3
 
 This section describes how a LAMMPS input script is formatted and the
 input script commands used to define a LAMMPS simulation.
 
 3.1 "LAMMPS input script"_#cmd_1
 3.2 "Parsing rules"_#cmd_2
 3.3 "Input script structure"_#cmd_3
 3.4 "Commands listed by category"_#cmd_4
 3.5 "Commands listed alphabetically"_#cmd_5 :all(b)
 
 :line
 :line
 
 3.1 LAMMPS input script :link(cmd_1),h4
 
 LAMMPS executes by reading commands from a input script (text file),
 one line at a time.  When the input script ends, LAMMPS exits.  Each
 command causes LAMMPS to take some action.  It may set an internal
 variable, read in a file, or run a simulation.  Most commands have
 default settings, which means you only need to use the command if you
 wish to change the default.
 
 In many cases, the ordering of commands in an input script is not
 important.  However the following rules apply:
 
 (1) LAMMPS does not read your entire input script and then perform a
 simulation with all the settings.  Rather, the input script is read
 one line at a time and each command takes effect when it is read.
 Thus this sequence of commands:
 
 timestep 0.5 
 run      100 
 run      100 :pre
 
 does something different than this sequence:
 
 run      100 
 timestep 0.5 
 run      100 :pre
 
 In the first case, the specified timestep (0.5 fmsec) is used for two
 simulations of 100 timesteps each.  In the 2nd case, the default
 timestep (1.0 fmsec) is used for the 1st 100 step simulation and a 0.5
 fmsec timestep is used for the 2nd one.
 
 (2) Some commands are only valid when they follow other commands.  For
 example you cannot set the temperature of a group of atoms until atoms
 have been defined and a group command is used to define which atoms
 belong to the group.
 
 (3) Sometimes command B will use values that can be set by command A.
 This means command A must precede command B in the input script if it
 is to have the desired effect.  For example, the
 "read_data"_read_data.html command initializes the system by setting
 up the simulation box and assigning atoms to processors.  If default
 values are not desired, the "processors"_processors.html and
 "boundary"_boundary.html commands need to be used before read_data to
 tell LAMMPS how to map processors to the simulation box.
 
 Many input script errors are detected by LAMMPS and an ERROR or
 WARNING message is printed.  "This section"_Section_errors.html gives
 more information on what errors mean.  The documentation for each
 command lists restrictions on how the command can be used.
 
 :line
 
 3.2 Parsing rules :link(cmd_2),h4
 
 Each non-blank line in the input script is treated as a command.
 LAMMPS commands are case sensitive.  Command names are lower-case, as
 are specified command arguments.  Upper case letters may be used in
 file names or user-chosen ID strings.
 
 Here is how each line in the input script is parsed by LAMMPS:
 
 (1) If the last printable character on the line is a "&" character
 (with no surrounding quotes), the command is assumed to continue on
 the next line.  The next line is concatenated to the previous line by
 removing the "&" character and newline.  This allows long commands to
 be continued across two or more lines.
 
 (2) All characters from the first "#" character onward are treated as
 comment and discarded.  See an exception in (6).  Note that a
 comment after a trailing "&" character will prevent the command from
 continuing on the next line.  Also note that for multi-line commands a
 single leading "#" will comment out the entire command.
 
 (3) The line is searched repeatedly for $ characters, which indicate
 variables that are replaced with a text string.  See an exception in
 (6).  
 
 If the $ is followed by curly brackets, then the variable name is the
 text inside the curly brackets.  If no curly brackets follow the $,
 then the variable name is the single character immediately following
 the $.  Thus $\{myTemp\} and $x refer to variable names "myTemp" and
 "x".
 
 How the variable is converted to a text string depends on what style
 of variable it is; see the "variable"_variable doc page for details.
 It can be a variable that stores multiple text strings, and return one
 of them.  The returned text string can be multiple "words" (space
 separated) which will then be interpreted as multiple arguments in the
 input command.  The variable can also store a numeric formula which
 will be evaluated and its numeric result returned as a string.
 
 As a special case, if the $ is followed by parenthesis, then the text
 inside the parenthesis is treated as an "immediate" variable and
 evaluated as an "equal-style variable"_variable.html.  This is a way
 to use numeric formulas in an input script without having to assign
 them to variable names.  For example, these 3 input script lines:
 
 variable X equal (xlo+xhi)/2+sqrt(v_area)
 region 1 block $X 2 INF INF EDGE EDGE
 variable X delete :pre
 
 can be replaced by 
 
 region 1 block $((xlo+xhi)/2+sqrt(v_area)) 2 INF INF EDGE EDGE :pre
 
 so that you do not have to define (or discard) a temporary variable X.
 
 Note that neither the curly-bracket or immediate form of variables can
 contain nested $ characters for other variables to substitute for.
 Thus you cannot do this:
 
 variable        a equal 2
 variable        b2 equal 4
 print           "B2 = $\{b$a\}" :pre
 
 Nor can you specify this $($x-1.0) for an immediate variable, but
 you could use $(v_x-1.0), since the latter is valid syntax for an
 "equal-style variable"_variable.html.
 
 See the "variable"_variable.html command for more details of how
 strings are assigned to variables and evaluated, and how they can be
 used in input script commands.
 
 (4) The line is broken into "words" separated by whitespace (tabs,
 spaces).  Note that words can thus contain letters, digits,
 underscores, or punctuation characters.
 
 (5) The first word is the command name.  All successive words in the
 line are arguments.
 
 (6) If you want text with spaces to be treated as a single argument,
 it can be enclosed in either double or single quotes.  A long single
 argument enclosed in quotes can even span multiple lines if the "&"
 character is used, as described above.  E.g.
 
 print "Volume = $v"
 print 'Volume = $v'
 variable a string "red green blue &
                    purple orange cyan"
 if "${steps} > 1000" then quit :pre
 
 The quotes are removed when the single argument is stored internally.
 
 See the "dump modify format"_dump_modify.html or "print"_print.html or
 "if"_if.html commands for examples.  A "#" or "$" character that is
 between quotes will not be treated as a comment indicator in (2) or
 substituted for as a variable in (3). 
 
 IMPORTANT NOTE: If the argument is itself a command that requires a
 quoted argument (e.g. using a "print"_print.html command as part of an
 "if"_if.html or "run every"_run.html command), then the double and
 single quotes can be nested in the usual manner.  See the doc pages
 for those commands for examples.  Only one of level of nesting is
 allowed, but that should be sufficient for most use cases.
 
 :line
 
 3.3 Input script structure :h4,link(cmd_3)
 
 This section describes the structure of a typical LAMMPS input script.
 The "examples" directory in the LAMMPS distribution contains many
 sample input scripts; the corresponding problems are discussed in
 "Section_example"_Section_example.html, and animated on the "LAMMPS
 WWW Site"_lws.
 
 A LAMMPS input script typically has 4 parts:
 
 Initialization
 Atom definition
 Settings
 Run a simulation :ol
 
 The last 2 parts can be repeated as many times as desired.  I.e. run a
 simulation, change some settings, run some more, etc.  Each of the 4
 parts is now described in more detail.  Remember that almost all the
 commands need only be used if a non-default value is desired.
 
 (1) Initialization
 
 Set parameters that need to be defined before atoms are created or
 read-in from a file.
 
 The relevant commands are "units"_units.html,
 "dimension"_dimension.html, "newton"_newton.html,
 "processors"_processors.html, "boundary"_boundary.html,
 "atom_style"_atom_style.html, "atom_modify"_atom_modify.html.
 
 If force-field parameters appear in the files that will be read, these
 commands tell LAMMPS what kinds of force fields are being used:
 "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.
 
 (2) Atom definition
 
 There are 3 ways to define atoms in LAMMPS.  Read them in from a data
 or restart file via the "read_data"_read_data.html or
 "read_restart"_read_restart.html commands.  These files can contain
 molecular topology information.  Or create atoms on a lattice (with no
 molecular topology), using these commands: "lattice"_lattice.html,
 "region"_region.html, "create_box"_create_box.html,
 "create_atoms"_create_atoms.html.  The entire set of atoms can be
 duplicated to make a larger simulation using the
 "replicate"_replicate.html command.
 
 (3) Settings
 
 Once atoms and molecular topology are defined, a variety of settings
 can be specified: force field coefficients, simulation parameters,
 output options, etc.
 
 Force field coefficients are set by these commands (they can also be
 set in the read-in files): "pair_coeff"_pair_coeff.html,
 "bond_coeff"_bond_coeff.html, "angle_coeff"_angle_coeff.html,
 "dihedral_coeff"_dihedral_coeff.html,
 "improper_coeff"_improper_coeff.html,
 "kspace_style"_kspace_style.html, "dielectric"_dielectric.html,
 "special_bonds"_special_bonds.html.
 
 Various simulation parameters are set by these commands:
 "neighbor"_neighbor.html, "neigh_modify"_neigh_modify.html,
 "group"_group.html, "timestep"_timestep.html,
 "reset_timestep"_reset_timestep.html, "run_style"_run_style.html,
 "min_style"_min_style.html, "min_modify"_min_modify.html.
 
 Fixes impose a variety of boundary conditions, time integration, and
 diagnostic options.  The "fix"_fix.html command comes in many flavors.
 
 Various computations can be specified for execution during a
 simulation using the "compute"_compute.html,
 "compute_modify"_compute_modify.html, and "variable"_variable.html
 commands.
 
 Output options are set by the "thermo"_thermo.html, "dump"_dump.html,
 and "restart"_restart.html commands.
 
 (4) Run a simulation
 
 A molecular dynamics simulation is run using the "run"_run.html
 command.  Energy minimization (molecular statics) is performed using
 the "minimize"_minimize.html command.  A parallel tempering
 (replica-exchange) simulation can be run using the
 "temper"_temper.html command.
 
 :line
 
 3.4 Commands listed by category :link(cmd_4),h4
 
 This section lists all LAMMPS commands, grouped by category.  The
 "next section"_#cmd_5 lists the same commands alphabetically.  Note
 that some style options for some commands are part of specific LAMMPS
 packages, which means they cannot be used unless the package was
 included when LAMMPS was built.  Not all packages are included in a
 default LAMMPS build.  These dependencies are listed as Restrictions
 in the command's documentation.
 
 Initialization:
 
 "atom_modify"_atom_modify.html, "atom_style"_atom_style.html,
 "boundary"_boundary.html, "dimension"_dimension.html,
 "newton"_newton.html, "processors"_processors.html, "units"_units.html
 
 Atom definition:
 
 "create_atoms"_create_atoms.html, "create_box"_create_box.html,
 "lattice"_lattice.html, "read_data"_read_data.html,
 "read_dump"_read_dump.html, "read_restart"_read_restart.html,
 "region"_region.html, "replicate"_replicate.html
 
 Force fields:
 
 "angle_coeff"_angle_coeff.html, "angle_style"_angle_style.html,
 "bond_coeff"_bond_coeff.html, "bond_style"_bond_style.html,
 "dielectric"_dielectric.html, "dihedral_coeff"_dihedral_coeff.html,
 "dihedral_style"_dihedral_style.html,
 "improper_coeff"_improper_coeff.html,
 "improper_style"_improper_style.html,
 "kspace_modify"_kspace_modify.html, "kspace_style"_kspace_style.html,
 "pair_coeff"_pair_coeff.html, "pair_modify"_pair_modify.html,
 "pair_style"_pair_style.html, "pair_write"_pair_write.html,
 "special_bonds"_special_bonds.html
 
 Settings:
 
 "comm_style"_comm_style.html, "group"_group.html, "mass"_mass.html,
 "min_modify"_min_modify.html, "min_style"_min_style.html,
 "neigh_modify"_neigh_modify.html, "neighbor"_neighbor.html,
 "reset_timestep"_reset_timestep.html, "run_style"_run_style.html,
 "set"_set.html, "timestep"_timestep.html, "velocity"_velocity.html
 
 Fixes:
 
 "fix"_fix.html, "fix_modify"_fix_modify.html, "unfix"_unfix.html
 
 Computes:
 
 "compute"_compute.html, "compute_modify"_compute_modify.html,
 "uncompute"_uncompute.html
 
 Output:
 
 "dump"_dump.html, "dump image"_dump_image.html,
 "dump_modify"_dump_modify.html, "dump movie"_dump_image.html,
 "restart"_restart.html, "thermo"_thermo.html,
 "thermo_modify"_thermo_modify.html, "thermo_style"_thermo_style.html,
 "undump"_undump.html, "write_data"_write_data.html,
 "write_dump"_write_dump.html, "write_restart"_write_restart.html
 
 Actions:
 
 "delete_atoms"_delete_atoms.html, "delete_bonds"_delete_bonds.html,
 "displace_atoms"_displace_atoms.html, "change_box"_change_box.html,
 "minimize"_minimize.html, "neb"_neb.html "prd"_prd.html,
 "rerun"_rerun.html, "run"_run.html, "temper"_temper.html
 
 Miscellaneous:
 
 "clear"_clear.html, "echo"_echo.html, "if"_if.html,
 "include"_include.html, "jump"_jump.html, "label"_label.html,
 "log"_log.html, "next"_next.html, "print"_print.html,
 "shell"_shell.html, "variable"_variable.html
 
 :line
 
 3.5 Individual commands :h4,link(cmd_5),link(comm)
 
 This section lists all LAMMPS commands alphabetically, with a separate
 listing below of styles within certain commands.  The "previous
 section"_#cmd_4 lists the same commands, grouped by category.  Note
 that some style options for some commands are part of specific LAMMPS
 packages, which means they cannot be used unless the package was
 included when LAMMPS was built.  Not all packages are included in a
 default LAMMPS build.  These dependencies are listed as Restrictions
 in the command's documentation.
 
 "angle_coeff"_angle_coeff.html,
 "angle_style"_angle_style.html,
 "atom_modify"_atom_modify.html,
 "atom_style"_atom_style.html,
 "balance"_balance.html,
 "bond_coeff"_bond_coeff.html,
 "bond_style"_bond_style.html,
 "boundary"_boundary.html,
 "box"_box.html,
 "change_box"_change_box.html,
 "clear"_clear.html,
 "comm_modify"_comm_modify.html,
 "comm_style"_comm_style.html,
 "compute"_compute.html,
 "compute_modify"_compute_modify.html,
 "create_atoms"_create_atoms.html,
 "create_box"_create_box.html,
 "delete_atoms"_delete_atoms.html,
 "delete_bonds"_delete_bonds.html,
 "dielectric"_dielectric.html,
 "dihedral_coeff"_dihedral_coeff.html,
 "dihedral_style"_dihedral_style.html,
 "dimension"_dimension.html,
 "displace_atoms"_displace_atoms.html,
 "dump"_dump.html,
 "dump image"_dump_image.html,
 "dump_modify"_dump_modify.html,
 "dump movie"_dump_image.html,
 "echo"_echo.html,
 "fix"_fix.html,
 "fix_modify"_fix_modify.html,
 "group"_group.html,
 "if"_if.html,
 "improper_coeff"_improper_coeff.html,
 "improper_style"_improper_style.html,
 "include"_include.html,
 "jump"_jump.html,
 "kspace_modify"_kspace_modify.html,
 "kspace_style"_kspace_style.html,
 "label"_label.html,
 "lattice"_lattice.html,
 "log"_log.html,
 "mass"_mass.html,
 "minimize"_minimize.html,
 "min_modify"_min_modify.html,
 "min_style"_min_style.html,
 "molecule"_molecule.html,
 "neb"_neb.html,
 "neigh_modify"_neigh_modify.html,
 "neighbor"_neighbor.html,
 "newton"_newton.html,
 "next"_next.html,
 "package"_package.html,
 "pair_coeff"_pair_coeff.html,
 "pair_modify"_pair_modify.html,
 "pair_style"_pair_style.html,
 "pair_write"_pair_write.html,
 "partition"_partition.html,
 "prd"_prd.html,
 "print"_print.html,
 "processors"_processors.html,
 "quit"_quit.html,
 "read_data"_read_data.html,
 "read_dump"_read_dump.html,
 "read_restart"_read_restart.html,
 "region"_region.html,
 "replicate"_replicate.html,
 "rerun"_rerun.html,
 "reset_timestep"_reset_timestep.html,
 "restart"_restart.html,
 "run"_run.html,
 "run_style"_run_style.html,
 "set"_set.html,
 "shell"_shell.html,
 "special_bonds"_special_bonds.html,
 "suffix"_suffix.html,
 "tad"_tad.html,
 "temper"_temper.html,
 "thermo"_thermo.html,
 "thermo_modify"_thermo_modify.html,
 "thermo_style"_thermo_style.html,
 "timestep"_timestep.html,
 "uncompute"_uncompute.html,
 "undump"_undump.html,
 "unfix"_unfix.html,
 "units"_units.html,
 "variable"_variable.html,
 "velocity"_velocity.html,
 "write_data"_write_data.html,
 "write_dump"_write_dump.html,
 "write_restart"_write_restart.html :tb(c=6,ea=c)
 
 These are commands contributed by users, which can be used if "LAMMPS
 is built with the appropriate package"_Section_start.html#start_3.
 
 "group2ndx"_group2ndx.html :tb(c=1,ea=c)
 
 :line
 
 Fix styles :h4
 
 See the "fix"_fix.html command for one-line descriptions
 of each style or click on the style itself for a full description:
 
 "adapt"_fix_adapt.html,
 "addforce"_fix_addforce.html,
 "append/atoms"_fix_append_atoms.html,
 "aveforce"_fix_aveforce.html,
 "ave/atom"_fix_ave_atom.html,
 "ave/correlate"_fix_ave_correlate.html,
 "ave/histo"_fix_ave_histo.html,
 "ave/spatial"_fix_ave_spatial.html,
 "ave/time"_fix_ave_time.html,
 "balance"_fix_balance.html,
 "bond/break"_fix_bond_break.html,
 "bond/create"_fix_bond_create.html,
 "bond/swap"_fix_bond_swap.html,
 "box/relax"_fix_box_relax.html,
 "deform"_fix_deform.html,
 "deposit"_fix_deposit.html,
 "drag"_fix_drag.html,
 "dt/reset"_fix_dt_reset.html,
 "efield"_fix_efield.html,
 "enforce2d"_fix_enforce2d.html,
 "evaporate"_fix_evaporate.html,
 "external"_fix_external.html,
 "freeze"_fix_freeze.html,
 "gcmc"_fix_gcmc.html,
 "gld"_fix_gld.html,
 "gravity"_fix_gravity.html,
 "heat"_fix_heat.html,
 "indent"_fix_indent.html,
 "langevin"_fix_langevin.html,
 "lineforce"_fix_lineforce.html,
 "momentum"_fix_momentum.html,
 "move"_fix_move.html,
 "msst"_fix_msst.html,
 "neb"_fix_neb.html,
 "nph"_fix_nh.html,
 "nphug"_fix_nphug.html,
 "nph/asphere"_fix_nph_asphere.html,
 "nph/sphere"_fix_nph_sphere.html,
 "npt"_fix_nh.html,
 "npt/asphere"_fix_npt_asphere.html,
 "npt/sphere"_fix_npt_sphere.html,
 "nve"_fix_nve.html,
 "nve/asphere"_fix_nve_asphere.html,
 "nve/asphere/noforce"_fix_nve_asphere_noforce.html,
 "nve/body"_fix_nve_body.html,
 "nve/limit"_fix_nve_limit.html,
 "nve/line"_fix_nve_line.html,
 "nve/noforce"_fix_nve_noforce.html,
 "nve/sphere"_fix_nve_sphere.html,
 "nve/tri"_fix_nve_tri.html,
 "nvt"_fix_nh.html,
 "nvt/asphere"_fix_nvt_asphere.html,
 "nvt/sllod"_fix_nvt_sllod.html,
 "nvt/sphere"_fix_nvt_sphere.html,
 "oneway"_fix_oneway.html,
 "orient/fcc"_fix_orient_fcc.html,
 "planeforce"_fix_planeforce.html,
 "poems"_fix_poems.html,
 "pour"_fix_pour.html,
 "press/berendsen"_fix_press_berendsen.html,
 "print"_fix_print.html,
 "property/atom"_fix_property_atom.html,
 "qeq/comb"_fix_qeq_comb.html,
 "reax/bonds"_fix_reax_bonds.html,
 "recenter"_fix_recenter.html,
 "restrain"_fix_restrain.html,
 "rigid"_fix_rigid.html,
 "rigid/nph"_fix_rigid.html,
 "rigid/npt"_fix_rigid.html,
 "rigid/nve"_fix_rigid.html,
 "rigid/nvt"_fix_rigid.html,
 "rigid/small"_fix_rigid.html,
 "rigid/small/nph"_fix_rigid.html,
 "rigid/small/npt"_fix_rigid.html,
 "rigid/small/nve"_fix_rigid.html,
 "rigid/small/nvt"_fix_rigid.html,
 "setforce"_fix_setforce.html,
 "shake"_fix_shake.html,
 "spring"_fix_spring.html,
 "spring/rg"_fix_spring_rg.html,
 "spring/self"_fix_spring_self.html,
 "srd"_fix_srd.html,
 "store/force"_fix_store_force.html,
 "store/state"_fix_store_state.html,
 "temp/berendsen"_fix_temp_berendsen.html,
 "temp/csvr"_fix_temp_csvr.html,
 "temp/rescale"_fix_temp_rescale.html,
 "thermal/conductivity"_fix_thermal_conductivity.html,
 "tmd"_fix_tmd.html,
 "ttm"_fix_ttm.html,
 "tune/kspace"_fix_tune_kspace.html,
 "vector"_fix_vector.html,
 "viscosity"_fix_viscosity.html,
 "viscous"_fix_viscous.html,
 "wall/colloid"_fix_wall.html,
 "wall/gran"_fix_wall_gran.html,
 "wall/harmonic"_fix_wall.html,
 "wall/lj1043"_fix_wall.html,
 "wall/lj126"_fix_wall.html,
 "wall/lj93"_fix_wall.html,
 "wall/piston"_fix_wall_piston.html,
 "wall/reflect"_fix_wall_reflect.html,
 "wall/region"_fix_wall_region.html,
 "wall/srd"_fix_wall_srd.html :tb(c=8,ea=c)
 
 These are fix styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "adapt/fep"_fix_adapt_fep.html,
 "addtorque"_fix_addtorque.html,
 "atc"_fix_atc.html,
 "colvars"_fix_colvars.html,
+"gle"_fix_gle.html,
 "imd"_fix_imd.html,
+"ipi"_fix_ipi.html,
 "langevin/eff"_fix_langevin_eff.html,
 "lb/fluid"_fix_lb_fluid.html,
 "lb/momentum"_fix_lb_momentum.html,
 "lb/pc"_fix_lb_pc.html,
 "lb/rigid/pc/sphere"_fix_lb_rigid_pc_sphere.html,
 "lb/viscous"_fix_lb_viscous.html,
 "meso"_fix_meso.html,
 "meso/stationary"_fix_meso_stationary.html,
 "nph/eff"_fix_nh_eff.html,
 "npt/eff"_fix_nh_eff.html,
 "nve/eff"_fix_nve_eff.html,
 "nvt/eff"_fix_nh_eff.html,
 "nvt/sllod/eff"_fix_nvt_sllod_eff.html,
 "phonon"_fix_phonon.html,
 "qeq/reax"_fix_qeq_reax.html,
 "qmmm"_fix_qmmm.html,
 "reax/c/bonds"_fix_reax_bonds.html,
 "reax/c/species"_fix_reaxc_species.html,
 "smd"_fix_smd.html,
 "temp/rescale/eff"_fix_temp_rescale_eff.html,
 "ti/rs"_fix_ti_rs.html,
 "ti/spring"_fix_ti_spring.html :tb(c=6,ea=c)
 
 These are accelerated fix styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "freeze/cuda"_fix_freeze.html,
 "addforce/cuda"_fix_addforce.html,
 "aveforce/cuda"_fix_aveforce.html,
 "enforce2d/cuda"_fix_enforce2d.html,
 "gravity/cuda"_fix_gravity.html,
 "gravity/omp"_fix_gravity.html,
 "nph/omp"_fix_nh.html,
 "nphug/omp"_fix_nphug.html,
 "nph/asphere/omp"_fix_nph_asphere.html,
 "nph/sphere/omp"_fix_nph_sphere.html,
 "npt/cuda"_fix_nh.html,
 "npt/omp"_fix_nh.html,
 "npt/asphere/omp"_fix_npt_asphere.html,
 "npt/sphere/omp"_fix_npt_sphere.html,
 "nve/cuda"_fix_nve.html,
 "nve/kk"_fix_nve.html,
 "nve/omp"_fix_nve.html,
 "nve/sphere/omp"_fix_nve_sphere.html,
 "nvt/cuda"_fix_nh.html,
 "nvt/omp"_fix_nh.html,
 "nvt/asphere/omp"_fix_nvt_asphere.html,
 "nvt/sllod/omp"_fix_nvt_sllod.html,
 "nvt/sphere/omp"_fix_nvt_sphere.html,
 "qeq/comb/omp"_fix_qeq_comb.html,
 "rigid/omp"_fix_rigid.html,
 "rigid/nph/omp"_fix_rigid.html,
 "rigid/npt/omp"_fix_rigid.html,
 "rigid/nve/omp"_fix_rigid.html,
 "rigid/nvt/omp"_fix_rigid.html,
 "rigid/small/omp"_fix_rigid.html,
 "setforce/cuda"_fix_setforce.html,
 "shake/cuda"_fix_shake.html,
 "temp/berendsen/cuda"_fix_temp_berendsen.html,
 "temp/rescale/cuda"_fix_temp_rescale.html,
 "temp/rescale/limit/cuda"_fix_temp_rescale.html,
 "viscous/cuda"_fix_viscous.html :tb(c=6,ea=c)
 
 :line
 
 Compute styles :h4
 
 See the "compute"_compute.html command for one-line descriptions of
 each style or click on the style itself for a full description:
 
 "angle/local"_compute_angle_local.html,
 "atom/molecule"_compute_atom_molecule.html,
 "body/local"_compute_body_local.html,
 "bond/local"_compute_bond_local.html,
 "centro/atom"_compute_centro_atom.html,
 "cluster/atom"_compute_cluster_atom.html,
 "cna/atom"_compute_cna_atom.html,
 "com"_compute_com.html,
 "com/molecule"_compute_com_molecule.html,
 "contact/atom"_compute_contact_atom.html,
 "coord/atom"_compute_coord_atom.html,
 "damage/atom"_compute_damage_atom.html,
 "dihedral/local"_compute_dihedral_local.html,
 "dilatation/atom"_compute_dilatation_atom.html,
 "displace/atom"_compute_displace_atom.html,
 "erotate/asphere"_compute_erotate_asphere.html,
 "erotate/rigid"_compute_erotate_rigid.html,
 "erotate/sphere"_compute_erotate_sphere.html,
 "erotate/sphere/atom"_compute_erotate_sphere_atom.html,
 "event/displace"_compute_event_displace.html,
 "group/group"_compute_group_group.html,
 "gyration"_compute_gyration.html,
 "gyration/molecule"_compute_gyration_molecule.html,
 "heat/flux"_compute_heat_flux.html,
 "improper/local"_compute_improper_local.html,
 "inertia/molecule"_compute_inertia_molecule.html,
 "ke"_compute_ke.html,
 "ke/atom"_compute_ke_atom.html,
 "ke/rigid"_compute_ke_rigid.html,
 "msd"_compute_msd.html,
 "msd/molecule"_compute_msd_molecule.html,
 "msd/nongauss"_compute_msd_nongauss.html,
 "pair"_compute_pair.html,
 "pair/local"_compute_pair_local.html,
 "pe"_compute_pe.html,
 "pe/atom"_compute_pe_atom.html,
 "plasticity/atom"_compute_plasticity_atom.html,
 "pressure"_compute_pressure.html,
 "property/atom"_compute_property_atom.html,
 "property/local"_compute_property_local.html,
 "property/molecule"_compute_property_molecule.html,
 "rdf"_compute_rdf.html,
 "reduce"_compute_reduce.html,
 "reduce/region"_compute_reduce.html,
 "slice"_compute_slice.html,
 "stress/atom"_compute_stress_atom.html,
 "temp"_compute_temp.html,
 "temp/asphere"_compute_temp_asphere.html,
 "temp/com"_compute_temp_com.html,
 "temp/deform"_compute_temp_deform.html,
 "temp/partial"_compute_temp_partial.html,
 "temp/profile"_compute_temp_profile.html,
 "temp/ramp"_compute_temp_ramp.html,
 "temp/region"_compute_temp_region.html,
 "temp/sphere"_compute_temp_sphere.html,
 "ti"_compute_ti.html,
 "vacf"_compute_vacf.html,
 "voronoi/atom"_compute_voronoi_atom.html :tb(c=6,ea=c)
 
 These are compute styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "ackland/atom"_compute_ackland_atom.html,
 "basal/atom"_compute_basal_atom.html,
 "fep"_compute_fep.html,
 "ke/eff"_compute_ke_eff.html,
 "ke/atom/eff"_compute_ke_atom_eff.html,
 "meso_e/atom"_compute_meso_e_atom.html,
 "meso_rho/atom"_compute_meso_rho_atom.html,
 "meso_t/atom"_compute_meso_t_atom.html,
 "temp/eff"_compute_temp_eff.html,
 "temp/deform/eff"_compute_temp_deform_eff.html,
 "temp/region/eff"_compute_temp_region_eff.html,
 "temp/rotate"_compute_temp_rotate.html :tb(c=6,ea=c)
 
 These are accelerated compute styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "pe/cuda"_compute_pe.html,
 "pressure/cuda"_compute_pressure.html,
 "temp/cuda"_compute_temp.html,
 "temp/partial/cuda"_compute_temp_partial.html :tb(c=6,ea=c)
 
 :line
 
 Pair_style potentials :h4
 
 See the "pair_style"_pair_style.html command for an overview of pair
 potentials.  Click on the style itself for a full description:
 
 "none"_pair_none.html,
 "hybrid"_pair_hybrid.html,
 "hybrid/overlay"_pair_hybrid.html,
 "adp"_pair_adp.html,
 "airebo"_pair_airebo.html,
 "beck"_pair_beck.html,
 "body"_pair_body.html,
 "bop"_pair_bop.html,
 "born"_pair_born.html,
 "born/coul/long"_pair_born.html,
 "born/coul/msm"_pair_born.html,
 "born/coul/wolf"_pair_born.html,
 "brownian"_pair_brownian.html,
 "brownian/poly"_pair_brownian.html,
 "buck"_pair_buck.html,
 "buck/coul/cut"_pair_buck.html,
 "buck/coul/long"_pair_buck.html,
 "buck/coul/msm"_pair_buck.html,
 "buck/long/coul/long"_pair_buck_long.html,
 "colloid"_pair_colloid.html,
 "comb"_pair_comb.html,
 "comb3"_pair_comb.html,
 "coul/cut"_pair_coul.html,
 "coul/debye"_pair_coul.html,
 "coul/dsf"_pair_coul.html,
 "coul/long"_pair_coul.html,
 "coul/msm"_pair_coul.html,
 "coul/wolf"_pair_coul.html,
 "dpd"_pair_dpd.html,
 "dpd/tstat"_pair_dpd.html,
 "dsmc"_pair_dsmc.html,
 "eam"_pair_eam.html,
 "eam/alloy"_pair_eam.html,
 "eam/fs"_pair_eam.html,
 "eim"_pair_eim.html,
 "gauss"_pair_gauss.html,
 "gayberne"_pair_gayberne.html,
 "gran/hertz/history"_pair_gran.html,
 "gran/hooke"_pair_gran.html,
 "gran/hooke/history"_pair_gran.html,
 "hbond/dreiding/lj"_pair_hbond_dreiding.html,
 "hbond/dreiding/morse"_pair_hbond_dreiding.html,
 "kim"_pair_kim.html,
 "lcbop"_pair_lcbop.html,
 "line/lj"_pair_line_lj.html,
 "lj/charmm/coul/charmm"_pair_charmm.html,
 "lj/charmm/coul/charmm/implicit"_pair_charmm.html,
 "lj/charmm/coul/long"_pair_charmm.html,
 "lj/charmm/coul/msm"_pair_charmm.html,
 "lj/class2"_pair_class2.html,
 "lj/class2/coul/cut"_pair_class2.html,
 "lj/class2/coul/long"_pair_class2.html,
 "lj/cut"_pair_lj.html,
 "lj/cut/coul/cut"_pair_lj.html,
 "lj/cut/coul/debye"_pair_lj.html,
 "lj/cut/coul/dsf"_pair_lj.html,
 "lj/cut/coul/long"_pair_lj.html,
 "lj/cut/coul/msm"_pair_lj.html,
 "lj/cut/dipole/cut"_pair_dipole.html,
 "lj/cut/dipole/long"_pair_dipole.html,
 "lj/cut/tip4p/cut"_pair_lj.html,
 "lj/cut/tip4p/long"_pair_lj.html,
 "lj/expand"_pair_lj_expand.html,
 "lj/gromacs"_pair_gromacs.html,
 "lj/gromacs/coul/gromacs"_pair_gromacs.html,
 "lj/long/coul/long"_pair_lj_long.html,
 "lj/long/dipole/long"_pair_dipole.html,
 "lj/long/tip4p/long"_pair_lj_long.html,
 "lj/smooth"_pair_lj_smooth.html,
 "lj/smooth/linear"_pair_lj_smooth_linear.html,
 "lj96/cut"_pair_lj96.html,
 "lubricate"_pair_lubricate.html,
 "lubricate/poly"_pair_lubricate.html,
 "lubricateU"_pair_lubricateU.html,
 "lubricateU/poly"_pair_lubricateU.html,
 "meam"_pair_meam.html,
 "mie/cut"_pair_mie.html,
 "morse"_pair_morse.html,
 "nb3b/harmonic"_pair_nb3b_harmonic.html,
 "nm/cut"_pair_nm.html,
 "nm/cut/coul/cut"_pair_nm.html,
 "nm/cut/coul/long"_pair_nm.html,
 "peri/eps"_pair_peri.html,
 "peri/lps"_pair_peri.html,
 "peri/pmb"_pair_peri.html,
 "peri/ves"_pair_peri.html,
 "reax"_pair_reax.html,
 "rebo"_pair_airebo.html,
 "resquared"_pair_resquared.html,
 "soft"_pair_soft.html,
 "sw"_pair_sw.html,
 "table"_pair_table.html,
 "tersoff"_pair_tersoff.html,
 "tersoff/mod"_pair_tersoff_mod.html,
 "tersoff/zbl"_pair_tersoff_zbl.html,
 "tip4p/cut"_pair_coul.html,
 "tip4p/long"_pair_coul.html,
 "tri/lj"_pair_tri_lj.html,
 "yukawa"_pair_yukawa.html,
 "yukawa/colloid"_pair_yukawa_colloid.html,
 "zbl"_pair_zbl.html :tb(c=4,ea=c)
 
 These are pair styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "awpmd/cut"_pair_awpmd.html,
 "coul/cut/soft"_pair_lj_soft.html,
 "coul/diel"_pair_coul_diel.html,
 "coul/long/soft"_pair_lj_soft.html,
 "eam/cd"_pair_eam.html,
 "edip"_pair_edip.html,
 "eff/cut"_pair_eff.html,
 "gauss/cut"_pair_gauss.html,
 "list"_pair_list.html,
 "lj/cut/coul/cut/soft"_pair_lj_soft.html,
 "lj/cut/coul/long/soft"_pair_lj_soft.html,
 "lj/cut/dipole/sf"_pair_dipole.html,
 "lj/cut/soft"_pair_lj_soft.html,
 "lj/cut/tip4p/long/soft"_pair_lj_soft.html,
 "lj/sdk"_pair_sdk.html,
 "lj/sdk/coul/long"_pair_sdk.html,
 "lj/sdk/coul/msm"_pair_sdk.html,
 "lj/sf"_pair_lj_sf.html,
 "meam/spline"_pair_meam_spline.html,
 "meam/sw/spline"_pair_meam_sw_spline.html,
 "reax/c"_pair_reax_c.html,
 "sph/heatconduction"_pair_sph_heatconduction.html,
 "sph/idealgas"_pair_sph_idealgas.html,
 "sph/lj"_pair_sph_lj.html,
 "sph/rhosum"_pair_sph_rhosum.html,
 "sph/taitwater"_pair_sph_taitwater.html,
 "sph/taitwater/morris"_pair_sph_taitwater_morris.html,
 "tersoff/table"_pair_tersoff.html,
 "tip4p/long/soft"_pair_lj_soft.html :tb(c=4,ea=c)
 
 These are accelerated pair styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "adp/omp"_pair_adp.html,
 "airebo/omp"_pair_airebo.html,
 "beck/gpu"_pair_beck.html,
 "beck/omp"_pair_beck.html,
 "born/coul/long/cuda"_pair_born.html,
 "born/coul/long/gpu"_pair_born.html,
 "born/coul/long/omp"_pair_born.html,
 "born/coul/msm/omp"_pair_born.html,
 "born/coul/wolf/gpu"_pair_born.html,
 "born/coul/wolf/omp"_pair_born.html,
 "born/gpu"_pair_born.html,
 "born/omp"_pair_born.html,
 "brownian/omp"_pair_brownian.html,
 "brownian/poly/omp"_pair_brownian.html,
 "buck/coul/cut/cuda"_pair_buck.html,
 "buck/coul/cut/gpu"_pair_buck.html,
 "buck/coul/cut/omp"_pair_buck.html,
 "buck/coul/long/cuda"_pair_buck.html,
 "buck/coul/long/gpu"_pair_buck.html,
 "buck/coul/long/omp"_pair_buck.html,
 "buck/coul/msm/omp"_pair_buck.html,
 "buck/cuda"_pair_buck.html,
 "buck/long/coul/long/omp"_pair_buck_long.html,
 "buck/gpu"_pair_buck.html,
 "buck/omp"_pair_buck.html,
 "colloid/gpu"_pair_colloid.html,
 "colloid/omp"_pair_colloid.html,
 "comb/omp"_pair_comb.html,
 "coul/cut/gpu"_pair_coul.html,
 "coul/cut/omp"_pair_coul.html,
 "coul/cut/soft/omp"_pair_lj_soft.html,
 "coul/debye/gpu"_pair_coul.html,
 "coul/debye/omp"_pair_coul.html,
 "coul/diel/omp"_pair_diel.html,
 "coul/dsf/gpu"_pair_coul.html,
 "coul/dsf/omp"_pair_coul.html,
 "coul/long/gpu"_pair_coul.html,
 "coul/long/omp"_pair_coul.html,
 "coul/long/soft/omp"_pair_lj_soft.html,
 "coul/msm/omp"_pair_coul.html,
 "coul/wolf"_pair_coul.html,
 "coul/cut/soft/omp"_pair_lj_soft.html,
 "coul/long/soft/omp"_pair_lj_soft.html,
 "dpd/omp"_pair_dpd.html,
 "dpd/tstat/omp"_pair_dpd.html,
 "eam/alloy/cuda"_pair_eam.html,
 "eam/alloy/gpu"_pair_eam.html,
 "eam/alloy/omp"_pair_eam.html,
 "eam/alloy/opt"_pair_eam.html,
 "eam/cd/omp"_pair_eam.html,
 "eam/cuda"_pair_eam.html,
 "eam/fs/cuda"_pair_eam.html,
 "eam/fs/gpu"_pair_eam.html,
 "eam/fs/omp"_pair_eam.html,
 "eam/fs/opt"_pair_eam.html,
 "eam/gpu"_pair_eam.html,
 "eam/omp"_pair_eam.html,
 "eam/opt"_pair_eam.html,
 "edip/omp"_pair_edip.html,
 "eim/omp"_pair_eim.html,
 "gauss/gpu"_pair_gauss.html,
 "gauss/omp"_pair_gauss.html,
 "gayberne/gpu"_pair_gayberne.html,
 "gayberne/omp"_pair_gayberne.html,
 "gran/hertz/history/omp"_pair_gran.html,
 "gran/hooke/cuda"_pair_gran.html,
 "gran/hooke/history/omp"_pair_gran.html,
 "gran/hooke/omp"_pair_gran.html,
 "hbond/dreiding/lj/omp"_pair_hbond_dreiding.html,
 "hbond/dreiding/morse/omp"_pair_hbond_dreiding.html,
 "line/lj/omp"_pair_line_lj.html,
 "lj/charmm/coul/charmm/cuda"_pair_charmm.html,
 "lj/charmm/coul/charmm/omp"_pair_charmm.html,
 "lj/charmm/coul/charmm/implicit/cuda"_pair_charmm.html,
 "lj/charmm/coul/charmm/implicit/omp"_pair_charmm.html,
 "lj/charmm/coul/long/cuda"_pair_charmm.html,
 "lj/charmm/coul/long/gpu"_pair_charmm.html,
 "lj/charmm/coul/long/omp"_pair_charmm.html,
 "lj/charmm/coul/long/soft"_pair_lj_soft.html,
 "lj/charmm/coul/long/soft/omp"_pair_lj_soft.html,
 "lj/class2/coul/cut/cuda"_pair_class2.html,
 "lj/class2/coul/cut/omp"_pair_class2.html,
 "lj/class2/coul/long/cuda"_pair_class2.html,
 "lj/class2/coul/long/gpu"_pair_class2.html,
 "lj/class2/coul/long/omp"_pair_class2.html,
 "lj/class2/coul/msm/omp"_pair_class2.html,
 "lj/class2/cuda"_pair_class2.html,
 "lj/class2/gpu"_pair_class2.html,
 "lj/class2/omp"_pair_class2.html,
 "lj/long/coul/long/omp"_pair_lj_long.html,
 "lj/cut/coul/cut/cuda"_pair_lj.html,
 "lj/cut/coul/cut/gpu"_pair_lj.html,
 "lj/cut/coul/cut/omp"_pair_lj.html,
 "lj/cut/coul/cut/soft/omp"_pair_lj_soft.html,
 "lj/cut/coul/debye/cuda"_pair_lj.html,
 "lj/cut/coul/debye/gpu"_pair_lj.html,
 "lj/cut/coul/debye/omp"_pair_lj.html,
 "lj/cut/coul/dsf/gpu"_pair_lj.html,
 "lj/cut/coul/dsf/omp"_pair_lj.html,
 "lj/cut/coul/long/cuda"_pair_lj.html,
 "lj/cut/coul/long/gpu"_pair_lj.html,
 "lj/cut/coul/long/omp"_pair_lj.html,
 "lj/cut/coul/long/opt"_pair_lj.html,
 "lj/cut/coul/msm/gpu"_pair_lj.html,
 "lj/cut/coul/msm/opt"_pair_lj.html,
 "lj/cut/coul/long/soft/omp"_pair_lj_soft.html,
 "lj/cut/cuda"_pair_lj.html,
 "lj/cut/kk"_pair_lj.html,
 "lj/cut/dipole/cut/gpu"_pair_dipole.html,
 "lj/cut/dipole/cut/omp"_pair_dipole.html,
 "lj/cut/dipole/sf/gpu"_pair_dipole.html,
 "lj/cut/dipole/sf/omp"_pair_dipole.html,
 "lj/cut/experimental/cuda"_pair_lj.html,
 "lj/cut/gpu"_pair_lj.html,
 "lj/cut/omp"_pair_lj.html,
 "lj/cut/opt"_pair_lj.html,
 "lj/cut/soft/omp"_pair_lj_soft.html,
 "lj/cut/tip4p/cut/omp"_pair_lj.html,
 "lj/cut/tip4p/long/omp"_pair_lj.html,
 "lj/cut/tip4p/long/opt"_pair_lj.html,
 "lj/cut/tip4p/long/soft/omp"_pair_lj_soft.html,
 "lj/expand/cuda"_pair_lj_expand.html,
 "lj/expand/gpu"_pair_lj_expand.html,
 "lj/expand/omp"_pair_lj_expand.html,
 "lj/gromacs/coul/gromacs/cuda"_pair_gromacs.html,
 "lj/gromacs/coul/gromacs/omp"_pair_gromacs.html,
 "lj/gromacs/cuda"_pair_gromacs.html,
 "lj/gromacs/gpu"_pair_gromacs.html,
 "lj/gromacs/omp"_pair_gromacs.html,
 "lj/long/coul/long/opt"_pair_lj_long.html,
 "lj/sdk/gpu"_pair_sdk.html,
 "lj/sdk/omp"_pair_sdk.html,
 "lj/sdk/coul/long/gpu"_pair_sdk.html,
 "lj/sdk/coul/long/omp"_pair_sdk.html,
 "lj/sdk/coul/msm/omp"_pair_sdk.html,
 "lj/sf/omp"_pair_lj_sf.html,
 "lj/smooth/cuda"_pair_lj_smooth.html,
 "lj/smooth/omp"_pair_lj_smooth.html,
 "lj/smooth/linear/omp"_pair_lj_smooth_linear.html,
 "lj96/cut/cuda"_pair_lj96.html,
 "lj96/cut/gpu"_pair_lj96.html,
 "lj96/cut/omp"_pair_lj96.html,
 "lubricate/omp"_pair_lubricate.html,
 "lubricate/poly/omp"_pair_lubricate.html,
 "meam/spline/omp"_pair_meam_spline.html,
 "mie/cut/gpu"_pair_mie.html,
 "morse/cuda"_pair_morse.html,
 "morse/gpu"_pair_morse.html,
 "morse/omp"_pair_morse.html,
 "morse/opt"_pair_morse.html,
 "nb3b/harmonic/omp"_pair_nb3b_harmonic.html,
 "nm/cut/omp"_pair_nm.html,
 "nm/cut/coul/cut/omp"_pair_nm.html,
 "nm/cut/coul/long/omp"_pair_nm.html,
 "peri/lps/omp"_pair_peri.html,
 "peri/pmb/omp"_pair_peri.html,
 "rebo/omp"_pair_airebo.html,
 "resquared/gpu"_pair_resquared.html,
 "resquared/omp"_pair_resquared.html,
 "soft/gpu"_pair_soft.html,
 "soft/omp"_pair_soft.html,
 "sw/cuda"_pair_sw.html,
 "sw/gpu"_pair_sw.html,
 "sw/omp"_pair_sw.html,
 "table/gpu"_pair_table.html,
 "table/kk"_pair_table.html,
 "table/omp"_pair_table.html,
 "tersoff/cuda"_pair_tersoff.html,
 "tersoff/omp"_pair_tersoff.html,
 "tersoff/mod/omp"_pair_tersoff_mod.html,
 "tersoff/table/omp"_pair_tersoff.html,
 "tersoff/zbl/omp"_pair_tersoff_zbl.html,
 "tip4p/cut/omp"_pair_coul.html,
 "tip4p/long/omp"_pair_coul.html,
 "tip4p/long/soft/omp"_pair_lj_soft.html,
 "tri/lj/omp"_pair_tri_lj.html,
 "yukawa/gpu"_pair_yukawa.html,
 "yukawa/omp"_pair_yukawa.html,
 "yukawa/colloid/gpu"_pair_yukawa_colloid.html,
 "yukawa/colloid/omp"_pair_yukawa_colloid.html,
 "zbl/omp"_pair_zbl.html :tb(c=4,ea=c)
 
 :line
 
 Bond_style potentials :h4
 
 See the "bond_style"_bond_style.html command for an overview of bond
 potentials.  Click on the style itself for a full description:
 
 "none"_bond_none.html,
 "hybrid"_bond_hybrid.html,
 "class2"_bond_class2.html,
 "fene"_bond_fene.html,
 "fene/expand"_bond_fene_expand.html,
 "harmonic"_bond_harmonic.html,
 "morse"_bond_morse.html,
 "nonlinear"_bond_nonlinear.html,
 "quartic"_bond_quartic.html,
 "table"_bond_table.html :tb(c=4,ea=c,w=100)
 
 These are bond styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "harmonic/shift"_bond_harmonic_shift.html,
 "harmonic/shift/cut"_bond_harmonic_shift_cut.html :tb(c=4,ea=c)
 
 These are accelerated bond styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "class2/omp"_bond_class2.html,
 "fene/omp"_bond_fene.html,
 "fene/expand/omp"_bond_fene_expand.html,
 "harmonic/omp"_bond_harmonic.html,
 "harmonic/shift/omp"_bond_harmonic_shift.html,
 "harmonic/shift/cut/omp"_bond_harmonic_shift_cut.html,
 "morse/omp"_bond_morse.html,
 "nonlinear/omp"_bond_nonlinear.html,
 "quartic/omp"_bond_quartic.html,
 "table/omp"_bond_table.html :tb(c=4,ea=c,w=100)
 
 :line
 
 Angle_style potentials :h4
 
 See the "angle_style"_angle_style.html command for an overview of
 angle potentials.  Click on the style itself for a full description:
 
 "none"_angle_none.html,
 "hybrid"_angle_hybrid.html,
 "charmm"_angle_charmm.html,
 "class2"_angle_class2.html,
 "cosine"_angle_cosine.html,
 "cosine/delta"_angle_cosine_delta.html,
 "cosine/periodic"_angle_cosine_periodic.html,
 "cosine/squared"_angle_cosine_squared.html,
 "harmonic"_angle_harmonic.html,
 "table"_angle_table.html :tb(c=4,ea=c,w=100)
 
 These are angle styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "sdk"_angle_sdk.html,
 "cosine/shift"_angle_cosine_shift.html,
 "cosine/shift/exp"_angle_cosine_shift_exp.html,
 "dipole"_angle_dipole.html,
 "fourier"_angle_fourier.html,
 "fourier/simple"_angle_fourier_simple.html,
 "quartic"_angle_quartic.html :tb(c=4,ea=c)
 
 These are accelerated angle styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "charmm/omp"_angle_charmm.html,
 "class2/omp"_angle_class2.html,
 "cosine/omp"_angle_cosine.html,
 "cosine/delta/omp"_angle_cosine_delta.html,
 "cosine/periodic/omp"_angle_cosine_periodic.html,
 "cosine/shift/omp"_angle_cosine_shift.html,
 "cosine/shift/exp/omp"_angle_cosine_shift_exp.html,
 "cosine/squared/omp"_angle_cosine_squared.html,
 "dipole/omp"_angle_dipole.html
 "fourier/omp"_angle_fourier.html,
 "fourier/simple/omp"_angle_fourier_simple.html,
 "harmonic/omp"_angle_harmonic.html,
 "quartic/omp"_angle_quartic.html
 "table/omp"_angle_table.html :tb(c=4,ea=c,w=100)
 
 :line
 
 Dihedral_style potentials :h4
 
 See the "dihedral_style"_dihedral_style.html command for an overview
 of dihedral potentials.  Click on the style itself for a full
 description:
 
 "none"_dihedral_none.html,
 "hybrid"_dihedral_hybrid.html,
 "charmm"_dihedral_charmm.html,
 "class2"_dihedral_class2.html,
 "harmonic"_dihedral_harmonic.html,
 "helix"_dihedral_helix.html,
 "multi/harmonic"_dihedral_multi_harmonic.html,
 "opls"_dihedral_opls.html :tb(c=4,ea=c,w=100)
 
 These are dihedral styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "cosine/shift/exp"_dihedral_cosine_shift_exp.html,
 "fourier"_dihedral_fourier.html,
 "nharmonic"_dihedral_nharmonic.html,
 "quadratic"_dihedral_quadratic.html,
 "table"_dihedral_table.html :tb(c=4,ea=c)
 
 These are accelerated dihedral styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "charmm/omp"_dihedral_charmm.html,
 "class2/omp"_dihedral_class2.html,
 "cosine/shift/exp/omp"_dihedral_cosine_shift_exp.html,
 "fourier/omp"_dihedral_fourier.html,
 "harmonic/omp"_dihedral_harmonic.html,
 "helix/omp"_dihedral_helix.html,
 "multi/harmonic/omp"_dihedral_multi_harmonic.html,
 "nharmonic/omp"_dihedral_nharmonic.html,
 "opls/omp"_dihedral_opls.html
 "quadratic/omp"_dihedral_quadratic.html,
 "table/omp"_dihedral_table.html :tb(c=4,ea=c,w=100)
 
 :line
 
 Improper_style potentials :h4
 
 See the "improper_style"_improper_style.html command for an overview
 of improper potentials.  Click on the style itself for a full
 description:
 
 "none"_improper_none.html,
 "hybrid"_improper_hybrid.html,
 "class2"_improper_class2.html,
 "cvff"_improper_cvff.html,
 "harmonic"_improper_harmonic.html,
 "umbrella"_improper_umbrella.html :tb(c=4,ea=c,w=100)
 
 These are improper styles contributed by users, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "cossq"_improper_cossq.html,
 "fourier"_improper_fourier.html,
 "ring"_improper_ring.html :tb(c=4,ea=c)
 
 These are accelerated improper styles, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "class2/omp"_improper_class2.html,
 "cossq/omp"_improper_cossq.html,
 "cvff/omp"_improper_cvff.html,
 "fourier/omp"_improper_fourier.html,
 "harmonic/omp"_improper_harmonic.html,
 "ring/omp"_improper_ring.html,
 "umbrella/omp"_improper_umbrella.html :tb(c=4,ea=c,w=100)
 
 :line
 
 Kspace solvers :h4
 
 See the "kspace_style"_kspace_style.html command for an overview of
 Kspace solvers.  Click on the style itself for a full description:
 
 "ewald"_kspace_style.html,
 "ewald/disp"_kspace_style.html,
 "msm"_kspace_style.html,
 "msm/cg"_kspace_style.html,
 "pppm"_kspace_style.html,
 "pppm/cg"_kspace_style.html,
 "pppm/disp"_kspace_style.html,
 "pppm/disp/tip4p"_kspace_style.html,
 "pppm/tip4p"_kspace_style.html :tb(c=4,ea=c,w=100)
 
 These are accelerated Kspace solvers, which can be used if LAMMPS is
 built with the "appropriate accelerated
 package"_Section_accelerate.html.
 
 "ewald/omp"_kspace_style.html,
 "msm/omp"_kspace_style.html,
 "msm/cg/omp"_kspace_style.html,
 "pppm/cuda"_kspace_style.html,
 "pppm/gpu"_kspace_style.html,
 "pppm/omp"_kspace_style.html,
 "pppm/cg/omp"_kspace_style.html,
 "pppm/tip4p/omp"_kspace_style.html :tb(c=4,ea=c)
diff --git a/doc/Section_intro.txt b/doc/Section_intro.txt
index f67f0c182..d992008ab 100644
--- a/doc/Section_intro.txt
+++ b/doc/Section_intro.txt
@@ -1,533 +1,534 @@
 "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
 
 This section provides an overview of what LAMMPS can and can't do,
 describes what it means for LAMMPS to be an open-source code, and
 acknowledges the funding and people who have contributed to LAMMPS
 over the years.
 
 1.1 "What is LAMMPS"_#intro_1
 1.2 "LAMMPS features"_#intro_2
 1.3 "LAMMPS non-features"_#intro_3
 1.4 "Open source distribution"_#intro_4
 1.5 "Acknowledgments and citations"_#intro_5 :all(b)
 
 :line
 :line
 
 1.1 What is LAMMPS :link(intro_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 "Section_perf"_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"_#intro_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 "Section_modify"_Section_modify.html
 for more details.
 
 The current version of LAMMPS is written in C++.  Earlier versions
 were written in F77 and F90.  See
 "Section_history"_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"_#intro_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"_#intro_5.
 
 :line
 
 1.2 LAMMPS features :link(intro_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
 "Section_modify"_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 used: MPI and single-processor FFT
   GPU (CUDA and OpenCL) and OpenMP support for many code features
   easy to extend with new features and functionality
   runs from an input script
   syntax for defining and using variables and formulas
   syntax for looping over runs and breaking out of loops
   run one or multiple simulations simultaneously (in parallel) from one script
   build as library, invoke LAMMPS thru library interface or provided Python wrapper
   couple with other codes: LAMMPS calls other code, other code calls LAMMPS, umbrella code calls both :ul
 
 Particle and model types :h4
 ("atom style"_atom_style.html command)
 
   atoms
   coarse-grained particles (e.g. bead-spring polymers)
   united-atom polymers or organic molecules
   all-atom polymers, organic molecules, proteins, DNA
   metals
   granular materials
   coarse-grained mesoscale models
   finite-size spherical and ellipsoidal particles
   finite-size  line segment (2d) and triangle (3d) particles
   point dipole particles
   rigid collections of 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, Born-Mayer-Huggins, \
     Yukawa, soft, class 2 (COMPASS), hydrogen bond, tabulated
   charged pairwise potentials: Coulombic, point-dipole
   manybody potentials: EAM, Finnis/Sinclair EAM, modified EAM (MEAM), \
     embedded ion method (EIM), EDIP, ADP, Stillinger-Weber, Tersoff, \
     REBO, AIREBO, ReaxFF, COMB
   electron force field (eFF, AWPMD)
   coarse-grained potentials: DPD, GayBerne, REsquared, colloidal, DLVO
   mesoscopic potentials: granular, Peridynamics, SPH
   bond potentials: harmonic, FENE, Morse, nonlinear, class 2, \
     quartic (breakable)
   angle potentials: harmonic, CHARMM, cosine, cosine/squared, cosine/periodic, \
     class 2 (COMPASS)
   dihedral potentials: harmonic, CHARMM, multi-harmonic, helix, \
     class 2 (COMPASS), OPLS
   improper potentials: harmonic, cvff, umbrella, class 2 (COMPASS)
   polymer potentials: all-atom, united-atom, bead-spring, breakable
   water potentials: TIP3P, TIP4P, SPC
   implicit solvent potentials: hydrodynamic lubrication, Debye
   "KIM archive"_http://openkim.org of potentials
   long-range interactions for charge, point-dipoles, and LJ dispersion: \
     Ewald, Wolf, PPPM (similar to particle-mesh Ewald)
   force-field compatibility with common CHARMM, AMBER, DREIDING, \
     OPLS, GROMACS, COMPASS options
   handful of GPU-enabled pair styles
   hybrid potentials: multiple pair, bond, angle, dihedral, improper \
     potentials can be used in one simulation
   overlaid potentials: superposition of multiple pair potentials :ul
 
 Atom creation :h4
 ("read_data"_read_data.html, "lattice"_lattice.html,
 "create_atoms"_create_atoms.html, "delete_atoms"_delete_atoms.html,
 "displace_atoms"_displace_atoms.html, "replicate"_replicate.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)
   replicate existing atoms multiple times
   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, Parinello/Rahman 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
   rigid body constraints
   SHAKE bond and angle constraints
   bond breaking, formation, swapping
   walls of various kinds
   non-equilibrium molecular dynamics (NEMD)
   variety of additional boundary conditions and constraints :ul
 
 Integrators :h4
 ("run"_run.html, "run_style"_run_style.html, "minimize"_minimize.html commands) 
 
   velocity-Verlet integrator
   Brownian dynamics
   rigid body integration
   energy minimization via conjugate gradient or steepest descent relaxation
   rRESPA hierarchical timestepping
   rerun command for post-processing of dump files :ul
 
 Diagnostics :h4
 
   see the various flavors of the "fix"_fix.html and "compute"_compute.html 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
   parallel I/O of dump and 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, CFG formats :ul
 
 Multi-replica models :h4
 
 "nudged elastic band"_neb.html
 "parallel replica dynamics"_prd.html
 "temperature accelerated dynamics"_tad.html
 "parallel tempering"_temper.html
 
 Pre- and post-processing :h4
 
 Various pre- and post-processing serial tools are packaged
 with LAMMPS; see these "doc pages"_Section_tools.html. :ulb,l
 
 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. :l,ule
 
 :link(pizza,http://www.sandia.gov/~sjplimp/pizza.html)
 :link(python,http://www.python.org)
 
 Specialized features :h4
 
 These are LAMMPS capabilities which you may not think of as typical
 molecular dynamics options:
 
 "static"_balance.html and "dynamic load-balancing"_fix_balance.html
 "generalized aspherical particles"_body.html
 "stochastic rotation dynamics (SRD)"_fix_srd.html
 "real-time visualization and interactive MD"_fix_imd.html
 "atom-to-continuum coupling"_fix_atc.html with finite elements
 coupled rigid body integration via the "POEMS"_fix_poems.html library
 "QM/MM coupling"_fix_qmmm.html
+"Path-Integral Molecular Dynamics"_fix_ipi.html
 "grand canonical Monte Carlo"_fix_gcmc.html insertions/deletions
 "Direct Simulation Monte Carlo"_pair_dsmc.html for low-density fluids
 "Peridynamics mesoscale modeling"_pair_peri.html
 "Lattice Boltzmann fluid"_fix_lb_fluid.html
 "targeted"_fix_tmd.html and "steered"_fix_smd.html molecular dynamics
 "two-temperature electron model"_fix_ttm.html :ul
 
 :line
 
 1.3 LAMMPS non-features :link(intro_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 "Section_modify"_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://mt.seas.upenn.edu/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 "Section_history"_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(intro_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, "Section_errors 2"_Section_errors.html#err_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 "Section_tools"_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(intro_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 paper describe the basic parallel algorithms used in
 LAMMPS.  If you use LAMMPS results in your published work, please cite
 this paper and include a pointer to the "LAMMPS WWW Site"_lws
 (http://lammps.sandia.gov):
 
 S. J. Plimpton, [Fast Parallel Algorithms for Short-Range Molecular
 Dynamics], J Comp Phys, 117, 1-19 (1995).
 
 Other papers describing specific algorithms used in LAMMPS are listed
 under the "Citing LAMMPS link"_http://lammps.sandia.gov/cite.html of
 the LAMMPS WWW page.
 
 The "Publications link"_http://lammps.sandia.gov/papers.html on the
 LAMMPS WWW page lists papers that have cited LAMMPS.  If your paper is
 not listed there for some reason, feel free to send us the info.  If
 the simulations in your paper produced cool pictures or animations,
 we'll be pleased to add them to the
 "Pictures"_http://lammps.sandia.gov/pictures.html or
 "Movies"_http://lammps.sandia.gov/movies.html pages of the LAMMPS WWW
 site.
 
 The core group of LAMMPS developers is at Sandia National Labs:
 
 Steve Plimpton, sjplimp at sandia.gov
 Aidan Thompson, athomps at sandia.gov
 Paul Crozier, pscrozi at sandia.gov :ul
 
 The following folks are responsible for significant contributions to
 the code, or other aspects of the LAMMPS development effort.  Many of
 the packages they have written are somewhat unique to LAMMPS and the
 code would not be as general-purpose as it is without their expertise
 and efforts.
 
 Axel Kohlmeyer (Temple U), akohlmey at gmail.com, SVN and Git repositories, indefatigable mail list responder, USER-CG-CMM and USER-OMP packages
 Roy Pollock (LLNL), Ewald and PPPM solvers
 Mike Brown (ORNL), brownw at ornl.gov, GPU package
 Greg Wagner (Sandia), gjwagne at sandia.gov, MEAM package for MEAM potential
 Mike Parks (Sandia), mlparks at sandia.gov, PERI package for Peridynamics
 Rudra Mukherjee (JPL), Rudranarayan.M.Mukherjee at jpl.nasa.gov, POEMS package for articulated rigid body motion
 Reese Jones (Sandia) and collaborators, rjones at sandia.gov, USER-ATC package for atom/continuum coupling
 Ilya Valuev (JIHT), valuev at physik.hu-berlin.de, USER-AWPMD package for wave-packet MD
 Christian Trott (U Tech Ilmenau), christian.trott at tu-ilmenau.de, USER-CUDA package
 Andres Jaramillo-Botero (Caltech), ajaramil at wag.caltech.edu, USER-EFF package for electron force field
 Christoph Kloss (JKU), Christoph.Kloss at jku.at, USER-LIGGGHTS package for granular models and granular/fluid coupling
 Metin Aktulga (LBL), hmaktulga at lbl.gov, USER-REAXC package for C version of ReaxFF
 Georg Gunzenmuller (EMI), georg.ganzenmueller at emi.fhg.de, USER-SPH package :ul
 
 As discussed in "Section_history"_Section_history.html, LAMMPS
 originated as a cooperative project between DOE labs and industrial
 partners. Folks involved in the design and testing of the original
 version of LAMMPS were the following:
 
 John Carpenter (Mayo Clinic, formerly at Cray Research)
 Terry Stouch (Lexicon Pharmaceuticals, formerly at Bristol Myers Squibb)
 Steve Lustig (Dupont)
 Jim Belak (LLNL) :ul