diff --git a/doc/src/Section_commands.txt b/doc/src/Section_commands.txt
index c36c961de..c6b799444 100644
--- a/doc/src/Section_commands.txt
+++ b/doc/src/Section_commands.txt
@@ -1,1215 +1,1216 @@
 "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,
 the command is assumed to continue on the next line.  The next line is
 concatenated to the previous line by removing the "&" character and
 line break.  This allows long commands to be continued across two or
 more lines.  See the discussion of triple quotes in (6) for how to
 continue a command across multiple line without using "&" characters.
 
 (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.html 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 single or double or triple quotes.  A
 long single argument enclosed in single or double quotes can span
 multiple lines if the "&" character is used, as described above.  When
 the lines are concatenated together (and the "&" characters and line
 breaks removed), the text will become a single line.  If you want
 multiple lines of an argument to retain their line breaks, the text
 can be enclosed in triple quotes, in which case "&" characters are not
 needed.  For example:
 
 print "Volume = $v"
 print 'Volume = $v'
 if "$\{steps\} > 1000" then quit
 variable a string "red green blue &
                    purple orange cyan"
 print """
 System volume = $v
 System temperature = $t
 """ :pre
 
 In each case, the single, double, or triple quotes are removed when
 the single argument they enclose is stored internally.
 
 See the "dump modify format"_dump_modify.html, "print"_print.html,
 "if"_if.html, and "python"_python.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).
 
 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 single, double, or
 triple 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 7"_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.  The
 next section also includes (long) lists of style options for entries
 that appear in the following categories as a single command (fix,
 compute, pair, etc).  Commands that are added by user packages are not
 included in these categories, but they are in the next section.
 
 Initialization:
 
 "newton"_newton.html,
 "package"_package.html,
 "processors"_processors.html,
 "suffix"_suffix.html,
 "units"_units.html
 
 Setup simulation box:
 
 "boundary"_boundary.html,
 "box"_box.html,
 "change_box"_change_box.html,
 "create_box"_create_box.html,
 "dimension"_dimension.html,
 "lattice"_lattice.html,
 "region"_region.html
 
 Setup atoms:
 
 "atom_modify"_atom_modify.html,
 "atom_style"_atom_style.html,
 "balance"_balance.html,
 "create_atoms"_create_atoms.html,
 "create_bonds"_create_bonds.html,
 "delete_atoms"_delete_atoms.html,
 "delete_bonds"_delete_bonds.html,
 "displace_atoms"_displace_atoms.html,
 "group"_group.html,
 "mass"_mass.html,
 "molecule"_molecule.html,
 "read_data"_read_data.html,
 "read_dump"_read_dump.html,
 "read_restart"_read_restart.html,
 "replicate"_replicate.html,
 "set"_set.html,
 "velocity"_velocity.html
 
 Force fields:
 
 "angle_coeff"_angle_coeff.html,
 "angle_style"_angle_style.html,
 "bond_coeff"_bond_coeff.html,
 "bond_style"_bond_style.html,
 "bond_write"_bond_write.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_modify"_comm_modify.html,
 "comm_style"_comm_style.html,
 "info"_info.html,
 "min_modify"_min_modify.html,
 "min_style"_min_style.html,
 "neigh_modify"_neigh_modify.html,
 "neighbor"_neighbor.html,
 "partition"_partition.html,
 "reset_timestep"_reset_timestep.html,
 "run_style"_run_style.html,
 "timer"_timer.html,
 "timestep"_timestep.html
 
 Operations within timestepping (fixes) and diagnositics (computes):
 
 "compute"_compute.html,
 "compute_modify"_compute_modify.html,
 "fix"_fix.html,
 "fix_modify"_fix_modify.html,
 "uncompute"_uncompute.html,
 "unfix"_unfix.html
 
 Output:
 
 "dump image"_dump_image.html,
 "dump movie"_dump_image.html,
 "dump"_dump.html,
 "dump_modify"_dump_modify.html,
 "restart"_restart.html,
 "thermo"_thermo.html,
 "thermo_modify"_thermo_modify.html,
 "thermo_style"_thermo_style.html,
 "undump"_undump.html,
 "write_coeff"_write_coeff.html,
 "write_data"_write_data.html,
 "write_dump"_write_dump.html,
 "write_restart"_write_restart.html
 
 Actions:
 
 "minimize"_minimize.html,
 "neb"_neb.html,
 "prd"_prd.html,
 "rerun"_rerun.html,
 "run"_run.html,
 "tad"_tad.html,
 "temper"_temper.html
 
 Input script control:
 
 "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,
 "python"_python.html,
 "quit"_quit.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,
 "bond_write"_bond_write.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_bonds"_create_bonds.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,
 "info"_info.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,
 "python"_python.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,
 "timer"_timer.html,
 "timestep"_timestep.html,
 "uncompute"_uncompute.html,
 "undump"_undump.html,
 "unfix"_unfix.html,
 "units"_units.html,
 "variable"_variable.html,
 "velocity"_velocity.html,
 "write_coeff"_write_coeff.html,
 "write_data"_write_data.html,
 "write_dump"_write_dump.html,
 "write_restart"_write_restart.html :tb(c=6,ea=c)
 
 These are additional commands in USER packages, which can be used if
 "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "dump custom/vtk"_dump_custom_vtk.html,
 "dump nc"_dump_nc.html,
 "dump nc/mpiio"_dump_nc.html,
 "group2ndx"_group2ndx.html,
 "ndx2group"_group2ndx.html,
 "temper/grem"_temper_grem.html :tb(c=3,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.  Some of the
 styles have accelerated versions, which can be used if LAMMPS is built
 with the "appropriate accelerated package"_Section_accelerate.html.
 This is indicated by additional letters in parenthesis: g = GPU, i =
 USER-INTEL, k = KOKKOS, o = USER-OMP, t = OPT.
 
 "adapt"_fix_adapt.html,
 "addforce"_fix_addforce.html,
 "append/atoms"_fix_append_atoms.html,
 "atom/swap"_fix_atom_swap.html,
 "aveforce"_fix_aveforce.html,
 "ave/atom"_fix_ave_atom.html,
 "ave/chunk"_fix_ave_chunk.html,
 "ave/correlate"_fix_ave_correlate.html,
 "ave/histo"_fix_ave_histo.html,
 "ave/histo/weight"_fix_ave_histo.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,
 "cmap"_fix_cmap.html,
 "controller"_fix_controller.html,
 "deform (k)"_fix_deform.html,
 "deposit"_fix_deposit.html,
 "drag"_fix_drag.html,
 "dt/reset"_fix_dt_reset.html,
 "efield"_fix_efield.html,
 "ehex"_fix_ehex.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 (o)"_fix_gravity.html,
 "halt"_fix_halt.html,
 "heat"_fix_heat.html,
 "indent"_fix_indent.html,
 "langevin (k)"_fix_langevin.html,
 "lineforce"_fix_lineforce.html,
 "momentum (k)"_fix_momentum.html,
 "move"_fix_move.html,
 "mscg"_fix_mscg.html,
 "msst"_fix_msst.html,
 "neb"_fix_neb.html,
 "nph (ko)"_fix_nh.html,
 "nphug (o)"_fix_nphug.html,
 "nph/asphere (o)"_fix_nph_asphere.html,
 "nph/body"_fix_nph_body.html,
 "nph/sphere (o)"_fix_nph_sphere.html,
 "npt (kio)"_fix_nh.html,
 "npt/asphere (o)"_fix_npt_asphere.html,
 "npt/body"_fix_npt_body.html,
 "npt/sphere (o)"_fix_npt_sphere.html,
 "nve (kio)"_fix_nve.html,
 "nve/asphere (i)"_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 (o)"_fix_nve_sphere.html,
 "nve/tri"_fix_nve_tri.html,
 "nvt (iko)"_fix_nh.html,
 "nvt/asphere (o)"_fix_nvt_asphere.html,
 "nvt/body"_fix_nvt_body.html,
 "nvt/sllod (io)"_fix_nvt_sllod.html,
 "nvt/sphere (o)"_fix_nvt_sphere.html,
 "oneway"_fix_oneway.html,
 "orient/bcc"_fix_orient.html,
 "orient/fcc"_fix_orient.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 (o)"_fix_qeq_comb.html,
 "qeq/dynamic"_fix_qeq.html,
 "qeq/fire"_fix_qeq.html,
 "qeq/point"_fix_qeq.html,
 "qeq/shielded"_fix_qeq.html,
 "qeq/slater"_fix_qeq.html,
 "rattle"_fix_shake.html,
 "reax/bonds"_fix_reax_bonds.html,
 "recenter"_fix_recenter.html,
 "restrain"_fix_restrain.html,
 "rigid (o)"_fix_rigid.html,
 "rigid/nph (o)"_fix_rigid.html,
 "rigid/npt (o)"_fix_rigid.html,
 "rigid/nve (o)"_fix_rigid.html,
 "rigid/nvt (o)"_fix_rigid.html,
 "rigid/small (o)"_fix_rigid.html,
 "rigid/small/nph (o)"_fix_rigid.html,
 "rigid/small/npt (o)"_fix_rigid.html,
 "rigid/small/nve (o)"_fix_rigid.html,
 "rigid/small/nvt (o)"_fix_rigid.html,
 "setforce (k)"_fix_setforce.html,
 "shake"_fix_shake.html,
 "spring"_fix_spring.html,
 "spring/chunk"_fix_spring_chunk.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/csld"_fix_temp_csvr.html,
 "temp/csvr"_fix_temp_csvr.html,
 "temp/rescale"_fix_temp_rescale.html,
 "tfmc"_fix_tfmc.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/gran/region"_fix_wall_gran_region.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 (k)"_fix_wall_reflect.html,
 "wall/region"_fix_wall_region.html,
 "wall/srd"_fix_wall_srd.html :tb(c=8,ea=c)
 
 These are additional fix styles in USER packages, 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,
 "ave/correlate/long"_fix_ave_correlate_long.html,
 "colvars"_fix_colvars.html,
 "dpd/energy"_fix_dpd_energy.html,
 "drude"_fix_drude.html,
 "drude/transform/direct"_fix_drude_transform.html,
 "drude/transform/reverse"_fix_drude_transform.html,
 "eos/cv"_fix_eos_cv.html,
 "eos/table"_fix_eos_table.html,
 "eos/table/rx"_fix_eos_table_rx.html,
 "flow/gauss"_fix_flow_gauss.html,
 "gle"_fix_gle.html,
 "grem"_fix_grem.html,
 "imd"_fix_imd.html,
 "ipi"_fix_ipi.html,
 "langevin/drude"_fix_langevin_drude.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,
 "manifoldforce"_fix_manifoldforce.html,
 "meso/stationary"_fix_meso_stationary.html,
 "nve/dot"_fix_nve_dot.html,
 "nve/dotc/langevin"_fix_nve_dotc_langevin.html,
 "nve/manifold/rattle"_fix_nve_manifold_rattle.html,
 "nvk"_fix_nvk.html,
 "nvt/manifold/rattle"_fix_nvt_manifold_rattle.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,
 "pimd"_fix_pimd.html,
 "qbmsst"_fix_qbmsst.html,
 "qeq/reax"_fix_qeq_reax.html,
 "qmmm"_fix_qmmm.html,
 "qtb"_fix_qtb.html,
 "reax/c/bonds"_fix_reax_bonds.html,
 "reax/c/species"_fix_reaxc_species.html,
 "rx"_fix_rx.html,
 "saed/vtk"_fix_saed_vtk.html,
 "shardlow"_fix_shardlow.html,
 "smd"_fix_smd.html,
 "smd/adjust/dt"_fix_smd_adjust_dt.html,
 "smd/integrate/tlsph"_fix_smd_integrate_tlsph.html,
 "smd/integrate/ulsph"_fix_smd_integrate_ulsph.html,
 "smd/move/triangulated/surface"_fix_smd_move_triangulated_surface.html,
 "smd/setvel"_fix_smd_setvel.html,
 "smd/wall/surface"_fix_smd_wall_surface.html,
 "temp/rescale/eff"_fix_temp_rescale_eff.html,
 "ti/spring"_fix_ti_spring.html,
 "ttm/mod"_fix_ttm.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.  Some
 of the styles have accelerated versions, which can be used if LAMMPS
 is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k =
 KOKKOS, o = USER-OMP, t = OPT.
 
 "angle"_compute_angle.html,
 "angle/local"_compute_angle_local.html,
 "angmom/chunk"_compute_angmom_chunk.html,
 "body/local"_compute_body_local.html,
 "bond"_compute_bond.html,
 "bond/local"_compute_bond_local.html,
 "centro/atom"_compute_centro_atom.html,
 "chunk/atom"_compute_chunk_atom.html,
 "cluster/atom"_compute_cluster_atom.html,
 "cna/atom"_compute_cna_atom.html,
 "com"_compute_com.html,
 "com/chunk"_compute_com_chunk.html,
 "contact/atom"_compute_contact_atom.html,
 "coord/atom"_compute_coord_atom.html,
 "damage/atom"_compute_damage_atom.html,
 "dihedral"_compute_dihedral.html,
 "dihedral/local"_compute_dihedral_local.html,
 "dilatation/atom"_compute_dilatation_atom.html,
 "dipole/chunk"_compute_dipole_chunk.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,
 "global/atom"_compute_global_atom.html,
 "group/group"_compute_group_group.html,
 "gyration"_compute_gyration.html,
 "gyration/chunk"_compute_gyration_chunk.html,
 "heat/flux"_compute_heat_flux.html,
 "hexorder/atom"_compute_hexorder_atom.html,
 "improper"_compute_improper.html,
 "improper/local"_compute_improper_local.html,
 "inertia/chunk"_compute_inertia_chunk.html,
 "ke"_compute_ke.html,
 "ke/atom"_compute_ke_atom.html,
 "ke/rigid"_compute_ke_rigid.html,
 "msd"_compute_msd.html,
 "msd/chunk"_compute_msd_chunk.html,
 "msd/nongauss"_compute_msd_nongauss.html,
 "omega/chunk"_compute_omega_chunk.html,
 "orientorder/atom"_compute_orientorder_atom.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/chunk"_compute_property_chunk.html,
 "rdf"_compute_rdf.html,
 "reduce"_compute_reduce.html,
 "reduce/region"_compute_reduce.html,
 "rigid/local"_compute_rigid_local.html,
 "slice"_compute_slice.html,
 "sna/atom"_compute_sna_atom.html,
 "snad/atom"_compute_sna_atom.html,
 "snav/atom"_compute_sna_atom.html,
 "stress/atom"_compute_stress_atom.html,
 "temp (k)"_compute_temp.html,
 "temp/asphere"_compute_temp_asphere.html,
 "temp/body"_compute_temp_body.html,
 "temp/chunk"_compute_temp_chunk.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,
 "torque/chunk"_compute_torque_chunk.html,
 "vacf"_compute_vacf.html,
 "vcm/chunk"_compute_vcm_chunk.html,
 "voronoi/atom"_compute_voronoi_atom.html :tb(c=6,ea=c)
 
 These are additional compute styles in USER packages, 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,
 "dpd"_compute_dpd.html,
 "dpd/atom"_compute_dpd_atom.html,
 "fep"_compute_fep.html,
 "force/tally"_compute_tally.html,
 "heat/flux/tally"_compute_tally.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,
 "pe/tally"_compute_tally.html,
 "pe/mol/tally"_compute_tally.html,
 "saed"_compute_saed.html,
 "smd/contact/radius"_compute_smd_contact_radius.html,
 "smd/damage"_compute_smd_damage.html,
 "smd/hourglass/error"_compute_smd_hourglass_error.html,
 "smd/internal/energy"_compute_smd_internal_energy.html,
 "smd/plastic/strain"_compute_smd_plastic_strain.html,
 "smd/plastic/strain/rate"_compute_smd_plastic_strain_rate.html,
 "smd/rho"_compute_smd_rho.html,
 "smd/tlsph/defgrad"_compute_smd_tlsph_defgrad.html,
 "smd/tlsph/dt"_compute_smd_tlsph_dt.html,
 "smd/tlsph/num/neighs"_compute_smd_tlsph_num_neighs.html,
 "smd/tlsph/shape"_compute_smd_tlsph_shape.html,
 "smd/tlsph/strain"_compute_smd_tlsph_strain.html,
 "smd/tlsph/strain/rate"_compute_smd_tlsph_strain_rate.html,
 "smd/tlsph/stress"_compute_smd_tlsph_stress.html,
 "smd/triangle/mesh/vertices"_compute_smd_triangle_mesh_vertices.html,
 "smd/ulsph/num/neighs"_compute_smd_ulsph_num_neighs.html,
 "smd/ulsph/strain"_compute_smd_ulsph_strain.html,
 "smd/ulsph/strain/rate"_compute_smd_ulsph_strain_rate.html,
 "smd/ulsph/stress"_compute_smd_ulsph_stress.html,
 "smd/vol"_compute_smd_vol.html,
 "stress/tally"_compute_tally.html,
 "temp/drude"_compute_temp_drude.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,
 "xrd"_compute_xrd.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.  Many
 of the styles have accelerated versions, which can be used if LAMMPS
 is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k =
 KOKKOS, o = USER-OMP, t = OPT.
 
 "none"_pair_none.html,
 "zero"_pair_zero.html,
 "hybrid"_pair_hybrid.html,
 "hybrid/overlay"_pair_hybrid.html,
 "adp (o)"_pair_adp.html,
 "airebo (o)"_pair_airebo.html,
 "airebo/morse (o)"_pair_airebo.html,
 "beck (go)"_pair_beck.html,
 "body"_pair_body.html,
 "bop"_pair_bop.html,
 "born (go)"_pair_born.html,
 "born/coul/dsf"_pair_born.html,
 "born/coul/dsf/cs"_pair_born.html,
 "born/coul/long (go)"_pair_born.html,
 "born/coul/long/cs"_pair_born.html,
 "born/coul/msm (o)"_pair_born.html,
 "born/coul/wolf (go)"_pair_born.html,
 "brownian (o)"_pair_brownian.html,
 "brownian/poly (o)"_pair_brownian.html,
 "buck (gkio)"_pair_buck.html,
 "buck/coul/cut (gkio)"_pair_buck.html,
 "buck/coul/long (gkio)"_pair_buck.html,
 "buck/coul/long/cs"_pair_buck.html,
 "buck/coul/msm (o)"_pair_buck.html,
 "buck/long/coul/long (o)"_pair_buck_long.html,
 "colloid (go)"_pair_colloid.html,
 "comb (o)"_pair_comb.html,
 "comb3"_pair_comb.html,
 "coul/cut (gko)"_pair_coul.html,
 "coul/debye (gko)"_pair_coul.html,
 "coul/dsf (gko)"_pair_coul.html,
 "coul/long (gko)"_pair_coul.html,
 "coul/long/cs"_pair_coul.html,
 "coul/msm"_pair_coul.html,
 "coul/streitz"_pair_coul.html,
 "coul/wolf (ko)"_pair_coul.html,
 "dpd (go)"_pair_dpd.html,
 "dpd/tstat (go)"_pair_dpd.html,
 "dsmc"_pair_dsmc.html,
 "eam (gkiot)"_pair_eam.html,
 "eam/alloy (gkot)"_pair_eam.html,
 "eam/fs (gkot)"_pair_eam.html,
 "eim (o)"_pair_eim.html,
 "gauss (go)"_pair_gauss.html,
 "gayberne (gio)"_pair_gayberne.html,
 "gran/hertz/history (o)"_pair_gran.html,
 "gran/hooke (o)"_pair_gran.html,
 "gran/hooke/history (o)"_pair_gran.html,
 "hbond/dreiding/lj (o)"_pair_hbond_dreiding.html,
 "hbond/dreiding/morse (o)"_pair_hbond_dreiding.html,
 "kim"_pair_kim.html,
 "lcbop"_pair_lcbop.html,
 "line/lj"_pair_line_lj.html,
 "lj/charmm/coul/charmm (ko)"_pair_charmm.html,
 "lj/charmm/coul/charmm/implicit (ko)"_pair_charmm.html,
 "lj/charmm/coul/long (giko)"_pair_charmm.html,
 "lj/charmm/coul/msm"_pair_charmm.html,
 "lj/class2 (gko)"_pair_class2.html,
 "lj/class2/coul/cut (ko)"_pair_class2.html,
 "lj/class2/coul/long (gko)"_pair_class2.html,
 "lj/cubic (go)"_pair_lj_cubic.html,
 "lj/cut (gikot)"_pair_lj.html,
 "lj/cut/coul/cut (gko)"_pair_lj.html,
 "lj/cut/coul/debye (gko)"_pair_lj.html,
 "lj/cut/coul/dsf (gko)"_pair_lj.html,
 "lj/cut/coul/long (gikot)"_pair_lj.html,
 "lj/cut/coul/long/cs"_pair_lj.html,
 "lj/cut/coul/msm (go)"_pair_lj.html,
 "lj/cut/dipole/cut (go)"_pair_dipole.html,
 "lj/cut/dipole/long"_pair_dipole.html,
 "lj/cut/tip4p/cut (o)"_pair_lj.html,
 "lj/cut/tip4p/long (ot)"_pair_lj.html,
 "lj/expand (gko)"_pair_lj_expand.html,
 "lj/gromacs (gko)"_pair_gromacs.html,
 "lj/gromacs/coul/gromacs (ko)"_pair_gromacs.html,
 "lj/long/coul/long (o)"_pair_lj_long.html,
 "lj/long/dipole/long"_pair_dipole.html,
 "lj/long/tip4p/long"_pair_lj_long.html,
 "lj/smooth (o)"_pair_lj_smooth.html,
 "lj/smooth/linear (o)"_pair_lj_smooth_linear.html,
 "lj96/cut (go)"_pair_lj96.html,
 "lubricate (o)"_pair_lubricate.html,
 "lubricate/poly (o)"_pair_lubricate.html,
 "lubricateU"_pair_lubricateU.html,
 "lubricateU/poly"_pair_lubricateU.html,
 "meam"_pair_meam.html,
 "mie/cut (o)"_pair_mie.html,
 "morse (gkot)"_pair_morse.html,
 "nb3b/harmonic (o)"_pair_nb3b_harmonic.html,
 "nm/cut (o)"_pair_nm.html,
 "nm/cut/coul/cut (o)"_pair_nm.html,
 "nm/cut/coul/long (o)"_pair_nm.html,
 "peri/eps"_pair_peri.html,
 "peri/lps (o)"_pair_peri.html,
 "peri/pmb (o)"_pair_peri.html,
 "peri/ves"_pair_peri.html,
 "polymorphic"_pair_polymorphic.html,
 "reax"_pair_reax.html,
 "rebo (o)"_pair_airebo.html,
 "resquared (go)"_pair_resquared.html,
 "snap"_pair_snap.html,
 "soft (go)"_pair_soft.html,
 "sw (gkio)"_pair_sw.html,
 "table (gko)"_pair_table.html,
 "tersoff (gkio)"_pair_tersoff.html,
 "tersoff/mod (gko)"_pair_tersoff_mod.html,
 "tersoff/mod/c (o)"_pair_tersoff_mod.html,
 "tersoff/zbl (gko)"_pair_tersoff_zbl.html,
 "tip4p/cut (o)"_pair_coul.html,
 "tip4p/long (o)"_pair_coul.html,
 "tri/lj"_pair_tri_lj.html,
 "vashishta (ko)"_pair_vashishta.html,
 "vashishta/table (o)"_pair_vashishta.html,
 "yukawa (go)"_pair_yukawa.html,
 "yukawa/colloid (go)"_pair_yukawa_colloid.html,
 "zbl (go)"_pair_zbl.html :tb(c=4,ea=c)
 
 These are additional pair styles in USER packages, which can be used
 if "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "agni (o)"_pair_agni.html,
 "awpmd/cut"_pair_awpmd.html,
 "buck/mdf"_pair_mdf.html,
 "coul/cut/soft (o)"_pair_lj_soft.html,
 "coul/diel (o)"_pair_coul_diel.html,
 "coul/long/soft (o)"_pair_lj_soft.html,
 "dpd/fdt"_pair_dpd_fdt.html,
 "dpd/fdt/energy"_pair_dpd_fdt.html,
 "eam/cd (o)"_pair_eam.html,
 "edip (o)"_pair_edip.html,
 "eff/cut"_pair_eff.html,
 "exp6/rx"_pair_exp6_rx.html,
 "gauss/cut"_pair_gauss.html,
+"kolmogorov/crespi/z"_pair_kolmogorov_crespi_z.html,
 "lennard/mdf"_pair_mdf.html,
 "list"_pair_list.html,
 "lj/charmm/coul/long/soft (o)"_pair_charmm.html,
 "lj/cut/coul/cut/soft (o)"_pair_lj_soft.html,
 "lj/cut/coul/long/soft (o)"_pair_lj_soft.html,
 "lj/cut/dipole/sf (go)"_pair_dipole.html,
 "lj/cut/soft (o)"_pair_lj_soft.html,
 "lj/cut/thole/long (o)"_pair_thole.html,
 "lj/cut/tip4p/long/soft (o)"_pair_lj_soft.html,
 "lj/mdf"_pair_mdf.html,
 "lj/sdk (gko)"_pair_sdk.html,
 "lj/sdk/coul/long (go)"_pair_sdk.html,
 "lj/sdk/coul/msm (o)"_pair_sdk.html,
 "lj/sf (o)"_pair_lj_sf.html,
 "meam/spline (o)"_pair_meam_spline.html,
 "meam/sw/spline"_pair_meam_sw_spline.html,
 "mgpt"_pair_mgpt.html,
 "morse/smooth/linear"_pair_morse.html,
 "morse/soft"_pair_morse.html,
 "multi/lucy"_pair_multi_lucy.html,
 "multi/lucy/rx"_pair_multi_lucy_rx.html,
 "oxdna/coaxstk"_pair_oxdna.html,
 "oxdna/excv"_pair_oxdna.html,
 "oxdna/hbond"_pair_oxdna.html,
 "oxdna/stk"_pair_oxdna.html,
 "oxdna/xstk"_pair_oxdna.html,
 "quip"_pair_quip.html,
 "reax/c (k)"_pair_reax_c.html,
 "smd/hertz"_pair_smd_hertz.html,
 "smd/tlsph"_pair_smd_tlsph.html,
 "smd/triangulated/surface"_pair_smd_triangulated_surface.html,
 "smd/ulsph"_pair_smd_ulsph.html,
 "smtbq"_pair_smtbq.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,
 "srp"_pair_srp.html,
 "table/rx"_pair_table_rx.html,
 "tersoff/table (o)"_pair_tersoff.html,
 "thole"_pair_thole.html,
 "tip4p/long/soft (o)"_pair_lj_soft.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.  Some
 of the styles have accelerated versions, which can be used if LAMMPS
 is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k =
 KOKKOS, o = USER-OMP, t = OPT.
 
 "none"_bond_none.html,
 "zero"_bond_zero.html,
 "hybrid"_bond_hybrid.html,
 "class2 (ko)"_bond_class2.html,
 "fene (iko)"_bond_fene.html,
 "fene/expand (o)"_bond_fene_expand.html,
 "harmonic (ko)"_bond_harmonic.html,
 "morse (o)"_bond_morse.html,
 "nonlinear (o)"_bond_nonlinear.html,
 "quartic (o)"_bond_quartic.html,
 "table (o)"_bond_table.html :tb(c=4,ea=c)
 
 These are additional bond styles in USER packages, which can be used
 if "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "harmonic/shift (o)"_bond_harmonic_shift.html,
 "harmonic/shift/cut (o)"_bond_harmonic_shift_cut.html,
 "oxdna/fene"_bond_oxdna_fene.html :tb(c=4,ea=c)
 
 :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.
 Some of the styles have accelerated versions, which can be used if
 LAMMPS is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o =
 USER-OMP, t = OPT.
 
 "none"_angle_none.html,
 "zero"_angle_zero.html,
 "hybrid"_angle_hybrid.html,
 "charmm (ko)"_angle_charmm.html,
 "class2 (ko)"_angle_class2.html,
 "cosine (o)"_angle_cosine.html,
 "cosine/delta (o)"_angle_cosine_delta.html,
 "cosine/periodic (o)"_angle_cosine_periodic.html,
 "cosine/squared (o)"_angle_cosine_squared.html,
 "harmonic (iko)"_angle_harmonic.html,
 "table (o)"_angle_table.html :tb(c=4,ea=c)
 
 These are additional angle styles in USER packages, which can be used
 if "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "cosine/shift (o)"_angle_cosine_shift.html,
 "cosine/shift/exp (o)"_angle_cosine_shift_exp.html,
 "dipole (o)"_angle_dipole.html,
 "fourier (o)"_angle_fourier.html,
 "fourier/simple (o)"_angle_fourier_simple.html,
 "quartic (o)"_angle_quartic.html,
 "sdk"_angle_sdk.html :tb(c=4,ea=c)
 
 :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.  Some of the styles have accelerated versions, which can
 be used if LAMMPS is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o =
 USER-OMP, t = OPT.
 
 "none"_dihedral_none.html,
 "zero"_dihedral_zero.html,
 "hybrid"_dihedral_hybrid.html,
 "charmm (ko)"_dihedral_charmm.html,
 "class2 (ko)"_dihedral_class2.html,
 "harmonic (io)"_dihedral_harmonic.html,
 "helix (o)"_dihedral_helix.html,
 "multi/harmonic (o)"_dihedral_multi_harmonic.html,
 "opls (iko)"_dihedral_opls.html :tb(c=4,ea=c)
 
 These are additional dihedral styles in USER packages, which can be
 used if "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "cosine/shift/exp (o)"_dihedral_cosine_shift_exp.html,
 "fourier (o)"_dihedral_fourier.html,
 "nharmonic (o)"_dihedral_nharmonic.html,
 "quadratic (o)"_dihedral_quadratic.html,
 "spherical (o)"_dihedral_spherical.html,
 "table (o)"_dihedral_table.html :tb(c=4,ea=c)
 
 :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.  Some of the styles have accelerated versions, which can
 be used if LAMMPS is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o =
 USER-OMP, t = OPT.
 
 "none"_improper_none.html,
 "zero"_improper_zero.html,
 "hybrid"_improper_hybrid.html,
 "class2 (ko)"_improper_class2.html,
 "cvff (io)"_improper_cvff.html,
 "harmonic (ko)"_improper_harmonic.html,
 "umbrella (o)"_improper_umbrella.html :tb(c=4,ea=c)
 
 These are additional improper styles in USER packages, which can be
 used if "LAMMPS is built with the appropriate
 package"_Section_start.html#start_3.
 
 "cossq (o)"_improper_cossq.html,
 "distance"_improper_distance.html,
 "fourier (o)"_improper_fourier.html,
 "ring (o)"_improper_ring.html :tb(c=4,ea=c)
 
 :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.
 Some of the styles have accelerated versions, which can be used if
 LAMMPS is built with the "appropriate accelerated
 package"_Section_accelerate.html.  This is indicated by additional
 letters in parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o =
 USER-OMP, t = OPT.
 
 "ewald (o)"_kspace_style.html,
 "ewald/disp"_kspace_style.html,
 "msm (o)"_kspace_style.html,
 "msm/cg (o)"_kspace_style.html,
 "pppm (go)"_kspace_style.html,
 "pppm/cg (o)"_kspace_style.html,
 "pppm/disp"_kspace_style.html,
 "pppm/disp/tip4p"_kspace_style.html,
 "pppm/stagger"_kspace_style.html,
 "pppm/tip4p (o)"_kspace_style.html :tb(c=4,ea=c)
diff --git a/doc/src/lammps.book b/doc/src/lammps.book
index 0e4f3a8db..a4465cab9 100644
--- a/doc/src/lammps.book
+++ b/doc/src/lammps.book
@@ -1,637 +1,638 @@
 #HTMLDOC 1.8.27
 -t pdf14 -f "../Manual.pdf" --book --toclevels 4 --no-numbered --toctitle "Table of Contents" --title --textcolor #000000 --linkcolor #0000ff --linkstyle plain --bodycolor #ffffff --size Universal --left 1.00in --right 0.50in --top 0.50in --bottom 0.50in --header .t. --header1 ... --footer ..1 --nup 1 --tocheader .t. --tocfooter ..i --portrait --color --no-pscommands --no-xrxcomments --compression=1 --jpeg=0 --fontsize 11.0 --fontspacing 1.2 --headingfont helvetica --bodyfont times --headfootsize 11.0 --headfootfont helvetica --charset iso-8859-1 --links --embedfonts --pagemode document --pagelayout single --firstpage c1 --pageeffect none --pageduration 10 --effectduration 1.0 --no-encryption --permissions all  --owner-password ""  --user-password "" --browserwidth 680 --no-strict --no-overflow
 
 Manual.html
 Section_intro.html
 Section_start.html
 Section_commands.html
 Section_packages.html
 Section_accelerate.html
 accelerate_gpu.html
 accelerate_intel.html
 accelerate_kokkos.html
 accelerate_omp.html
 accelerate_opt.html
 Section_howto.html
 Section_example.html
 Section_perf.html
 Section_tools.html
 Section_modify.html
 Section_python.html
 Section_errors.html
 Section_history.html
 
 tutorial_drude.html
 tutorial_github.html
 tutorial_pylammps.html
 
 body.html
 manifolds.html
 
 angle_coeff.html
 angle_style.html
 atom_modify.html
 atom_style.html
 balance.html
 bond_coeff.html
 bond_style.html
 bond_write.html
 boundary.html
 box.html
 change_box.html
 clear.html
 comm_modify.html
 comm_style.html
 compute.html
 compute_modify.html
 create_atoms.html
 create_bonds.html
 create_box.html
 delete_atoms.html
 delete_bonds.html
 dielectric.html
 dihedral_coeff.html
 dihedral_style.html
 dimension.html
 displace_atoms.html
 dump.html
 dump_custom_vtk.html
 dump_h5md.html
 dump_image.html
 dump_modify.html
 dump_molfile.html
 dump_nc.html
 echo.html
 fix.html
 fix_modify.html
 group.html
 group2ndx.html
 if.html
 improper_coeff.html
 improper_style.html
 include.html
 info.html
 jump.html
 kspace_modify.html
 kspace_style.html
 label.html
 lattice.html
 log.html
 mass.html
 min_modify.html
 min_style.html
 minimize.html
 molecule.html
 neb.html
 neigh_modify.html
 neighbor.html
 newton.html
 next.html
 package.html
 pair_coeff.html
 pair_modify.html
 pair_style.html
 pair_write.html
 partition.html
 prd.html
 print.html
 processors.html
 python.html
 quit.html
 read_data.html
 read_dump.html
 read_restart.html
 region.html
 replicate.html
 rerun.html
 reset_timestep.html
 restart.html
 run.html
 run_style.html
 set.html
 shell.html
 special_bonds.html
 suffix.html
 tad.html
 temper.html
 temper_grem.html
 thermo.html
 thermo_modify.html
 thermo_style.html
 timer.html
 timestep.html
 uncompute.html
 undump.html
 unfix.html
 units.html
 variable.html
 velocity.html
 write_coeff.html
 write_data.html
 write_dump.html
 write_restart.html
 
 fix_adapt.html
 fix_adapt_fep.html
 fix_addforce.html
 fix_addtorque.html
 fix_append_atoms.html
 fix_atc.html
 fix_atom_swap.html
 fix_ave_atom.html
 fix_ave_chunk.html
 fix_ave_correlate.html
 fix_ave_correlate_long.html
 fix_ave_histo.html
 fix_ave_time.html
 fix_aveforce.html
 fix_balance.html
 fix_bond_break.html
 fix_bond_create.html
 fix_bond_swap.html
 fix_box_relax.html
 fix_cmap.html
 fix_colvars.html
 fix_controller.html
 fix_deform.html
 fix_deposit.html
 fix_dpd_energy.html
 fix_drag.html
 fix_drude.html
 fix_drude_transform.html
 fix_dt_reset.html
 fix_efield.html
 fix_ehex.html
 fix_enforce2d.html
 fix_eos_cv.html
 fix_eos_table.html
 fix_eos_table_rx.html
 fix_evaporate.html
 fix_external.html
 fix_flow_gauss.html
 fix_freeze.html
 fix_gcmc.html
 fix_gld.html
 fix_gle.html
 fix_gravity.html
 fix_grem.html
 fix_halt.html
 fix_heat.html
 fix_imd.html
 fix_indent.html
 fix_ipi.html
 fix_langevin.html
 fix_langevin_drude.html
 fix_langevin_eff.html
 fix_lb_fluid.html
 fix_lb_momentum.html
 fix_lb_pc.html
 fix_lb_rigid_pc_sphere.html
 fix_lb_viscous.html
 fix_lineforce.html
 fix_manifoldforce.html
 fix_meso.html
 fix_meso_stationary.html
 fix_momentum.html
 fix_move.html
 fix_msst.html
 fix_neb.html
 fix_nh.html
 fix_nh_eff.html
 fix_nph_asphere.html
 fix_nph_body.html
 fix_nph_sphere.html
 fix_nphug.html
 fix_npt_asphere.html
 fix_npt_body.html
 fix_npt_sphere.html
 fix_nve.html
 fix_nve_asphere.html
 fix_nve_asphere_noforce.html
 fix_nve_body.html
 fix_nve_dot.html
 fix_nve_dotc_langevin.html
 fix_nve_eff.html
 fix_nve_limit.html
 fix_nve_line.html
 fix_nve_manifold_rattle.html
 fix_nve_noforce.html
 fix_nve_sphere.html
 fix_nve_tri.html
 fix_nvt_asphere.html
 fix_nvt_body.html
 fix_nvt_manifold_rattle.html
 fix_nvt_sllod.html
 fix_nvt_sllod_eff.html
 fix_nvt_sphere.html
 fix_oneway.html
 fix_orient.html
 fix_phonon.html
 fix_pimd.html
 fix_planeforce.html
 fix_poems.html
 fix_pour.html
 fix_press_berendsen.html
 fix_print.html
 fix_property_atom.html
 fix_qbmsst.html
 fix_qeq.html
 fix_qeq_comb.html
 fix_qeq_reax.html
 fix_qmmm.html
 fix_qtb.html
 fix_reax_bonds.html
 fix_reaxc_species.html
 fix_recenter.html
 fix_restrain.html
 fix_rigid.html
 fix_rx.html
 fix_saed_vtk.html
 fix_setforce.html
 fix_shake.html
 fix_shardlow.html
 fix_smd.html
 fix_smd_adjust_dt.html
 fix_smd_integrate_tlsph.html
 fix_smd_integrate_ulsph.html
 fix_smd_move_triangulated_surface.html
 fix_smd_setvel.html
 fix_smd_wall_surface.html
 fix_spring.html
 fix_spring_chunk.html
 fix_spring_rg.html
 fix_spring_self.html
 fix_srd.html
 fix_store_force.html
 fix_store_state.html
 fix_temp_berendsen.html
 fix_temp_csvr.html
 fix_temp_rescale.html
 fix_temp_rescale_eff.html
 fix_tfmc.html
 fix_thermal_conductivity.html
 fix_ti_spring.html
 fix_tmd.html
 fix_ttm.html
 fix_tune_kspace.html
 fix_vector.html
 fix_viscosity.html
 fix_viscous.html
 fix_wall.html
 fix_wall_gran.html
 fix_wall_gran_region.html
 fix_wall_piston.html
 fix_wall_reflect.html
 fix_wall_region.html
 fix_wall_srd.html
 
 compute_ackland_atom.html
 compute_angle.html
 compute_angle_local.html
 compute_angmom_chunk.html
 compute_basal_atom.html
 compute_body_local.html
 compute_bond.html
 compute_bond_local.html
 compute_centro_atom.html
 compute_chunk_atom.html
 compute_cluster_atom.html
 compute_cna_atom.html
 compute_com.html
 compute_com_chunk.html
 compute_contact_atom.html
 compute_coord_atom.html
 compute_damage_atom.html
 compute_dihedral.html
 compute_dihedral_local.html
 compute_dilatation_atom.html
 compute_dipole_chunk.html
 compute_displace_atom.html
 compute_dpd.html
 compute_dpd_atom.html
 compute_erotate_asphere.html
 compute_erotate_rigid.html
 compute_erotate_sphere.html
 compute_erotate_sphere_atom.html
 compute_event_displace.html
 compute_fep.html
 compute_global_atom.html
 compute_group_group.html
 compute_gyration.html
 compute_gyration_chunk.html
 compute_heat_flux.html
 compute_hexorder_atom.html
 compute_improper.html
 compute_improper_local.html
 compute_inertia_chunk.html
 compute_ke.html
 compute_ke_atom.html
 compute_ke_atom_eff.html
 compute_ke_eff.html
 compute_ke_rigid.html
 compute_meso_e_atom.html
 compute_meso_rho_atom.html
 compute_meso_t_atom.html
 compute_msd.html
 compute_msd_chunk.html
 compute_msd_nongauss.html
 compute_omega_chunk.html
 compute_orientorder_atom.html
 compute_pair.html
 compute_pair_local.html
 compute_pe.html
 compute_pe_atom.html
 compute_plasticity_atom.html
 compute_pressure.html
 compute_property_atom.html
 compute_property_chunk.html
 compute_property_local.html
 compute_rdf.html
 compute_reduce.html
 compute_rigid_local.html
 compute_saed.html
 compute_slice.html
 compute_smd_contact_radius.html
 compute_smd_damage.html
 compute_smd_hourglass_error.html
 compute_smd_internal_energy.html
 compute_smd_plastic_strain.html
 compute_smd_plastic_strain_rate.html
 compute_smd_rho.html
 compute_smd_tlsph_defgrad.html
 compute_smd_tlsph_dt.html
 compute_smd_tlsph_num_neighs.html
 compute_smd_tlsph_shape.html
 compute_smd_tlsph_strain.html
 compute_smd_tlsph_strain_rate.html
 compute_smd_tlsph_stress.html
 compute_smd_triangle_mesh_vertices.html
 compute_smd_ulsph_num_neighs.html
 compute_smd_ulsph_strain.html
 compute_smd_ulsph_strain_rate.html
 compute_smd_ulsph_stress.html
 compute_smd_vol.html
 compute_sna_atom.html
 compute_stress_atom.html
 compute_tally.html
 compute_temp.html
 compute_temp_asphere.html
 compute_temp_body.html
 compute_temp_chunk.html
 compute_temp_com.html
 compute_temp_cs.html
 compute_temp_deform.html
 compute_temp_deform_eff.html
 compute_temp_drude.html
 compute_temp_eff.html
 compute_temp_partial.html
 compute_temp_profile.html
 compute_temp_ramp.html
 compute_temp_region.html
 compute_temp_region_eff.html
 compute_temp_rotate.html
 compute_temp_sphere.html
 compute_ti.html
 compute_torque_chunk.html
 compute_vacf.html
 compute_vcm_chunk.html
 compute_voronoi_atom.html
 compute_xrd.html
 
 pair_adp.html
 pair_agni.html
 pair_airebo.html
 pair_awpmd.html
 pair_beck.html
 pair_body.html
 pair_bop.html
 pair_born.html
 pair_brownian.html
 pair_buck.html
 pair_buck_long.html
 pair_charmm.html
 pair_class2.html
 pair_colloid.html
 pair_comb.html
 pair_coul.html
 pair_coul_diel.html
 pair_cs.html
 pair_dipole.html
 pair_dpd.html
 pair_dpd_fdt.html
 pair_dsmc.html
 pair_eam.html
 pair_edip.html
 pair_eff.html
 pair_eim.html
 pair_exp6_rx.html
 pair_gauss.html
 pair_gayberne.html
 pair_gran.html
 pair_gromacs.html
 pair_hbond_dreiding.html
 pair_hybrid.html
 pair_kim.html
+pair_kolmogorov_crespi_z.html
 pair_lcbop.html
 pair_line_lj.html
 pair_list.html
 pair_lj.html
 pair_lj96.html
 pair_lj_cubic.html
 pair_lj_expand.html
 pair_lj_long.html
 pair_lj_sf.html
 pair_lj_smooth.html
 pair_lj_smooth_linear.html
 pair_lj_soft.html
 pair_lubricate.html
 pair_lubricateU.html
 pair_mdf.html
 pair_meam.html
 pair_meam_spline.html
 pair_meam_sw_spline.html
 pair_mgpt.html
 pair_mie.html
 pair_morse.html
 pair_multi_lucy.html
 pair_multi_lucy_rx.html
 pair_nb3b_harmonic.html
 pair_nm.html
 pair_none.html
 pair_oxdna_excv.html
 pair_peri.html
 pair_polymorphic.html
 pair_quip.html
 pair_reax.html
 pair_reax_c.html
 pair_resquared.html
 pair_sdk.html
 pair_smd_hertz.html
 pair_smd_tlsph.html
 pair_smd_triangulated_surface.html
 pair_smd_ulsph.html
 pair_smtbq.html
 pair_snap.html
 pair_soft.html
 pair_sph_heatconduction.html
 pair_sph_idealgas.html
 pair_sph_lj.html
 pair_sph_rhosum.html
 pair_sph_taitwater.html
 pair_sph_taitwater_morris.html
 pair_srp.html
 pair_sw.html
 pair_table.html
 pair_table_rx.html
 pair_tersoff.html
 pair_tersoff_mod.html
 pair_tersoff_zbl.html
 pair_thole.html
 pair_tri_lj.html
 pair_vashishta.html
 pair_yukawa.html
 pair_yukawa_colloid.html
 pair_zbl.html
 pair_zero.html
 
 bond_class2.html
 bond_fene.html
 bond_fene_expand.html
 bond_oxdna_fene.html
 bond_harmonic.html
 bond_harmonic_shift.html
 bond_harmonic_shift_cut.html
 bond_hybrid.html
 bond_morse.html
 bond_none.html
 bond_nonlinear.html
 bond_quartic.html
 bond_table.html
 bond_zero.html
 
 angle_charmm.html
 angle_class2.html
 angle_cosine.html
 angle_cosine_delta.html
 angle_cosine_periodic.html
 angle_cosine_shift.html
 angle_cosine_shift_exp.html
 angle_cosine_squared.html
 angle_dipole.html
 angle_fourier.html
 angle_fourier_simple.html
 angle_harmonic.html
 angle_hybrid.html
 angle_none.html
 angle_quartic.html
 angle_sdk.html
 angle_table.html
 angle_zero.html
 
 dihedral_charmm.html
 dihedral_class2.html
 dihedral_cosine_shift_exp.html
 dihedral_fourier.html
 dihedral_harmonic.html
 dihedral_helix.html
 dihedral_hybrid.html
 dihedral_multi_harmonic.html
 dihedral_nharmonic.html
 dihedral_none.html
 dihedral_opls.html
 dihedral_quadratic.html
 dihedral_spherical.html
 dihedral_table.html
 dihedral_zero.html
 
 improper_class2.html
 improper_cossq.html
 improper_cvff.html
 improper_distance.html
 improper_fourier.html
 improper_harmonic.html
 improper_hybrid.html
 improper_none.html
 improper_ring.html
 improper_umbrella.html
 improper_zero.html
 
 USER/atc/man_add_molecule.html
 USER/atc/man_add_species.html
 USER/atc/man_atom_element_map.html
 USER/atc/man_atom_weight.html
 USER/atc/man_atomic_charge.html
 USER/atc/man_boundary.html
 USER/atc/man_boundary_dynamics.html
 USER/atc/man_boundary_faceset.html
 USER/atc/man_boundary_integral.html
 USER/atc/man_consistent_fe_initialization.html
 USER/atc/man_contour_integral.html
 USER/atc/man_control.html
 USER/atc/man_control_momentum.html
 USER/atc/man_control_thermal.html
 USER/atc/man_control_thermal_correction_max_iterations.html
 USER/atc/man_decomposition.html
 USER/atc/man_electron_integration.html
 USER/atc/man_equilibrium_start.html
 USER/atc/man_extrinsic_exchange.html
 USER/atc/man_fe_md_boundary.html
 USER/atc/man_fem_mesh.html
 USER/atc/man_filter_scale.html
 USER/atc/man_filter_type.html
 USER/atc/man_fix_atc.html
 USER/atc/man_fix_flux.html
 USER/atc/man_fix_nodes.html
 USER/atc/man_hardy_computes.html
 USER/atc/man_hardy_fields.html
 USER/atc/man_hardy_gradients.html
 USER/atc/man_hardy_kernel.html
 USER/atc/man_hardy_on_the_fly.html
 USER/atc/man_hardy_rates.html
 USER/atc/man_initial.html
 USER/atc/man_internal_atom_integrate.html
 USER/atc/man_internal_element_set.html
 USER/atc/man_internal_quadrature.html
 USER/atc/man_kernel_function.html
 USER/atc/man_localized_lambda.html
 USER/atc/man_lumped_lambda_solve.html
 USER/atc/man_mask_direction.html
 USER/atc/man_mass_matrix.html
 USER/atc/man_material.html
 USER/atc/man_mesh_add_to_nodeset.html
 USER/atc/man_mesh_create.html
 USER/atc/man_mesh_create_elementset.html
 USER/atc/man_mesh_create_faceset_box.html
 USER/atc/man_mesh_create_faceset_plane.html
 USER/atc/man_mesh_create_nodeset.html
 USER/atc/man_mesh_delete_elements.html
 USER/atc/man_mesh_nodeset_to_elementset.html
 USER/atc/man_mesh_output.html
 USER/atc/man_mesh_quadrature.html
 USER/atc/man_mesh_read.html
 USER/atc/man_mesh_write.html
 USER/atc/man_momentum_time_integration.html
 USER/atc/man_output.html
 USER/atc/man_output_elementset.html
 USER/atc/man_output_nodeset.html
 USER/atc/man_pair_interactions.html
 USER/atc/man_poisson_solver.html
 USER/atc/man_read_restart.html
 USER/atc/man_remove_molecule.html
 USER/atc/man_remove_source.html
 USER/atc/man_remove_species.html
 USER/atc/man_reset_atomic_reference_positions.html
 USER/atc/man_reset_time.html
 USER/atc/man_sample_frequency.html
 USER/atc/man_set.html
 USER/atc/man_source.html
 USER/atc/man_source_integration.html
 USER/atc/man_temperature_definition.html
 USER/atc/man_thermal_time_integration.html
 USER/atc/man_time_filter.html
 USER/atc/man_track_displacement.html
 USER/atc/man_unfix_flux.html
 USER/atc/man_unfix_nodes.html
 USER/atc/man_write_atom_weights.html
 USER/atc/man_write_restart.html
 
diff --git a/src/USER-MISC/README b/src/USER-MISC/README
index 8aed79723..52ee6cad9 100644
--- a/src/USER-MISC/README
+++ b/src/USER-MISC/README
@@ -1,71 +1,72 @@
 The files in this package are a potpourri of (mostly) unrelated
 features contributed to LAMMPS by users.  Each feature is a single
 pair of files (*.cpp and *.h).
 
 More information about each feature can be found by reading its doc
 page in the LAMMPS doc directory.  The doc page which lists all LAMMPS
 input script commands is as follows:
 
 doc/Section_commands.html, subsection 3.5
 
 User-contributed features are listed at the bottom of the fix,
 compute, pair, etc sections.
 
 The list of features and author of each is given below.
 
 You should contact the author directly if you have specific questions
 about the feature or its coding.
 
 ------------------------------------------------------------
 
 angle_style cosine/shift, Carsten Svaneborg, science at zqex.dk, 8 Aug 11
 angle_style cosine/shift/exp, Carsten Svaneborg, science at zqex.dk, 8 Aug 11
 angle_style fourier, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 angle_style fourier/simple, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 angle_style dipole, Mario Orsi, orsimario at gmail.com, 10 Jan 12
 angle_style quartic, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 bond_style harmonic/shift, Carsten Svaneborg, science at zqex.dk, 8 Aug 11
 bond_style harmonic/shift/cut, Carsten Svaneborg, science at zqex.dk, 8 Aug 11
 compute ackland/atom, Gerolf Ziegenhain, gerolf at ziegenhain.com, 4 Oct 2007
 compute basal/atom, Christopher Barrett, cdb333 at cavs.msstate.edu, 3 Mar 2013
 compute temp/rotate, Laurent Joly (U Lyon), ljoly.ulyon at gmail.com, 8 Aug 11
 compute PRESSURE/GREM, David Stelter, dstelter@bu.edu, 22 Nov 16
 dihedral_style cosine/shift/exp, Carsten Svaneborg, science at zqex.dk, 8 Aug 11
 dihedral_style fourier, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 dihedral_style nharmonic, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 dihedral_style quadratic, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 dihedral_style spherical, Andrew Jewett, jewett.aij@gmail.com, 15 Jul 16
 dihedral_style table, Andrew Jewett, jewett.aij@gmail.com, 10 Jan 12
 fix addtorque, Laurent Joly (U Lyon), ljoly.ulyon at gmail.com, 8 Aug 11
 fix ave/correlate/long, Jorge Ramirez (UPM Madrid), jorge.ramirez at upm.es, 21 Oct 2015
 fix flow/gauss, Joel Eaves (CU Boulder), Joel.Eaves@Colorado.edu, 23 Aug 2016
 fix gle, Michele Ceriotti (EPFL Lausanne), michele.ceriotti at gmail.com, 24 Nov 2014
 fix grem, David Stelter, dstelter@bu.edu, 22 Nov 16
 fix imd, Axel Kohlmeyer, akohlmey at gmail.com, 9 Nov 2009
 fix ipi, Michele Ceriotti (EPFL Lausanne), michele.ceriotti at gmail.com, 24 Nov 2014
 fix nvk, Efrem Braun (UC Berkeley), efrem.braun at gmail.com, https://github.com/lammps/lammps/pull/310
 fix pimd, Yuxing Peng (U Chicago), yuxing at uchicago.edu, 24 Nov 2014
 fix smd, Axel Kohlmeyer, akohlmey at gmail.com, 19 May 2008
 fix ti/spring, Rodrigo Freitas (Unicamp/Brazil), rodrigohb at gmail.com, 7 Nov 2013
 fix ttm/mod, Sergey Starikov and Vasily Pisarev (JIHT), pisarevvv at gmail.com, 2 Feb 2015
 improper_style cossq, Georgios Vogiatzis, gvog at chemeng.ntua.gr, 25 May 12
 improper_style fourier, Loukas Peristeras, loukas.peristeras at scienomics.com, 27 Oct 12
 improper_style ring, Georgios Vogiatzis, gvog at chemeng.ntua.gr, 25 May 12
 improper_style distance, Paolo Raiteri, p.raiteri at curtin.edu.au, 2 Dec 15
 pair_style agni, Axel Kohlmeyer, akohlmey at gmail.com, 9 Nov 16
 pair_style buck/mdf, Paolo Raiteri, p.raiteri at curtin.edu.au, 2 Dec 15
 pair_style coul/diel, Axel Kohlmeyer, akohlmey at gmail.com, 1 Dec 11
 pair_style dipole/sf, Mario Orsi, orsimario at gmail.com, 8 Aug 11
 pair_style edip, Luca Ferraro, luca.ferraro at caspur.it, 15 Sep 11
 pair_style eam/cd, Alexander Stukowski, stukowski at mm.tu-darmstadt.de, 7 Nov 09
 pair_style gauss/cut, Axel Kohlmeyer, akohlmey at gmail.com, 1 Dec 11
 pair_style lennard/mdf, Paolo Raiteri, p.raiteri at curtin.edu.au, 2 Dec 15
 pair_style list, Axel Kohlmeyer (Temple U), akohlmey at gmail.com, 1 Jun 13
 pair_style lj/mdf, Paolo Raiteri, p.raiteri at curtin.edu.au, 2 Dec 15
 pair_style lj/sf, Laurent Joly (U Lyon), ljoly.ulyon at gmail.com, 8 Aug 11
+pair_style kolmogorov/crespi/z, Jaap Kroes (Radboud U), jaapkroes at gmail dot com, 28 Feb 17
 pair_style meam/spline, Alexander Stukowski (LLNL), alex at stukowski.com, 1 Feb 12
 pair_style meam/sw/spline, Robert Rudd (LLNL), robert.rudd at llnl.gov, 1 Oct 12
 pair_style morse/smooth/linear, Stefan Paquay (TU Eindhoven), stefanpaquay at gmail.com, 29 Feb 16
 pair_style srp, Tim Sirk, tim.sirk at us.army.mil, 21 Nov 14
 pair_style tersoff/table, Luca Ferraro, luca.ferraro@caspur.it, 1 Dec 11
 temper/grem, David Stelter, dstelter@bu.edu, 22 Nov 16