Merge release-2019 into master
[alexxy/gromacs.git] / docs / user-guide / mdp-options.rst
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.
7
8 Molecular dynamics parameters (.mdp options)
9 ============================================
10
11 .. _mdp-general:
12
13 General information
14 -------------------
15
16 Default values are given in parentheses, or listed first among
17 choices. The first option in the list is always the default
18 option. Units are given in square brackets. The difference between a
19 dash and an underscore is ignored.
20
21 A :ref:`sample mdp file <mdp>` is available. This should be
22 appropriate to start a normal simulation. Edit it to suit your
23 specific needs and desires.
24
25
26 Preprocessing
27 ^^^^^^^^^^^^^
28
29 .. mdp:: include
30
31    directories to include in your topology. Format:
32    ``-I/home/john/mylib -I../otherlib``
33
34 .. mdp:: define
35
36    defines to pass to the preprocessor, default is no defines. You can
37    use any defines to control options in your customized topology
38    files. Options that act on existing :ref:`top` file mechanisms
39    include
40
41       ``-DFLEXIBLE`` will use flexible water instead of rigid water
42       into your topology, this can be useful for normal mode analysis.
43
44       ``-DPOSRES`` will trigger the inclusion of ``posre.itp`` into
45       your topology, used for implementing position restraints.
46
47
48 Run control
49 ^^^^^^^^^^^
50
51 .. mdp:: integrator
52
53    (Despite the name, this list includes algorithms that are not
54    actually integrators over time. :mdp-value:`integrator=steep` and
55    all entries following it are in this category)
56
57    .. mdp-value:: md
58
59       A leap-frog algorithm for integrating Newton's equations of motion.
60
61    .. mdp-value:: md-vv
62
63       A velocity Verlet algorithm for integrating Newton's equations
64       of motion.  For constant NVE simulations started from
65       corresponding points in the same trajectory, the trajectories
66       are analytically, but not binary, identical to the
67       :mdp-value:`integrator=md` leap-frog integrator. The the kinetic
68       energy, which is determined from the whole step velocities and
69       is therefore slightly too high. The advantage of this integrator
70       is more accurate, reversible Nose-Hoover and Parrinello-Rahman
71       coupling integration based on Trotter expansion, as well as
72       (slightly too small) full step velocity output. This all comes
73       at the cost off extra computation, especially with constraints
74       and extra communication in parallel. Note that for nearly all
75       production simulations the :mdp-value:`integrator=md` integrator
76       is accurate enough.
77
78    .. mdp-value:: md-vv-avek
79
80       A velocity Verlet algorithm identical to
81       :mdp-value:`integrator=md-vv`, except that the kinetic energy is
82       determined as the average of the two half step kinetic energies
83       as in the :mdp-value:`integrator=md` integrator, and this thus
84       more accurate.  With Nose-Hoover and/or Parrinello-Rahman
85       coupling this comes with a slight increase in computational
86       cost.
87
88    .. mdp-value:: sd
89
90       An accurate and efficient leap-frog stochastic dynamics
91       integrator. With constraints, coordinates needs to be
92       constrained twice per integration step. Depending on the
93       computational cost of the force calculation, this can take a
94       significant part of the simulation time. The temperature for one
95       or more groups of atoms (:mdp:`tc-grps`) is set with
96       :mdp:`ref-t`, the inverse friction constant for each group is
97       set with :mdp:`tau-t`.  The parameter :mdp:`tcoupl` is
98       ignored. The random generator is initialized with
99       :mdp:`ld-seed`. When used as a thermostat, an appropriate value
100       for :mdp:`tau-t` is 2 ps, since this results in a friction that
101       is lower than the internal friction of water, while it is high
102       enough to remove excess heat NOTE: temperature deviations decay
103       twice as fast as with a Berendsen thermostat with the same
104       :mdp:`tau-t`.
105
106    .. mdp-value:: bd
107
108       An Euler integrator for Brownian or position Langevin dynamics,
109       the velocity is the force divided by a friction coefficient
110       (:mdp:`bd-fric`) plus random thermal noise (:mdp:`ref-t`). When
111       :mdp:`bd-fric` is 0, the friction coefficient for each particle
112       is calculated as mass/ :mdp:`tau-t`, as for the integrator
113       :mdp-value:`integrator=sd`. The random generator is initialized
114       with :mdp:`ld-seed`.
115
116    .. mdp-value:: steep
117
118       A steepest descent algorithm for energy minimization. The
119       maximum step size is :mdp:`emstep`, the tolerance is
120       :mdp:`emtol`.
121
122    .. mdp-value:: cg
123
124       A conjugate gradient algorithm for energy minimization, the
125       tolerance is :mdp:`emtol`. CG is more efficient when a steepest
126       descent step is done every once in a while, this is determined
127       by :mdp:`nstcgsteep`. For a minimization prior to a normal mode
128       analysis, which requires a very high accuracy, |Gromacs| should be
129       compiled in double precision.
130
131    .. mdp-value:: l-bfgs
132
133       A quasi-Newtonian algorithm for energy minimization according to
134       the low-memory Broyden-Fletcher-Goldfarb-Shanno approach. In
135       practice this seems to converge faster than Conjugate Gradients,
136       but due to the correction steps necessary it is not (yet)
137       parallelized.
138
139    .. mdp-value:: nm
140
141       Normal mode analysis is performed on the structure in the :ref:`tpr`
142       file.  |Gromacs| should be compiled in double precision.
143
144    .. mdp-value:: tpi
145
146       Test particle insertion. The last molecule in the topology is
147       the test particle. A trajectory must be provided to ``mdrun
148       -rerun``. This trajectory should not contain the molecule to be
149       inserted. Insertions are performed :mdp:`nsteps` times in each
150       frame at random locations and with random orientiations of the
151       molecule. When :mdp:`nstlist` is larger than one,
152       :mdp:`nstlist` insertions are performed in a sphere with radius
153       :mdp:`rtpi` around a the same random location using the same
154       pair list. Since pair list construction is expensive,
155       one can perform several extra insertions with the same list
156       almost for free. The random seed is set with
157       :mdp:`ld-seed`. The temperature for the Boltzmann weighting is
158       set with :mdp:`ref-t`, this should match the temperature of the
159       simulation of the original trajectory. Dispersion correction is
160       implemented correctly for TPI. All relevant quantities are
161       written to the file specified with ``mdrun -tpi``. The
162       distribution of insertion energies is written to the file
163       specified with ``mdrun -tpid``. No trajectory or energy file is
164       written. Parallel TPI gives identical results to single-node
165       TPI. For charged molecules, using PME with a fine grid is most
166       accurate and also efficient, since the potential in the system
167       only needs to be calculated once per frame.
168
169    .. mdp-value:: tpic
170
171       Test particle insertion into a predefined cavity location. The
172       procedure is the same as for :mdp-value:`integrator=tpi`, except
173       that one coordinate extra is read from the trajectory, which is
174       used as the insertion location. The molecule to be inserted
175       should be centered at 0,0,0. |Gromacs| does not do this for you,
176       since for different situations a different way of centering
177       might be optimal. Also :mdp:`rtpi` sets the radius for the
178       sphere around this location. Neighbor searching is done only
179       once per frame, :mdp:`nstlist` is not used. Parallel
180       :mdp-value:`integrator=tpic` gives identical results to
181       single-rank :mdp-value:`integrator=tpic`.
182
183    .. mdp-value:: mimic
184
185       Enable MiMiC QM/MM coupling to run hybrid molecular dynamics.
186       Keey in mind that its required to launch CPMD compiled with MiMiC as well.
187       In this mode all options regarding integration (T-coupling, P-coupling,
188       timestep and number of steps) are ignored as CPMD will do the integration
189       instead. Options related to forces computation (cutoffs, PME parameters,
190       etc.) are working as usual. Atom selection to define QM atoms is read
191       from :mdp:`QMMM-grps`
192
193 .. mdp:: tinit
194
195         (0) [ps]
196         starting time for your run (only makes sense for time-based
197         integrators)
198
199 .. mdp:: dt
200
201         (0.001) [ps]
202         time step for integration (only makes sense for time-based
203         integrators)
204
205 .. mdp:: nsteps
206
207         (0)
208         maximum number of steps to integrate or minimize, -1 is no
209         maximum
210
211 .. mdp:: init-step
212
213         (0)
214         The starting step. The time at step i in a run is
215         calculated as: t = :mdp:`tinit` + :mdp:`dt` *
216         (:mdp:`init-step` + i). The free-energy lambda is calculated
217         as: lambda = :mdp:`init-lambda` + :mdp:`delta-lambda` *
218         (:mdp:`init-step` + i). Also non-equilibrium MD parameters can
219         depend on the step number. Thus for exact restarts or redoing
220         part of a run it might be necessary to set :mdp:`init-step` to
221         the step number of the restart frame. :ref:`gmx convert-tpr`
222         does this automatically.
223
224 .. mdp:: simulation-part
225
226          (0)
227          A simulation can consist of multiple parts, each of which has
228          a part number. This option specifies what that number will
229          be, which helps keep track of parts that are logically the
230          same simulation. This option is generally useful to set only
231          when coping with a crashed simulation where files were lost.
232
233 .. mdp:: comm-mode
234
235    .. mdp-value:: Linear
236
237       Remove center of mass translational velocity
238
239    .. mdp-value:: Angular
240
241       Remove center of mass translational and rotational velocity
242
243    .. mdp-value:: Linear-acceleration-correction
244
245       Remove center of mass translational velocity. Correct the center of
246       mass position assuming linear acceleration over :mdp:`nstcomm` steps.
247       This is useful for cases where an acceleration is expected on the
248       center of mass which is nearly constant over :mdp:`nstcomm` steps.
249       This can occur for example when pulling on a group using an absolute
250       reference.
251
252    .. mdp-value:: None
253
254       No restriction on the center of mass motion
255
256 .. mdp:: nstcomm
257
258    (100) [steps]
259    frequency for center of mass motion removal
260
261 .. mdp:: comm-grps
262
263    group(s) for center of mass motion removal, default is the whole
264    system
265
266
267 Langevin dynamics
268 ^^^^^^^^^^^^^^^^^
269
270 .. mdp:: bd-fric
271
272    (0) [amu ps\ :sup:`-1`]
273    Brownian dynamics friction coefficient. When :mdp:`bd-fric` is 0,
274    the friction coefficient for each particle is calculated as mass/
275    :mdp:`tau-t`.
276
277 .. mdp:: ld-seed
278
279    (-1) [integer]
280    used to initialize random generator for thermal noise for
281    stochastic and Brownian dynamics. When :mdp:`ld-seed` is set to -1,
282    a pseudo random seed is used. When running BD or SD on multiple
283    processors, each processor uses a seed equal to :mdp:`ld-seed` plus
284    the processor number.
285
286
287 Energy minimization
288 ^^^^^^^^^^^^^^^^^^^
289
290 .. mdp:: emtol
291
292    (10.0) [kJ mol\ :sup:`-1` nm\ :sup:`-1`]
293    the minimization is converged when the maximum force is smaller
294    than this value
295
296 .. mdp:: emstep
297
298    (0.01) [nm]
299    initial step-size
300
301 .. mdp:: nstcgsteep
302
303    (1000) [steps]
304    frequency of performing 1 steepest descent step while doing
305    conjugate gradient energy minimization.
306
307 .. mdp:: nbfgscorr
308
309    (10)
310    Number of correction steps to use for L-BFGS minimization. A higher
311    number is (at least theoretically) more accurate, but slower.
312
313
314 Shell Molecular Dynamics
315 ^^^^^^^^^^^^^^^^^^^^^^^^
316
317 When shells or flexible constraints are present in the system the
318 positions of the shells and the lengths of the flexible constraints
319 are optimized at every time step until either the RMS force on the
320 shells and constraints is less than :mdp:`emtol`, or a maximum number
321 of iterations :mdp:`niter` has been reached. Minimization is converged
322 when the maximum force is smaller than :mdp:`emtol`. For shell MD this
323 value should be 1.0 at most.
324
325 .. mdp:: niter
326
327    (20)
328    maximum number of iterations for optimizing the shell positions and
329    the flexible constraints.
330
331 .. mdp:: fcstep
332
333    (0) [ps\ :sup:`2`]
334    the step size for optimizing the flexible constraints. Should be
335    chosen as mu/(d2V/dq2) where mu is the reduced mass of two
336    particles in a flexible constraint and d2V/dq2 is the second
337    derivative of the potential in the constraint direction. Hopefully
338    this number does not differ too much between the flexible
339    constraints, as the number of iterations and thus the runtime is
340    very sensitive to fcstep. Try several values!
341
342
343 Test particle insertion
344 ^^^^^^^^^^^^^^^^^^^^^^^
345
346 .. mdp:: rtpi
347
348    (0.05) [nm]
349    the test particle insertion radius, see integrators
350    :mdp-value:`integrator=tpi` and :mdp-value:`integrator=tpic`
351
352
353 Output control
354 ^^^^^^^^^^^^^^
355
356 .. mdp:: nstxout
357
358    (0) [steps]
359    number of steps that elapse between writing coordinates to the output
360    trajectory file (:ref:`trr`), the last coordinates are always written
361
362 .. mdp:: nstvout
363
364    (0) [steps]
365    number of steps that elapse between writing velocities to the output
366    trajectory file (:ref:`trr`), the last velocities are always written
367
368 .. mdp:: nstfout
369
370    (0) [steps]
371    number of steps that elapse between writing forces to the output
372    trajectory file (:ref:`trr`), the last forces are always written.
373
374 .. mdp:: nstlog
375
376    (1000) [steps]
377    number of steps that elapse between writing energies to the log
378    file, the last energies are always written
379
380 .. mdp:: nstcalcenergy
381
382    (100)
383    number of steps that elapse between calculating the energies, 0 is
384    never. This option is only relevant with dynamics. This option affects the
385    performance in parallel simulations, because calculating energies
386    requires global communication between all processes which can
387    become a bottleneck at high parallelization.
388
389 .. mdp:: nstenergy
390
391    (1000) [steps]
392    number of steps that elapse between writing energies to energy file,
393    the last energies are always written, should be a multiple of
394    :mdp:`nstcalcenergy`. Note that the exact sums and fluctuations
395    over all MD steps modulo :mdp:`nstcalcenergy` are stored in the
396    energy file, so :ref:`gmx energy` can report exact energy averages
397    and fluctuations also when :mdp:`nstenergy` > 1
398
399 .. mdp:: nstxout-compressed
400
401    (0) [steps]
402    number of steps that elapse between writing position coordinates
403    using lossy compression (:ref:`xtc` file)
404
405 .. mdp:: compressed-x-precision
406
407    (1000) [real]
408    precision with which to write to the compressed trajectory file
409
410 .. mdp:: compressed-x-grps
411
412    group(s) to write to the compressed trajectory file, by default the
413    whole system is written (if :mdp:`nstxout-compressed` > 0)
414
415 .. mdp:: energygrps
416
417    group(s) for which to write to write short-ranged non-bonded
418    potential energies to the energy file (not supported on GPUs)
419
420
421 Neighbor searching
422 ^^^^^^^^^^^^^^^^^^
423
424 .. mdp:: cutoff-scheme
425
426    .. mdp-value:: Verlet
427
428       Generate a pair list with buffering. The buffer size is
429       automatically set based on :mdp:`verlet-buffer-tolerance`,
430       unless this is set to -1, in which case :mdp:`rlist` will be
431       used. This option has an explicit, exact cut-off at :mdp:`rvdw`
432       equal to :mdp:`rcoulomb`, unless PME or Ewald is used, in which
433       case :mdp:`rcoulomb` > :mdp:`rvdw` is allowed. Currently only
434       cut-off, reaction-field, PME or Ewald electrostatics and plain
435       LJ are supported. Some :ref:`gmx mdrun` functionality is not yet
436       supported with the :mdp-value:`cutoff-scheme=Verlet` scheme, but :ref:`gmx grompp`
437       checks for this. Native GPU acceleration is only supported with
438       :mdp-value:`cutoff-scheme=Verlet`. With GPU-accelerated PME or with separate PME
439       ranks, :ref:`gmx mdrun` will automatically tune the CPU/GPU load
440       balance by scaling :mdp:`rcoulomb` and the grid spacing. This
441       can be turned off with ``mdrun -notunepme``. :mdp-value:`cutoff-scheme=Verlet` is
442       faster than :mdp-value:`cutoff-scheme=group` when there is no water, or if
443       :mdp-value:`cutoff-scheme=group` would use a pair-list buffer to conserve energy.
444
445    .. mdp-value:: group
446
447       Generate a pair list for groups of atoms. These groups
448       correspond to the charge groups in the topology. This was the
449       only cut-off treatment scheme before version 4.6, and is
450       **deprecated since 5.1**. There is no explicit buffering of
451       the pair list. This enables efficient force calculations for
452       water, but energy is only conserved when a buffer is explicitly
453       added.
454
455 .. mdp:: nstlist
456
457    (10) [steps]
458
459    .. mdp-value:: >0
460
461       Frequency to update the neighbor list. When this is 0, the
462       neighbor list is made only once. With energy minimization the
463       pair list will be updated for every energy evaluation when
464       :mdp:`nstlist` is greater than 0. With :mdp-value:`cutoff-scheme=Verlet` and
465       :mdp:`verlet-buffer-tolerance` set, :mdp:`nstlist` is actually
466       a minimum value and :ref:`gmx mdrun` might increase it, unless
467       it is set to 1. With parallel simulations and/or non-bonded
468       force calculation on the GPU, a value of 20 or 40 often gives
469       the best performance. With :mdp-value:`cutoff-scheme=group` and non-exact
470       cut-off's, :mdp:`nstlist` will affect the accuracy of your
471       simulation and it can not be chosen freely.
472
473    .. mdp-value:: 0
474
475       The neighbor list is only constructed once and never
476       updated. This is mainly useful for vacuum simulations in which
477       all particles see each other.
478
479    .. mdp-value:: <0
480
481       Unused.
482
483 .. mdp:: ns-type
484
485    .. mdp-value:: grid
486
487       Make a grid in the box and only check atoms in neighboring grid
488       cells when constructing a new neighbor list every
489       :mdp:`nstlist` steps. In large systems grid search is much
490       faster than simple search.
491
492    .. mdp-value:: simple
493
494       Check every atom in the box when constructing a new neighbor
495       list every :mdp:`nstlist` steps (only with :mdp-value:`cutoff-scheme=group`
496       cut-off scheme).
497
498 .. mdp:: pbc
499
500    .. mdp-value:: xyz
501
502       Use periodic boundary conditions in all directions.
503
504    .. mdp-value:: no
505
506       Use no periodic boundary conditions, ignore the box. To simulate
507       without cut-offs, set all cut-offs and :mdp:`nstlist` to 0. For
508       best performance without cut-offs on a single MPI rank, set
509       :mdp:`nstlist` to zero and :mdp-value:`ns-type=simple`.
510
511    .. mdp-value:: xy
512
513       Use periodic boundary conditions in x and y directions
514       only. This works only with :mdp-value:`ns-type=grid` and can be used
515       in combination with walls_. Without walls or with only one wall
516       the system size is infinite in the z direction. Therefore
517       pressure coupling or Ewald summation methods can not be
518       used. These disadvantages do not apply when two walls are used.
519
520 .. mdp:: periodic-molecules
521
522    .. mdp-value:: no
523
524       molecules are finite, fast molecular PBC can be used
525
526    .. mdp-value:: yes
527
528       for systems with molecules that couple to themselves through the
529       periodic boundary conditions, this requires a slower PBC
530       algorithm and molecules are not made whole in the output
531
532 .. mdp:: verlet-buffer-tolerance
533
534    (0.005) [kJ mol\ :sup:`-1` ps\ :sup:`-1`]
535
536    Useful only with the :mdp-value:`cutoff-scheme=Verlet` :mdp:`cutoff-scheme`. This sets
537    the maximum allowed error for pair interactions per particle caused
538    by the Verlet buffer, which indirectly sets :mdp:`rlist`. As both
539    :mdp:`nstlist` and the Verlet buffer size are fixed (for
540    performance reasons), particle pairs not in the pair list can
541    occasionally get within the cut-off distance during
542    :mdp:`nstlist` -1 steps. This causes very small jumps in the
543    energy. In a constant-temperature ensemble, these very small energy
544    jumps can be estimated for a given cut-off and :mdp:`rlist`. The
545    estimate assumes a homogeneous particle distribution, hence the
546    errors might be slightly underestimated for multi-phase
547    systems. (See the `reference manual`_ for details). For longer
548    pair-list life-time (:mdp:`nstlist` -1) * :mdp:`dt` the buffer is
549    overestimated, because the interactions between particles are
550    ignored. Combined with cancellation of errors, the actual drift of
551    the total energy is usually one to two orders of magnitude
552    smaller. Note that the generated buffer size takes into account
553    that the |Gromacs| pair-list setup leads to a reduction in the
554    drift by a factor 10, compared to a simple particle-pair based
555    list. Without dynamics (energy minimization etc.), the buffer is 5%
556    of the cut-off. For NVE simulations the initial temperature is
557    used, unless this is zero, in which case a buffer of 10% is
558    used. For NVE simulations the tolerance usually needs to be lowered
559    to achieve proper energy conservation on the nanosecond time
560    scale. To override the automated buffer setting, use
561    :mdp:`verlet-buffer-tolerance` =-1 and set :mdp:`rlist` manually.
562
563 .. mdp:: rlist
564
565    (1) [nm]
566    Cut-off distance for the short-range neighbor list. With the
567    :mdp-value:`cutoff-scheme=Verlet` :mdp:`cutoff-scheme`, this is by default set by the
568    :mdp:`verlet-buffer-tolerance` option and the value of
569    :mdp:`rlist` is ignored.
570
571
572 Electrostatics
573 ^^^^^^^^^^^^^^
574
575 .. mdp:: coulombtype
576
577    .. mdp-value:: Cut-off
578
579       Plain cut-off with pair list radius :mdp:`rlist` and
580       Coulomb cut-off :mdp:`rcoulomb`, where :mdp:`rlist` >=
581       :mdp:`rcoulomb`.
582
583    .. mdp-value:: Ewald
584
585       Classical Ewald sum electrostatics. The real-space cut-off
586       :mdp:`rcoulomb` should be equal to :mdp:`rlist`. Use *e.g.*
587       :mdp:`rlist` =0.9, :mdp:`rcoulomb` =0.9. The highest magnitude
588       of wave vectors used in reciprocal space is controlled by
589       :mdp:`fourierspacing`. The relative accuracy of
590       direct/reciprocal space is controlled by :mdp:`ewald-rtol`.
591
592       NOTE: Ewald scales as O(N\ :sup:`3/2`) and is thus extremely slow for
593       large systems. It is included mainly for reference - in most
594       cases PME will perform much better.
595
596    .. mdp-value:: PME
597
598       Fast smooth Particle-Mesh Ewald (SPME) electrostatics. Direct
599       space is similar to the Ewald sum, while the reciprocal part is
600       performed with FFTs. Grid dimensions are controlled with
601       :mdp:`fourierspacing` and the interpolation order with
602       :mdp:`pme-order`. With a grid spacing of 0.1 nm and cubic
603       interpolation the electrostatic forces have an accuracy of
604       2-3*10\ :sup:`-4`. Since the error from the vdw-cutoff is larger than
605       this you might try 0.15 nm. When running in parallel the
606       interpolation parallelizes better than the FFT, so try
607       decreasing grid dimensions while increasing interpolation.
608
609    .. mdp-value:: P3M-AD
610
611       Particle-Particle Particle-Mesh algorithm with analytical
612       derivative for for long range electrostatic interactions. The
613       method and code is identical to SPME, except that the influence
614       function is optimized for the grid. This gives a slight increase
615       in accuracy.
616
617    .. mdp-value:: Reaction-Field
618
619       Reaction field electrostatics with Coulomb cut-off
620       :mdp:`rcoulomb`, where :mdp:`rlist` >= :mdp:`rvdw`. The
621       dielectric constant beyond the cut-off is
622       :mdp:`epsilon-rf`. The dielectric constant can be set to
623       infinity by setting :mdp:`epsilon-rf` =0.
624
625    .. mdp-value:: Reaction-Field-zero
626
627       In |Gromacs|, normal reaction-field electrostatics with
628       :mdp-value:`cutoff-scheme=group` leads to bad energy
629       conservation. :mdp-value:`coulombtype=Reaction-Field-zero` solves this by making
630       the potential zero beyond the cut-off. It can only be used with
631       an infinite dielectric constant (:mdp:`epsilon-rf` =0), because
632       only for that value the force vanishes at the
633       cut-off. :mdp:`rlist` should be 0.1 to 0.3 nm larger than
634       :mdp:`rcoulomb` to accommodate the size of charge groups
635       and diffusion between neighbor list updates. This, and the fact
636       that table lookups are used instead of analytical functions make
637       reaction-field-zero computationally more expensive than
638       normal reaction-field.
639
640    .. mdp-value:: Shift
641
642       Analogous to :mdp-value:`vdwtype=Shift` for :mdp:`vdwtype`. You
643       might want to use :mdp-value:`coulombtype=Reaction-Field-zero` instead, which has
644       a similar potential shape, but has a physical interpretation and
645       has better energies due to the exclusion correction terms.
646
647    .. mdp-value:: Encad-Shift
648
649       The Coulomb potential is decreased over the whole range, using
650       the definition from the Encad simulation package.
651
652    .. mdp-value:: Switch
653
654       Analogous to :mdp-value:`vdwtype=Switch` for
655       :mdp:`vdwtype`. Switching the Coulomb potential can lead to
656       serious artifacts, advice: use :mdp-value:`coulombtype=Reaction-Field-zero`
657       instead.
658
659    .. mdp-value:: User
660
661       :ref:`gmx mdrun` will now expect to find a file ``table.xvg``
662       with user-defined potential functions for repulsion, dispersion
663       and Coulomb. When pair interactions are present, :ref:`gmx
664       mdrun` also expects to find a file ``tablep.xvg`` for the pair
665       interactions. When the same interactions should be used for
666       non-bonded and pair interactions the user can specify the same
667       file name for both table files. These files should contain 7
668       columns: the ``x`` value, ``f(x)``, ``-f'(x)``, ``g(x)``,
669       ``-g'(x)``, ``h(x)``, ``-h'(x)``, where ``f(x)`` is the Coulomb
670       function, ``g(x)`` the dispersion function and ``h(x)`` the
671       repulsion function. When :mdp:`vdwtype` is not set to User the
672       values for ``g``, ``-g'``, ``h`` and ``-h'`` are ignored. For
673       the non-bonded interactions ``x`` values should run from 0 to
674       the largest cut-off distance + :mdp:`table-extension` and
675       should be uniformly spaced. For the pair interactions the table
676       length in the file will be used. The optimal spacing, which is
677       used for non-user tables, is ``0.002 nm`` when you run in mixed
678       precision or ``0.0005 nm`` when you run in double precision. The
679       function value at ``x=0`` is not important. More information is
680       in the printed manual.
681
682    .. mdp-value:: PME-Switch
683
684       A combination of PME and a switch function for the direct-space
685       part (see above). :mdp:`rcoulomb` is allowed to be smaller than
686       :mdp:`rlist`. This is mainly useful constant energy simulations
687       (note that using PME with :mdp-value:`cutoff-scheme=Verlet`
688       will be more efficient).
689
690    .. mdp-value:: PME-User
691
692       A combination of PME and user tables (see
693       above). :mdp:`rcoulomb` is allowed to be smaller than
694       :mdp:`rlist`. The PME mesh contribution is subtracted from the
695       user table by :ref:`gmx mdrun`. Because of this subtraction the
696       user tables should contain about 10 decimal places.
697
698    .. mdp-value:: PME-User-Switch
699
700       A combination of PME-User and a switching function (see
701       above). The switching function is applied to final
702       particle-particle interaction, *i.e.* both to the user supplied
703       function and the PME Mesh correction part.
704
705 .. mdp:: coulomb-modifier
706
707    .. mdp-value:: Potential-shift-Verlet
708
709       Selects Potential-shift with the Verlet cutoff-scheme, as it is
710       (nearly) free; selects None with the group cutoff-scheme.
711
712    .. mdp-value:: Potential-shift
713
714       Shift the Coulomb potential by a constant such that it is zero
715       at the cut-off. This makes the potential the integral of the
716       force. Note that this does not affect the forces or the
717       sampling.
718
719    .. mdp-value:: None
720
721       Use an unmodified Coulomb potential. With the group scheme this
722       means no exact cut-off is used, energies and forces are
723       calculated for all pairs in the pair list.
724
725 .. mdp:: rcoulomb-switch
726
727    (0) [nm]
728    where to start switching the Coulomb potential, only relevant
729    when force or potential switching is used
730
731 .. mdp:: rcoulomb
732
733    (1) [nm]
734    The distance for the Coulomb cut-off. Note that with PME this value
735    can be increased by the PME tuning in :ref:`gmx mdrun` along with
736    the PME grid spacing.
737
738 .. mdp:: epsilon-r
739
740    (1)
741    The relative dielectric constant. A value of 0 means infinity.
742
743 .. mdp:: epsilon-rf
744
745    (0)
746    The relative dielectric constant of the reaction field. This
747    is only used with reaction-field electrostatics. A value of 0
748    means infinity.
749
750
751 Van der Waals
752 ^^^^^^^^^^^^^
753
754 .. mdp:: vdwtype
755
756    .. mdp-value:: Cut-off
757
758       Plain cut-off with pair list radius :mdp:`rlist` and VdW
759       cut-off :mdp:`rvdw`, where :mdp:`rlist` >= :mdp:`rvdw`.
760
761    .. mdp-value:: PME
762
763       Fast smooth Particle-mesh Ewald (SPME) for VdW interactions. The
764       grid dimensions are controlled with :mdp:`fourierspacing` in
765       the same way as for electrostatics, and the interpolation order
766       is controlled with :mdp:`pme-order`. The relative accuracy of
767       direct/reciprocal space is controlled by :mdp:`ewald-rtol-lj`,
768       and the specific combination rules that are to be used by the
769       reciprocal routine are set using :mdp:`lj-pme-comb-rule`.
770
771    .. mdp-value:: Shift
772
773       This functionality is deprecated and replaced by using
774       :mdp-value:`vdwtype=Cut-off` with :mdp-value:`vdw-modifier=Force-switch`.
775       The LJ (not Buckingham) potential is decreased over the whole range and
776       the forces decay smoothly to zero between :mdp:`rvdw-switch` and
777       :mdp:`rvdw`. The neighbor search cut-off :mdp:`rlist` should
778       be 0.1 to 0.3 nm larger than :mdp:`rvdw` to accommodate the
779       size of charge groups and diffusion between neighbor list
780       updates.
781
782    .. mdp-value:: Switch
783
784       This functionality is deprecated and replaced by using
785       :mdp-value:`vdwtype=Cut-off` with :mdp-value:`vdw-modifier=Potential-switch`.
786       The LJ (not Buckingham) potential is normal out to :mdp:`rvdw-switch`, after
787       which it is switched off to reach zero at :mdp:`rvdw`. Both the
788       potential and force functions are continuously smooth, but be
789       aware that all switch functions will give rise to a bulge
790       (increase) in the force (since we are switching the
791       potential). The neighbor search cut-off :mdp:`rlist` should be
792       0.1 to 0.3 nm larger than :mdp:`rvdw` to accommodate the
793       size of charge groups and diffusion between neighbor list
794       updates.
795
796    .. mdp-value:: Encad-Shift
797
798       The LJ (not Buckingham) potential is decreased over the whole
799       range, using the definition from the Encad simulation package.
800
801    .. mdp-value:: User
802
803       See user for :mdp:`coulombtype`. The function value at zero is
804       not important. When you want to use LJ correction, make sure
805       that :mdp:`rvdw` corresponds to the cut-off in the user-defined
806       function. When :mdp:`coulombtype` is not set to User the values
807       for the ``f`` and ``-f'`` columns are ignored.
808
809 .. mdp:: vdw-modifier
810
811    .. mdp-value:: Potential-shift-Verlet
812
813       Selects Potential-shift with the Verlet cutoff-scheme, as it is
814       (nearly) free; selects None with the group cutoff-scheme.
815
816    .. mdp-value:: Potential-shift
817
818       Shift the Van der Waals potential by a constant such that it is
819       zero at the cut-off. This makes the potential the integral of
820       the force. Note that this does not affect the forces or the
821       sampling.
822
823    .. mdp-value:: None
824
825       Use an unmodified Van der Waals potential. With the group scheme
826       this means no exact cut-off is used, energies and forces are
827       calculated for all pairs in the pair list.
828
829    .. mdp-value:: Force-switch
830
831       Smoothly switches the forces to zero between :mdp:`rvdw-switch`
832       and :mdp:`rvdw`. This shifts the potential shift over the whole
833       range and switches it to zero at the cut-off. Note that this is
834       more expensive to calculate than a plain cut-off and it is not
835       required for energy conservation, since Potential-shift
836       conserves energy just as well.
837
838    .. mdp-value:: Potential-switch
839
840       Smoothly switches the potential to zero between
841       :mdp:`rvdw-switch` and :mdp:`rvdw`. Note that this introduces
842       articifically large forces in the switching region and is much
843       more expensive to calculate. This option should only be used if
844       the force field you are using requires this.
845
846 .. mdp:: rvdw-switch
847
848    (0) [nm]
849    where to start switching the LJ force and possibly the potential,
850    only relevant when force or potential switching is used
851
852 .. mdp:: rvdw
853
854    (1) [nm]
855    distance for the LJ or Buckingham cut-off
856
857 .. mdp:: DispCorr
858
859    .. mdp-value:: no
860
861       don't apply any correction
862
863    .. mdp-value:: EnerPres
864
865       apply long range dispersion corrections for Energy and Pressure
866
867    .. mdp-value:: Ener
868
869       apply long range dispersion corrections for Energy only
870
871
872 Tables
873 ^^^^^^
874
875 .. mdp:: table-extension
876
877    (1) [nm]
878    Extension of the non-bonded potential lookup tables beyond the
879    largest cut-off distance. The value should be large enough to
880    account for charge group sizes and the diffusion between
881    neighbor-list updates. Without user defined potential the same
882    table length is used for the lookup tables for the 1-4
883    interactions, which are always tabulated irrespective of the use of
884    tables for the non-bonded interactions. The value of
885    :mdp:`table-extension` in no way affects the values of
886    :mdp:`rlist`, :mdp:`rcoulomb`, or :mdp:`rvdw`.
887
888 .. mdp:: energygrp-table
889
890    When user tables are used for electrostatics and/or VdW, here one
891    can give pairs of energy groups for which seperate user tables
892    should be used. The two energy groups will be appended to the table
893    file name, in order of their definition in :mdp:`energygrps`,
894    seperated by underscores. For example, if ``energygrps = Na Cl
895    Sol`` and ``energygrp-table = Na Na Na Cl``, :ref:`gmx mdrun` will
896    read ``table_Na_Na.xvg`` and ``table_Na_Cl.xvg`` in addition to the
897    normal ``table.xvg`` which will be used for all other energy group
898    pairs.
899
900
901 Ewald
902 ^^^^^
903
904 .. mdp:: fourierspacing
905
906    (0.12) [nm]
907    For ordinary Ewald, the ratio of the box dimensions and the spacing
908    determines a lower bound for the number of wave vectors to use in
909    each (signed) direction. For PME and P3M, that ratio determines a
910    lower bound for the number of Fourier-space grid points that will
911    be used along that axis. In all cases, the number for each
912    direction can be overridden by entering a non-zero value for that
913    :mdp:`fourier-nx` direction. For optimizing the relative load of
914    the particle-particle interactions and the mesh part of PME, it is
915    useful to know that the accuracy of the electrostatics remains
916    nearly constant when the Coulomb cut-off and the PME grid spacing
917    are scaled by the same factor. Note that this spacing can be scaled
918    up along with :mdp:`rcoulomb` by the PME tuning in :ref:`gmx mdrun`.
919
920 .. mdp:: fourier-nx
921 .. mdp:: fourier-ny
922 .. mdp:: fourier-nz
923
924    (0)
925    Highest magnitude of wave vectors in reciprocal space when using Ewald.
926    Grid size when using PME or P3M. These values override
927    :mdp:`fourierspacing` per direction. The best choice is powers of
928    2, 3, 5 and 7. Avoid large primes. Note that these grid sizes can
929    be reduced along with scaling up :mdp:`rcoulomb` by the PME tuning
930    in :ref:`gmx mdrun`.
931
932 .. mdp:: pme-order
933
934    (4)
935    Interpolation order for PME. 4 equals cubic interpolation. You
936    might try 6/8/10 when running in parallel and simultaneously
937    decrease grid dimension.
938
939 .. mdp:: ewald-rtol
940
941    (10\ :sup:`-5`)
942    The relative strength of the Ewald-shifted direct potential at
943    :mdp:`rcoulomb` is given by :mdp:`ewald-rtol`. Decreasing this
944    will give a more accurate direct sum, but then you need more wave
945    vectors for the reciprocal sum.
946
947 .. mdp:: ewald-rtol-lj
948
949    (10\ :sup:`-3`)
950    When doing PME for VdW-interactions, :mdp:`ewald-rtol-lj` is used
951    to control the relative strength of the dispersion potential at
952    :mdp:`rvdw` in the same way as :mdp:`ewald-rtol` controls the
953    electrostatic potential.
954
955 .. mdp:: lj-pme-comb-rule
956
957    (Geometric)
958    The combination rules used to combine VdW-parameters in the
959    reciprocal part of LJ-PME. Geometric rules are much faster than
960    Lorentz-Berthelot and usually the recommended choice, even when the
961    rest of the force field uses the Lorentz-Berthelot rules.
962
963    .. mdp-value:: Geometric
964
965       Apply geometric combination rules
966
967    .. mdp-value:: Lorentz-Berthelot
968
969       Apply Lorentz-Berthelot combination rules
970
971 .. mdp:: ewald-geometry
972
973    .. mdp-value:: 3d
974
975       The Ewald sum is performed in all three dimensions.
976
977    .. mdp-value:: 3dc
978
979       The reciprocal sum is still performed in 3D, but a force and
980       potential correction applied in the `z` dimension to produce a
981       pseudo-2D summation. If your system has a slab geometry in the
982       `x-y` plane you can try to increase the `z`-dimension of the box
983       (a box height of 3 times the slab height is usually ok) and use
984       this option.
985
986 .. mdp:: epsilon-surface
987
988    (0)
989    This controls the dipole correction to the Ewald summation in
990    3D. The default value of zero means it is turned off. Turn it on by
991    setting it to the value of the relative permittivity of the
992    imaginary surface around your infinite system. Be careful - you
993    shouldn't use this if you have free mobile charges in your
994    system. This value does not affect the slab 3DC variant of the long
995    range corrections.
996
997
998 Temperature coupling
999 ^^^^^^^^^^^^^^^^^^^^
1000
1001 .. mdp:: tcoupl
1002
1003    .. mdp-value:: no
1004
1005       No temperature coupling.
1006
1007    .. mdp-value:: berendsen
1008
1009       Temperature coupling with a Berendsen thermostat to a bath with
1010       temperature :mdp:`ref-t`, with time constant
1011       :mdp:`tau-t`. Several groups can be coupled separately, these
1012       are specified in the :mdp:`tc-grps` field separated by spaces.
1013
1014    .. mdp-value:: nose-hoover
1015
1016       Temperature coupling using a Nose-Hoover extended ensemble. The
1017       reference temperature and coupling groups are selected as above,
1018       but in this case :mdp:`tau-t` controls the period of the
1019       temperature fluctuations at equilibrium, which is slightly
1020       different from a relaxation time. For NVT simulations the
1021       conserved energy quantity is written to the energy and log files.
1022
1023    .. mdp-value:: andersen
1024
1025       Temperature coupling by randomizing a fraction of the particle velocities
1026       at each timestep. Reference temperature and coupling groups are
1027       selected as above. :mdp:`tau-t` is the average time between
1028       randomization of each molecule. Inhibits particle dynamics
1029       somewhat, but little or no ergodicity issues. Currently only
1030       implemented with velocity Verlet, and not implemented with
1031       constraints.
1032
1033    .. mdp-value:: andersen-massive
1034
1035       Temperature coupling by randomizing velocities of all particles at
1036       infrequent timesteps. Reference temperature and coupling groups are
1037       selected as above. :mdp:`tau-t` is the time between
1038       randomization of all molecules. Inhibits particle dynamics
1039       somewhat, but little or no ergodicity issues. Currently only
1040       implemented with velocity Verlet.
1041
1042    .. mdp-value:: v-rescale
1043
1044       Temperature coupling using velocity rescaling with a stochastic
1045       term (JCP 126, 014101). This thermostat is similar to Berendsen
1046       coupling, with the same scaling using :mdp:`tau-t`, but the
1047       stochastic term ensures that a proper canonical ensemble is
1048       generated. The random seed is set with :mdp:`ld-seed`. This
1049       thermostat works correctly even for :mdp:`tau-t` =0. For NVT
1050       simulations the conserved energy quantity is written to the
1051       energy and log file.
1052
1053 .. mdp:: nsttcouple
1054
1055    (-1)
1056    The frequency for coupling the temperature. The default value of -1
1057    sets :mdp:`nsttcouple` equal to :mdp:`nstlist`, unless
1058    :mdp:`nstlist` <=0, then a value of 10 is used. For velocity
1059    Verlet integrators :mdp:`nsttcouple` is set to 1.
1060
1061 .. mdp:: nh-chain-length
1062
1063    (10)
1064    The number of chained Nose-Hoover thermostats for velocity Verlet
1065    integrators, the leap-frog :mdp-value:`integrator=md` integrator
1066    only supports 1. Data for the NH chain variables is not printed
1067    to the :ref:`edr` file by default, but can be turned on with the
1068    :mdp:`print-nose-hoover-chain-variables` option.
1069
1070 .. mdp:: print-nose-hoover-chain-variables
1071
1072    .. mdp-value:: no
1073
1074       Do not store Nose-Hoover chain variables in the energy file.
1075
1076    .. mdp-value:: yes
1077
1078       Store all positions and velocities of the Nose-Hoover chain
1079       in the energy file.
1080
1081 .. mdp:: tc-grps
1082
1083    groups to couple to separate temperature baths
1084
1085 .. mdp:: tau-t
1086
1087    [ps]
1088    time constant for coupling (one for each group in
1089    :mdp:`tc-grps`), -1 means no temperature coupling
1090
1091 .. mdp:: ref-t
1092
1093    [K]
1094    reference temperature for coupling (one for each group in
1095    :mdp:`tc-grps`)
1096
1097
1098 Pressure coupling
1099 ^^^^^^^^^^^^^^^^^
1100
1101 .. mdp:: pcoupl
1102
1103    .. mdp-value:: no
1104
1105       No pressure coupling. This means a fixed box size.
1106
1107    .. mdp-value:: Berendsen
1108
1109       Exponential relaxation pressure coupling with time constant
1110       :mdp:`tau-p`. The box is scaled every :mdp:`nstpcouple` steps. It has been
1111       argued that this does not yield a correct thermodynamic
1112       ensemble, but it is the most efficient way to scale a box at the
1113       beginning of a run.
1114
1115    .. mdp-value:: Parrinello-Rahman
1116
1117       Extended-ensemble pressure coupling where the box vectors are
1118       subject to an equation of motion. The equation of motion for the
1119       atoms is coupled to this. No instantaneous scaling takes
1120       place. As for Nose-Hoover temperature coupling the time constant
1121       :mdp:`tau-p` is the period of pressure fluctuations at
1122       equilibrium. This is probably a better method when you want to
1123       apply pressure scaling during data collection, but beware that
1124       you can get very large oscillations if you are starting from a
1125       different pressure. For simulations where the exact fluctations
1126       of the NPT ensemble are important, or if the pressure coupling
1127       time is very short it may not be appropriate, as the previous
1128       time step pressure is used in some steps of the |Gromacs|
1129       implementation for the current time step pressure.
1130
1131    .. mdp-value:: MTTK
1132
1133       Martyna-Tuckerman-Tobias-Klein implementation, only useable with
1134       :mdp-value:`integrator=md-vv` or :mdp-value:`integrator=md-vv-avek`, very similar to
1135       Parrinello-Rahman. As for Nose-Hoover temperature coupling the
1136       time constant :mdp:`tau-p` is the period of pressure
1137       fluctuations at equilibrium. This is probably a better method
1138       when you want to apply pressure scaling during data collection,
1139       but beware that you can get very large oscillations if you are
1140       starting from a different pressure. Currently (as of version
1141       5.1), it only supports isotropic scaling, and only works without
1142       constraints.
1143
1144 .. mdp:: pcoupltype
1145
1146    Specifies the kind of isotropy of the pressure coupling used. Each
1147    kind takes one or more values for :mdp:`compressibility` and
1148    :mdp:`ref-p`. Only a single value is permitted for :mdp:`tau-p`.
1149
1150    .. mdp-value:: isotropic
1151
1152       Isotropic pressure coupling with time constant
1153       :mdp:`tau-p`. One value each for :mdp:`compressibility` and
1154       :mdp:`ref-p` is required.
1155
1156    .. mdp-value:: semiisotropic
1157
1158       Pressure coupling which is isotropic in the ``x`` and ``y``
1159       direction, but different in the ``z`` direction. This can be
1160       useful for membrane simulations. Two values each for
1161       :mdp:`compressibility` and :mdp:`ref-p` are required, for
1162       ``x/y`` and ``z`` directions respectively.
1163
1164    .. mdp-value:: anisotropic
1165
1166       Same as before, but 6 values are needed for ``xx``, ``yy``, ``zz``,
1167       ``xy/yx``, ``xz/zx`` and ``yz/zy`` components,
1168       respectively. When the off-diagonal compressibilities are set to
1169       zero, a rectangular box will stay rectangular. Beware that
1170       anisotropic scaling can lead to extreme deformation of the
1171       simulation box.
1172
1173    .. mdp-value:: surface-tension
1174
1175       Surface tension coupling for surfaces parallel to the
1176       xy-plane. Uses normal pressure coupling for the `z`-direction,
1177       while the surface tension is coupled to the `x/y` dimensions of
1178       the box. The first :mdp:`ref-p` value is the reference surface
1179       tension times the number of surfaces ``bar nm``, the second
1180       value is the reference `z`-pressure ``bar``. The two
1181       :mdp:`compressibility` values are the compressibility in the
1182       `x/y` and `z` direction respectively. The value for the
1183       `z`-compressibility should be reasonably accurate since it
1184       influences the convergence of the surface-tension, it can also
1185       be set to zero to have a box with constant height.
1186
1187 .. mdp:: nstpcouple
1188
1189    (-1)
1190    The frequency for coupling the pressure. The default value of -1
1191    sets :mdp:`nstpcouple` equal to :mdp:`nstlist`, unless
1192    :mdp:`nstlist` <=0, then a value of 10 is used. For velocity
1193    Verlet integrators :mdp:`nstpcouple` is set to 1.
1194
1195 .. mdp:: tau-p
1196
1197    (1) [ps]
1198    The time constant for pressure coupling (one value for all
1199    directions).
1200
1201 .. mdp:: compressibility
1202
1203    [bar\ :sup:`-1`]
1204    The compressibility (NOTE: this is now really in bar\ :sup:`-1`) For water at 1
1205    atm and 300 K the compressibility is 4.5e-5 bar\ :sup:`-1`. The number of
1206    required values is implied by :mdp:`pcoupltype`.
1207
1208 .. mdp:: ref-p
1209
1210    [bar]
1211    The reference pressure for coupling. The number of required values
1212    is implied by :mdp:`pcoupltype`.
1213
1214 .. mdp:: refcoord-scaling
1215
1216    .. mdp-value:: no
1217
1218       The reference coordinates for position restraints are not
1219       modified. Note that with this option the virial and pressure
1220       might be ill defined, see :ref:`here <reference-manual-position-restraints>`
1221       for more details.
1222
1223    .. mdp-value:: all
1224
1225       The reference coordinates are scaled with the scaling matrix of
1226       the pressure coupling.
1227
1228    .. mdp-value:: com
1229
1230       Scale the center of mass of the reference coordinates with the
1231       scaling matrix of the pressure coupling. The vectors of each
1232       reference coordinate to the center of mass are not scaled. Only
1233       one COM is used, even when there are multiple molecules with
1234       position restraints. For calculating the COM of the reference
1235       coordinates in the starting configuration, periodic boundary
1236       conditions are not taken into account. Note that with this option
1237       the virial and pressure might be ill defined, see
1238       :ref:`here <reference-manual-position-restraints>` for more details.
1239
1240
1241 Simulated annealing
1242 ^^^^^^^^^^^^^^^^^^^
1243
1244 Simulated annealing is controlled separately for each temperature
1245 group in |Gromacs|. The reference temperature is a piecewise linear
1246 function, but you can use an arbitrary number of points for each
1247 group, and choose either a single sequence or a periodic behaviour for
1248 each group. The actual annealing is performed by dynamically changing
1249 the reference temperature used in the thermostat algorithm selected,
1250 so remember that the system will usually not instantaneously reach the
1251 reference temperature!
1252
1253 .. mdp:: annealing
1254
1255    Type of annealing for each temperature group
1256
1257    .. mdp-value:: no
1258
1259        No simulated annealing - just couple to reference temperature value.
1260
1261    .. mdp-value:: single
1262
1263        A single sequence of annealing points. If your simulation is
1264        longer than the time of the last point, the temperature will be
1265        coupled to this constant value after the annealing sequence has
1266        reached the last time point.
1267
1268    .. mdp-value:: periodic
1269
1270        The annealing will start over at the first reference point once
1271        the last reference time is reached. This is repeated until the
1272        simulation ends.
1273
1274 .. mdp:: annealing-npoints
1275
1276    A list with the number of annealing reference/control points used
1277    for each temperature group. Use 0 for groups that are not
1278    annealed. The number of entries should equal the number of
1279    temperature groups.
1280
1281 .. mdp:: annealing-time
1282
1283    List of times at the annealing reference/control points for each
1284    group. If you are using periodic annealing, the times will be used
1285    modulo the last value, *i.e.* if the values are 0, 5, 10, and 15,
1286    the coupling will restart at the 0ps value after 15ps, 30ps, 45ps,
1287    etc. The number of entries should equal the sum of the numbers
1288    given in :mdp:`annealing-npoints`.
1289
1290 .. mdp:: annealing-temp
1291
1292    List of temperatures at the annealing reference/control points for
1293    each group. The number of entries should equal the sum of the
1294    numbers given in :mdp:`annealing-npoints`.
1295
1296 Confused? OK, let's use an example. Assume you have two temperature
1297 groups, set the group selections to ``annealing = single periodic``,
1298 the number of points of each group to ``annealing-npoints = 3 4``, the
1299 times to ``annealing-time = 0 3 6 0 2 4 6`` and finally temperatures
1300 to ``annealing-temp = 298 280 270 298 320 320 298``. The first group
1301 will be coupled to 298K at 0ps, but the reference temperature will
1302 drop linearly to reach 280K at 3ps, and then linearly between 280K and
1303 270K from 3ps to 6ps. After this is stays constant, at 270K. The
1304 second group is coupled to 298K at 0ps, it increases linearly to 320K
1305 at 2ps, where it stays constant until 4ps. Between 4ps and 6ps it
1306 decreases to 298K, and then it starts over with the same pattern
1307 again, *i.e.* rising linearly from 298K to 320K between 6ps and
1308 8ps. Check the summary printed by :ref:`gmx grompp` if you are unsure!
1309
1310
1311 Velocity generation
1312 ^^^^^^^^^^^^^^^^^^^
1313
1314 .. mdp:: gen-vel
1315
1316    .. mdp-value:: no
1317
1318         Do not generate velocities. The velocities are set to zero
1319         when there are no velocities in the input structure file.
1320
1321    .. mdp-value:: yes
1322
1323         Generate velocities in :ref:`gmx grompp` according to a
1324         Maxwell distribution at temperature :mdp:`gen-temp`, with
1325         random seed :mdp:`gen-seed`. This is only meaningful with
1326         :mdp-value:`integrator=md`.
1327
1328 .. mdp:: gen-temp
1329
1330    (300) [K]
1331    temperature for Maxwell distribution
1332
1333 .. mdp:: gen-seed
1334
1335    (-1) [integer]
1336    used to initialize random generator for random velocities,
1337    when :mdp:`gen-seed` is set to -1, a pseudo random seed is
1338    used.
1339
1340
1341 Bonds
1342 ^^^^^
1343
1344 .. mdp:: constraints
1345
1346    Controls which bonds in the topology will be converted to rigid
1347    holonomic constraints. Note that typical rigid water models do not
1348    have bonds, but rather a specialized ``[settles]`` directive, so
1349    are not affected by this keyword.
1350
1351    .. mdp-value:: none
1352
1353       No bonds converted to constraints.
1354
1355    .. mdp-value:: h-bonds
1356
1357       Convert the bonds with H-atoms to constraints.
1358
1359    .. mdp-value:: all-bonds
1360
1361       Convert all bonds to constraints.
1362
1363    .. mdp-value:: h-angles
1364
1365       Convert all bonds to constraints and convert the angles that
1366       involve H-atoms to bond-constraints.
1367
1368    .. mdp-value:: all-angles
1369
1370       Convert all bonds to constraints and all angles to bond-constraints.
1371
1372 .. mdp:: constraint-algorithm
1373
1374    Chooses which solver satisfies any non-SETTLE holonomic
1375    constraints.
1376
1377    .. mdp-value:: LINCS
1378
1379       LINear Constraint Solver. With domain decomposition the parallel
1380       version P-LINCS is used. The accuracy in set with
1381       :mdp:`lincs-order`, which sets the number of matrices in the
1382       expansion for the matrix inversion. After the matrix inversion
1383       correction the algorithm does an iterative correction to
1384       compensate for lengthening due to rotation. The number of such
1385       iterations can be controlled with :mdp:`lincs-iter`. The root
1386       mean square relative constraint deviation is printed to the log
1387       file every :mdp:`nstlog` steps. If a bond rotates more than
1388       :mdp:`lincs-warnangle` in one step, a warning will be printed
1389       both to the log file and to ``stderr``. LINCS should not be used
1390       with coupled angle constraints.
1391
1392    .. mdp-value:: SHAKE
1393
1394       SHAKE is slightly slower and less stable than LINCS, but does
1395       work with angle constraints. The relative tolerance is set with
1396       :mdp:`shake-tol`, 0.0001 is a good value for "normal" MD. SHAKE
1397       does not support constraints between atoms on different nodes,
1398       thus it can not be used with domain decompositon when inter
1399       charge-group constraints are present. SHAKE can not be used with
1400       energy minimization.
1401
1402 .. mdp:: continuation
1403
1404    This option was formerly known as ``unconstrained-start``.
1405
1406    .. mdp-value:: no
1407
1408       apply constraints to the start configuration and reset shells
1409
1410    .. mdp-value:: yes
1411
1412       do not apply constraints to the start configuration and do not
1413       reset shells, useful for exact coninuation and reruns
1414
1415 .. mdp:: shake-tol
1416
1417    (0.0001)
1418    relative tolerance for SHAKE
1419
1420 .. mdp:: lincs-order
1421
1422    (4)
1423    Highest order in the expansion of the constraint coupling
1424    matrix. When constraints form triangles, an additional expansion of
1425    the same order is applied on top of the normal expansion only for
1426    the couplings within such triangles. For "normal" MD simulations an
1427    order of 4 usually suffices, 6 is needed for large time-steps with
1428    virtual sites or BD. For accurate energy minimization an order of 8
1429    or more might be required. With domain decomposition, the cell size
1430    is limited by the distance spanned by :mdp:`lincs-order` +1
1431    constraints. When one wants to scale further than this limit, one
1432    can decrease :mdp:`lincs-order` and increase :mdp:`lincs-iter`,
1433    since the accuracy does not deteriorate when (1+ :mdp:`lincs-iter`
1434    )* :mdp:`lincs-order` remains constant.
1435
1436 .. mdp:: lincs-iter
1437
1438    (1)
1439    Number of iterations to correct for rotational lengthening in
1440    LINCS. For normal runs a single step is sufficient, but for NVE
1441    runs where you want to conserve energy accurately or for accurate
1442    energy minimization you might want to increase it to 2.
1443
1444 .. mdp:: lincs-warnangle
1445
1446    (30) [deg]
1447    maximum angle that a bond can rotate before LINCS will complain
1448
1449 .. mdp:: morse
1450
1451    .. mdp-value:: no
1452
1453       bonds are represented by a harmonic potential
1454
1455    .. mdp-value:: yes
1456
1457       bonds are represented by a Morse potential
1458
1459
1460 Energy group exclusions
1461 ^^^^^^^^^^^^^^^^^^^^^^^
1462
1463 .. mdp:: energygrp-excl
1464
1465    Pairs of energy groups for which all non-bonded interactions are
1466    excluded. An example: if you have two energy groups ``Protein`` and
1467    ``SOL``, specifying ``energygrp-excl = Protein Protein SOL SOL``
1468    would give only the non-bonded interactions between the protein and
1469    the solvent. This is especially useful for speeding up energy
1470    calculations with ``mdrun -rerun`` and for excluding interactions
1471    within frozen groups.
1472
1473
1474 Walls
1475 ^^^^^
1476
1477 .. mdp:: nwall
1478
1479    (0)
1480    When set to 1 there is a wall at ``z=0``, when set to 2 there is
1481    also a wall at ``z=z-box``. Walls can only be used with :mdp:`pbc`
1482    ``=xy``. When set to 2, pressure coupling and Ewald summation can be
1483    used (it is usually best to use semiisotropic pressure coupling
1484    with the ``x/y`` compressibility set to 0, as otherwise the surface
1485    area will change). Walls interact wit the rest of the system
1486    through an optional :mdp:`wall-atomtype`. Energy groups ``wall0``
1487    and ``wall1`` (for :mdp:`nwall` =2) are added automatically to
1488    monitor the interaction of energy groups with each wall. The center
1489    of mass motion removal will be turned off in the ``z``-direction.
1490
1491 .. mdp:: wall-atomtype
1492
1493    the atom type name in the force field for each wall. By (for
1494    example) defining a special wall atom type in the topology with its
1495    own combination rules, this allows for independent tuning of the
1496    interaction of each atomtype with the walls.
1497
1498 .. mdp:: wall-type
1499
1500    .. mdp-value:: 9-3
1501
1502       LJ integrated over the volume behind the wall: 9-3 potential
1503
1504    .. mdp-value:: 10-4
1505
1506       LJ integrated over the wall surface: 10-4 potential
1507
1508    .. mdp-value:: 12-6
1509
1510       direct LJ potential with the ``z`` distance from the wall
1511
1512 .. mdp:: table
1513
1514    user defined potentials indexed with the ``z`` distance from the
1515    wall, the tables are read analogously to the
1516    :mdp:`energygrp-table` option, where the first name is for a
1517    "normal" energy group and the second name is ``wall0`` or
1518    ``wall1``, only the dispersion and repulsion columns are used
1519
1520 .. mdp:: wall-r-linpot
1521
1522    (-1) [nm]
1523    Below this distance from the wall the potential is continued
1524    linearly and thus the force is constant. Setting this option to a
1525    postive value is especially useful for equilibration when some
1526    atoms are beyond a wall. When the value is <=0 (<0 for
1527    :mdp:`wall-type` =table), a fatal error is generated when atoms
1528    are beyond a wall.
1529
1530 .. mdp:: wall-density
1531
1532    [nm\ :sup:`-3`] / [nm\ :sup:`-2`]
1533    the number density of the atoms for each wall for wall types 9-3
1534    and 10-4
1535
1536 .. mdp:: wall-ewald-zfac
1537
1538    (3)
1539    The scaling factor for the third box vector for Ewald summation
1540    only, the minimum is 2. Ewald summation can only be used with
1541    :mdp:`nwall` =2, where one should use :mdp:`ewald-geometry`
1542    ``=3dc``. The empty layer in the box serves to decrease the
1543    unphysical Coulomb interaction between periodic images.
1544
1545
1546 COM pulling
1547 ^^^^^^^^^^^
1548
1549 Note that where pulling coordinates are applicable, there can be more
1550 than one (set with :mdp:`pull-ncoords`) and multiple related :ref:`mdp`
1551 variables will exist accordingly. Documentation references to things
1552 like :mdp:`pull-coord1-vec` should be understood to apply to to the
1553 applicable pulling coordinate, eg. the second pull coordinate is described by
1554 pull-coord2-vec, pull-coord2-k, and so on.
1555
1556 .. mdp:: pull
1557
1558    .. mdp-value:: no
1559
1560       No center of mass pulling. All the following pull options will
1561       be ignored (and if present in the :ref:`mdp` file, they unfortunately
1562       generate warnings)
1563
1564    .. mdp-value:: yes
1565
1566        Center of mass pulling will be applied on 1 or more groups using
1567        1 or more pull coordinates.
1568
1569 .. mdp:: pull-cylinder-r
1570
1571    (1.5) [nm]
1572    the radius of the cylinder for :mdp-value:`pull-coord1-geometry=cylinder`
1573
1574 .. mdp:: pull-constr-tol
1575
1576    (10\ :sup:`-6`)
1577    the relative constraint tolerance for constraint pulling
1578
1579 .. mdp:: pull-print-com
1580
1581    .. mdp-value:: no
1582
1583       do not print the COM for any group
1584
1585    .. mdp-value:: yes
1586
1587       print the COM of all groups for all pull coordinates
1588
1589 .. mdp:: pull-print-ref-value
1590
1591    .. mdp-value:: no
1592
1593       do not print the reference value for each pull coordinate
1594
1595    .. mdp-value:: yes
1596
1597       print the reference value for each pull coordinate
1598
1599 .. mdp:: pull-print-components
1600
1601    .. mdp-value:: no
1602
1603       only print the distance for each pull coordinate
1604
1605    .. mdp-value:: yes
1606
1607       print the distance and Cartesian components selected in
1608       :mdp:`pull-coord1-dim`
1609
1610 .. mdp:: pull-nstxout
1611
1612    (50)
1613    frequency for writing out the COMs of all the pull group (0 is
1614    never)
1615
1616 .. mdp:: pull-nstfout
1617
1618    (50)
1619    frequency for writing out the force of all the pulled group
1620    (0 is never)
1621
1622 .. mdp:: pull-pbc-ref-prev-step-com
1623
1624    .. mdp-value:: no
1625
1626       Use the reference atom (:mdp:`pull-group1-pbcatom`) for the
1627       treatment of periodic boundary conditions.
1628
1629    .. mdp-value:: yes
1630
1631       Use the COM of the previous step as reference for the treatment
1632       of periodic boundary conditions. The reference is initialized
1633       using the reference atom (:mdp:`pull-group1-pbcatom`), which should
1634       be located centrally in the group. Using the COM from the
1635       previous step can be useful if one or more pull groups are large.
1636
1637 .. mdp:: pull-xout-average
1638
1639    .. mdp-value:: no
1640
1641       Write the instantaneous coordinates for all the pulled groups.
1642
1643    .. mdp-value:: yes
1644
1645       Write the average coordinates (since last output) for all the
1646       pulled groups. N.b., some analysis tools might expect instantaneous
1647       pull output.
1648
1649 .. mdp:: pull-fout-average
1650
1651    .. mdp-value:: no
1652
1653       Write the instantaneous force for all the pulled groups.
1654
1655    .. mdp-value:: yes
1656
1657       Write the average force (since last output) for all the
1658       pulled groups. N.b., some analysis tools might expect instantaneous
1659       pull output.
1660
1661 .. mdp:: pull-ngroups
1662
1663    (1)
1664    The number of pull groups, not including the absolute reference
1665    group, when used. Pull groups can be reused in multiple pull
1666    coordinates. Below only the pull options for group 1 are given,
1667    further groups simply increase the group index number.
1668
1669 .. mdp:: pull-ncoords
1670
1671    (1)
1672    The number of pull coordinates. Below only the pull options for
1673    coordinate 1 are given, further coordinates simply increase the
1674    coordinate index number.
1675
1676 .. mdp:: pull-group1-name
1677
1678    The name of the pull group, is looked up in the index file or in
1679    the default groups to obtain the atoms involved.
1680
1681 .. mdp:: pull-group1-weights
1682
1683    Optional relative weights which are multiplied with the masses of
1684    the atoms to give the total weight for the COM. The number should
1685    be 0, meaning all 1, or the number of atoms in the pull group.
1686
1687 .. mdp:: pull-group1-pbcatom
1688
1689    (0)
1690    The reference atom for the treatment of periodic boundary
1691    conditions inside the group (this has no effect on the treatment of
1692    the pbc between groups). This option is only important when the
1693    diameter of the pull group is larger than half the shortest box
1694    vector. For determining the COM, all atoms in the group are put at
1695    their periodic image which is closest to
1696    :mdp:`pull-group1-pbcatom`. A value of 0 means that the middle
1697    atom (number wise) is used, which is only safe for small groups.
1698    :ref:`gmx grompp` checks that the maximum distance from the reference
1699    atom (specifically chosen, or not) to the other atoms in the group
1700    is not too large. This parameter is not used with
1701    :mdp:`pull-coord1-geometry` cylinder. A value of -1 turns on cosine
1702    weighting, which is useful for a group of molecules in a periodic
1703    system, *e.g.* a water slab (see Engin et al. J. Chem. Phys. B
1704    2010).
1705
1706 .. mdp:: pull-coord1-type
1707
1708    .. mdp-value:: umbrella
1709
1710       Center of mass pulling using an umbrella potential between the
1711       reference group and one or more groups.
1712
1713    .. mdp-value:: constraint
1714
1715       Center of mass pulling using a constraint between the reference
1716       group and one or more groups. The setup is identical to the
1717       option umbrella, except for the fact that a rigid constraint is
1718       applied instead of a harmonic potential.
1719
1720    .. mdp-value:: constant-force
1721
1722       Center of mass pulling using a linear potential and therefore a
1723       constant force. For this option there is no reference position
1724       and therefore the parameters :mdp:`pull-coord1-init` and
1725       :mdp:`pull-coord1-rate` are not used.
1726
1727    .. mdp-value:: flat-bottom
1728
1729       At distances above :mdp:`pull-coord1-init` a harmonic potential
1730       is applied, otherwise no potential is applied.
1731
1732    .. mdp-value:: flat-bottom-high
1733
1734       At distances below :mdp:`pull-coord1-init` a harmonic potential
1735       is applied, otherwise no potential is applied.
1736
1737    .. mdp-value:: external-potential
1738
1739       An external potential that needs to be provided by another
1740       module.
1741
1742 .. mdp:: pull-coord1-potential-provider
1743
1744       The name of the external module that provides the potential for
1745       the case where :mdp:`pull-coord1-type` is external-potential.
1746
1747 .. mdp:: pull-coord1-geometry
1748
1749    .. mdp-value:: distance
1750
1751       Pull along the vector connecting the two groups. Components can
1752       be selected with :mdp:`pull-coord1-dim`.
1753
1754    .. mdp-value:: direction
1755
1756       Pull in the direction of :mdp:`pull-coord1-vec`.
1757
1758    .. mdp-value:: direction-periodic
1759
1760       As :mdp-value:`pull-coord1-geometry=direction`, but allows the distance to be larger
1761       than half the box size. With this geometry the box should not be
1762       dynamic (*e.g.* no pressure scaling) in the pull dimensions and
1763       the pull force is not added to virial.
1764
1765    .. mdp-value:: direction-relative
1766
1767       As :mdp-value:`pull-coord1-geometry=direction`, but the pull vector is the vector
1768       that points from the COM of a third to the COM of a fourth pull
1769       group. This means that 4 groups need to be supplied in
1770       :mdp:`pull-coord1-groups`. Note that the pull force will give
1771       rise to a torque on the pull vector, which is turn leads to
1772       forces perpendicular to the pull vector on the two groups
1773       defining the vector. If you want a pull group to move between
1774       the two groups defining the vector, simply use the union of
1775       these two groups as the reference group.
1776
1777    .. mdp-value:: cylinder
1778
1779       Designed for pulling with respect to a layer where the reference
1780       COM is given by a local cylindrical part of the reference group.
1781       The pulling is in the direction of :mdp:`pull-coord1-vec`. From
1782       the first of the two groups in :mdp:`pull-coord1-groups` a
1783       cylinder is selected around the axis going through the COM of
1784       the second group with direction :mdp:`pull-coord1-vec` with
1785       radius :mdp:`pull-cylinder-r`. Weights of the atoms decrease
1786       continously to zero as the radial distance goes from 0 to
1787       :mdp:`pull-cylinder-r` (mass weighting is also used). The radial
1788       dependence gives rise to radial forces on both pull groups.
1789       Note that the radius should be smaller than half the box size.
1790       For tilted cylinders they should be even smaller than half the
1791       box size since the distance of an atom in the reference group
1792       from the COM of the pull group has both a radial and an axial
1793       component. This geometry is not supported with constraint
1794       pulling.
1795
1796    .. mdp-value:: angle
1797
1798       Pull along an angle defined by four groups. The angle is
1799       defined as the angle between two vectors: the vector connecting
1800       the COM of the first group to the COM of the second group and
1801       the vector connecting the COM of the third group to the COM of
1802       the fourth group.
1803
1804    .. mdp-value:: angle-axis
1805
1806       As :mdp-value:`pull-coord1-geometry=angle` but the second vector is given by :mdp:`pull-coord1-vec`.
1807       Thus, only the two groups that define the first vector need to be given.
1808
1809    .. mdp-value:: dihedral
1810
1811       Pull along a dihedral angle defined by six groups. These pairwise
1812       define three vectors: the vector connecting the COM of group 1
1813       to the COM of group 2, the COM of group 3 to the COM of group 4,
1814       and the COM of group 5 to the COM group 6. The dihedral angle is
1815       then defined as the angle between two planes: the plane spanned by the
1816       the two first vectors and the plane spanned the two last vectors.
1817
1818
1819 .. mdp:: pull-coord1-groups
1820
1821    The group indices on which this pull coordinate will operate.
1822    The number of group indices required is geometry dependent.
1823    The first index can be 0, in which case an
1824    absolute reference of :mdp:`pull-coord1-origin` is used. With an
1825    absolute reference the system is no longer translation invariant
1826    and one should think about what to do with the center of mass
1827    motion.
1828
1829 .. mdp:: pull-coord1-dim
1830
1831    (Y Y Y)
1832    Selects the dimensions that this pull coordinate acts on and that
1833    are printed to the output files when
1834    :mdp:`pull-print-components` = :mdp-value:`pull-coord1-start=yes`. With
1835    :mdp:`pull-coord1-geometry` = :mdp-value:`pull-coord1-geometry=distance`, only Cartesian
1836    components set to Y contribute to the distance. Thus setting this
1837    to Y Y N results in a distance in the x/y plane. With other
1838    geometries all dimensions with non-zero entries in
1839    :mdp:`pull-coord1-vec` should be set to Y, the values for other
1840    dimensions only affect the output.
1841
1842 .. mdp:: pull-coord1-origin
1843
1844    (0.0 0.0 0.0)
1845    The pull reference position for use with an absolute reference.
1846
1847 .. mdp:: pull-coord1-vec
1848
1849    (0.0 0.0 0.0)
1850    The pull direction. :ref:`gmx grompp` normalizes the vector.
1851
1852 .. mdp:: pull-coord1-start
1853
1854    .. mdp-value:: no
1855
1856       do not modify :mdp:`pull-coord1-init`
1857
1858    .. mdp-value:: yes
1859
1860       add the COM distance of the starting conformation to
1861       :mdp:`pull-coord1-init`
1862
1863 .. mdp:: pull-coord1-init
1864
1865    (0.0) [nm] or [deg]
1866    The reference distance or reference angle at t=0.
1867
1868 .. mdp:: pull-coord1-rate
1869
1870    (0) [nm/ps] or [deg/ps]
1871    The rate of change of the reference position or reference angle.
1872
1873 .. mdp:: pull-coord1-k
1874
1875    (0) [kJ mol\ :sup:`-1` nm\ :sup:`-2`] or [kJ mol\ :sup:`-1` nm\ :sup:`-1`] or
1876    [kJ mol\ :sup:`-1` rad\ :sup:`-2`] or [kJ mol\ :sup:`-1` rad\ :sup:`-1`]
1877    The force constant. For umbrella pulling this is the harmonic force
1878    constant in kJ mol\ :sup:`-1` nm\ :sup:`-2` (or kJ mol\ :sup:`-1` rad\ :sup:`-2`
1879    for angles). For constant force pulling this is the
1880    force constant of the linear potential, and thus the negative (!)
1881    of the constant force in kJ mol\ :sup:`-1` nm\ :sup:`-1`
1882    (or kJ mol\ :sup:`-1` rad\ :sup:`-1` for angles).
1883    Note that for angles the force constant is expressed in terms of radians
1884    (while :mdp:`pull-coord1-init` and :mdp:`pull-coord1-rate` are expressed in degrees).
1885
1886 .. mdp:: pull-coord1-kB
1887
1888    (pull-k1) [kJ mol\ :sup:`-1` nm\ :sup:`-2`] or [kJ mol\ :sup:`-1` nm\ :sup:`-1`]
1889    or [kJ mol\ :sup:`-1` rad\ :sup:`-2`] or [kJ mol\ :sup:`-1` rad\ :sup:`-1`]
1890    As :mdp:`pull-coord1-k`, but for state B. This is only used when
1891    :mdp:`free-energy` is turned on. The force constant is then (1 -
1892    lambda) * :mdp:`pull-coord1-k` + lambda * :mdp:`pull-coord1-kB`.
1893
1894 AWH adaptive biasing
1895 ^^^^^^^^^^^^^^^^^^^^
1896
1897 .. mdp:: awh
1898
1899    .. mdp-value:: no
1900
1901       No biasing.
1902
1903    .. mdp-value:: yes
1904
1905       Adaptively bias a reaction coordinate using the AWH method and estimate
1906       the corresponding PMF. The PMF and other AWH data are written to energy
1907       file at an interval set by :mdp:`awh-nstout` and can be extracted with
1908       the ``gmx awh`` tool. The AWH coordinate can be
1909       multidimensional and is defined by mapping each dimension to a pull coordinate index.
1910       This is only allowed if :mdp-value:`pull-coord1-type=external-potential` and
1911       :mdp:`pull-coord1-potential-provider` = ``awh`` for the concerned pull coordinate
1912       indices. Pull geometry 'direction-periodic' is not supported by AWH.
1913
1914 .. mdp:: awh-potential
1915
1916    .. mdp-value:: convolved
1917
1918       The applied biasing potential is the convolution of the bias function and a
1919       set of harmonic umbrella potentials (see :mdp-value:`awh-potential=umbrella` below). This results
1920       in a smooth potential function and force. The resolution of the potential is set
1921       by the force constant of each umbrella, see :mdp:`awh1-dim1-force-constant`.
1922
1923    .. mdp-value:: umbrella
1924
1925       The potential bias is applied by controlling the position of an harmonic potential
1926       using Monte-Carlo sampling.  The force constant is set with
1927       :mdp:`awh1-dim1-force-constant`. The umbrella location
1928       is sampled using Monte-Carlo every :mdp:`awh-nstsample` steps.
1929       There are no advantages to using an umbrella.
1930       This option is mainly for comparison and testing purposes.
1931
1932 .. mdp:: awh-share-multisim
1933
1934    .. mdp-value:: no
1935
1936       AWH will not share biases across simulations started with
1937       :ref:`gmx mdrun` option ``-multidir``. The biases will be independent.
1938
1939    .. mdp-value:: yes
1940
1941       With :ref:`gmx mdrun` and option ``-multidir`` the bias and PMF estimates
1942       for biases with :mdp:`awh1-share-group` >0 will be shared across simulations
1943       with the biases with the same :mdp:`awh1-share-group` value.
1944       The simulations should have the same AWH settings for sharing to make sense.
1945       :ref:`gmx mdrun` will check whether the simulations are technically
1946       compatible for sharing, but the user should check that bias sharing
1947       physically makes sense.
1948
1949 .. mdp:: awh-seed
1950
1951    (-1) Random seed for Monte-Carlo sampling the umbrella position,
1952    where -1 indicates to generate a seed. Only used with
1953    :mdp-value:`awh-potential=umbrella`.
1954
1955 .. mdp:: awh-nstout
1956
1957    (100000)
1958    Number of steps between printing AWH data to the energy file, should be
1959    a multiple of :mdp:`nstenergy`.
1960
1961 .. mdp:: awh-nstsample
1962
1963    (10)
1964    Number of steps between sampling of the coordinate value. This sampling
1965    is the basis for updating the bias and estimating the PMF and other AWH observables.
1966
1967 .. mdp:: awh-nsamples-update
1968
1969    (10)
1970    The number of coordinate samples used for each AWH update.
1971    The update interval in steps is :mdp:`awh-nstsample` times this value.
1972
1973 .. mdp:: awh-nbias
1974
1975    (1)
1976    The number of biases, each acting on its own coordinate.
1977    The following options should be specified
1978    for each bias although below only the options for bias number 1 is shown. Options for
1979    other bias indices are  obtained by replacing '1' by the bias index.
1980
1981 .. mdp:: awh1-error-init
1982
1983    (10.0) [kJ mol\ :sup:`-1`]
1984    Estimated initial average error of the PMF for this bias. This value together with the
1985    given diffusion constant(s) :mdp:`awh1-dim1-diffusion` determine the initial biasing rate.
1986    The error is obviously not known *a priori*. Only a rough estimate of :mdp:`awh1-error-init`
1987    is needed however.
1988    As a  general guideline, leave :mdp:`awh1-error-init` to its default value when starting a new
1989    simulation. On the other hand, when there is *a priori* knowledge of the PMF (e.g. when
1990    an initial PMF estimate is provided, see the :mdp:`awh1-user-data` option)
1991    then :mdp:`awh1-error-init` should reflect that knowledge.
1992
1993 .. mdp:: awh1-growth
1994
1995    .. mdp-value:: exp-linear
1996
1997    Each bias keeps a reference weight histogram for the coordinate samples.
1998    Its size sets the magnitude of the bias function and free energy estimate updates
1999    (few samples corresponds to large updates and vice versa).
2000    Thus, its growth rate sets the maximum convergence rate.
2001    By default, there is an initial stage in which the histogram grows close to exponentially (but slower than the sampling rate).
2002    In the final stage that follows, the growth rate is linear and equal to the sampling rate (set by :mdp:`awh-nstsample`).
2003    The initial stage is typically necessary for efficient convergence when starting a new simulation where
2004    high free energy barriers have not yet been flattened by the bias.
2005
2006    .. mdp-value:: linear
2007
2008    As :mdp-value:`awh1-growth=exp-linear` but skip the initial stage. This may be useful if there is *a priori*
2009    knowledge (see :mdp:`awh1-error-init`) which eliminates the need for an initial stage. This is also
2010    the setting compatible with :mdp-value:`awh1-target=local-boltzmann`.
2011
2012 .. mdp:: awh1-equilibrate-histogram
2013
2014    .. mdp-value:: no
2015
2016       Do not equilibrate histogram.
2017
2018    .. mdp-value:: yes
2019
2020       Before entering the initial stage (see :mdp-value:`awh1-growth=exp-linear`), make sure the
2021       histogram of sampled weights is following the target distribution closely enough (specifically,
2022       at least 80% of the target region needs to have a local relative error of less than 20%). This
2023       option would typically only be used when :mdp:`awh1-share-group` > 0
2024       and the initial configurations poorly represent the target
2025       distribution.
2026
2027 .. mdp:: awh1-target
2028
2029    .. mdp-value:: constant
2030
2031       The bias is tuned towards a constant (uniform) coordinate distribution
2032       in the defined sampling interval (defined by  [:mdp:`awh1-dim1-start`, :mdp:`awh1-dim1-end`]).
2033
2034    .. mdp-value:: cutoff
2035
2036       Similar to :mdp-value:`awh1-target=constant`, but the target
2037       distribution is proportional to 1/(1 + exp(F - :mdp-value:`awh1-target=cutoff`)),
2038       where F is the free energy relative to the estimated global minimum.
2039       This provides a smooth switch of a flat target distribution in
2040       regions with free energy lower than the cut-off to a Boltzmann
2041       distribution in regions with free energy higher than the cut-off.
2042
2043    .. mdp-value:: boltzmann
2044
2045       The target distribution is a Boltzmann distribtution with a scaled beta (inverse temperature)
2046       factor given by :mdp:`awh1-target-beta-scaling`. *E.g.*, a value of 0.1
2047       would give the same coordinate distribution as sampling with a simulation temperature
2048       scaled by 10.
2049
2050    .. mdp-value:: local-boltzmann
2051
2052       Same target distribution and use of :mdp:`awh1-target-beta-scaling`
2053       but the convergence towards the target distribution is inherently local *i.e.*, the rate of
2054       change of the bias only depends on the local sampling. This local convergence property is
2055       only compatible with :mdp-value:`awh1-growth=linear`, since for
2056       :mdp-value:`awh1-growth=exp-linear` histograms are globally rescaled in the initial stage.
2057
2058 .. mdp:: awh1-target-beta-scaling
2059
2060    (0)
2061    For :mdp-value:`awh1-target=boltzmann` and :mdp-value:`awh1-target=local-boltzmann`
2062    it is the unitless beta scaling factor taking values in (0,1).
2063
2064 .. mdp:: awh1-target-cutoff
2065
2066    (0) [kJ mol\ :sup:`-1`]
2067    For :mdp-value:`awh1-target=cutoff` this is the cutoff, should be > 0.
2068
2069 .. mdp:: awh1-user-data
2070
2071    .. mdp-value:: no
2072
2073       Initialize the PMF and target distribution with default values.
2074
2075    .. mdp-value:: yes
2076
2077       Initialize the PMF and target distribution with user provided data. For :mdp:`awh-nbias` = 1,
2078       :ref:`gmx mdrun` will expect a file ``awhinit.xvg`` to be present in the run directory.
2079       For multiple biases, :ref:`gmx mdrun` expects files ``awhinit1.xvg``, ``awhinit2.xvg``, etc.
2080       The file name can be changed with the ``-awh`` option.
2081       The first :mdp:`awh1-ndim` columns of
2082       each input file should contain the coordinate values, such that each row defines a point in
2083       coordinate space. Column :mdp:`awh1-ndim` + 1 should contain the PMF value for each point.
2084       The target distribution column can either follow the PMF (column  :mdp:`awh1-ndim` + 2) or
2085       be in the same column as written by :ref:`gmx awh`.
2086
2087 .. mdp:: awh1-share-group
2088
2089    .. mdp-value:: 0
2090
2091       Do not share the bias.
2092
2093    .. mdp-value:: positive
2094
2095       Share the bias and PMF estimates within and/or between simulations.
2096       Within a simulation, the bias will be shared between biases that have the
2097       same :mdp:`awh1-share-group` index (note that the current code does not support this).
2098       With :mdp-value:`awh-share-multisim=yes` and
2099       :ref:`gmx mdrun` option ``-multidir`` the bias will also be shared across simulations.
2100       Sharing may increase convergence initially, although the starting configurations
2101       can be critical, especially when sharing between many biases.
2102       Currently, positive group values should start at 1 and increase
2103       by 1 for each subsequent bias that is shared.
2104
2105 .. mdp:: awh1-ndim
2106
2107    (1) [integer]
2108    Number of dimensions of the coordinate, each dimension maps to 1 pull coordinate.
2109    The following options should be specified for each such dimension. Below only
2110    the options for dimension number 1 is shown. Options for other dimension indices are
2111    obtained by replacing '1' by the dimension index.
2112
2113 .. mdp:: awh1-dim1-coord-provider
2114
2115    .. mdp-value:: pull
2116
2117       The module providing the reaction coordinate for this dimension.
2118       Currently AWH can only act on pull coordinates.
2119
2120 .. mdp:: awh1-dim1-coord-index
2121
2122    (1)
2123    Index of the pull coordinate defining this coordinate dimension.
2124
2125 .. mdp:: awh1-dim1-force-constant
2126
2127    (0) [kJ mol\ :sup:`-1` nm\ :sup:`-2`] or [kJ mol\ :sup:`-1` rad\ :sup:`-2`]
2128    Force constant for the (convolved) umbrella potential(s) along this
2129    coordinate dimension.
2130
2131 .. mdp:: awh1-dim1-start
2132
2133    (0.0) [nm] or [rad]
2134    Start value of the sampling interval along this dimension. The range of allowed
2135    values depends on the relevant pull geometry (see :mdp:`pull-coord1-geometry`).
2136    For dihedral geometries :mdp:`awh1-dim1-start` greater than :mdp:`awh1-dim1-end`
2137    is allowed. The interval will then wrap around from +period/2 to -period/2.
2138    For the direction geometry, the dimension is made periodic when
2139    the direction is along a box vector and covers more than 95%
2140    of the box length. Note that one should not apply pressure coupling
2141    along a periodic dimension.
2142
2143 .. mdp:: awh1-dim1-end
2144
2145    (0.0) [nm] or [rad]
2146    End value defining the sampling interval together with :mdp:`awh1-dim1-start`.
2147
2148 .. mdp:: awh1-dim1-diffusion
2149
2150    (10\ :sup:`-5`) [nm\ :sup:`2`/ps] or [rad\ :sup:`2`/ps]
2151    Estimated diffusion constant for this coordinate dimension determining the initial
2152    biasing rate. This needs only be a rough estimate and should not critically
2153    affect the results unless it is set to something very low, leading to slow convergence,
2154    or very high, forcing the system far from equilibrium. Not setting this value
2155    explicitly generates a warning.
2156
2157 .. mdp:: awh1-dim1-cover-diameter
2158
2159    (0.0) [nm] or [rad]
2160    Diameter that needs to be sampled by a single simulation around a coordinate value
2161    before the point is considered covered in the initial stage (see :mdp-value:`awh1-growth=exp-linear`).
2162    A value > 0  ensures that for each covering there is a continuous transition of this diameter
2163    across each coordinate value.
2164    This is trivially true for independent simulations but not for for multiple bias-sharing simulations
2165    (:mdp:`awh1-share-group`>0).
2166    For a diameter = 0, covering occurs as soon as the simulations have sampled the whole interval, which
2167    for many sharing simulations does not guarantee transitions across free energy barriers.
2168    On the other hand, when the diameter >= the sampling interval length, covering occurs when a single simulation
2169    has independently sampled the whole interval.
2170
2171 Enforced rotation
2172 ^^^^^^^^^^^^^^^^^
2173
2174 These :ref:`mdp` parameters can be used enforce the rotation of a group of atoms,
2175 e.g. a protein subunit. The `reference manual`_ describes in detail 13 different potentials
2176 that can be used to achieve such a rotation.
2177
2178 .. mdp:: rotation
2179
2180    .. mdp-value:: no
2181
2182       No enforced rotation will be applied. All enforced rotation options will
2183       be ignored (and if present in the :ref:`mdp` file, they unfortunately
2184       generate warnings).
2185
2186    .. mdp-value:: yes
2187
2188       Apply the rotation potential specified by :mdp:`rot-type0` to the group of atoms given
2189       under the :mdp:`rot-group0` option.
2190
2191 .. mdp:: rot-ngroups
2192
2193    (1)
2194    Number of rotation groups.
2195
2196 .. mdp:: rot-group0
2197
2198    Name of rotation group 0 in the index file.
2199
2200 .. mdp:: rot-type0
2201
2202    (iso)
2203    Type of rotation potential that is applied to rotation group 0. Can be of of the following:
2204    ``iso``, ``iso-pf``, ``pm``, ``pm-pf``, ``rm``, ``rm-pf``, ``rm2``, ``rm2-pf``,
2205    ``flex``, ``flex-t``, ``flex2``, or ``flex2-t``.
2206
2207 .. mdp:: rot-massw0
2208
2209    (no)
2210    Use mass weighted rotation group positions.
2211
2212 .. mdp:: rot-vec0
2213
2214    (1.0 0.0 0.0)
2215    Rotation vector, will get normalized.
2216
2217 .. mdp:: rot-pivot0
2218
2219    (0.0 0.0 0.0) [nm]
2220    Pivot point for the potentials ``iso``, ``pm``, ``rm``, and ``rm2``.
2221
2222 .. mdp:: rot-rate0
2223
2224    (0) [degree ps\ :sup:`-1`]
2225    Reference rotation rate of group 0.
2226
2227 .. mdp:: rot-k0
2228
2229    (0) [kJ mol\ :sup:`-1` nm\ :sup:`-2`]
2230    Force constant for group 0.
2231
2232 .. mdp:: rot-slab-dist0
2233
2234    (1.5) [nm]
2235    Slab distance, if a flexible axis rotation type was chosen.
2236
2237 .. mdp:: rot-min-gauss0
2238
2239    (0.001)
2240    Minimum value (cutoff) of Gaussian function for the force to be evaluated
2241    (for the flexible axis potentials).
2242
2243 .. mdp:: rot-eps0
2244
2245    (0.0001) [nm\ :sup:`2`]
2246    Value of additive constant epsilon for ``rm2*`` and ``flex2*`` potentials.
2247
2248 .. mdp:: rot-fit-method0
2249
2250    (rmsd)
2251    Fitting method when determining the actual angle of a rotation group
2252    (can be one of ``rmsd``, ``norm``, or ``potential``).
2253
2254 .. mdp:: rot-potfit-nsteps0
2255
2256    (21)
2257    For fit type ``potential``, the number of angular positions around the reference angle for which the
2258    rotation potential is evaluated.
2259
2260 .. mdp:: rot-potfit-step0
2261
2262    (0.25)
2263    For fit type ``potential``, the distance in degrees between two angular positions.
2264
2265 .. mdp:: rot-nstrout
2266
2267    (100)
2268    Output frequency (in steps) for the angle of the rotation group, as well as for the torque
2269    and the rotation potential energy.
2270
2271 .. mdp:: rot-nstsout
2272
2273    (1000)
2274    Output frequency for per-slab data of the flexible axis potentials, i.e. angles, torques and slab centers.
2275
2276
2277 NMR refinement
2278 ^^^^^^^^^^^^^^
2279
2280 .. mdp:: disre
2281
2282    .. mdp-value:: no
2283
2284       ignore distance restraint information in topology file
2285
2286    .. mdp-value:: simple
2287
2288       simple (per-molecule) distance restraints.
2289
2290    .. mdp-value:: ensemble
2291
2292       distance restraints over an ensemble of molecules in one
2293       simulation box. Normally, one would perform ensemble averaging
2294       over multiple simulations, using ``mdrun
2295       -multidir``. The environment
2296       variable ``GMX_DISRE_ENSEMBLE_SIZE`` sets the number of systems
2297       within each ensemble (usually equal to the number of directories
2298       supplied to ``mdrun -multidir``).
2299
2300 .. mdp:: disre-weighting
2301
2302    .. mdp-value:: equal
2303
2304       divide the restraint force equally over all atom pairs in the
2305       restraint
2306
2307    .. mdp-value:: conservative
2308
2309       the forces are the derivative of the restraint potential, this
2310       results in an weighting of the atom pairs to the reciprocal
2311       seventh power of the displacement. The forces are conservative
2312       when :mdp:`disre-tau` is zero.
2313
2314 .. mdp:: disre-mixed
2315
2316    .. mdp-value:: no
2317
2318       the violation used in the calculation of the restraint force is
2319       the time-averaged violation
2320
2321    .. mdp-value:: yes
2322
2323       the violation used in the calculation of the restraint force is
2324       the square root of the product of the time-averaged violation
2325       and the instantaneous violation
2326
2327 .. mdp:: disre-fc
2328
2329    (1000) [kJ mol\ :sup:`-1` nm\ :sup:`-2`]
2330    force constant for distance restraints, which is multiplied by a
2331    (possibly) different factor for each restraint given in the `fac`
2332    column of the interaction in the topology file.
2333
2334 .. mdp:: disre-tau
2335
2336    (0) [ps]
2337    time constant for distance restraints running average. A value of
2338    zero turns off time averaging.
2339
2340 .. mdp:: nstdisreout
2341
2342    (100) [steps]
2343    period between steps when the running time-averaged and
2344    instantaneous distances of all atom pairs involved in restraints
2345    are written to the energy file (can make the energy file very
2346    large)
2347
2348 .. mdp:: orire
2349
2350    .. mdp-value:: no
2351
2352       ignore orientation restraint information in topology file
2353
2354    .. mdp-value:: yes
2355
2356       use orientation restraints, ensemble averaging can be performed
2357       with ``mdrun -multidir``
2358
2359 .. mdp:: orire-fc
2360
2361    (0) [kJ mol\ :sup:`-1`]
2362    force constant for orientation restraints, which is multiplied by a
2363    (possibly) different weight factor for each restraint, can be set
2364    to zero to obtain the orientations from a free simulation
2365
2366 .. mdp:: orire-tau
2367
2368    (0) [ps]
2369    time constant for orientation restraints running average. A value
2370    of zero turns off time averaging.
2371
2372 .. mdp:: orire-fitgrp
2373
2374    fit group for orientation restraining. This group of atoms is used
2375    to determine the rotation **R** of the system with respect to the
2376    reference orientation. The reference orientation is the starting
2377    conformation of the first subsystem. For a protein, backbone is a
2378    reasonable choice
2379
2380 .. mdp:: nstorireout
2381
2382    (100) [steps]
2383    period between steps when the running time-averaged and
2384    instantaneous orientations for all restraints, and the molecular
2385    order tensor are written to the energy file (can make the energy
2386    file very large)
2387
2388
2389 Free energy calculations
2390 ^^^^^^^^^^^^^^^^^^^^^^^^
2391
2392 .. mdp:: free-energy
2393
2394    .. mdp-value:: no
2395
2396       Only use topology A.
2397
2398    .. mdp-value:: yes
2399
2400       Interpolate between topology A (lambda=0) to topology B
2401       (lambda=1) and write the derivative of the Hamiltonian with
2402       respect to lambda (as specified with :mdp:`dhdl-derivatives`),
2403       or the Hamiltonian differences with respect to other lambda
2404       values (as specified with foreign lambda) to the energy file
2405       and/or to ``dhdl.xvg``, where they can be processed by, for
2406       example :ref:`gmx bar`. The potentials, bond-lengths and angles
2407       are interpolated linearly as described in the manual. When
2408       :mdp:`sc-alpha` is larger than zero, soft-core potentials are
2409       used for the LJ and Coulomb interactions.
2410
2411 .. mdp:: expanded
2412
2413    Turns on expanded ensemble simulation, where the alchemical state
2414    becomes a dynamic variable, allowing jumping between different
2415    Hamiltonians. See the expanded ensemble options for controlling how
2416    expanded ensemble simulations are performed. The different
2417    Hamiltonians used in expanded ensemble simulations are defined by
2418    the other free energy options.
2419
2420 .. mdp:: init-lambda
2421
2422    (-1)
2423    starting value for lambda (float). Generally, this should only be
2424    used with slow growth (*i.e.* nonzero :mdp:`delta-lambda`). In
2425    other cases, :mdp:`init-lambda-state` should be specified
2426    instead. Must be greater than or equal to 0.
2427
2428 .. mdp:: delta-lambda
2429
2430    (0)
2431    increment per time step for lambda
2432
2433 .. mdp:: init-lambda-state
2434
2435    (-1)
2436    starting value for the lambda state (integer). Specifies which
2437    columm of the lambda vector (:mdp:`coul-lambdas`,
2438    :mdp:`vdw-lambdas`, :mdp:`bonded-lambdas`,
2439    :mdp:`restraint-lambdas`, :mdp:`mass-lambdas`,
2440    :mdp:`temperature-lambdas`, :mdp:`fep-lambdas`) should be
2441    used. This is a zero-based index: :mdp:`init-lambda-state` 0 means
2442    the first column, and so on.
2443
2444 .. mdp:: fep-lambdas
2445
2446    [array]
2447    Zero, one or more lambda values for which Delta H values will be
2448    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2449    steps. Values must be between 0 and 1. Free energy differences
2450    between different lambda values can then be determined with
2451    :ref:`gmx bar`. :mdp:`fep-lambdas` is different from the
2452    other -lambdas keywords because all components of the lambda vector
2453    that are not specified will use :mdp:`fep-lambdas` (including
2454    :mdp:`restraint-lambdas` and therefore the pull code restraints).
2455
2456 .. mdp:: coul-lambdas
2457
2458    [array]
2459    Zero, one or more lambda values for which Delta H values will be
2460    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2461    steps. Values must be between 0 and 1. Only the electrostatic
2462    interactions are controlled with this component of the lambda
2463    vector (and only if the lambda=0 and lambda=1 states have differing
2464    electrostatic interactions).
2465
2466 .. mdp:: vdw-lambdas
2467
2468    [array]
2469    Zero, one or more lambda values for which Delta H values will be
2470    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2471    steps. Values must be between 0 and 1. Only the van der Waals
2472    interactions are controlled with this component of the lambda
2473    vector.
2474
2475 .. mdp:: bonded-lambdas
2476
2477    [array]
2478    Zero, one or more lambda values for which Delta H values will be
2479    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2480    steps. Values must be between 0 and 1. Only the bonded interactions
2481    are controlled with this component of the lambda vector.
2482
2483 .. mdp:: restraint-lambdas
2484
2485    [array]
2486    Zero, one or more lambda values for which Delta H values will be
2487    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2488    steps. Values must be between 0 and 1. Only the restraint
2489    interactions: dihedral restraints, and the pull code restraints are
2490    controlled with this component of the lambda vector.
2491
2492 .. mdp:: mass-lambdas
2493
2494    [array]
2495    Zero, one or more lambda values for which Delta H values will be
2496    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2497    steps. Values must be between 0 and 1. Only the particle masses are
2498    controlled with this component of the lambda vector.
2499
2500 .. mdp:: temperature-lambdas
2501
2502    [array]
2503    Zero, one or more lambda values for which Delta H values will be
2504    determined and written to dhdl.xvg every :mdp:`nstdhdl`
2505    steps. Values must be between 0 and 1. Only the temperatures
2506    controlled with this component of the lambda vector. Note that
2507    these lambdas should not be used for replica exchange, only for
2508    simulated tempering.
2509
2510 .. mdp:: calc-lambda-neighbors
2511
2512    (1)
2513    Controls the number of lambda values for which Delta H values will
2514    be calculated and written out, if :mdp:`init-lambda-state` has
2515    been set. A positive value will limit the number of lambda points
2516    calculated to only the nth neighbors of :mdp:`init-lambda-state`:
2517    for example, if :mdp:`init-lambda-state` is 5 and this parameter
2518    has a value of 2, energies for lambda points 3-7 will be calculated
2519    and writen out. A value of -1 means all lambda points will be
2520    written out. For normal BAR such as with :ref:`gmx bar`, a value of
2521    1 is sufficient, while for MBAR -1 should be used.
2522
2523 .. mdp:: sc-alpha
2524
2525    (0)
2526    the soft-core alpha parameter, a value of 0 results in linear
2527    interpolation of the LJ and Coulomb interactions
2528
2529 .. mdp:: sc-r-power
2530
2531    (6)
2532    the power of the radial term in the soft-core equation. Possible
2533    values are 6 and 48. 6 is more standard, and is the default. When
2534    48 is used, then sc-alpha should generally be much lower (between
2535    0.001 and 0.003).
2536
2537 .. mdp:: sc-coul
2538
2539    (no)
2540    Whether to apply the soft-core free energy interaction
2541    transformation to the Columbic interaction of a molecule. Default
2542    is no, as it is generally more efficient to turn off the Coulomic
2543    interactions linearly before turning off the van der Waals
2544    interactions. Note that it is only taken into account when lambda
2545    states are used, not with :mdp:`couple-lambda0` /
2546    :mdp:`couple-lambda1`, and you can still turn off soft-core
2547    interactions by setting :mdp:`sc-alpha` to 0.
2548
2549 .. mdp:: sc-power
2550
2551    (0)
2552    the power for lambda in the soft-core function, only the values 1
2553    and 2 are supported
2554
2555 .. mdp:: sc-sigma
2556
2557    (0.3) [nm]
2558    the soft-core sigma for particles which have a C6 or C12 parameter
2559    equal to zero or a sigma smaller than :mdp:`sc-sigma`
2560
2561 .. mdp:: couple-moltype
2562
2563    Here one can supply a molecule type (as defined in the topology)
2564    for calculating solvation or coupling free energies. There is a
2565    special option ``system`` that couples all molecule types in the
2566    system. This can be useful for equilibrating a system starting from
2567    (nearly) random coordinates. :mdp:`free-energy` has to be turned
2568    on. The Van der Waals interactions and/or charges in this molecule
2569    type can be turned on or off between lambda=0 and lambda=1,
2570    depending on the settings of :mdp:`couple-lambda0` and
2571    :mdp:`couple-lambda1`. If you want to decouple one of several
2572    copies of a molecule, you need to copy and rename the molecule
2573    definition in the topology.
2574
2575 .. mdp:: couple-lambda0
2576
2577    .. mdp-value:: vdw-q
2578
2579       all interactions are on at lambda=0
2580
2581    .. mdp-value:: vdw
2582
2583       the charges are zero (no Coulomb interactions) at lambda=0
2584
2585    .. mdp-value:: q
2586
2587       the Van der Waals interactions are turned at lambda=0; soft-core
2588       interactions will be required to avoid singularities
2589
2590    .. mdp-value:: none
2591
2592       the Van der Waals interactions are turned off and the charges
2593       are zero at lambda=0; soft-core interactions will be required to
2594       avoid singularities.
2595
2596 .. mdp:: couple-lambda1
2597
2598    analogous to :mdp:`couple-lambda1`, but for lambda=1
2599
2600 .. mdp:: couple-intramol
2601
2602    .. mdp-value:: no
2603
2604       All intra-molecular non-bonded interactions for moleculetype
2605       :mdp:`couple-moltype` are replaced by exclusions and explicit
2606       pair interactions. In this manner the decoupled state of the
2607       molecule corresponds to the proper vacuum state without
2608       periodicity effects.
2609
2610    .. mdp-value:: yes
2611
2612       The intra-molecular Van der Waals and Coulomb interactions are
2613       also turned on/off. This can be useful for partitioning
2614       free-energies of relatively large molecules, where the
2615       intra-molecular non-bonded interactions might lead to
2616       kinetically trapped vacuum conformations. The 1-4 pair
2617       interactions are not turned off.
2618
2619 .. mdp:: nstdhdl
2620
2621    (100)
2622    the frequency for writing dH/dlambda and possibly Delta H to
2623    dhdl.xvg, 0 means no ouput, should be a multiple of
2624    :mdp:`nstcalcenergy`.
2625
2626 .. mdp:: dhdl-derivatives
2627
2628    (yes)
2629
2630    If yes (the default), the derivatives of the Hamiltonian with
2631    respect to lambda at each :mdp:`nstdhdl` step are written
2632    out. These values are needed for interpolation of linear energy
2633    differences with :ref:`gmx bar` (although the same can also be
2634    achieved with the right foreign lambda setting, that may not be as
2635    flexible), or with thermodynamic integration
2636
2637 .. mdp:: dhdl-print-energy
2638
2639    (no)
2640
2641    Include either the total or the potential energy in the dhdl
2642    file. Options are 'no', 'potential', or 'total'. This information
2643    is needed for later free energy analysis if the states of interest
2644    are at different temperatures. If all states are at the same
2645    temperature, this information is not needed. 'potential' is useful
2646    in case one is using ``mdrun -rerun`` to generate the ``dhdl.xvg``
2647    file. When rerunning from an existing trajectory, the kinetic
2648    energy will often not be correct, and thus one must compute the
2649    residual free energy from the potential alone, with the kinetic
2650    energy component computed analytically.
2651
2652 .. mdp:: separate-dhdl-file
2653
2654    .. mdp-value:: yes
2655
2656       The free energy values that are calculated (as specified with
2657       the foreign lambda and :mdp:`dhdl-derivatives` settings) are
2658       written out to a separate file, with the default name
2659       ``dhdl.xvg``. This file can be used directly with :ref:`gmx
2660       bar`.
2661
2662    .. mdp-value:: no
2663
2664       The free energy values are written out to the energy output file
2665       (``ener.edr``, in accumulated blocks at every :mdp:`nstenergy`
2666       steps), where they can be extracted with :ref:`gmx energy` or
2667       used directly with :ref:`gmx bar`.
2668
2669 .. mdp:: dh-hist-size
2670
2671    (0)
2672    If nonzero, specifies the size of the histogram into which the
2673    Delta H values (specified with foreign lambda) and the derivative
2674    dH/dl values are binned, and written to ener.edr. This can be used
2675    to save disk space while calculating free energy differences. One
2676    histogram gets written for each foreign lambda and two for the
2677    dH/dl, at every :mdp:`nstenergy` step. Be aware that incorrect
2678    histogram settings (too small size or too wide bins) can introduce
2679    errors. Do not use histograms unless you're certain you need it.
2680
2681 .. mdp:: dh-hist-spacing
2682
2683    (0.1)
2684    Specifies the bin width of the histograms, in energy units. Used in
2685    conjunction with :mdp:`dh-hist-size`. This size limits the
2686    accuracy with which free energies can be calculated. Do not use
2687    histograms unless you're certain you need it.
2688
2689
2690 Expanded Ensemble calculations
2691 ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
2692
2693 .. mdp:: nstexpanded
2694
2695    The number of integration steps beween attempted moves changing the
2696    system Hamiltonian in expanded ensemble simulations. Must be a
2697    multiple of :mdp:`nstcalcenergy`, but can be greater or less than
2698    :mdp:`nstdhdl`.
2699
2700 .. mdp:: lmc-stats
2701
2702    .. mdp-value:: no
2703
2704       No Monte Carlo in state space is performed.
2705
2706    .. mdp-value:: metropolis-transition
2707
2708       Uses the Metropolis weights to update the expanded ensemble
2709       weight of each state. Min{1,exp(-(beta_new u_new - beta_old
2710       u_old)}
2711
2712    .. mdp-value:: barker-transition
2713
2714       Uses the Barker transition critera to update the expanded
2715       ensemble weight of each state i, defined by exp(-beta_new
2716       u_new)/(exp(-beta_new u_new)+exp(-beta_old u_old))
2717
2718    .. mdp-value:: wang-landau
2719
2720       Uses the Wang-Landau algorithm (in state space, not energy
2721       space) to update the expanded ensemble weights.
2722
2723    .. mdp-value:: min-variance
2724
2725       Uses the minimum variance updating method of Escobedo et al. to
2726       update the expanded ensemble weights. Weights will not be the
2727       free energies, but will rather emphasize states that need more
2728       sampling to give even uncertainty.
2729
2730 .. mdp:: lmc-mc-move
2731
2732    .. mdp-value:: no
2733
2734       No Monte Carlo in state space is performed.
2735
2736    .. mdp-value:: metropolis-transition
2737
2738       Randomly chooses a new state up or down, then uses the
2739       Metropolis critera to decide whether to accept or reject:
2740       Min{1,exp(-(beta_new u_new - beta_old u_old)}
2741
2742    .. mdp-value:: barker-transition
2743
2744       Randomly chooses a new state up or down, then uses the Barker
2745       transition critera to decide whether to accept or reject:
2746       exp(-beta_new u_new)/(exp(-beta_new u_new)+exp(-beta_old u_old))
2747
2748    .. mdp-value:: gibbs
2749
2750        Uses the conditional weights of the state given the coordinate
2751        (exp(-beta_i u_i) / sum_k exp(beta_i u_i) to decide which state
2752        to move to.
2753
2754    .. mdp-value:: metropolized-gibbs
2755
2756        Uses the conditional weights of the state given the coordinate
2757        (exp(-beta_i u_i) / sum_k exp(beta_i u_i) to decide which state
2758        to move to, EXCLUDING the current state, then uses a rejection
2759        step to ensure detailed balance. Always more efficient that
2760        Gibbs, though only marginally so in many situations, such as
2761        when only the nearest neighbors have decent phase space
2762        overlap.
2763
2764 .. mdp:: lmc-seed
2765
2766    (-1)
2767    random seed to use for Monte Carlo moves in state space. When
2768    :mdp:`lmc-seed` is set to -1, a pseudo random seed is us
2769
2770 .. mdp:: mc-temperature
2771
2772    Temperature used for acceptance/rejection for Monte Carlo moves. If
2773    not specified, the temperature of the simulation specified in the
2774    first group of :mdp:`ref-t` is used.
2775
2776 .. mdp:: wl-ratio
2777
2778    (0.8)
2779    The cutoff for the histogram of state occupancies to be reset, and
2780    the free energy incrementor to be changed from delta to delta *
2781    :mdp:`wl-scale`. If we define the Nratio = (number of samples at
2782    each histogram) / (average number of samples at each
2783    histogram). :mdp:`wl-ratio` of 0.8 means that means that the
2784    histogram is only considered flat if all Nratio > 0.8 AND
2785    simultaneously all 1/Nratio > 0.8.
2786
2787 .. mdp:: wl-scale
2788
2789    (0.8)
2790    Each time the histogram is considered flat, then the current value
2791    of the Wang-Landau incrementor for the free energies is multiplied
2792    by :mdp:`wl-scale`. Value must be between 0 and 1.
2793
2794 .. mdp:: init-wl-delta
2795
2796    (1.0)
2797    The initial value of the Wang-Landau incrementor in kT. Some value
2798    near 1 kT is usually most efficient, though sometimes a value of
2799    2-3 in units of kT works better if the free energy differences are
2800    large.
2801
2802 .. mdp:: wl-oneovert
2803
2804    (no)
2805    Set Wang-Landau incrementor to scale with 1/(simulation time) in
2806    the large sample limit. There is significant evidence that the
2807    standard Wang-Landau algorithms in state space presented here
2808    result in free energies getting 'burned in' to incorrect values
2809    that depend on the initial state. when :mdp:`wl-oneovert` is true,
2810    then when the incrementor becomes less than 1/N, where N is the
2811    mumber of samples collected (and thus proportional to the data
2812    collection time, hence '1 over t'), then the Wang-Lambda
2813    incrementor is set to 1/N, decreasing every step. Once this occurs,
2814    :mdp:`wl-ratio` is ignored, but the weights will still stop
2815    updating when the equilibration criteria set in
2816    :mdp:`lmc-weights-equil` is achieved.
2817
2818 .. mdp:: lmc-repeats
2819
2820    (1)
2821    Controls the number of times that each Monte Carlo swap type is
2822    performed each iteration. In the limit of large numbers of Monte
2823    Carlo repeats, then all methods converge to Gibbs sampling. The
2824    value will generally not need to be different from 1.
2825
2826 .. mdp:: lmc-gibbsdelta
2827
2828    (-1)
2829    Limit Gibbs sampling to selected numbers of neighboring states. For
2830    Gibbs sampling, it is sometimes inefficient to perform Gibbs
2831    sampling over all of the states that are defined. A positive value
2832    of :mdp:`lmc-gibbsdelta` means that only states plus or minus
2833    :mdp:`lmc-gibbsdelta` are considered in exchanges up and down. A
2834    value of -1 means that all states are considered. For less than 100
2835    states, it is probably not that expensive to include all states.
2836
2837 .. mdp:: lmc-forced-nstart
2838
2839    (0)
2840    Force initial state space sampling to generate weights. In order to
2841    come up with reasonable initial weights, this setting allows the
2842    simulation to drive from the initial to the final lambda state,
2843    with :mdp:`lmc-forced-nstart` steps at each state before moving on
2844    to the next lambda state. If :mdp:`lmc-forced-nstart` is
2845    sufficiently long (thousands of steps, perhaps), then the weights
2846    will be close to correct. However, in most cases, it is probably
2847    better to simply run the standard weight equilibration algorithms.
2848
2849 .. mdp:: nst-transition-matrix
2850
2851    (-1)
2852    Frequency of outputting the expanded ensemble transition matrix. A
2853    negative number means it will only be printed at the end of the
2854    simulation.
2855
2856 .. mdp:: symmetrized-transition-matrix
2857
2858    (no)
2859    Whether to symmetrize the empirical transition matrix. In the
2860    infinite limit the matrix will be symmetric, but will diverge with
2861    statistical noise for short timescales. Forced symmetrization, by
2862    using the matrix T_sym = 1/2 (T + transpose(T)), removes problems
2863    like the existence of (small magnitude) negative eigenvalues.
2864
2865 .. mdp:: mininum-var-min
2866
2867    (100)
2868    The min-variance strategy (option of :mdp:`lmc-stats` is only
2869    valid for larger number of samples, and can get stuck if too few
2870    samples are used at each state. :mdp:`mininum-var-min` is the
2871    minimum number of samples that each state that are allowed before
2872    the min-variance strategy is activated if selected.
2873
2874 .. mdp:: init-lambda-weights
2875
2876    The initial weights (free energies) used for the expanded ensemble
2877    states. Default is a vector of zero weights. format is similar to
2878    the lambda vector settings in :mdp:`fep-lambdas`, except the
2879    weights can be any floating point number. Units are kT. Its length
2880    must match the lambda vector lengths.
2881
2882 .. mdp:: lmc-weights-equil
2883
2884    .. mdp-value:: no
2885
2886       Expanded ensemble weights continue to be updated throughout the
2887       simulation.
2888
2889    .. mdp-value:: yes
2890
2891       The input expanded ensemble weights are treated as equilibrated,
2892       and are not updated throughout the simulation.
2893
2894    .. mdp-value:: wl-delta
2895
2896       Expanded ensemble weight updating is stopped when the
2897       Wang-Landau incrementor falls below this value.
2898
2899    .. mdp-value:: number-all-lambda
2900
2901       Expanded ensemble weight updating is stopped when the number of
2902       samples at all of the lambda states is greater than this value.
2903
2904    .. mdp-value:: number-steps
2905
2906       Expanded ensemble weight updating is stopped when the number of
2907       steps is greater than the level specified by this value.
2908
2909    .. mdp-value:: number-samples
2910
2911       Expanded ensemble weight updating is stopped when the number of
2912       total samples across all lambda states is greater than the level
2913       specified by this value.
2914
2915    .. mdp-value:: count-ratio
2916
2917       Expanded ensemble weight updating is stopped when the ratio of
2918       samples at the least sampled lambda state and most sampled
2919       lambda state greater than this value.
2920
2921 .. mdp:: simulated-tempering
2922
2923    (no)
2924    Turn simulated tempering on or off. Simulated tempering is
2925    implemented as expanded ensemble sampling with different
2926    temperatures instead of different Hamiltonians.
2927
2928 .. mdp:: sim-temp-low
2929
2930    (300) [K]
2931    Low temperature for simulated tempering.
2932
2933 .. mdp:: sim-temp-high
2934
2935    (300) [K]
2936    High temperature for simulated tempering.
2937
2938 .. mdp:: simulated-tempering-scaling
2939
2940    Controls the way that the temperatures at intermediate lambdas are
2941    calculated from the :mdp:`temperature-lambdas` part of the lambda
2942    vector.
2943
2944    .. mdp-value:: linear
2945
2946       Linearly interpolates the temperatures using the values of
2947       :mdp:`temperature-lambdas`, *i.e.* if :mdp:`sim-temp-low`
2948       =300, :mdp:`sim-temp-high` =400, then lambda=0.5 correspond to
2949       a temperature of 350. A nonlinear set of temperatures can always
2950       be implemented with uneven spacing in lambda.
2951
2952    .. mdp-value:: geometric
2953
2954       Interpolates temperatures geometrically between
2955       :mdp:`sim-temp-low` and :mdp:`sim-temp-high`. The i:th state
2956       has temperature :mdp:`sim-temp-low` * (:mdp:`sim-temp-high` /
2957       :mdp:`sim-temp-low`) raised to the power of
2958       (i/(ntemps-1)). This should give roughly equal exchange for
2959       constant heat capacity, though of course things simulations that
2960       involve protein folding have very high heat capacity peaks.
2961
2962    .. mdp-value:: exponential
2963
2964       Interpolates temperatures exponentially between
2965       :mdp:`sim-temp-low` and :mdp:`sim-temp-high`. The i:th state
2966       has temperature :mdp:`sim-temp-low` + (:mdp:`sim-temp-high` -
2967       :mdp:`sim-temp-low`)*((exp(:mdp:`temperature-lambdas`
2968       (i))-1)/(exp(1.0)-i)).
2969
2970
2971 Non-equilibrium MD
2972 ^^^^^^^^^^^^^^^^^^
2973
2974 .. mdp:: acc-grps
2975
2976    groups for constant acceleration (*e.g.* ``Protein Sol``) all atoms
2977    in groups Protein and Sol will experience constant acceleration as
2978    specified in the :mdp:`accelerate` line
2979
2980 .. mdp:: accelerate
2981
2982    (0) [nm ps\ :sup:`-2`]
2983    acceleration for :mdp:`acc-grps`; x, y and z for each group
2984    (*e.g.* ``0.1 0.0 0.0 -0.1 0.0 0.0`` means that first group has
2985    constant acceleration of 0.1 nm ps\ :sup:`-2` in X direction, second group
2986    the opposite).
2987
2988 .. mdp:: freezegrps
2989
2990    Groups that are to be frozen (*i.e.* their X, Y, and/or Z position
2991    will not be updated; *e.g.* ``Lipid SOL``). :mdp:`freezedim`
2992    specifies for which dimension(s) the freezing applies. To avoid
2993    spurious contributions to the virial and pressure due to large
2994    forces between completely frozen atoms you need to use energy group
2995    exclusions, this also saves computing time. Note that coordinates
2996    of frozen atoms are not scaled by pressure-coupling algorithms.
2997
2998 .. mdp:: freezedim
2999
3000    dimensions for which groups in :mdp:`freezegrps` should be frozen,
3001    specify `Y` or `N` for X, Y and Z and for each group (*e.g.* ``Y Y
3002    N N N N`` means that particles in the first group can move only in
3003    Z direction. The particles in the second group can move in any
3004    direction).
3005
3006 .. mdp:: cos-acceleration
3007
3008    (0) [nm ps\ :sup:`-2`]
3009    the amplitude of the acceleration profile for calculating the
3010    viscosity. The acceleration is in the X-direction and the magnitude
3011    is :mdp:`cos-acceleration` cos(2 pi z/boxheight). Two terms are
3012    added to the energy file: the amplitude of the velocity profile and
3013    1/viscosity.
3014
3015 .. mdp:: deform
3016
3017    (0 0 0 0 0 0) [nm ps\ :sup:`-1`]
3018    The velocities of deformation for the box elements: a(x) b(y) c(z)
3019    b(x) c(x) c(y). Each step the box elements for which :mdp:`deform`
3020    is non-zero are calculated as: box(ts)+(t-ts)*deform, off-diagonal
3021    elements are corrected for periodicity. The coordinates are
3022    transformed accordingly. Frozen degrees of freedom are (purposely)
3023    also transformed. The time ts is set to t at the first step and at
3024    steps at which x and v are written to trajectory to ensure exact
3025    restarts. Deformation can be used together with semiisotropic or
3026    anisotropic pressure coupling when the appropriate
3027    compressibilities are set to zero. The diagonal elements can be
3028    used to strain a solid. The off-diagonal elements can be used to
3029    shear a solid or a liquid.
3030
3031
3032 Electric fields
3033 ^^^^^^^^^^^^^^^
3034
3035 .. mdp:: electric-field-x
3036 .. mdp:: electric-field-y
3037 .. mdp:: electric-field-z
3038
3039    Here you can specify an electric field that optionally can be
3040    alternating and pulsed. The general expression for the field
3041    has the form of a gaussian laser pulse:
3042
3043    .. math:: E(t) = E_0 \exp\left[-\frac{(t-t_0)^2}{2\sigma^2}\right]\cos\left[\omega (t-t_0)\right]
3044
3045    For example, the four parameters for direction x are set in the
3046    fields of :mdp:`electric-field-x` (and similar for ``electric-field-y``
3047    and ``electric-field-z``) like
3048
3049    ``electric-field-x  = E0 omega t0 sigma``
3050
3051    with units (respectively) V nm\ :sup:`-1`, ps\ :sup:`-1`, ps, ps.
3052
3053    In the special case that ``sigma = 0``, the exponential term is omitted
3054    and only the cosine term is used. If also ``omega = 0`` a static
3055    electric field is applied.
3056
3057    Read more at :ref:`electric fields` and in ref. \ :ref:`146 <refCaleman2008a>`.
3058
3059
3060 Mixed quantum/classical molecular dynamics
3061 ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
3062
3063 .. MDP:: QMMM
3064
3065    .. mdp-value:: no
3066
3067       No QM/MM.
3068
3069    .. mdp-value:: yes
3070
3071       Do a QM/MM simulation. Several groups can be described at
3072       different QM levels separately. These are specified in the
3073       :mdp:`QMMM-grps` field separated by spaces. The level of *ab
3074       initio* theory at which the groups are described is specified by
3075       :mdp:`QMmethod` and :mdp:`QMbasis` Fields. Describing the
3076       groups at different levels of theory is only possible with the
3077       ONIOM QM/MM scheme, specified by :mdp:`QMMMscheme`.
3078
3079 .. mdp:: QMMM-grps
3080
3081    groups to be descibed at the QM level (works also in case of MiMiC QM/MM)
3082
3083 .. mdp:: QMMMscheme
3084
3085    .. mdp-value:: normal
3086
3087       normal QM/MM. There can only be one :mdp:`QMMM-grps` that is
3088       modelled at the :mdp:`QMmethod` and :mdp:`QMbasis` level of
3089       *ab initio* theory. The rest of the system is described at the
3090       MM level. The QM and MM subsystems interact as follows: MM point
3091       charges are included in the QM one-electron hamiltonian and all
3092       Lennard-Jones interactions are described at the MM level.
3093
3094    .. mdp-value:: ONIOM
3095
3096       The interaction between the subsystem is described using the
3097       ONIOM method by Morokuma and co-workers. There can be more than
3098       one :mdp:`QMMM-grps` each modeled at a different level of QM
3099       theory (:mdp:`QMmethod` and :mdp:`QMbasis`).
3100
3101 .. mdp:: QMmethod
3102
3103    (RHF)
3104    Method used to compute the energy and gradients on the QM
3105    atoms. Available methods are AM1, PM3, RHF, UHF, DFT, B3LYP, MP2,
3106    CASSCF, and MMVB. For CASSCF, the number of electrons and orbitals
3107    included in the active space is specified by :mdp:`CASelectrons`
3108    and :mdp:`CASorbitals`.
3109
3110 .. mdp:: QMbasis
3111
3112    (STO-3G)
3113    Basis set used to expand the electronic wavefuntion. Only Gaussian
3114    basis sets are currently available, *i.e.* ``STO-3G, 3-21G, 3-21G*,
3115    3-21+G*, 6-21G, 6-31G, 6-31G*, 6-31+G*,`` and ``6-311G``.
3116
3117 .. mdp:: QMcharge
3118
3119    (0) [integer]
3120    The total charge in `e` of the :mdp:`QMMM-grps`. In case there are
3121    more than one :mdp:`QMMM-grps`, the total charge of each ONIOM
3122    layer needs to be specified separately.
3123
3124 .. mdp:: QMmult
3125
3126    (1) [integer]
3127    The multiplicity of the :mdp:`QMMM-grps`. In case there are more
3128    than one :mdp:`QMMM-grps`, the multiplicity of each ONIOM layer
3129    needs to be specified separately.
3130
3131 .. mdp:: CASorbitals
3132
3133    (0) [integer]
3134    The number of orbitals to be included in the active space when
3135    doing a CASSCF computation.
3136
3137 .. mdp:: CASelectrons
3138
3139    (0) [integer]
3140    The number of electrons to be included in the active space when
3141    doing a CASSCF computation.
3142
3143 .. MDP:: SH
3144
3145    .. mdp-value:: no
3146
3147       No surface hopping. The system is always in the electronic
3148       ground-state.
3149
3150    .. mdp-value:: yes
3151
3152       Do a QM/MM MD simulation on the excited state-potential energy
3153       surface and enforce a *diabatic* hop to the ground-state when
3154       the system hits the conical intersection hyperline in the course
3155       the simulation. This option only works in combination with the
3156       CASSCF method.
3157
3158
3159 Computational Electrophysiology
3160 ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
3161 Use these options to switch on and control ion/water position exchanges in "Computational
3162 Electrophysiology" simulation setups. (See the `reference manual`_ for details).
3163
3164 .. mdp:: swapcoords
3165
3166    .. mdp-value:: no
3167
3168       Do not enable ion/water position exchanges.
3169
3170    .. mdp-value:: X ; Y ; Z
3171
3172       Allow for ion/water position exchanges along the chosen direction.
3173       In a typical setup with the membranes parallel to the x-y plane,
3174       ion/water pairs need to be exchanged in Z direction to sustain the
3175       requested ion concentrations in the compartments.
3176
3177 .. mdp:: swap-frequency
3178
3179    (1) The swap attempt frequency, i.e. every how many time steps the ion counts
3180    per compartment are determined and exchanges made if necessary.
3181    Normally it is not necessary to check at every time step.
3182    For typical Computational Electrophysiology setups, a value of about 100 is
3183    sufficient and yields a negligible performance impact.
3184
3185 .. mdp:: split-group0
3186
3187    Name of the index group of the membrane-embedded part of channel #0.
3188    The center of mass of these atoms defines one of the compartment boundaries
3189    and should be chosen such that it is near the center of the membrane.
3190
3191 .. mdp:: split-group1
3192
3193    Channel #1 defines the position of the other compartment boundary.
3194
3195 .. mdp:: massw-split0
3196
3197    (no) Defines whether or not mass-weighting is used to calculate the split group center.
3198
3199    .. mdp-value:: no
3200
3201       Use the geometrical center.
3202
3203    .. mdp-value:: yes
3204
3205       Use the center of mass.
3206
3207 .. mdp:: massw-split1
3208
3209    (no) As above, but for split-group #1.
3210
3211 .. mdp:: solvent-group
3212
3213    Name of the index group of solvent molecules.
3214
3215 .. mdp:: coupl-steps
3216
3217    (10) Average the number of ions per compartment over these many swap attempt steps.
3218    This can be used to prevent that ions near a compartment boundary
3219    (diffusing through a channel, e.g.) lead to unwanted back and forth swaps.
3220
3221 .. mdp:: iontypes
3222
3223    (1) The number of different ion types to be controlled. These are during the
3224    simulation exchanged with solvent molecules to reach the desired reference numbers.
3225
3226 .. mdp:: iontype0-name
3227
3228    Name of the first ion type.
3229
3230 .. mdp:: iontype0-in-A
3231
3232    (-1) Requested (=reference) number of ions of type 0 in compartment A.
3233    The default value of -1 means: use the number of ions as found in time step 0
3234    as reference value.
3235
3236 .. mdp:: iontype0-in-B
3237
3238    (-1) Reference number of ions of type 0 for compartment B.
3239
3240 .. mdp:: bulk-offsetA
3241
3242    (0.0) Offset of the first swap layer from the compartment A midplane.
3243    By default (i.e. bulk offset = 0.0), ion/water exchanges happen between layers
3244    at maximum distance (= bulk concentration) to the split group layers. However,
3245    an offset b (-1.0 < b < +1.0) can be specified to offset the bulk layer from the middle at 0.0
3246    towards one of the compartment-partitioning layers (at +/- 1.0).
3247
3248 .. mdp:: bulk-offsetB
3249
3250    (0.0) Offset of the other swap layer from the compartment B midplane.
3251
3252
3253 .. mdp:: threshold
3254
3255    (\1) Only swap ions if threshold difference to requested count is reached.
3256
3257 .. mdp:: cyl0-r
3258
3259    (2.0) [nm] Radius of the split cylinder #0.
3260    Two split cylinders (mimicking the channel pores) can optionally be defined
3261    relative to the center of the split group. With the help of these cylinders
3262    it can be counted which ions have passed which channel. The split cylinder
3263    definition has no impact on whether or not ion/water swaps are done.
3264
3265 .. mdp:: cyl0-up
3266
3267    (1.0) [nm] Upper extension of the split cylinder #0.
3268
3269 .. mdp:: cyl0-down
3270
3271    (1.0) [nm] Lower extension of the split cylinder #0.
3272
3273 .. mdp:: cyl1-r
3274
3275    (2.0) [nm] Radius of the split cylinder #1.
3276
3277 .. mdp:: cyl1-up
3278
3279    (1.0) [nm] Upper extension of the split cylinder #1.
3280
3281 .. mdp:: cyl1-down
3282
3283    (1.0) [nm] Lower extension of the split cylinder #1.
3284
3285
3286 User defined thingies
3287 ^^^^^^^^^^^^^^^^^^^^^
3288
3289 .. mdp:: user1-grps
3290 .. mdp:: user2-grps
3291 .. mdp:: userint1 (0)
3292 .. mdp:: userint2 (0)
3293 .. mdp:: userint3 (0)
3294 .. mdp:: userint4 (0)
3295 .. mdp:: userreal1 (0)
3296 .. mdp:: userreal2 (0)
3297 .. mdp:: userreal3 (0)
3298 .. mdp:: userreal4 (0)
3299
3300    These you can use if you modify code. You can pass integers and
3301    reals and groups to your subroutine. Check the inputrec definition
3302    in ``src/gromacs/mdtypes/inputrec.h``
3303
3304 Removed features
3305 ^^^^^^^^^^^^^^^^
3306
3307 These features have been removed from |Gromacs|, but so that old
3308 :ref:`mdp` and :ref:`tpr` files cannot be mistakenly misused, we still
3309 parse this option. :ref:`gmx grompp` and :ref:`gmx mdrun` will issue a
3310 fatal error if this is set.
3311
3312 .. mdp:: adress
3313
3314    (no)
3315
3316 .. mdp:: implicit-solvent
3317
3318    (no)
3319
3320 .. _reference manual: gmx-manual-parent-dir_