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