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