Updated cool quotes
[gromacs.git] / docs / user-guide / mdp-options.rst
blobe111c89668041f097d9dfd3686a810864c34c35d
1 .. README
2    See the "run control" section for a working example of the
3    syntax to use when making .mdp entries, with and without detailed
4    documentation for values those entries might take. Everything can
5    be cross-referenced, see the examples there. TODO Make more
6    cross-references.
8 Molecular dynamics parameters (.mdp options)
9 ============================================
11 General information
12 -------------------
14 Default values are given in parentheses, or listed first among
15 choices. The first option in the list is always the default
16 option. Units are given in square brackets. The difference between a
17 dash and an underscore is ignored.
19 A :ref:`sample mdp file <mdp>` is available. This should be
20 appropriate to start a normal simulation. Edit it to suit your
21 specific needs and desires.
24 Preprocessing
25 ^^^^^^^^^^^^^
27 .. mdp:: include
29    directories to include in your topology. Format:
30    ``-I/home/john/mylib -I../otherlib``
32 .. mdp:: define
34    defines to pass to the preprocessor, default is no defines. You can
35    use any defines to control options in your customized topology
36    files. Options that act on existing :ref:`top` file mechanisms
37    include
39       ``-DFLEXIBLE`` will use flexible water instead of rigid water
40       into your topology, this can be useful for normal mode analysis.
42       ``-DPOSRES`` will trigger the inclusion of ``posre.itp`` into
43       your topology, used for implementing position restraints.
46 Run control
47 ^^^^^^^^^^^
49 .. mdp:: integrator
51    (Despite the name, this list includes algorithms that are not
52    actually integrators over time. :mdp-value:`integrator=steep` and
53    all entries following it are in this category)
55    .. mdp-value:: md
57       A leap-frog algorithm for integrating Newton's equations of motion.
59    .. mdp-value:: md-vv
61       A velocity Verlet algorithm for integrating Newton's equations
62       of motion.  For constant NVE simulations started from
63       corresponding points in the same trajectory, the trajectories
64       are analytically, but not binary, identical to the
65       :mdp-value:`integrator=md` leap-frog integrator. The the kinetic
66       energy, which is determined from the whole step velocities and
67       is therefore slightly too high. The advantage of this integrator
68       is more accurate, reversible Nose-Hoover and Parrinello-Rahman
69       coupling integration based on Trotter expansion, as well as
70       (slightly too small) full step velocity output. This all comes
71       at the cost off extra computation, especially with constraints
72       and extra communication in parallel. Note that for nearly all
73       production simulations the :mdp-value:`integrator=md` integrator
74       is accurate enough.
76    .. mdp-value:: md-vv-avek
78       A velocity Verlet algorithm identical to
79       :mdp-value:`integrator=md-vv`, except that the kinetic energy is
80       determined as the average of the two half step kinetic energies
81       as in the :mdp-value:`integrator=md` integrator, and this thus
82       more accurate.  With Nose-Hoover and/or Parrinello-Rahman
83       coupling this comes with a slight increase in computational
84       cost.
86    .. mdp-value:: sd
88       An accurate and efficient leap-frog stochastic dynamics
89       integrator. With constraints, coordinates needs to be
90       constrained twice per integration step. Depending on the
91       computational cost of the force calculation, this can take a
92       significant part of the simulation time. The temperature for one
93       or more groups of atoms (:mdp:`tc-grps`) is set with
94       :mdp:`ref-t`, the inverse friction constant for each group is
95       set with :mdp:`tau-t`.  The parameter :mdp:`tcoupl` is
96       ignored. The random generator is initialized with
97       :mdp:`ld-seed`. When used as a thermostat, an appropriate value
98       for :mdp:`tau-t` is 2 ps, since this results in a friction that
99       is lower than the internal friction of water, while it is high
100       enough to remove excess heat NOTE: temperature deviations decay
101       twice as fast as with a Berendsen thermostat with the same
102       :mdp:`tau-t`.
104    .. mdp-value:: bd
106       An Euler integrator for Brownian or position Langevin dynamics,
107       the velocity is the force divided by a friction coefficient
108       (:mdp:`bd-fric`) plus random thermal noise (:mdp:`ref-t`). When
109       :mdp:`bd-fric` is 0, the friction coefficient for each particle
110       is calculated as mass/ :mdp:`tau-t`, as for the integrator
111       :mdp-value:`integrator=sd`. The random generator is initialized
112       with :mdp:`ld-seed`.
114    .. mdp-value:: steep
116       A steepest descent algorithm for energy minimization. The
117       maximum step size is :mdp:`emstep`, the tolerance is
118       :mdp:`emtol`.
120    .. mdp-value:: cg
122       A conjugate gradient algorithm for energy minimization, the
123       tolerance is :mdp:`emtol`. CG is more efficient when a steepest
124       descent step is done every once in a while, this is determined
125       by :mdp:`nstcgsteep`. For a minimization prior to a normal mode
126       analysis, which requires a very high accuracy, |Gromacs| should be
127       compiled in double precision.
129    .. mdp-value:: l-bfgs
131       A quasi-Newtonian algorithm for energy minimization according to
132       the low-memory Broyden-Fletcher-Goldfarb-Shanno approach. In
133       practice this seems to converge faster than Conjugate Gradients,
134       but due to the correction steps necessary it is not (yet)
135       parallelized.
137    .. mdp-value:: nm
139       Normal mode analysis is performed on the structure in the :ref:`tpr`
140       file.  |Gromacs| should be compiled in double precision.
142    .. mdp-value:: tpi
144       Test particle insertion. The last molecule in the topology is
145       the test particle. A trajectory must be provided to ``mdrun
146       -rerun``. This trajectory should not contain the molecule to be
147       inserted. Insertions are performed :mdp:`nsteps` times in each
148       frame at random locations and with random orientiations of the
149       molecule. When :mdp:`nstlist` is larger than one,
150       :mdp:`nstlist` insertions are performed in a sphere with radius
151       :mdp:`rtpi` around a the same random location using the same
152       neighborlist. Since neighborlist construction is expensive,
153       one can perform several extra insertions with the same list
154       almost for free. The random seed is set with
155       :mdp:`ld-seed`. The temperature for the Boltzmann weighting is
156       set with :mdp:`ref-t`, this should match the temperature of the
157       simulation of the original trajectory. Dispersion correction is
158       implemented correctly for TPI. All relevant quantities are
159       written to the file specified with ``mdrun -tpi``. The
160       distribution of insertion energies is written to the file
161       specified with ``mdrun -tpid``. No trajectory or energy file is
162       written. Parallel TPI gives identical results to single-node
163       TPI. For charged molecules, using PME with a fine grid is most
164       accurate and also efficient, since the potential in the system
165       only needs to be calculated once per frame.
167    .. mdp-value:: tpic
169       Test particle insertion into a predefined cavity location. The
170       procedure is the same as for :mdp-value:`integrator=tpi`, except
171       that one coordinate extra is read from the trajectory, which is
172       used as the insertion location. The molecule to be inserted
173       should be centered at 0,0,0. |Gromacs| does not do this for you,
174       since for different situations a different way of centering
175       might be optimal. Also :mdp:`rtpi` sets the radius for the
176       sphere around this location. Neighbor searching is done only
177       once per frame, :mdp:`nstlist` is not used. Parallel
178       :mdp-value:`integrator=tpic` gives identical results to
179       single-rank :mdp-value:`integrator=tpic`.
181 .. mdp:: tinit
183         (0) \[ps\]
184         starting time for your run (only makes sense for time-based
185         integrators)
187 .. mdp:: dt
189         (0.001) \[ps\]
190         time step for integration (only makes sense for time-based
191         integrators)
193 .. mdp:: nsteps
195         (0)
196         maximum number of steps to integrate or minimize, -1 is no
197         maximum
199 .. mdp:: init-step
201         (0)
202         The starting step. The time at an step i in a run is
203         calculated as: t = :mdp:`tinit` + :mdp:`dt` *
204         (:mdp:`init-step` + i). The free-energy lambda is calculated
205         as: lambda = :mdp:`init-lambda` + :mdp:`delta-lambda` *
206         (:mdp:`init-step` + i). Also non-equilibrium MD parameters can
207         depend on the step number. Thus for exact restarts or redoing
208         part of a run it might be necessary to set :mdp:`init-step` to
209         the step number of the restart frame. :ref:`gmx convert-tpr`
210         does this automatically.
212 .. mdp:: simulation-part
214          (0)
215          A simulation can consist of multiple parts, each of which has
216          a part number. This option specifies what that number will
217          be, which helps keep track of parts that are logically the
218          same simulation. This option is generally useful to set only
219          when coping with a crashed simulation where files were lost.
221 .. mdp:: comm-mode
223    .. mdp-value:: Linear
225       Remove center of mass translation
227    .. mdp-value:: Angular
229       Remove center of mass translation and rotation around the center of mass
231    .. mdp-value:: None
233       No restriction on the center of mass motion
235 .. mdp:: nstcomm
237    (100) \[steps\]
238    frequency for center of mass motion removal
240 .. mdp:: comm-grps
242    group(s) for center of mass motion removal, default is the whole
243    system
246 Langevin dynamics
247 ^^^^^^^^^^^^^^^^^
249 .. mdp:: bd-fric
251    (0) \[amu ps-1\]
252    Brownian dynamics friction coefficient. When :mdp:`bd-fric` is 0,
253    the friction coefficient for each particle is calculated as mass/
254    :mdp:`tau-t`.
256 .. mdp:: ld-seed
258    (-1) \[integer\]
259    used to initialize random generator for thermal noise for
260    stochastic and Brownian dynamics. When :mdp:`ld-seed` is set to -1,
261    a pseudo random seed is used. When running BD or SD on multiple
262    processors, each processor uses a seed equal to :mdp:`ld-seed` plus
263    the processor number.
266 Energy minimization
267 ^^^^^^^^^^^^^^^^^^^
269 .. mdp:: emtol
271    (10.0) \[kJ mol-1 nm-1\]
272    the minimization is converged when the maximum force is smaller
273    than this value
275 .. mdp:: emstep
277    (0.01) \[nm\]
278    initial step-size
280 .. mdp:: nstcgsteep
282    (1000) \[steps\]
283    frequency of performing 1 steepest descent step while doing
284    conjugate gradient energy minimization.
286 .. mdp:: nbfgscorr
288    (10)
289    Number of correction steps to use for L-BFGS minimization. A higher
290    number is (at least theoretically) more accurate, but slower.
293 Shell Molecular Dynamics
294 ^^^^^^^^^^^^^^^^^^^^^^^^
296 When shells or flexible constraints are present in the system the
297 positions of the shells and the lengths of the flexible constraints
298 are optimized at every time step until either the RMS force on the
299 shells and constraints is less than :mdp:`emtol`, or a maximum number
300 of iterations :mdp:`niter` has been reached. Minimization is converged
301 when the maximum force is smaller than :mdp:`emtol`. For shell MD this
302 value should be 1.0 at most.
304 .. mdp:: niter
306    (20)
307    maximum number of iterations for optimizing the shell positions and
308    the flexible constraints.
310 .. mdp:: fcstep
312    (0) \[ps^2\]
313    the step size for optimizing the flexible constraints. Should be
314    chosen as mu/(d2V/dq2) where mu is the reduced mass of two
315    particles in a flexible constraint and d2V/dq2 is the second
316    derivative of the potential in the constraint direction. Hopefully
317    this number does not differ too much between the flexible
318    constraints, as the number of iterations and thus the runtime is
319    very sensitive to fcstep. Try several values!
322 Test particle insertion
323 ^^^^^^^^^^^^^^^^^^^^^^^
325 .. mdp:: rtpi
327    (0.05) \[nm\]
328    the test particle insertion radius, see integrators
329    :mdp-value:`integrator=tpi` and :mdp-value:`integrator=tpic`
332 Output control
333 ^^^^^^^^^^^^^^
335 .. mdp:: nstxout
337    (0) \[steps\]
338    number of steps that elapse between writing coordinates to output
339    trajectory file, the last coordinates are always written
341 .. mdp:: nstvout
343    (0) \[steps\]
344    number of steps that elapse between writing velocities to output
345    trajectory, the last velocities are always written
347 .. mdp:: nstfout
349    (0) \[steps\]
350    number of steps that elapse between writing forces to output
351    trajectory.
353 .. mdp:: nstlog
355    (1000) \[steps\]
356    number of steps that elapse between writing energies to the log
357    file, the last energies are always written
359 .. mdp:: nstcalcenergy
361    (100)
362    number of steps that elapse between calculating the energies, 0 is
363    never. This option is only relevant with dynamics. This option affects the
364    performance in parallel simulations, because calculating energies
365    requires global communication between all processes which can
366    become a bottleneck at high parallelization.
368 .. mdp:: nstenergy
370    (1000) \[steps\]
371    number of steps that else between writing energies to energy file,
372    the last energies are always written, should be a multiple of
373    :mdp:`nstcalcenergy`. Note that the exact sums and fluctuations
374    over all MD steps modulo :mdp:`nstcalcenergy` are stored in the
375    energy file, so :ref:`gmx energy` can report exact energy averages
376    and fluctuations also when :mdp:`nstenergy` > 1
378 .. mdp:: nstxout-compressed
380    (0) \[steps\]
381    number of steps that elapse between writing position coordinates
382    using lossy compression
384 .. mdp:: compressed-x-precision
386    (1000) \[real\]
387    precision with which to write to the compressed trajectory file
389 .. mdp:: compressed-x-grps
391    group(s) to write to the compressed trajectory file, by default the
392    whole system is written (if :mdp:`nstxout-compressed` > 0)
394 .. mdp:: energygrps
396    group(s) for which to write to write short-ranged non-bonded
397    potential energies to the energy file (not supported on GPUs)
400 Neighbor searching
401 ^^^^^^^^^^^^^^^^^^
403 .. mdp:: cutoff-scheme
405    .. mdp-value:: Verlet
407       Generate a pair list with buffering. The buffer size is
408       automatically set based on :mdp:`verlet-buffer-tolerance`,
409       unless this is set to -1, in which case :mdp:`rlist` will be
410       used. This option has an explicit, exact cut-off at :mdp:`rvdw`
411       equal to :mdp:`rcoulomb`, unless PME or Ewald is used, in which
412       case :mdp:`rcoulomb` > :mdp:`rvdw` is allowed. Currently only
413       cut-off, reaction-field, PME or Ewald electrostatics and plain
414       LJ are supported. Some :ref:`gmx mdrun` functionality is not yet
415       supported with the :mdp:`Verlet` scheme, but :ref:`gmx grompp`
416       checks for this. Native GPU acceleration is only supported with
417       :mdp:`Verlet`. With GPU-accelerated PME or with separate PME
418       ranks, :ref:`gmx mdrun` will automatically tune the CPU/GPU load
419       balance by scaling :mdp:`rcoulomb` and the grid spacing. This
420       can be turned off with ``mdrun -notunepme``. :mdp:`Verlet` is
421       faster than :mdp:`group` when there is no water, or if
422       :mdp:`group` would use a pair-list buffer to conserve energy.
424    .. mdp-value:: group
426       Generate a pair list for groups of atoms. These groups
427       correspond to the charge groups in the topology. This was the
428       only cut-off treatment scheme before version 4.6, and is
429       **deprecated in |gmx-version|**. There is no explicit buffering of
430       the pair list. This enables efficient force calculations for
431       water, but energy is only conserved when a buffer is explicitly
432       added.
434 .. mdp:: nstlist
436    \(10) \[steps\]
438    .. mdp-value:: >0
440       Frequency to update the neighbor list. When this is 0, the
441       neighbor list is made only once. With energy minimization the
442       neighborlist will be updated for every energy evaluation when
443       :mdp:`nstlist` is greater than 0. With :mdp:`Verlet` and
444       :mdp:`verlet-buffer-tolerance` set, :mdp:`nstlist` is actually
445       a minimum value and :ref:`gmx mdrun` might increase it, unless
446       it is set to 1. With parallel simulations and/or non-bonded
447       force calculation on the GPU, a value of 20 or 40 often gives
448       the best performance. With :mdp:`group` and non-exact
449       cut-off's, :mdp:`nstlist` will affect the accuracy of your
450       simulation and it can not be chosen freely.
452    .. mdp-value:: 0
454       The neighbor list is only constructed once and never
455       updated. This is mainly useful for vacuum simulations in which
456       all particles see each other.
458    .. mdp-value:: <0
460       Unused.
462 .. mdp:: ns-type
464    .. mdp-value:: grid
466       Make a grid in the box and only check atoms in neighboring grid
467       cells when constructing a new neighbor list every
468       :mdp:`nstlist` steps. In large systems grid search is much
469       faster than simple search.
471    .. mdp-value:: simple
473       Check every atom in the box when constructing a new neighbor
474       list every :mdp:`nstlist` steps (only with :mdp:`group`
475       cut-off scheme).
477 .. mdp:: pbc
479    .. mdp-value:: xyz
481       Use periodic boundary conditions in all directions.
483    .. mdp-value:: no
485       Use no periodic boundary conditions, ignore the box. To simulate
486       without cut-offs, set all cut-offs and :mdp:`nstlist` to 0. For
487       best performance without cut-offs on a single MPI rank, set
488       :mdp:`nstlist` to zero and :mdp:`ns-type` =simple.
490    .. mdp-value:: xy
492       Use periodic boundary conditions in x and y directions
493       only. This works only with :mdp:`ns-type` =grid and can be used
494       in combination with walls_. Without walls or with only one wall
495       the system size is infinite in the z direction. Therefore
496       pressure coupling or Ewald summation methods can not be
497       used. These disadvantages do not apply when two walls are used.
499 .. mdp:: periodic-molecules
501    .. mdp-value:: no
503       molecules are finite, fast molecular PBC can be used
505    .. mdp-value:: yes
507       for systems with molecules that couple to themselves through the
508       periodic boundary conditions, this requires a slower PBC
509       algorithm and molecules are not made whole in the output
511 .. mdp:: verlet-buffer-tolerance
513    (0.005) \[kJ/mol/ps\]
515    Useful only with the :mdp:`Verlet` :mdp:`cutoff-scheme`. This sets
516    the maximum allowed error for pair interactions per particle caused
517    by the Verlet buffer, which indirectly sets :mdp:`rlist`. As both
518    :mdp:`nstlist` and the Verlet buffer size are fixed (for
519    performance reasons), particle pairs not in the pair list can
520    occasionally get within the cut-off distance during
521    :mdp:`nstlist` -1 steps. This causes very small jumps in the
522    energy. In a constant-temperature ensemble, these very small energy
523    jumps can be estimated for a given cut-off and :mdp:`rlist`. The
524    estimate assumes a homogeneous particle distribution, hence the
525    errors might be slightly underestimated for multi-phase
526    systems. (See the `reference manual`_ for details). For longer
527    pair-list life-time (:mdp:`nstlist` -1) * :mdp:`dt` the buffer is
528    overestimated, because the interactions between particles are
529    ignored. Combined with cancellation of errors, the actual drift of
530    the total energy is usually one to two orders of magnitude
531    smaller. Note that the generated buffer size takes into account
532    that the |Gromacs| pair-list setup leads to a reduction in the
533    drift by a factor 10, compared to a simple particle-pair based
534    list. Without dynamics (energy minimization etc.), the buffer is 5%
535    of the cut-off. For NVE simulations the initial temperature is
536    used, unless this is zero, in which case a buffer of 10% is
537    used. For NVE simulations the tolerance usually needs to be lowered
538    to achieve proper energy conservation on the nanosecond time
539    scale. To override the automated buffer setting, use
540    :mdp:`verlet-buffer-tolerance` =-1 and set :mdp:`rlist` manually.
542 .. mdp:: rlist
544    (1) \[nm\]
545    Cut-off distance for the short-range neighbor list. With the
546    :mdp:`Verlet` :mdp:`cutoff-scheme`, this is by default set by the
547    :mdp:`verlet-buffer-tolerance` option and the value of
548    :mdp:`rlist` is ignored.
551 Electrostatics
552 ^^^^^^^^^^^^^^
554 .. mdp:: coulombtype
556    .. mdp-value:: Cut-off
558       Plain cut-off with neighborlist radius :mdp:`rlist` and
559       Coulomb cut-off :mdp:`rcoulomb`, where :mdp:`rlist` >=
560       :mdp:`rcoulomb`.
562    .. mdp-value:: Ewald
564       Classical Ewald sum electrostatics. The real-space cut-off
565       :mdp:`rcoulomb` should be equal to :mdp:`rlist`. Use *e.g.*
566       :mdp:`rlist` =0.9, :mdp:`rcoulomb` =0.9. The highest magnitude
567       of wave vectors used in reciprocal space is controlled by
568       :mdp:`fourierspacing`. The relative accuracy of
569       direct/reciprocal space is controlled by :mdp:`ewald-rtol`.
571       NOTE: Ewald scales as O(N^3/2) and is thus extremely slow for
572       large systems. It is included mainly for reference - in most
573       cases PME will perform much better.
575    .. mdp-value:: PME
577       Fast smooth Particle-Mesh Ewald (SPME) electrostatics. Direct
578       space is similar to the Ewald sum, while the reciprocal part is
579       performed with FFTs. Grid dimensions are controlled with
580       :mdp:`fourierspacing` and the interpolation order with
581       :mdp:`pme-order`. With a grid spacing of 0.1 nm and cubic
582       interpolation the electrostatic forces have an accuracy of
583       2-3*10^-4. Since the error from the vdw-cutoff is larger than
584       this you might try 0.15 nm. When running in parallel the
585       interpolation parallelizes better than the FFT, so try
586       decreasing grid dimensions while increasing interpolation.
588    .. mdp-value:: P3M-AD
590       Particle-Particle Particle-Mesh algorithm with analytical
591       derivative for for long range electrostatic interactions. The
592       method and code is identical to SPME, except that the influence
593       function is optimized for the grid. This gives a slight increase
594       in accuracy.
596    .. mdp-value:: Reaction-Field
598       Reaction field electrostatics with Coulomb cut-off
599       :mdp:`rcoulomb`, where :mdp:`rlist` >= :mdp:`rvdw`. The
600       dielectric constant beyond the cut-off is
601       :mdp:`epsilon-rf`. The dielectric constant can be set to
602       infinity by setting :mdp:`epsilon-rf` =0.
604    .. mdp-value:: Generalized-Reaction-Field
606       Generalized reaction field with Coulomb cut-off
607       :mdp:`rcoulomb`, where :mdp:`rlist` >= :mdp:`rcoulomb`. The
608       dielectric constant beyond the cut-off is
609       :mdp:`epsilon-rf`. The ionic strength is computed from the
610       number of charged (*i.e.* with non zero charge) charge
611       groups. The temperature for the GRF potential is set with
612       :mdp:`ref-t`.
614    .. mdp-value:: Reaction-Field-zero
616       In |Gromacs|, normal reaction-field electrostatics with
617       :mdp:`cutoff-scheme` = :mdp:`group` leads to bad energy
618       conservation. :mdp:`Reaction-Field-zero` solves this by making
619       the potential zero beyond the cut-off. It can only be used with
620       an infinite dielectric constant (:mdp:`epsilon-rf` =0), because
621       only for that value the force vanishes at the
622       cut-off. :mdp:`rlist` should be 0.1 to 0.3 nm larger than
623       :mdp:`rcoulomb` to accommodate for the size of charge groups
624       and diffusion between neighbor list updates. This, and the fact
625       that table lookups are used instead of analytical functions make
626       :mdp:`Reaction-Field-zero` computationally more expensive than
627       normal reaction-field.
629    .. mdp-value:: Shift
631       Analogous to :mdp-value:`vdwtype=Shift` for :mdp:`vdwtype`. You
632       might want to use :mdp:`Reaction-Field-zero` instead, which has
633       a similar potential shape, but has a physical interpretation and
634       has better energies due to the exclusion correction terms.
636    .. mdp-value:: Encad-Shift
638       The Coulomb potential is decreased over the whole range, using
639       the definition from the Encad simulation package.
641    .. mdp-value:: Switch
643       Analogous to :mdp-value:`vdwtype=Switch` for
644       :mdp:`vdwtype`. Switching the Coulomb potential can lead to
645       serious artifacts, advice: use :mdp:`Reaction-Field-zero`
646       instead.
648    .. mdp-value:: User
650       :ref:`gmx mdrun` will now expect to find a file ``table.xvg``
651       with user-defined potential functions for repulsion, dispersion
652       and Coulomb. When pair interactions are present, :ref:`gmx
653       mdrun` also expects to find a file ``tablep.xvg`` for the pair
654       interactions. When the same interactions should be used for
655       non-bonded and pair interactions the user can specify the same
656       file name for both table files. These files should contain 7
657       columns: the ``x`` value, ``f(x)``, ``-f'(x)``, ``g(x)``,
658       ``-g'(x)``, ``h(x)``, ``-h'(x)``, where ``f(x)`` is the Coulomb
659       function, ``g(x)`` the dispersion function and ``h(x)`` the
660       repulsion function. When :mdp:`vdwtype` is not set to User the
661       values for ``g``, ``-g'``, ``h`` and ``-h'`` are ignored. For
662       the non-bonded interactions ``x`` values should run from 0 to
663       the largest cut-off distance + :mdp:`table-extension` and
664       should be uniformly spaced. For the pair interactions the table
665       length in the file will be used. The optimal spacing, which is
666       used for non-user tables, is ``0.002 nm`` when you run in mixed
667       precision or ``0.0005 nm`` when you run in double precision. The
668       function value at ``x=0`` is not important. More information is
669       in the printed manual.
671    .. mdp-value:: PME-Switch
673       A combination of PME and a switch function for the direct-space
674       part (see above). :mdp:`rcoulomb` is allowed to be smaller than
675       :mdp:`rlist`. This is mainly useful constant energy simulations
676       (note that using PME with :mdp:`cutoff-scheme` = :mdp:`Verlet`
677       will be more efficient).
679    .. mdp-value:: PME-User
681       A combination of PME and user tables (see
682       above). :mdp:`rcoulomb` is allowed to be smaller than
683       :mdp:`rlist`. The PME mesh contribution is subtracted from the
684       user table by :ref:`gmx mdrun`. Because of this subtraction the
685       user tables should contain about 10 decimal places.
687    .. mdp-value:: PME-User-Switch
689       A combination of PME-User and a switching function (see
690       above). The switching function is applied to final
691       particle-particle interaction, *i.e.* both to the user supplied
692       function and the PME Mesh correction part.
694 .. mdp:: coulomb-modifier
696    .. mdp-value:: Potential-shift-Verlet
698       Selects Potential-shift with the Verlet cutoff-scheme, as it is
699       (nearly) free; selects None with the group cutoff-scheme.
701    .. mdp-value:: Potential-shift
703       Shift the Coulomb potential by a constant such that it is zero
704       at the cut-off. This makes the potential the integral of the
705       force. Note that this does not affect the forces or the
706       sampling.
708    .. mdp-value:: None
710       Use an unmodified Coulomb potential. With the group scheme this
711       means no exact cut-off is used, energies and forces are
712       calculated for all pairs in the neighborlist.
714 .. mdp:: rcoulomb-switch
716    (0) \[nm\]
717    where to start switching the Coulomb potential, only relevant
718    when force or potential switching is used
720 .. mdp:: rcoulomb
722    (1) \[nm\]
723    distance for the Coulomb cut-off
725 .. mdp:: epsilon-r
727    (1)
728    The relative dielectric constant. A value of 0 means infinity.
730 .. mdp:: epsilon-rf
732    (0)
733    The relative dielectric constant of the reaction field. This
734    is only used with reaction-field electrostatics. A value of 0
735    means infinity.
738 Van der Waals
739 ^^^^^^^^^^^^^
741 .. mdp:: vdwtype
743    .. mdp-value:: Cut-off
745       Twin range cut-offs with neighbor list cut-off :mdp:`rlist` and
746       VdW cut-off :mdp:`rvdw`, where :mdp:`rvdw` >= :mdp:`rlist`.
748    .. mdp-value:: PME
750       Fast smooth Particle-mesh Ewald (SPME) for VdW interactions. The
751       grid dimensions are controlled with :mdp:`fourierspacing` in
752       the same way as for electrostatics, and the interpolation order
753       is controlled with :mdp:`pme-order`. The relative accuracy of
754       direct/reciprocal space is controlled by :mdp:`ewald-rtol-lj`,
755       and the specific combination rules that are to be used by the
756       reciprocal routine are set using :mdp:`lj-pme-comb-rule`.
758    .. mdp-value:: Shift
760       This functionality is deprecated and replaced by
761       :mdp:`vdw-modifier` = Force-switch. The LJ (not Buckingham)
762       potential is decreased over the whole range and the forces decay
763       smoothly to zero between :mdp:`rvdw-switch` and
764       :mdp:`rvdw`. The neighbor search cut-off :mdp:`rlist` should
765       be 0.1 to 0.3 nm larger than :mdp:`rvdw` to accommodate for the
766       size of charge groups and diffusion between neighbor list
767       updates.
769    .. mdp-value:: Switch
771       This functionality is deprecated and replaced by
772       :mdp:`vdw-modifier` = Potential-switch. The LJ (not Buckingham)
773       potential is normal out to :mdp:`rvdw-switch`, after which it
774       is switched off to reach zero at :mdp:`rvdw`. Both the
775       potential and force functions are continuously smooth, but be
776       aware that all switch functions will give rise to a bulge
777       (increase) in the force (since we are switching the
778       potential). The neighbor search cut-off :mdp:`rlist` should be
779       0.1 to 0.3 nm larger than :mdp:`rvdw` to accommodate for the
780       size of charge groups and diffusion between neighbor list
781       updates.
783    .. mdp-value:: Encad-Shift
785       The LJ (not Buckingham) potential is decreased over the whole
786       range, using the definition from the Encad simulation package.
788    .. mdp-value:: User
790       See user for :mdp:`coulombtype`. The function value at zero is
791       not important. When you want to use LJ correction, make sure
792       that :mdp:`rvdw` corresponds to the cut-off in the user-defined
793       function. When :mdp:`coulombtype` is not set to User the values
794       for the ``f`` and ``-f'`` columns are ignored.
796 .. mdp:: vdw-modifier
798    .. mdp-value:: Potential-shift-Verlet
800       Selects Potential-shift with the Verlet cutoff-scheme, as it is
801       (nearly) free; selects None with the group cutoff-scheme.
803    .. mdp-value:: Potential-shift
805       Shift the Van der Waals potential by a constant such that it is
806       zero at the cut-off. This makes the potential the integral of
807       the force. Note that this does not affect the forces or the
808       sampling.
810    .. mdp-value:: None
812       Use an unmodified Van der Waals potential. With the group scheme
813       this means no exact cut-off is used, energies and forces are
814       calculated for all pairs in the neighborlist.
816    .. mdp-value:: Force-switch
818       Smoothly switches the forces to zero between :mdp:`rvdw-switch`
819       and :mdp:`rvdw`. This shifts the potential shift over the whole
820       range and switches it to zero at the cut-off. Note that this is
821       more expensive to calculate than a plain cut-off and it is not
822       required for energy conservation, since Potential-shift
823       conserves energy just as well.
825    .. mdp-value:: Potential-switch
827       Smoothly switches the potential to zero between
828       :mdp:`rvdw-switch` and :mdp:`rvdw`. Note that this introduces
829       articifically large forces in the switching region and is much
830       more expensive to calculate. This option should only be used if
831       the force field you are using requires this.
833 .. mdp:: rvdw-switch
835    (0) \[nm\]
837    where to start switching the LJ force and possibly the potential,
838    only relevant when force or potential switching is used
840 .. mdp:: rvdw
842    (1) \[nm\]
843    distance for the LJ or Buckingham cut-off
845 .. mdp:: DispCorr
847    .. mdp-value:: no
849       don't apply any correction
851    .. mdp-value:: EnerPres
853       apply long range dispersion corrections for Energy and Pressure
855    .. mdp-value:: Ener
857       apply long range dispersion corrections for Energy only
860 Tables
861 ^^^^^^
863 .. mdp:: table-extension
865    (1) \[nm\]
866    Extension of the non-bonded potential lookup tables beyond the
867    largest cut-off distance. The value should be large enough to
868    account for charge group sizes and the diffusion between
869    neighbor-list updates. Without user defined potential the same
870    table length is used for the lookup tables for the 1-4
871    interactions, which are always tabulated irrespective of the use of
872    tables for the non-bonded interactions. The value of
873    :mdp:`table-extension` in no way affects the values of
874    :mdp:`rlist`, :mdp:`rcoulomb`, or :mdp:`rvdw`.
876 .. mdp:: energygrp-table
878    When user tables are used for electrostatics and/or VdW, here one
879    can give pairs of energy groups for which seperate user tables
880    should be used. The two energy groups will be appended to the table
881    file name, in order of their definition in :mdp:`energygrps`,
882    seperated by underscores. For example, if ``energygrps = Na Cl
883    Sol`` and ``energygrp-table = Na Na Na Cl``, :ref:`gmx mdrun` will
884    read ``table_Na_Na.xvg`` and ``table_Na_Cl.xvg`` in addition to the
885    normal ``table.xvg`` which will be used for all other energy group
886    pairs.
889 Ewald
890 ^^^^^
892 .. mdp:: fourierspacing
894    (0.12) \[nm\]
895    For ordinary Ewald, the ratio of the box dimensions and the spacing
896    determines a lower bound for the number of wave vectors to use in
897    each (signed) direction. For PME and P3M, that ratio determines a
898    lower bound for the number of Fourier-space grid points that will
899    be used along that axis. In all cases, the number for each
900    direction can be overridden by entering a non-zero value for that
901    :mdp:`fourier-nx` direction. For optimizing the relative load of
902    the particle-particle interactions and the mesh part of PME, it is
903    useful to know that the accuracy of the electrostatics remains
904    nearly constant when the Coulomb cut-off and the PME grid spacing
905    are scaled by the same factor.
907 .. mdp:: fourier-nx
908 .. mdp:: fourier-ny
909 .. mdp:: fourier-nz
911    (0)
912    Highest magnitude of wave vectors in reciprocal space when using Ewald.
913    Grid size when using PME or P3M. These values override
914    :mdp:`fourierspacing` per direction. The best choice is powers of
915    2, 3, 5 and 7. Avoid large primes.
917 .. mdp:: pme-order
919    (4)
920    Interpolation order for PME. 4 equals cubic interpolation. You
921    might try 6/8/10 when running in parallel and simultaneously
922    decrease grid dimension.
924 .. mdp:: ewald-rtol
926    (1e-5)
927    The relative strength of the Ewald-shifted direct potential at
928    :mdp:`rcoulomb` is given by :mdp:`ewald-rtol`. Decreasing this
929    will give a more accurate direct sum, but then you need more wave
930    vectors for the reciprocal sum.
932 .. mdp:: ewald-rtol-lj
934    (1e-3)
935    When doing PME for VdW-interactions, :mdp:`ewald-rtol-lj` is used
936    to control the relative strength of the dispersion potential at
937    :mdp:`rvdw` in the same way as :mdp:`ewald-rtol` controls the
938    electrostatic potential.
940 .. mdp:: lj-pme-comb-rule
942    (Geometric)
943    The combination rules used to combine VdW-parameters in the
944    reciprocal part of LJ-PME. Geometric rules are much faster than
945    Lorentz-Berthelot and usually the recommended choice, even when the
946    rest of the force field uses the Lorentz-Berthelot rules.
948    .. mdp-value:: Geometric
950       Apply geometric combination rules
952    .. mdp-value:: Lorentz-Berthelot
954       Apply Lorentz-Berthelot combination rules
956 .. mdp:: ewald-geometry
958    .. mdp-value:: 3d
960       The Ewald sum is performed in all three dimensions.
962    .. mdp-value:: 3dc
964       The reciprocal sum is still performed in 3D, but a force and
965       potential correction applied in the `z` dimension to produce a
966       pseudo-2D summation. If your system has a slab geometry in the
967       `x-y` plane you can try to increase the `z`-dimension of the box
968       (a box height of 3 times the slab height is usually ok) and use
969       this option.
971 .. mdp:: epsilon-surface
973    (0)
974    This controls the dipole correction to the Ewald summation in
975    3D. The default value of zero means it is turned off. Turn it on by
976    setting it to the value of the relative permittivity of the
977    imaginary surface around your infinite system. Be careful - you
978    shouldn't use this if you have free mobile charges in your
979    system. This value does not affect the slab 3DC variant of the long
980    range corrections.
983 Temperature coupling
984 ^^^^^^^^^^^^^^^^^^^^
986 .. mdp:: tcoupl
988    .. mdp-value:: no
990       No temperature coupling.
992    .. mdp-value:: berendsen
994       Temperature coupling with a Berendsen-thermostat to a bath with
995       temperature :mdp:`ref-t`, with time constant
996       :mdp:`tau-t`. Several groups can be coupled separately, these
997       are specified in the :mdp:`tc-grps` field separated by spaces.
999    .. mdp-value:: nose-hoover
1001       Temperature coupling using a Nose-Hoover extended ensemble. The
1002       reference temperature and coupling groups are selected as above,
1003       but in this case :mdp:`tau-t` controls the period of the
1004       temperature fluctuations at equilibrium, which is slightly
1005       different from a relaxation time. For NVT simulations the
1006       conserved energy quantity is written to energy and log file.
1008    .. mdp-value:: andersen
1010       Temperature coupling by randomizing a fraction of the particles
1011       at each timestep. Reference temperature and coupling groups are
1012       selected as above. :mdp:`tau-t` is the average time between
1013       randomization of each molecule. Inhibits particle dynamics
1014       somewhat, but little or no ergodicity issues. Currently only
1015       implemented with velocity Verlet, and not implemented with
1016       constraints.
1018    .. mdp-value:: andersen-massive
1020       Temperature coupling by randomizing all particles at infrequent
1021       timesteps. Reference temperature and coupling groups are
1022       selected as above. :mdp:`tau-t` is the time between
1023       randomization of all molecules. Inhibits particle dynamics
1024       somewhat, but little or no ergodicity issues. Currently only
1025       implemented with velocity Verlet.
1027    .. mdp-value:: v-rescale
1029       Temperature coupling using velocity rescaling with a stochastic
1030       term (JCP 126, 014101). This thermostat is similar to Berendsen
1031       coupling, with the same scaling using :mdp:`tau-t`, but the
1032       stochastic term ensures that a proper canonical ensemble is
1033       generated. The random seed is set with :mdp:`ld-seed`. This
1034       thermostat works correctly even for :mdp:`tau-t` =0. For NVT
1035       simulations the conserved energy quantity is written to the
1036       energy and log file.
1038 .. mdp:: nsttcouple
1040    (-1)
1041    The frequency for coupling the temperature. The default value of -1
1042    sets :mdp:`nsttcouple` equal to :mdp:`nstlist`, unless
1043    :mdp:`nstlist` <=0, then a value of 10 is used. For velocity
1044    Verlet integrators :mdp:`nsttcouple` is set to 1.
1046 .. mdp:: nh-chain-length
1048    (10)
1049    The number of chained Nose-Hoover thermostats for velocity Verlet
1050    integrators, the leap-frog :mdp-value:`integrator=md` integrator
1051    only supports 1. Data for the NH chain variables is not printed to
1052    the :ref:`edr` file, but can be using the ``GMX_NOSEHOOVER_CHAINS``
1053    environment variable
1055 .. mdp:: tc-grps
1057    groups to couple to separate temperature baths
1059 .. mdp:: tau-t
1061    \[ps\]
1062    time constant for coupling (one for each group in
1063    :mdp:`tc-grps`), -1 means no temperature coupling
1065 .. mdp:: ref-t
1067    \[K\]
1068    reference temperature for coupling (one for each group in
1069    :mdp:`tc-grps`)
1072 Pressure coupling
1073 ^^^^^^^^^^^^^^^^^
1075 .. mdp:: pcoupl
1077    .. mdp-value:: no
1079       No pressure coupling. This means a fixed box size.
1081    .. mdp-value:: Berendsen
1083       Exponential relaxation pressure coupling with time constant
1084       :mdp:`tau-p`. The box is scaled every timestep. It has been
1085       argued that this does not yield a correct thermodynamic
1086       ensemble, but it is the most efficient way to scale a box at the
1087       beginning of a run.
1089    .. mdp-value:: Parrinello-Rahman
1091       Extended-ensemble pressure coupling where the box vectors are
1092       subject to an equation of motion. The equation of motion for the
1093       atoms is coupled to this. No instantaneous scaling takes
1094       place. As for Nose-Hoover temperature coupling the time constant
1095       :mdp:`tau-p` is the period of pressure fluctuations at
1096       equilibrium. This is probably a better method when you want to
1097       apply pressure scaling during data collection, but beware that
1098       you can get very large oscillations if you are starting from a
1099       different pressure. For simulations where the exact fluctation
1100       of the NPT ensemble are important, or if the pressure coupling
1101       time is very short it may not be appropriate, as the previous
1102       time step pressure is used in some steps of the |Gromacs|
1103       implementation for the current time step pressure.
1105    .. mdp-value:: MTTK
1107       Martyna-Tuckerman-Tobias-Klein implementation, only useable with
1108       :mdp-value:`md-vv` or :mdp-value:`md-vv-avek`, very similar to
1109       Parrinello-Rahman. As for Nose-Hoover temperature coupling the
1110       time constant :mdp:`tau-p` is the period of pressure
1111       fluctuations at equilibrium. This is probably a better method
1112       when you want to apply pressure scaling during data collection,
1113       but beware that you can get very large oscillations if you are
1114       starting from a different pressure. Currently (as of version
1115       5.1), it only supports isotropic scaling, and only works without
1116       constraints.
1118 .. mdp:: pcoupltype
1120    Specifies the kind of isotropy of the pressure coupling used. Each
1121    kind takes one or more values for :mdp:`compressibility` and
1122    :mdp:`ref-p`. Only a single value is permitted for :mdp:`tau-p`.
1124    .. mdp-value:: isotropic
1126       Isotropic pressure coupling with time constant
1127       :mdp:`tau-p`. One value each for :mdp:`compressibility` and
1128       :mdp:`ref-p` is required.
1130    .. mdp-value:: semiisotropic
1132       Pressure coupling which is isotropic in the ``x`` and ``y``
1133       direction, but different in the ``z`` direction. This can be
1134       useful for membrane simulations. Two values each for
1135       :mdp:`compressibility` and :mdp:`ref-p` are required, for
1136       ``x/y`` and ``z`` directions respectively.
1138    .. mdp-value:: anisotropic
1140       Same as before, but 6 values are needed for ``xx``, ``yy``, ``zz``,
1141       ``xy/yx``, ``xz/zx`` and ``yz/zy`` components,
1142       respectively. When the off-diagonal compressibilities are set to
1143       zero, a rectangular box will stay rectangular. Beware that
1144       anisotropic scaling can lead to extreme deformation of the
1145       simulation box.
1147    .. mdp-value:: surface-tension
1149       Surface tension coupling for surfaces parallel to the
1150       xy-plane. Uses normal pressure coupling for the `z`-direction,
1151       while the surface tension is coupled to the `x/y` dimensions of
1152       the box. The first :mdp:`ref-p` value is the reference surface
1153       tension times the number of surfaces ``bar nm``, the second
1154       value is the reference `z`-pressure ``bar``. The two
1155       :mdp:`compressibility` values are the compressibility in the
1156       `x/y` and `z` direction respectively. The value for the
1157       `z`-compressibility should be reasonably accurate since it
1158       influences the convergence of the surface-tension, it can also
1159       be set to zero to have a box with constant height.
1161 .. mdp:: nstpcouple
1163    (-1)
1164    The frequency for coupling the pressure. The default value of -1
1165    sets :mdp:`nstpcouple` equal to :mdp:`nstlist`, unless
1166    :mdp:`nstlist` <=0, then a value of 10 is used. For velocity
1167    Verlet integrators :mdp:`nstpcouple` is set to 1.
1169 .. mdp:: tau-p
1171    (1) \[ps\]
1172    The time constant for pressure coupling (one value for all
1173    directions).
1175 .. mdp:: compressibility
1177    \[bar^-1\]
1178    The compressibility (NOTE: this is now really in bar^-1) For water at 1
1179    atm and 300 K the compressibility is 4.5e-5 bar^-1. The number of
1180    required values is implied by :mdp:`pcoupltype`.
1182 .. mdp:: ref-p
1184    \[bar\]
1185    The reference pressure for coupling. The number of required values
1186    is implied by :mdp:`pcoupltype`.
1188 .. mdp:: refcoord-scaling
1190    .. mdp-value:: no
1192       The reference coordinates for position restraints are not
1193       modified. Note that with this option the virial and pressure
1194       will depend on the absolute positions of the reference
1195       coordinates.
1197    .. mdp-value:: all
1199       The reference coordinates are scaled with the scaling matrix of
1200       the pressure coupling.
1202    .. mdp-value:: com
1204       Scale the center of mass of the reference coordinates with the
1205       scaling matrix of the pressure coupling. The vectors of each
1206       reference coordinate to the center of mass are not scaled. Only
1207       one COM is used, even when there are multiple molecules with
1208       position restraints. For calculating the COM of the reference
1209       coordinates in the starting configuration, periodic boundary
1210       conditions are not taken into account.
1213 Simulated annealing
1214 ^^^^^^^^^^^^^^^^^^^
1216 Simulated annealing is controlled separately for each temperature
1217 group in |Gromacs|. The reference temperature is a piecewise linear
1218 function, but you can use an arbitrary number of points for each
1219 group, and choose either a single sequence or a periodic behaviour for
1220 each group. The actual annealing is performed by dynamically changing
1221 the reference temperature used in the thermostat algorithm selected,
1222 so remember that the system will usually not instantaneously reach the
1223 reference temperature!
1225 .. mdp:: annealing
1227    Type of annealing for each temperature group
1229    .. mdp-value:: no
1231        No simulated annealing - just couple to reference temperature value.
1233    .. mdp-value:: single
1235        A single sequence of annealing points. If your simulation is
1236        longer than the time of the last point, the temperature will be
1237        coupled to this constant value after the annealing sequence has
1238        reached the last time point.
1240    .. mdp-value:: periodic
1242        The annealing will start over at the first reference point once
1243        the last reference time is reached. This is repeated until the
1244        simulation ends.
1246 .. mdp:: annealing-npoints
1248    A list with the number of annealing reference/control points used
1249    for each temperature group. Use 0 for groups that are not
1250    annealed. The number of entries should equal the number of
1251    temperature groups.
1253 .. mdp:: annealing-time
1255    List of times at the annealing reference/control points for each
1256    group. If you are using periodic annealing, the times will be used
1257    modulo the last value, *i.e.* if the values are 0, 5, 10, and 15,
1258    the coupling will restart at the 0ps value after 15ps, 30ps, 45ps,
1259    etc. The number of entries should equal the sum of the numbers
1260    given in :mdp:`annealing-npoints`.
1262 .. mdp:: annealing-temp
1264    List of temperatures at the annealing reference/control points for
1265    each group. The number of entries should equal the sum of the
1266    numbers given in :mdp:`annealing-npoints`.
1268 Confused? OK, let's use an example. Assume you have two temperature
1269 groups, set the group selections to ``annealing = single periodic``,
1270 the number of points of each group to ``annealing-npoints = 3 4``, the
1271 times to ``annealing-time = 0 3 6 0 2 4 6`` and finally temperatures
1272 to ``annealing-temp = 298 280 270 298 320 320 298``. The first group
1273 will be coupled to 298K at 0ps, but the reference temperature will
1274 drop linearly to reach 280K at 3ps, and then linearly between 280K and
1275 270K from 3ps to 6ps. After this is stays constant, at 270K. The
1276 second group is coupled to 298K at 0ps, it increases linearly to 320K
1277 at 2ps, where it stays constant until 4ps. Between 4ps and 6ps it
1278 decreases to 298K, and then it starts over with the same pattern
1279 again, *i.e.* rising linearly from 298K to 320K between 6ps and
1280 8ps. Check the summary printed by :ref:`gmx grompp` if you are unsure!
1283 Velocity generation
1284 ^^^^^^^^^^^^^^^^^^^
1286 .. mdp:: gen-vel
1288    .. mdp-value:: no
1290         Do not generate velocities. The velocities are set to zero
1291         when there are no velocities in the input structure file.
1293    .. mdp-value:: yes
1295         Generate velocities in :ref:`gmx grompp` according to a
1296         Maxwell distribution at temperature :mdp:`gen-temp`, with
1297         random seed :mdp:`gen-seed`. This is only meaningful with
1298         integrator :mdp-value:`integrator=md`.
1300 .. mdp:: gen-temp
1302    (300) \[K\]
1303    temperature for Maxwell distribution
1305 .. mdp:: gen-seed
1307    (-1) \[integer\]
1308    used to initialize random generator for random velocities,
1309    when :mdp:`gen-seed` is set to -1, a pseudo random seed is
1310    used.
1313 Bonds
1314 ^^^^^
1316 .. mdp:: constraints
1318    .. mdp-value:: none
1320       No constraints except for those defined explicitly in the
1321       topology, *i.e.* bonds are represented by a harmonic (or other)
1322       potential or a Morse potential (depending on the setting of
1323       :mdp:`morse`) and angles by a harmonic (or other) potential.
1325    .. mdp-value:: h-bonds
1327       Convert the bonds with H-atoms to constraints.
1329    .. mdp-value:: all-bonds
1331       Convert all bonds to constraints.
1333    .. mdp-value:: h-angles
1335       Convert all bonds and additionally the angles that involve
1336       H-atoms to bond-constraints.
1338    .. mdp-value:: all-angles
1340       Convert all bonds and angles to bond-constraints.
1342 .. mdp:: constraint-algorithm
1344    .. mdp-value:: LINCS
1346       LINear Constraint Solver. With domain decomposition the parallel
1347       version P-LINCS is used. The accuracy in set with
1348       :mdp:`lincs-order`, which sets the number of matrices in the
1349       expansion for the matrix inversion. After the matrix inversion
1350       correction the algorithm does an iterative correction to
1351       compensate for lengthening due to rotation. The number of such
1352       iterations can be controlled with :mdp:`lincs-iter`. The root
1353       mean square relative constraint deviation is printed to the log
1354       file every :mdp:`nstlog` steps. If a bond rotates more than
1355       :mdp:`lincs-warnangle` in one step, a warning will be printed
1356       both to the log file and to ``stderr``. LINCS should not be used
1357       with coupled angle constraints.
1359    .. mdp-value:: SHAKE
1361       SHAKE is slightly slower and less stable than LINCS, but does
1362       work with angle constraints. The relative tolerance is set with
1363       :mdp:`shake-tol`, 0.0001 is a good value for "normal" MD. SHAKE
1364       does not support constraints between atoms on different nodes,
1365       thus it can not be used with domain decompositon when inter
1366       charge-group constraints are present. SHAKE can not be used with
1367       energy minimization.
1369 .. mdp:: continuation
1371    This option was formerly known as unconstrained-start.
1373    .. mdp-value:: no
1375       apply constraints to the start configuration and reset shells
1377    .. mdp-value:: yes
1379       do not apply constraints to the start configuration and do not
1380       reset shells, useful for exact coninuation and reruns
1382 .. mdp:: shake-tol
1384    (0.0001)
1385    relative tolerance for SHAKE
1387 .. mdp:: lincs-order
1389    (4)
1390    Highest order in the expansion of the constraint coupling
1391    matrix. When constraints form triangles, an additional expansion of
1392    the same order is applied on top of the normal expansion only for
1393    the couplings within such triangles. For "normal" MD simulations an
1394    order of 4 usually suffices, 6 is needed for large time-steps with
1395    virtual sites or BD. For accurate energy minimization an order of 8
1396    or more might be required. With domain decomposition, the cell size
1397    is limited by the distance spanned by :mdp:`lincs-order` +1
1398    constraints. When one wants to scale further than this limit, one
1399    can decrease :mdp:`lincs-order` and increase :mdp:`lincs-iter`,
1400    since the accuracy does not deteriorate when (1+ :mdp:`lincs-iter`
1401    )* :mdp:`lincs-order` remains constant.
1403 .. mdp:: lincs-iter
1405    (1)
1406    Number of iterations to correct for rotational lengthening in
1407    LINCS. For normal runs a single step is sufficient, but for NVE
1408    runs where you want to conserve energy accurately or for accurate
1409    energy minimization you might want to increase it to 2.
1411 .. mdp:: lincs-warnangle
1413    (30) \[deg\]
1414    maximum angle that a bond can rotate before LINCS will complain
1416 .. mdp:: morse
1418    .. mdp-value:: no
1420       bonds are represented by a harmonic potential
1422    .. mdp-value:: yes
1424       bonds are represented by a Morse potential
1427 Energy group exclusions
1428 ^^^^^^^^^^^^^^^^^^^^^^^
1430 .. mdp:: energygrp-excl
1432    Pairs of energy groups for which all non-bonded interactions are
1433    excluded. An example: if you have two energy groups ``Protein`` and
1434    ``SOL``, specifying ``energygrp-excl = Protein Protein SOL SOL``
1435    would give only the non-bonded interactions between the protein and
1436    the solvent. This is especially useful for speeding up energy
1437    calculations with ``mdrun -rerun`` and for excluding interactions
1438    within frozen groups.
1441 Walls
1442 ^^^^^
1444 .. mdp:: nwall
1446    (0)
1447    When set to 1 there is a wall at ``z=0``, when set to 2 there is
1448    also a wall at ``z=z-box``. Walls can only be used with :mdp:`pbc`
1449    ``=xy``. When set to 2 pressure coupling and Ewald summation can be
1450    used (it is usually best to use semiisotropic pressure coupling
1451    with the ``x/y`` compressibility set to 0, as otherwise the surface
1452    area will change). Walls interact wit the rest of the system
1453    through an optional :mdp:`wall-atomtype`. Energy groups ``wall0``
1454    and ``wall1`` (for :mdp:`nwall` =2) are added automatically to
1455    monitor the interaction of energy groups with each wall. The center
1456    of mass motion removal will be turned off in the ``z``-direction.
1458 .. mdp:: wall-atomtype
1460    the atom type name in the force field for each wall. By (for
1461    example) defining a special wall atom type in the topology with its
1462    own combination rules, this allows for independent tuning of the
1463    interaction of each atomtype with the walls.
1465 .. mdp:: wall-type
1467    .. mdp-value:: 9-3
1469       LJ integrated over the volume behind the wall: 9-3 potential
1471    .. mdp-value:: 10-4
1473       LJ integrated over the wall surface: 10-4 potential
1475    .. mdp-value:: 12-6
1477       direct LJ potential with the ``z`` distance from the wall
1479 .. mdp:: table
1481    user defined potentials indexed with the ``z`` distance from the
1482    wall, the tables are read analogously to the
1483    :mdp:`energygrp-table` option, where the first name is for a
1484    "normal" energy group and the second name is ``wall0`` or
1485    ``wall1``, only the dispersion and repulsion columns are used
1487 .. mdp:: wall-r-linpot
1489    (-1) \[nm\]
1490    Below this distance from the wall the potential is continued
1491    linearly and thus the force is constant. Setting this option to a
1492    postive value is especially useful for equilibration when some
1493    atoms are beyond a wall. When the value is <=0 (<0 for
1494    :mdp:`wall-type` =table), a fatal error is generated when atoms
1495    are beyond a wall.
1497 .. mdp:: wall-density
1499    \[nm^-3/nm^-2\]
1500    the number density of the atoms for each wall for wall types 9-3
1501    and 10-4
1503 .. mdp:: wall-ewald-zfac
1505    (3)
1506    The scaling factor for the third box vector for Ewald summation
1507    only, the minimum is 2. Ewald summation can only be used with
1508    :mdp:`nwall` =2, where one should use :mdp:`ewald-geometry`
1509    ``=3dc``. The empty layer in the box serves to decrease the
1510    unphysical Coulomb interaction between periodic images.
1513 COM pulling
1514 ^^^^^^^^^^^
1516 Note that where pulling coordinate are applicable, there can be more
1517 than one (set with :mdp:`pull-ncoords`) and multiple related :ref:`mdp`
1518 variables will exist accordingly. Documentation references to things
1519 like :mdp:`pull-coord1-vec` should be understood to apply to to the
1520 applicable pulling coordinate.
1522 .. mdp:: pull
1524    .. mdp-value:: no
1526       No center of mass pulling. All the following pull options will
1527       be ignored (and if present in the :ref:`mdp` file, they unfortunately
1528       generate warnings)
1530    .. mdp-value:: yes
1532        Center of mass pulling will be applied on 1 or more groups using
1533        1 or more pull coordinates.
1535 .. mdp:: pull-cylinder-r
1537    (1.5) \[nm\]
1538    the radius of the cylinder for
1539    :mdp:`pull-coord1-geometry` = :mdp-value:`cylinder`
1541 .. mdp:: pull-constr-tol
1543    (1e-6)
1544    the relative constraint tolerance for constraint pulling
1546 .. mdp:: pull-print-com
1548    .. mdp-value:: no
1550       do not print the COM for any group
1552    .. mdp-value:: yes
1554       print the COM of all groups for all pull coordinates
1556 .. mdp:: pull-print-ref-value
1558    .. mdp-value:: no
1560       do not print the reference value for each pull coordinate
1562    .. mdp-value:: yes
1564       print the reference value for each pull coordinate
1566 .. mdp:: pull-print-components
1568    .. mdp-value:: no
1570       only print the distance for each pull coordinate
1571    
1572    .. mdp-value:: yes
1574       print the distance and Cartesian components selected in
1575       :mdp:`pull-coord1-dim`
1577 .. mdp:: pull-nstxout
1579    (50)
1580    frequency for writing out the COMs of all the pull group (0 is
1581    never)
1583 .. mdp:: pull-nstfout
1585    (50)
1586    frequency for writing out the force of all the pulled group
1587    (0 is never)
1590 .. mdp:: pull-ngroups
1592    (1)
1593    The number of pull groups, not including the absolute reference
1594    group, when used. Pull groups can be reused in multiple pull
1595    coordinates. Below only the pull options for group 1 are given,
1596    further groups simply increase the group index number.
1598 .. mdp:: pull-ncoords
1600    (1)
1601    The number of pull coordinates. Below only the pull options for
1602    coordinate 1 are given, further coordinates simply increase the
1603    coordinate index number.
1605 .. mdp:: pull-group1-name
1607    The name of the pull group, is looked up in the index file or in
1608    the default groups to obtain the atoms involved.
1610 .. mdp:: pull-group1-weights
1612    Optional relative weights which are multiplied with the masses of
1613    the atoms to give the total weight for the COM. The number should
1614    be 0, meaning all 1, or the number of atoms in the pull group.
1616 .. mdp:: pull-group1-pbcatom
1618    (0)
1619    The reference atom for the treatment of periodic boundary
1620    conditions inside the group (this has no effect on the treatment of
1621    the pbc between groups). This option is only important when the
1622    diameter of the pull group is larger than half the shortest box
1623    vector. For determining the COM, all atoms in the group are put at
1624    their periodic image which is closest to
1625    :mdp:`pull-group1-pbcatom`. A value of 0 means that the middle
1626    atom (number wise) is used. This parameter is not used with
1627    :mdp:`pull-coord1-geometry` cylinder. A value of -1 turns on cosine
1628    weighting, which is useful for a group of molecules in a periodic
1629    system, *e.g.* a water slab (see Engin et al. J. Chem. Phys. B
1630    2010).
1632 .. mdp:: pull-coord1-type
1634    .. mdp-value:: umbrella
1636       Center of mass pulling using an umbrella potential between the
1637       reference group and one or more groups.
1639    .. mdp-value:: constraint
1641       Center of mass pulling using a constraint between the reference
1642       group and one or more groups. The setup is identical to the
1643       option umbrella, except for the fact that a rigid constraint is
1644       applied instead of a harmonic potential.
1646    .. mdp-value:: constant-force
1648       Center of mass pulling using a linear potential and therefore a
1649       constant force. For this option there is no reference position
1650       and therefore the parameters :mdp:`pull-coord1-init` and
1651       :mdp:`pull-coord1-rate` are not used.
1653    .. mdp-value:: flat-bottom
1655       At distances above :mdp:`pull-coord1-init` a harmonic potential
1656       is applied, otherwise no potential is applied.
1658    .. mdp-value:: flat-bottom-high
1660       At distances below :mdp:`pull-coord1-init` a harmonic potential
1661       is applied, otherwise no potential is applied.
1663    .. mdp-value:: external-potential
1665       An external potential that needs to be provided by another
1666       module.
1668 .. mdp:: pull-coord1-potential-provider
1670       The name of the external module that provides the potential for
1671       the case where :mdp:`pull-coord1-type` is external-potential.
1673 .. mdp:: pull-coord1-geometry
1675    .. mdp-value:: distance
1677       Pull along the vector connecting the two groups. Components can
1678       be selected with :mdp:`pull-coord1-dim`.
1680    .. mdp-value:: direction
1682       Pull in the direction of :mdp:`pull-coord1-vec`.
1684    .. mdp-value:: direction-periodic
1686       As :mdp-value:`direction`, but allows the distance to be larger
1687       than half the box size. With this geometry the box should not be
1688       dynamic (*e.g.* no pressure scaling) in the pull dimensions and
1689       the pull force is not added to virial.
1691    .. mdp-value:: direction-relative
1693       As :mdp-value:`direction`, but the pull vector is the vector
1694       that points from the COM of a third to the COM of a fourth pull
1695       group. This means that 4 groups need to be supplied in
1696       :mdp:`pull-coord1-groups`. Note that the pull force will give
1697       rise to a torque on the pull vector, which is turn leads to
1698       forces perpendicular to the pull vector on the two groups
1699       defining the vector. If you want a pull group to move between
1700       the two groups defining the vector, simply use the union of
1701       these two groups as the reference group.
1703    .. mdp-value:: cylinder
1705       Designed for pulling with respect to a layer where the reference
1706       COM is given by a local cylindrical part of the reference group.
1707       The pulling is in the direction of :mdp:`pull-coord1-vec`. From
1708       the first of the two groups in :mdp:`pull-coord1-groups` a
1709       cylinder is selected around the axis going through the COM of
1710       the second group with direction :mdp:`pull-coord1-vec` with
1711       radius :mdp:`pull-cylinder-r`. Weights of the atoms decrease
1712       continously to zero as the radial distance goes from 0 to
1713       :mdp:`pull-cylinder-r` (mass weighting is also used). The radial
1714       dependence gives rise to radial forces on both pull groups.
1715       Note that the radius should be smaller than half the box size.
1716       For tilted cylinders they should be even smaller than half the
1717       box size since the distance of an atom in the reference group
1718       from the COM of the pull group has both a radial and an axial
1719       component. This geometry is not supported with constraint
1720       pulling.
1722    .. mdp-value:: angle
1724       Pull along an angle defined by four groups. The angle is
1725       defined as the angle between two vectors: the vector connecting
1726       the COM of the first group to the COM of the second group and
1727       the vector connecting the COM of the third group to the COM of
1728       the fourth group.
1730    .. mdp-value:: angle-axis
1732       As :mdp-value:`angle` but the second vector is given by :mdp:`pull-coord1-vec`.
1733       Thus, only the two groups that define the first vector need to be given.
1735    .. mdp-value:: dihedral
1737       Pull along a dihedral angle defined by six groups. These pairwise
1738       define three vectors: the vector connecting the COM of group 1
1739       to the COM of group 2, the COM of group 3 to the COM of group 4,
1740       and the COM of group 5 to the COM group 6. The dihedral angle is
1741       then defined as the angle between two planes: the plane spanned by the
1742       the two first vectors and the plane spanned the two last vectors.
1745 .. mdp:: pull-coord1-groups
1747    The group indices on which this pull coordinate will operate.
1748    The number of group indices required is geometry dependent.
1749    The first index can be 0, in which case an
1750    absolute reference of :mdp:`pull-coord1-origin` is used. With an
1751    absolute reference the system is no longer translation invariant
1752    and one should think about what to do with the center of mass
1753    motion.
1755 .. mdp:: pull-coord1-dim
1757    (Y Y Y)
1758    Selects the dimensions that this pull coordinate acts on and that
1759    are printed to the output files when
1760    :mdp:`pull-print-components` = :mdp-value:`yes`. With
1761    :mdp:`pull-coord1-geometry` = :mdp-value:`distance`, only Cartesian
1762    components set to Y contribute to the distance. Thus setting this
1763    to Y Y N results in a distance in the x/y plane. With other
1764    geometries all dimensions with non-zero entries in
1765    :mdp:`pull-coord1-vec` should be set to Y, the values for other
1766    dimensions only affect the output.
1768 .. mdp:: pull-coord1-origin
1770    (0.0 0.0 0.0)
1771    The pull reference position for use with an absolute reference.
1773 .. mdp:: pull-coord1-vec
1775    (0.0 0.0 0.0)
1776    The pull direction. :ref:`gmx grompp` normalizes the vector.
1778 .. mdp:: pull-coord1-start
1780    .. mdp-value:: no
1782       do not modify :mdp:`pull-coord1-init`
1784    .. mdp-value:: yes
1786       add the COM distance of the starting conformation to
1787       :mdp:`pull-coord1-init`
1789 .. mdp:: pull-coord1-init
1791    (0.0) \[nm\] / \[deg\]
1792    The reference distance at t=0.
1794 .. mdp:: pull-coord1-rate
1796    (0) \[nm/ps\] / \[deg/ps\]
1797    The rate of change of the reference position.
1799 .. mdp:: pull-coord1-k
1801    (0) \[kJ mol-1 nm-2\] / \[kJ mol-1 nm-1\] / \[kJ mol-1 rad-2\] / \[kJ mol-1 rad-1\]
1802    The force constant. For umbrella pulling this is the harmonic force
1803    constant in kJ mol-1 nm-2 (or kJ mol-1 rad-2 for angles). For constant force pulling this is the
1804    force constant of the linear potential, and thus the negative (!)
1805    of the constant force in kJ mol-1 nm-1 (or kJ mol-1 rad-1 for angles).
1806    Note that for angles the force constant is expressed in terms of radians
1807    (while :mdp:`pull-coord1-init` and :mdp:`pull-coord1-rate` are expressed in degrees).
1809 .. mdp:: pull-coord1-kB
1811    (pull-k1) \[kJ mol-1 nm-2\] / \[kJ mol-1 nm-1\] / \[kJ mol-1 rad-2\] / \[kJ mol-1 rad-1\]
1812    As :mdp:`pull-coord1-k`, but for state B. This is only used when
1813    :mdp:`free-energy` is turned on. The force constant is then (1 -
1814    lambda) * :mdp:`pull-coord1-k` + lambda * :mdp:`pull-coord1-kB`.
1817 NMR refinement
1818 ^^^^^^^^^^^^^^
1820 .. mdp:: disre
1822    .. mdp-value:: no
1824       ignore distance restraint information in topology file
1826    .. mdp-value:: simple
1828       simple (per-molecule) distance restraints.
1830    .. mdp-value:: ensemble
1832       distance restraints over an ensemble of molecules in one
1833       simulation box. Normally, one would perform ensemble averaging
1834       over multiple subsystems, each in a separate box, using ``mdrun
1835       -multi``. Supply ``topol0.tpr``, ``topol1.tpr``, ... with
1836       different coordinates and/or velocities. The environment
1837       variable ``GMX_DISRE_ENSEMBLE_SIZE`` sets the number of systems
1838       within each ensemble (usually equal to the ``mdrun -multi``
1839       value).
1841 .. mdp:: disre-weighting
1843    .. mdp-value:: equal
1845       divide the restraint force equally over all atom pairs in the
1846       restraint
1848    .. mdp-value:: conservative
1850       the forces are the derivative of the restraint potential, this
1851       results in an weighting of the atom pairs to the reciprocal
1852       seventh power of the displacement. The forces are conservative
1853       when :mdp:`disre-tau` is zero.
1855 .. mdp:: disre-mixed
1857    .. mdp-value:: no
1859       the violation used in the calculation of the restraint force is
1860       the time-averaged violation
1862    .. mdp-value:: yes
1864       the violation used in the calculation of the restraint force is
1865       the square root of the product of the time-averaged violation
1866       and the instantaneous violation
1868 .. mdp:: disre-fc
1870    (1000) \[kJ mol-1 nm-2\]
1871    force constant for distance restraints, which is multiplied by a
1872    (possibly) different factor for each restraint given in the `fac`
1873    column of the interaction in the topology file.
1875 .. mdp:: disre-tau
1877    (0) \[ps\]
1878    time constant for distance restraints running average. A value of
1879    zero turns off time averaging.
1881 .. mdp:: nstdisreout
1883    (100) \[steps\]
1884    period between steps when the running time-averaged and
1885    instantaneous distances of all atom pairs involved in restraints
1886    are written to the energy file (can make the energy file very
1887    large)
1889 .. mdp:: orire
1891    .. mdp-value:: no
1893       ignore orientation restraint information in topology file
1895    .. mdp-value:: yes
1897       use orientation restraints, ensemble averaging can be performed
1898       with `mdrun -multi`
1900 .. mdp:: orire-fc
1902    (0) \[kJ mol\]
1903    force constant for orientation restraints, which is multiplied by a
1904    (possibly) different weight factor for each restraint, can be set
1905    to zero to obtain the orientations from a free simulation
1907 .. mdp:: orire-tau
1909    (0) \[ps\]
1910    time constant for orientation restraints running average. A value
1911    of zero turns off time averaging.
1913 .. mdp:: orire-fitgrp
1915    fit group for orientation restraining. This group of atoms is used
1916    to determine the rotation **R** of the system with respect to the
1917    reference orientation. The reference orientation is the starting
1918    conformation of the first subsystem. For a protein, backbone is a
1919    reasonable choice
1921 .. mdp:: nstorireout
1923    (100) \[steps\]
1924    period between steps when the running time-averaged and
1925    instantaneous orientations for all restraints, and the molecular
1926    order tensor are written to the energy file (can make the energy
1927    file very large)
1930 Free energy calculations
1931 ^^^^^^^^^^^^^^^^^^^^^^^^
1933 .. mdp:: free-energy
1935    .. mdp-value:: no
1937       Only use topology A.
1939    .. mdp-value:: yes
1941       Interpolate between topology A (lambda=0) to topology B
1942       (lambda=1) and write the derivative of the Hamiltonian with
1943       respect to lambda (as specified with :mdp:`dhdl-derivatives`),
1944       or the Hamiltonian differences with respect to other lambda
1945       values (as specified with foreign lambda) to the energy file
1946       and/or to ``dhdl.xvg``, where they can be processed by, for
1947       example :ref:`gmx bar`. The potentials, bond-lengths and angles
1948       are interpolated linearly as described in the manual. When
1949       :mdp:`sc-alpha` is larger than zero, soft-core potentials are
1950       used for the LJ and Coulomb interactions.
1952 .. mdp:: expanded
1954    Turns on expanded ensemble simulation, where the alchemical state
1955    becomes a dynamic variable, allowing jumping between different
1956    Hamiltonians. See the expanded ensemble options for controlling how
1957    expanded ensemble simulations are performed. The different
1958    Hamiltonians used in expanded ensemble simulations are defined by
1959    the other free energy options.
1961 .. mdp:: init-lambda
1963    (-1)
1964    starting value for lambda (float). Generally, this should only be
1965    used with slow growth (*i.e.* nonzero :mdp:`delta-lambda`). In
1966    other cases, :mdp:`init-lambda-state` should be specified
1967    instead. Must be greater than or equal to 0.
1969 .. mdp:: delta-lambda
1971    (0)
1972    increment per time step for lambda
1974 .. mdp:: init-lambda-state
1976    (-1)
1977    starting value for the lambda state (integer). Specifies which
1978    columm of the lambda vector (:mdp:`coul-lambdas`,
1979    :mdp:`vdw-lambdas`, :mdp:`bonded-lambdas`,
1980    :mdp:`restraint-lambdas`, :mdp:`mass-lambdas`,
1981    :mdp:`temperature-lambdas`, :mdp:`fep-lambdas`) should be
1982    used. This is a zero-based index: :mdp:`init-lambda-state` 0 means
1983    the first column, and so on.
1985 .. mdp:: fep-lambdas
1987    \[array\]
1988    Zero, one or more lambda values for which Delta H values will be
1989    determined and written to dhdl.xvg every :mdp:`nstdhdl`
1990    steps. Values must be between 0 and 1. Free energy differences
1991    between different lambda values can then be determined with
1992    :ref:`gmx bar`. :mdp:`fep-lambdas` is different from the
1993    other -lambdas keywords because all components of the lambda vector
1994    that are not specified will use :mdp:`fep-lambdas` (including
1995    :mdp:`restraint-lambdas` and therefore the pull code restraints).
1997 .. mdp:: coul-lambdas
1999    \[array\]
2000    Zero, one or more lambda values for which Delta H values will be
2001    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2002    steps. Values must be between 0 and 1. Only the electrostatic
2003    interactions are controlled with this component of the lambda
2004    vector (and only if the lambda=0 and lambda=1 states have differing
2005    electrostatic interactions).
2007 .. mdp:: vdw-lambdas
2009    \[array\]
2010    Zero, one or more lambda values for which Delta H values will be
2011    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2012    steps. Values must be between 0 and 1. Only the van der Waals
2013    interactions are controlled with this component of the lambda
2014    vector.
2016 .. mdp:: bonded-lambdas
2018    \[array\]
2019    Zero, one or more lambda values for which Delta H values will be
2020    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2021    steps. Values must be between 0 and 1. Only the bonded interactions
2022    are controlled with this component of the lambda vector.
2024 .. mdp:: restraint-lambdas
2026    \[array\]
2027    Zero, one or more lambda values for which Delta H values will be
2028    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2029    steps. Values must be between 0 and 1. Only the restraint
2030    interactions: dihedral restraints, and the pull code restraints are
2031    controlled with this component of the lambda vector.
2033 .. mdp:: mass-lambdas
2035    \[array\]
2036    Zero, one or more lambda values for which Delta H values will be
2037    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2038    steps. Values must be between 0 and 1. Only the particle masses are
2039    controlled with this component of the lambda vector.
2041 .. mdp:: temperature-lambdas
2043    \[array\]
2044    Zero, one or more lambda values for which Delta H values will be
2045    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2046    steps. Values must be between 0 and 1. Only the temperatures
2047    controlled with this component of the lambda vector. Note that
2048    these lambdas should not be used for replica exchange, only for
2049    simulated tempering.
2051 .. mdp:: calc-lambda-neighbors
2053    (1)
2054    Controls the number of lambda values for which Delta H values will
2055    be calculated and written out, if :mdp:`init-lambda-state` has
2056    been set. A positive value will limit the number of lambda points
2057    calculated to only the nth neighbors of :mdp:`init-lambda-state`:
2058    for example, if :mdp:`init-lambda-state` is 5 and this parameter
2059    has a value of 2, energies for lambda points 3-7 will be calculated
2060    and writen out. A value of -1 means all lambda points will be
2061    written out. For normal BAR such as with :ref:`gmx bar`, a value of
2062    1 is sufficient, while for MBAR -1 should be used.
2064 .. mdp:: sc-alpha
2066    (0)
2067    the soft-core alpha parameter, a value of 0 results in linear
2068    interpolation of the LJ and Coulomb interactions
2070 .. mdp:: sc-r-power
2072    (6)
2073    the power of the radial term in the soft-core equation. Possible
2074    values are 6 and 48. 6 is more standard, and is the default. When
2075    48 is used, then sc-alpha should generally be much lower (between
2076    0.001 and 0.003).
2078 .. mdp:: sc-coul
2080    (no)
2081    Whether to apply the soft-core free energy interaction
2082    transformation to the Columbic interaction of a molecule. Default
2083    is no, as it is generally more efficient to turn off the Coulomic
2084    interactions linearly before turning off the van der Waals
2085    interactions. Note that it is only taken into account when lambda
2086    states are used, not with :mdp:`couple-lambda0` /
2087    :mdp:`couple-lambda1`, and you can still turn off soft-core
2088    interactions by setting :mdp:`sc-alpha` to 0.
2090 .. mdp:: sc-power
2092    (0)
2093    the power for lambda in the soft-core function, only the values 1
2094    and 2 are supported
2096 .. mdp:: sc-sigma
2098    (0.3) \[nm\]
2099    the soft-core sigma for particles which have a C6 or C12 parameter
2100    equal to zero or a sigma smaller than :mdp:`sc-sigma`
2102 .. mdp:: couple-moltype
2104    Here one can supply a molecule type (as defined in the topology)
2105    for calculating solvation or coupling free energies. There is a
2106    special option ``system`` that couples all molecule types in the
2107    system. This can be useful for equilibrating a system starting from
2108    (nearly) random coordinates. :mdp:`free-energy` has to be turned
2109    on. The Van der Waals interactions and/or charges in this molecule
2110    type can be turned on or off between lambda=0 and lambda=1,
2111    depending on the settings of :mdp:`couple-lambda0` and
2112    :mdp:`couple-lambda1`. If you want to decouple one of several
2113    copies of a molecule, you need to copy and rename the molecule
2114    definition in the topology.
2116 .. mdp:: couple-lambda0
2118    .. mdp-value:: vdw-q
2120       all interactions are on at lambda=0
2122    .. mdp-value:: vdw
2124       the charges are zero (no Coulomb interactions) at lambda=0
2126    .. mdp-value:: q
2128       the Van der Waals interactions are turned at lambda=0; soft-core
2129       interactions will be required to avoid singularities
2131    .. mdp-value:: none
2133       the Van der Waals interactions are turned off and the charges
2134       are zero at lambda=0; soft-core interactions will be required to
2135       avoid singularities.
2137 .. mdp:: couple-lambda1
2139    analogous to :mdp:`couple-lambda1`, but for lambda=1
2141 .. mdp:: couple-intramol
2143    .. mdp-value:: no
2145       All intra-molecular non-bonded interactions for moleculetype
2146       :mdp:`couple-moltype` are replaced by exclusions and explicit
2147       pair interactions. In this manner the decoupled state of the
2148       molecule corresponds to the proper vacuum state without
2149       periodicity effects.
2151    .. mdp-value:: yes
2153       The intra-molecular Van der Waals and Coulomb interactions are
2154       also turned on/off. This can be useful for partitioning
2155       free-energies of relatively large molecules, where the
2156       intra-molecular non-bonded interactions might lead to
2157       kinetically trapped vacuum conformations. The 1-4 pair
2158       interactions are not turned off.
2160 .. mdp:: nstdhdl
2162    (100)
2163    the frequency for writing dH/dlambda and possibly Delta H to
2164    dhdl.xvg, 0 means no ouput, should be a multiple of
2165    :mdp:`nstcalcenergy`.
2167 .. mdp:: dhdl-derivatives
2169    (yes)
2171    If yes (the default), the derivatives of the Hamiltonian with
2172    respect to lambda at each :mdp:`nstdhdl` step are written
2173    out. These values are needed for interpolation of linear energy
2174    differences with :ref:`gmx bar` (although the same can also be
2175    achieved with the right foreign lambda setting, that may not be as
2176    flexible), or with thermodynamic integration
2178 .. mdp:: dhdl-print-energy
2180    (no)
2182    Include either the total or the potential energy in the dhdl
2183    file. Options are 'no', 'potential', or 'total'. This information
2184    is needed for later free energy analysis if the states of interest
2185    are at different temperatures. If all states are at the same
2186    temperature, this information is not needed. 'potential' is useful
2187    in case one is using ``mdrun -rerun`` to generate the ``dhdl.xvg``
2188    file. When rerunning from an existing trajectory, the kinetic
2189    energy will often not be correct, and thus one must compute the
2190    residual free energy from the potential alone, with the kinetic
2191    energy component computed analytically.
2193 .. mdp:: separate-dhdl-file
2195    .. mdp-value:: yes
2197       The free energy values that are calculated (as specified with
2198       the foreign lambda and :mdp:`dhdl-derivatives` settings) are
2199       written out to a separate file, with the default name
2200       ``dhdl.xvg``. This file can be used directly with :ref:`gmx
2201       bar`.
2203    .. mdp-value:: no
2205       The free energy values are written out to the energy output file
2206       (``ener.edr``, in accumulated blocks at every :mdp:`nstenergy`
2207       steps), where they can be extracted with :ref:`gmx energy` or
2208       used directly with :ref:`gmx bar`.
2210 .. mdp:: dh-hist-size
2212    (0)
2213    If nonzero, specifies the size of the histogram into which the
2214    Delta H values (specified with foreign lambda) and the derivative
2215    dH/dl values are binned, and written to ener.edr. This can be used
2216    to save disk space while calculating free energy differences. One
2217    histogram gets written for each foreign lambda and two for the
2218    dH/dl, at every :mdp:`nstenergy` step. Be aware that incorrect
2219    histogram settings (too small size or too wide bins) can introduce
2220    errors. Do not use histograms unless you're certain you need it.
2222 .. mdp:: dh-hist-spacing
2224    (0.1)
2225    Specifies the bin width of the histograms, in energy units. Used in
2226    conjunction with :mdp:`dh-hist-size`. This size limits the
2227    accuracy with which free energies can be calculated. Do not use
2228    histograms unless you're certain you need it.
2231 Expanded Ensemble calculations
2232 ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
2234 .. mdp:: nstexpanded
2236    The number of integration steps beween attempted moves changing the
2237    system Hamiltonian in expanded ensemble simulations. Must be a
2238    multiple of :mdp:`nstcalcenergy`, but can be greater or less than
2239    :mdp:`nstdhdl`.
2241 .. mdp:: lmc-stats
2243    .. mdp-value:: no
2245       No Monte Carlo in state space is performed.
2247    .. mdp-value:: metropolis-transition
2249       Uses the Metropolis weights to update the expanded ensemble
2250       weight of each state. Min{1,exp(-(beta_new u_new - beta_old
2251       u_old)}
2253    .. mdp-value:: barker-transition
2255       Uses the Barker transition critera to update the expanded
2256       ensemble weight of each state i, defined by exp(-beta_new
2257       u_new)/(exp(-beta_new u_new)+exp(-beta_old u_old))
2259    .. mdp-value:: wang-landau
2261       Uses the Wang-Landau algorithm (in state space, not energy
2262       space) to update the expanded ensemble weights.
2264    .. mdp-value:: min-variance
2266       Uses the minimum variance updating method of Escobedo et al. to
2267       update the expanded ensemble weights. Weights will not be the
2268       free energies, but will rather emphasize states that need more
2269       sampling to give even uncertainty.
2271 .. mdp:: lmc-mc-move
2273    .. mdp-value:: no
2275       No Monte Carlo in state space is performed.
2277    .. mdp-value:: metropolis-transition
2279       Randomly chooses a new state up or down, then uses the
2280       Metropolis critera to decide whether to accept or reject:
2281       Min{1,exp(-(beta_new u_new - beta_old u_old)}
2283    .. mdp-value:: barker-transition
2285       Randomly chooses a new state up or down, then uses the Barker
2286       transition critera to decide whether to accept or reject:
2287       exp(-beta_new u_new)/(exp(-beta_new u_new)+exp(-beta_old u_old))
2289    .. mdp-value:: gibbs
2291        Uses the conditional weights of the state given the coordinate
2292        (exp(-beta_i u_i) / sum_k exp(beta_i u_i) to decide which state
2293        to move to.
2295    .. mdp-value:: metropolized-gibbs
2297        Uses the conditional weights of the state given the coordinate
2298        (exp(-beta_i u_i) / sum_k exp(beta_i u_i) to decide which state
2299        to move to, EXCLUDING the current state, then uses a rejection
2300        step to ensure detailed balance. Always more efficient that
2301        Gibbs, though only marginally so in many situations, such as
2302        when only the nearest neighbors have decent phase space
2303        overlap.
2305 .. mdp:: lmc-seed
2307    (-1)
2308    random seed to use for Monte Carlo moves in state space. When
2309    :mdp:`lmc-seed` is set to -1, a pseudo random seed is us
2311 .. mdp:: mc-temperature
2313    Temperature used for acceptance/rejection for Monte Carlo moves. If
2314    not specified, the temperature of the simulation specified in the
2315    first group of :mdp:`ref-t` is used.
2317 .. mdp:: wl-ratio
2319    (0.8)
2320    The cutoff for the histogram of state occupancies to be reset, and
2321    the free energy incrementor to be changed from delta to delta *
2322    :mdp:`wl-scale`. If we define the Nratio = (number of samples at
2323    each histogram) / (average number of samples at each
2324    histogram). :mdp:`wl-ratio` of 0.8 means that means that the
2325    histogram is only considered flat if all Nratio > 0.8 AND
2326    simultaneously all 1/Nratio > 0.8.
2328 .. mdp:: wl-scale
2330    (0.8)
2331    Each time the histogram is considered flat, then the current value
2332    of the Wang-Landau incrementor for the free energies is multiplied
2333    by :mdp:`wl-scale`. Value must be between 0 and 1.
2335 .. mdp:: init-wl-delta
2337    (1.0)
2338    The initial value of the Wang-Landau incrementor in kT. Some value
2339    near 1 kT is usually most efficient, though sometimes a value of
2340    2-3 in units of kT works better if the free energy differences are
2341    large.
2343 .. mdp:: wl-oneovert
2345    (no)
2346    Set Wang-Landau incrementor to scale with 1/(simulation time) in
2347    the large sample limit. There is significant evidence that the
2348    standard Wang-Landau algorithms in state space presented here
2349    result in free energies getting 'burned in' to incorrect values
2350    that depend on the initial state. when :mdp:`wl-oneovert` is true,
2351    then when the incrementor becomes less than 1/N, where N is the
2352    mumber of samples collected (and thus proportional to the data
2353    collection time, hence '1 over t'), then the Wang-Lambda
2354    incrementor is set to 1/N, decreasing every step. Once this occurs,
2355    :mdp:`wl-ratio` is ignored, but the weights will still stop
2356    updating when the equilibration criteria set in
2357    :mdp:`lmc-weights-equil` is achieved.
2359 .. mdp:: lmc-repeats
2361    (1)
2362    Controls the number of times that each Monte Carlo swap type is
2363    performed each iteration. In the limit of large numbers of Monte
2364    Carlo repeats, then all methods converge to Gibbs sampling. The
2365    value will generally not need to be different from 1.
2367 .. mdp:: lmc-gibbsdelta
2369    (-1)
2370    Limit Gibbs sampling to selected numbers of neighboring states. For
2371    Gibbs sampling, it is sometimes inefficient to perform Gibbs
2372    sampling over all of the states that are defined. A positive value
2373    of :mdp:`lmc-gibbsdelta` means that only states plus or minus
2374    :mdp:`lmc-gibbsdelta` are considered in exchanges up and down. A
2375    value of -1 means that all states are considered. For less than 100
2376    states, it is probably not that expensive to include all states.
2378 .. mdp:: lmc-forced-nstart
2380    (0)
2381    Force initial state space sampling to generate weights. In order to
2382    come up with reasonable initial weights, this setting allows the
2383    simulation to drive from the initial to the final lambda state,
2384    with :mdp:`lmc-forced-nstart` steps at each state before moving on
2385    to the next lambda state. If :mdp:`lmc-forced-nstart` is
2386    sufficiently long (thousands of steps, perhaps), then the weights
2387    will be close to correct. However, in most cases, it is probably
2388    better to simply run the standard weight equilibration algorithms.
2390 .. mdp:: nst-transition-matrix
2392    (-1)
2393    Frequency of outputting the expanded ensemble transition matrix. A
2394    negative number means it will only be printed at the end of the
2395    simulation.
2397 .. mdp:: symmetrized-transition-matrix
2399    (no)
2400    Whether to symmetrize the empirical transition matrix. In the
2401    infinite limit the matrix will be symmetric, but will diverge with
2402    statistical noise for short timescales. Forced symmetrization, by
2403    using the matrix T_sym = 1/2 (T + transpose(T)), removes problems
2404    like the existence of (small magnitude) negative eigenvalues.
2406 .. mdp:: mininum-var-min
2408    (100)
2409    The min-variance strategy (option of :mdp:`lmc-stats` is only
2410    valid for larger number of samples, and can get stuck if too few
2411    samples are used at each state. :mdp:`mininum-var-min` is the
2412    minimum number of samples that each state that are allowed before
2413    the min-variance strategy is activated if selected.
2415 .. mdp:: init-lambda-weights
2417    The initial weights (free energies) used for the expanded ensemble
2418    states. Default is a vector of zero weights. format is similar to
2419    the lambda vector settings in :mdp:`fep-lambdas`, except the
2420    weights can be any floating point number. Units are kT. Its length
2421    must match the lambda vector lengths.
2423 .. mdp:: lmc-weights-equil
2425    .. mdp-value:: no
2427       Expanded ensemble weights continue to be updated throughout the
2428       simulation.
2430    .. mdp-value:: yes
2432       The input expanded ensemble weights are treated as equilibrated,
2433       and are not updated throughout the simulation.
2435    .. mdp-value:: wl-delta
2437       Expanded ensemble weight updating is stopped when the
2438       Wang-Landau incrementor falls below this value.
2440    .. mdp-value:: number-all-lambda
2442       Expanded ensemble weight updating is stopped when the number of
2443       samples at all of the lambda states is greater than this value.
2445    .. mdp-value:: number-steps
2447       Expanded ensemble weight updating is stopped when the number of
2448       steps is greater than the level specified by this value.
2450    .. mdp-value:: number-samples
2452       Expanded ensemble weight updating is stopped when the number of
2453       total samples across all lambda states is greater than the level
2454       specified by this value.
2456    .. mdp-value:: count-ratio
2458       Expanded ensemble weight updating is stopped when the ratio of
2459       samples at the least sampled lambda state and most sampled
2460       lambda state greater than this value.
2462 .. mdp:: simulated-tempering
2464    (no)
2465    Turn simulated tempering on or off. Simulated tempering is
2466    implemented as expanded ensemble sampling with different
2467    temperatures instead of different Hamiltonians.
2469 .. mdp:: sim-temp-low
2471    (300) \[K\]
2472    Low temperature for simulated tempering.
2474 .. mdp:: sim-temp-high
2476    (300) \[K\]
2477    High temperature for simulated tempering.
2479 .. mdp:: simulated-tempering-scaling
2481    Controls the way that the temperatures at intermediate lambdas are
2482    calculated from the :mdp:`temperature-lambdas` part of the lambda
2483    vector.
2485    .. mdp-value:: linear
2487       Linearly interpolates the temperatures using the values of
2488       :mdp:`temperature-lambdas`, *i.e.* if :mdp:`sim-temp-low`
2489       =300, :mdp:`sim-temp-high` =400, then lambda=0.5 correspond to
2490       a temperature of 350. A nonlinear set of temperatures can always
2491       be implemented with uneven spacing in lambda.
2493    .. mdp-value:: geometric
2495       Interpolates temperatures geometrically between
2496       :mdp:`sim-temp-low` and :mdp:`sim-temp-high`. The i:th state
2497       has temperature :mdp:`sim-temp-low` * (:mdp:`sim-temp-high` /
2498       :mdp:`sim-temp-low`) raised to the power of
2499       (i/(ntemps-1)). This should give roughly equal exchange for
2500       constant heat capacity, though of course things simulations that
2501       involve protein folding have very high heat capacity peaks.
2503    .. mdp-value:: exponential
2505       Interpolates temperatures exponentially between
2506       :mdp:`sim-temp-low` and :mdp:`sim-temp-high`. The i:th state
2507       has temperature :mdp:`sim-temp-low` + (:mdp:`sim-temp-high` -
2508       :mdp:`sim-temp-low`)*((exp(:mdp:`temperature-lambdas`
2509       (i))-1)/(exp(1.0)-i)).
2512 Non-equilibrium MD
2513 ^^^^^^^^^^^^^^^^^^
2515 .. mdp:: acc-grps
2517    groups for constant acceleration (*e.g.* ``Protein Sol``) all atoms
2518    in groups Protein and Sol will experience constant acceleration as
2519    specified in the :mdp:`accelerate` line
2521 .. mdp:: accelerate
2523    (0) \[nm ps^-2\]
2524    acceleration for :mdp:`acc-grps`; x, y and z for each group
2525    (*e.g.* ``0.1 0.0 0.0 -0.1 0.0 0.0`` means that first group has
2526    constant acceleration of 0.1 nm ps-2 in X direction, second group
2527    the opposite).
2529 .. mdp:: freezegrps
2531    Groups that are to be frozen (*i.e.* their X, Y, and/or Z position
2532    will not be updated; *e.g.* ``Lipid SOL``). :mdp:`freezedim`
2533    specifies for which dimension the freezing applies. To avoid
2534    spurious contibrutions to the virial and pressure due to large
2535    forces between completely frozen atoms you need to use energy group
2536    exclusions, this also saves computing time. Note that coordinates
2537    of frozen atoms are not scaled by pressure-coupling algorithms.
2539 .. mdp:: freezedim
2541    dimensions for which groups in :mdp:`freezegrps` should be frozen,
2542    specify `Y` or `N` for X, Y and Z and for each group (*e.g.* ``Y Y
2543    N N N N`` means that particles in the first group can move only in
2544    Z direction. The particles in the second group can move in any
2545    direction).
2547 .. mdp:: cos-acceleration
2549    (0) \[nm ps^-2\]
2550    the amplitude of the acceleration profile for calculating the
2551    viscosity. The acceleration is in the X-direction and the magnitude
2552    is :mdp:`cos-acceleration` cos(2 pi z/boxheight). Two terms are
2553    added to the energy file: the amplitude of the velocity profile and
2554    1/viscosity.
2556 .. mdp:: deform
2558    (0 0 0 0 0 0) \[nm ps-1\]
2559    The velocities of deformation for the box elements: a(x) b(y) c(z)
2560    b(x) c(x) c(y). Each step the box elements for which :mdp:`deform`
2561    is non-zero are calculated as: box(ts)+(t-ts)*deform, off-diagonal
2562    elements are corrected for periodicity. The coordinates are
2563    transformed accordingly. Frozen degrees of freedom are (purposely)
2564    also transformed. The time ts is set to t at the first step and at
2565    steps at which x and v are written to trajectory to ensure exact
2566    restarts. Deformation can be used together with semiisotropic or
2567    anisotropic pressure coupling when the appropriate
2568    compressibilities are set to zero. The diagonal elements can be
2569    used to strain a solid. The off-diagonal elements can be used to
2570    shear a solid or a liquid.
2573 Electric fields
2574 ^^^^^^^^^^^^^^^
2576 .. mdp:: E-x ; E-y ; E-z
2578    If you want to use an electric field in a direction, enter 3
2579    numbers after the appropriate E-direction, the first number: the
2580    number of cosines, only 1 is implemented (with frequency 0) so
2581    enter 1, the second number: the strength of the electric field in V
2582    nm^-1, the third number: the phase of the cosine, you can enter any
2583    number here since a cosine of frequency zero has no phase.
2585 .. mdp:: E-xt; E-yt; E-zt
2587    Here you can specify a pulsed alternating electric field. The field
2588    has the form of a gaussian laser pulse:
2590    E(t) = E0 exp ( -(t-t0)^2/(2 sigma^2) ) cos(omega (t-t0))
2592    For example, the four parameters for direction x are set in the
2593    three fields of :mdp:`E-x` and :mdp:`E-xt` like
2595    E-x  = 1 E0 0
2597    E-xt = omega t0 sigma
2599    In the special case that sigma = 0, the exponential term is omitted
2600    and only the cosine term is used.
2602    More details in Carl Caleman and David van der Spoel: Picosecond
2603    Melting of Ice by an Infrared Laser Pulse - A Simulation Study
2604    Angew. Chem. Intl. Ed. 47 pp. 14 17-1420 (2008)
2608 Mixed quantum/classical molecular dynamics
2609 ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
2611 .. MDP:: QMMM
2613    .. mdp-value:: no
2615       No QM/MM.
2617    .. mdp-value:: yes
2619       Do a QM/MM simulation. Several groups can be described at
2620       different QM levels separately. These are specified in the
2621       :mdp:`QMMM-grps` field separated by spaces. The level of *ab
2622       initio* theory at which the groups are described is specified by
2623       :mdp:`QMmethod` and :mdp:`QMbasis` Fields. Describing the
2624       groups at different levels of theory is only possible with the
2625       ONIOM QM/MM scheme, specified by :mdp:`QMMMscheme`.
2627 .. mdp:: QMMM-grps
2629    groups to be descibed at the QM level
2631 .. mdp:: QMMMscheme
2633    .. mdp-value:: normal
2635       normal QM/MM. There can only be one :mdp:`QMMM-grps` that is
2636       modelled at the :mdp:`QMmethod` and :mdp:`QMbasis` level of
2637       *ab initio* theory. The rest of the system is described at the
2638       MM level. The QM and MM subsystems interact as follows: MM point
2639       charges are included in the QM one-electron hamiltonian and all
2640       Lennard-Jones interactions are described at the MM level.
2642    .. mdp-value:: ONIOM
2644       The interaction between the subsystem is described using the
2645       ONIOM method by Morokuma and co-workers. There can be more than
2646       one :mdp:`QMMM-grps` each modeled at a different level of QM
2647       theory (:mdp:`QMmethod` and :mdp:`QMbasis`).
2649 .. mdp:: QMmethod
2651    (RHF)
2652    Method used to compute the energy and gradients on the QM
2653    atoms. Available methods are AM1, PM3, RHF, UHF, DFT, B3LYP, MP2,
2654    CASSCF, and MMVB. For CASSCF, the number of electrons and orbitals
2655    included in the active space is specified by :mdp:`CASelectrons`
2656    and :mdp:`CASorbitals`.
2658 .. mdp:: QMbasis
2660    (STO-3G)
2661    Basis set used to expand the electronic wavefuntion. Only Gaussian
2662    basis sets are currently available, *i.e.* ``STO-3G, 3-21G, 3-21G*,
2663    3-21+G*, 6-21G, 6-31G, 6-31G*, 6-31+G*,`` and ``6-311G``.
2665 .. mdp:: QMcharge
2667    (0) \[integer\]
2668    The total charge in `e` of the :mdp:`QMMM-grps`. In case there are
2669    more than one :mdp:`QMMM-grps`, the total charge of each ONIOM
2670    layer needs to be specified separately.
2672 .. mdp:: QMmult
2674    (1) \[integer\]
2675    The multiplicity of the :mdp:`QMMM-grps`. In case there are more
2676    than one :mdp:`QMMM-grps`, the multiplicity of each ONIOM layer
2677    needs to be specified separately.
2679 .. mdp:: CASorbitals
2681    (0) \[integer\]
2682    The number of orbitals to be included in the active space when
2683    doing a CASSCF computation.
2685 .. mdp:: CASelectrons
2687    (0) \[integer\]
2688    The number of electrons to be included in the active space when
2689    doing a CASSCF computation.
2691 .. MDP:: SH
2693    .. mdp-value:: no
2695       No surface hopping. The system is always in the electronic
2696       ground-state.
2698    .. mdp-value:: yes
2700       Do a QM/MM MD simulation on the excited state-potential energy
2701       surface and enforce a *diabatic* hop to the ground-state when
2702       the system hits the conical intersection hyperline in the course
2703       the simulation. This option only works in combination with the
2704       CASSCF method.
2707 Implicit solvent
2708 ^^^^^^^^^^^^^^^^
2710 .. mdp:: implicit-solvent
2712    .. mdp-value:: no
2714       No implicit solvent
2716    .. mdp-value:: GBSA
2718       Do a simulation with implicit solvent using the Generalized Born
2719       formalism. Three different methods for calculating the Born
2720       radii are available, Still, HCT and OBC. These are specified
2721       with the :mdp:`gb-algorithm` field. The non-polar solvation is
2722       specified with the :mdp:`sa-algorithm` field.
2724 .. mdp:: gb-algorithm
2726    .. mdp-value:: Still
2728       Use the Still method to calculate the Born radii
2730    .. mdp-value:: HCT
2732       Use the Hawkins-Cramer-Truhlar method to calculate the Born
2733       radii
2735    .. mdp-value:: OBC
2737       Use the Onufriev-Bashford-Case method to calculate the Born
2738       radii
2740 .. mdp:: nstgbradii
2742    (1) \[steps\]
2743    Frequency to (re)-calculate the Born radii. For most practial
2744    purposes, setting a value larger than 1 violates energy
2745    conservation and leads to unstable trajectories.
2747 .. mdp:: rgbradii
2749    (1.0) \[nm\]
2750    Cut-off for the calculation of the Born radii. Currently must be
2751    equal to rlist
2753 .. mdp:: gb-epsilon-solvent
2755    (80)
2756    Dielectric constant for the implicit solvent
2758 .. mdp:: gb-saltconc
2760    (0) \[M\]
2761    Salt concentration for implicit solvent models, currently not used
2763 .. mdp:: gb-obc-alpha
2764 .. mdp:: gb-obc-beta
2765 .. mdp:: gb-obc-gamma
2767    Scale factors for the OBC model. Default values of 1, 0.78 and 4.85
2768    respectively are for OBC(II). Values for OBC(I) are 0.8, 0 and 2.91
2769    respectively
2771 .. mdp:: gb-dielectric-offset
2773    (0.009) \[nm\]
2774    Distance for the di-electric offset when calculating the Born
2775    radii. This is the offset between the center of each atom the
2776    center of the polarization energy for the corresponding atom
2778 .. mdp:: sa-algorithm
2780    .. mdp-value:: Ace-approximation
2782       Use an Ace-type approximation
2784    .. mdp-value:: None
2786       No non-polar solvation calculation done. For GBSA only the polar
2787       part gets calculated
2789 .. mdp:: sa-surface-tension
2791    \[kJ mol-1 nm-2\]
2792    Default value for surface tension with SA algorithms. The default
2793    value is -1; Note that if this default value is not changed it will
2794    be overridden by :ref:`gmx grompp` using values that are specific
2795    for the choice of radii algorithm (0.0049 kcal/mol/Angstrom^2 for
2796    Still, 0.0054 kcal/mol/Angstrom2 for HCT/OBC) Setting it to 0 will
2797    while using an sa-algorithm other than None means no non-polar
2798    calculations are done.
2801 Computational Electrophysiology
2802 ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
2803 Use these options to switch on and control ion/water position exchanges in "Computational
2804 Electrophysiology" simulation setups. (See the `reference manual`_ for details).
2806 .. mdp:: swapcoords
2808    .. mdp-value:: no
2810       Do not enable ion/water position exchanges.
2812    .. mdp-value:: X ; Y ; Z
2814       Allow for ion/water position exchanges along the chosen direction.
2815       In a typical setup with the membranes parallel to the x-y plane,
2816       ion/water pairs need to be exchanged in Z direction to sustain the
2817       requested ion concentrations in the compartments.
2819 .. mdp:: swap-frequency
2821    (1) The swap attempt frequency, i.e. every how many time steps the ion counts
2822    per compartment are determined and exchanges made if necessary.
2823    Normally it is not necessary to check at every time step.
2824    For typical Computational Electrophysiology setups, a value of about 100 is
2825    sufficient and yields a negligible performance impact.
2827 .. mdp:: split-group0
2829    Name of the index group of the membrane-embedded part of channel #0.
2830    The center of mass of these atoms defines one of the compartment boundaries
2831    and should be chosen such that it is near the center of the membrane.
2833 .. mdp:: split-group1
2835    Channel #1 defines the position of the other compartment boundary.
2837 .. mdp:: massw-split0
2839    (no) Defines whether or not mass-weighting is used to calculate the split group center.
2841    .. mdp-value:: no
2843       Use the geometrical center.
2845    .. mdp-value:: yes
2847       Use the center of mass.
2849 .. mdp:: massw-split1
2851    (no) As above, but for split-group #1.
2853 .. mdp:: solvent-group
2855    Name of the index group of solvent molecules.
2857 .. mdp:: coupl-steps
2859    (\10) Average the number of ions per compartment over these many swap attempt steps.
2860    This can be used to prevent that ions near a compartment boundary
2861    (diffusing through a channel, e.g.) lead to unwanted back and forth swaps.
2863 .. mdp:: iontypes
2865    (1) The number of different ion types to be controlled. These are during the
2866    simulation exchanged with solvent molecules to reach the desired reference numbers.
2868 .. mdp:: iontype0-name
2870    Name of the first ion type.
2872 .. mdp:: iontype0-in-A
2874    (-1) Requested (=reference) number of ions of type 0 in compartment A.
2875    The default value of -1 means: use the number of ions as found in time step 0
2876    as reference value.
2878 .. mdp:: iontype0-in-B
2880    (-1) Reference number of ions of type 0 for compartment B.
2882 .. mdp:: bulk-offsetA
2884    (0.0) Offset of the first swap layer from the compartment A midplane.
2885    By default (i.e. bulk offset = 0.0), ion/water exchanges happen between layers
2886    at maximum distance (= bulk concentration) to the split group layers. However,
2887    an offset b (-1.0 < b < +1.0) can be specified to offset the bulk layer from the middle at 0.0
2888    towards one of the compartment-partitioning layers (at +/- 1.0).
2890 .. mdp:: bulk-offsetB
2892    (0.0) Offset of the other swap layer from the compartment B midplane.
2895 .. mdp:: threshold
2897    (\1) Only swap ions if threshold difference to requested count is reached.
2899 .. mdp:: cyl0-r
2901    (2.0) \[nm\] Radius of the split cylinder #0.
2902    Two split cylinders (mimicking the channel pores) can optionally be defined
2903    relative to the center of the split group. With the help of these cylinders
2904    it can be counted which ions have passed which channel. The split cylinder
2905    definition has no impact on whether or not ion/water swaps are done.
2907 .. mdp:: cyl0-up
2909    (1.0) \[nm\] Upper extension of the split cylinder #0.
2911 .. mdp:: cyl0-down
2913    (1.0) \[nm\] Lower extension of the split cylinder #0.
2915 .. mdp:: cyl1-r
2917    (2.0) \[nm\] Radius of the split cylinder #1.
2919 .. mdp:: cyl1-up
2921    (1.0) \[nm\] Upper extension of the split cylinder #1.
2923 .. mdp:: cyl1-down
2925    (1.0) \[nm\] Lower extension of the split cylinder #1.
2928 User defined thingies
2929 ^^^^^^^^^^^^^^^^^^^^^
2931 .. mdp:: user1-grps
2932 .. mdp:: user2-grps
2933 .. mdp:: userint1 (0)
2934 .. mdp:: userint2 (0)
2935 .. mdp:: userint3 (0)
2936 .. mdp:: userint4 (0)
2937 .. mdp:: userreal1 (0)
2938 .. mdp:: userreal2 (0)
2939 .. mdp:: userreal3 (0)
2940 .. mdp:: userreal4 (0)
2942    These you can use if you modify code. You can pass integers and
2943    reals and groups to your subroutine. Check the inputrec definition
2944    in ``src/gromacs/mdtypes/inputrec.h``
2946 Removed features
2947 ^^^^^^^^^^^^^^^^
2949 This feature has been removed from |Gromacs|, but so that old
2950 :ref:`mdp` and :ref:`tpr` files cannot be mistakenly misused, we still
2951 parse this option. :ref:`gmx grompp` and :ref:`gmx mdrun` will issue a
2952 fatal error if this is set.
2954 .. mdp:: adress
2956    (no)
2958 .. _reference manual: gmx-manual-parent-dir_