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