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