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