Remove cycle suppression
[gromacs.git] / docs / manual / topology.tex
blobbfd0393b5a7fe43f8103ee145a34fcac3d0e3fc6
2 % This file is part of the GROMACS molecular simulation package.
4 % Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
5 % Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6 % and including many others, as listed in the AUTHORS file in the
7 % top-level source directory and at http://www.gromacs.org.
9 % GROMACS is free software; you can redistribute it and/or
10 % modify it under the terms of the GNU Lesser General Public License
11 % as published by the Free Software Foundation; either version 2.1
12 % of the License, or (at your option) any later version.
14 % GROMACS is distributed in the hope that it will be useful,
15 % but WITHOUT ANY WARRANTY; without even the implied warranty of
16 % MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
17 % Lesser General Public License for more details.
19 % You should have received a copy of the GNU Lesser General Public
20 % License along with GROMACS; if not, see
21 % http://www.gnu.org/licenses, or write to the Free Software Foundation,
22 % Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
24 % If you want to redistribute modifications to GROMACS, please
25 % consider that scientific software is very special. Version
26 % control is crucial - bugs must be traceable. We will be happy to
27 % consider code for inclusion in the official distribution, but
28 % derived work must not be called official GROMACS. Details are found
29 % in the README & COPYING files - if they are missing, get the
30 % official version at http://www.gromacs.org.
32 % To help us fund GROMACS development, we humbly ask that you cite
33 % the research papers on the package. Check out http://www.gromacs.org.
35 \chapter{Topologies}
36 \label{ch:top}
37 \section{Introduction}
38 {\gromacs} must know on which atoms and combinations of atoms the
39 various contributions to the potential functions (see
40 \chref{ff}) must act. It must
41 also know what \normindex{parameter}s must be applied to the various
42 functions. All this is described in the {\em \normindex{topology}} file
43 {\tt *.top}, which lists the {\em constant attributes} of each atom.
44 There are many more atom types than elements, but only atom types
45 present in biological systems are parameterized in the force field,
46 plus some metals, ions and silicon. The bonded and special
47 interactions are determined by fixed lists that are included in the
48 topology file. Certain non-bonded interactions must be excluded (first
49 and second neighbors), as these are already treated in bonded
50 interactions. In addition, there are {\em dynamic attributes} of
51 atoms - their positions, velocities and forces. These do not
52 strictly belong to the molecular topology, and are stored in the
53 coordinate file {\tt *.gro} (positions and velocities), or trajectory
54 file {\tt *.trr} (positions, velocities, forces).
56 This chapter describes the setup of the topology file, the
57 {\tt *.top} file and the database files: what the parameters
58 stand for and how/where to change them if needed.
59 First, all file formats are explained.
60 Section \ssecref{fffiles} describes the organization of
61 the files in each force field.
63 {\bf Note:} if you construct your own topologies, we encourage you
64 to upload them to our topology archive at {\wwwpage}! Just imagine
65 how thankful you'd have been if your topology had been available
66 there before you started. The same goes for new force fields or
67 modified versions of the standard force fields - contribute them
68 to the force field archive!
70 \section{Particle type}
71 \label{sec:parttype}
73 In {\gromacs}, there are three types of \normindex{particle}s, see
74 \tabref{ptype}. Only regular atoms and virtual interaction sites are used
75 in {\gromacs}; shells are necessary for
76 polarizable models like the Shell-Water models~\cite{Maaren2001a}.
78 \begin{table}
79 \centerline{
80 \begin{tabular}{|l|c|}
81 \dline
82 Particle & Symbol \\
83 \hline
84 \seeindex{atom}{particle}s & A \\
85 \seeindex{shell}{particle}s & S \\
86 \normindex{virtual interaction sites} & V (or D) \\
87 \dline
88 \end{tabular}
90 \caption{Particle types in {\gromacs}}
91 \label{tab:ptype}
92 \end{table}
94 \subsection{Atom types}
95 \label{subsec:atomtype}
97 Each force field defines a set of \swapindex{atom}{type}s,
98 which have a characteristic name or number, and mass (in
99 a.m.u.). These listings are found in the {\tt atomtypes.atp}
100 file (.atp = {\bf a}tom {\bf t}ype {\bf p}arameter file).
101 Therefore, it is in this file that you can begin to change
102 and/or add an atom type. A sample from the {\tt gromos43a1.ff}
103 force field is listed below.
105 {\small
106 \begin{verbatim}
107 O 15.99940 ; carbonyl oxygen (C=O)
108 OM 15.99940 ; carboxyl oxygen (CO-)
109 OA 15.99940 ; hydroxyl, sugar or ester oxygen
110 OW 15.99940 ; water oxygen
111 N 14.00670 ; peptide nitrogen (N or NH)
112 NT 14.00670 ; terminal nitrogen (NH2)
113 NL 14.00670 ; terminal nitrogen (NH3)
114 NR 14.00670 ; aromatic nitrogen
115 NZ 14.00670 ; Arg NH (NH2)
116 NE 14.00670 ; Arg NE (NH)
117 C 12.01100 ; bare carbon
118 CH1 13.01900 ; aliphatic or sugar CH-group
119 CH2 14.02700 ; aliphatic or sugar CH2-group
120 CH3 15.03500 ; aliphatic CH3-group
121 \end{verbatim}}
123 {\bf Note:} {\gromacs} makes use of the atom types as a name, {\em
124 not} as a number (as {\eg} in {\gromos}).
126 %Atomic detail is used except for hydrogen atoms bound to (aliphatic)
127 %carbon atoms, which are treated as {\em \swapindex{united}{atom}s}. No
128 %special \normindex{hydrogen-bond} term is included. {\bf Note} that other force field
129 %like OPLS/AA, CHARMM, and AMBER use all atoms.
131 %\subsection{Nucleus}
132 %{\em Necessary for \normindex{polarisability}, not implemented yet.}
134 %\subsection{Shell}
135 %{\em Necessary for polarisability, not implemented yet.}
137 %\subsection{Bond shell}
138 %{\em Necessary for polarisability, not implemented yet.}
140 \subsection{Virtual sites}
141 \label{sec:vsitetop}
142 Some force fields use \normindex{virtual interaction sites}
143 (interaction sites that are constructed from other particle positions)
144 on which certain interactions are located
145 ({\eg} on benzene rings, to reproduce the correct
146 \normindex{quadrupole}). This is described in~\secref{virtual_sites}.
148 To make virtual sites in your system, you should include a section
149 {\tt [~virtual_sites?~]} (for backward compatibility the old name
150 {\tt [~dummies?~]} can also be used) in your topology file,
151 where the `{\tt ?}' stands
152 for the number constructing particles for the virtual site. This will be
153 `{\tt 2}' for type 2, `{\tt 3}' for types 3, 3fd, 3fad and 3out and
154 `{\tt 4}' for type 4fdn. The last of these replace an older 4fd type (with the `type' value 1)
155 that could occasionally be unstable; while it is still supported internally
156 in the code, the old 4fd type should not be used in new input files.
157 The different types are explained
158 in~\secref{virtual_sites}.
160 Parameters for type 2 should look like this:
161 {\small
162 \begin{verbatim}
163 [ virtual_sites2 ]
164 ; Site from funct a
165 5 1 2 1 0.7439756
166 \end{verbatim}}
168 for type 3 like this:
169 {\small
170 \begin{verbatim}
171 [ virtual_sites3 ]
172 ; Site from funct a b
173 5 1 2 3 1 0.7439756 0.128012
174 \end{verbatim}}
176 for type 3fd like this:
177 {\small
178 \begin{verbatim}
179 [ virtual_sites3 ]
180 ; Site from funct a d
181 5 1 2 3 2 0.5 -0.105
182 \end{verbatim}}
184 for type 3fad like this:
185 {\small
186 \begin{verbatim}
187 [ virtual_sites3 ]
188 ; Site from funct theta d
189 5 1 2 3 3 120 0.5
190 \end{verbatim}}
192 for type 3out like this:
193 {\small
194 \begin{verbatim}
195 [ virtual_sites3 ]
196 ; Site from funct a b c
197 5 1 2 3 4 -0.4 -0.4 6.9281
198 \end{verbatim}}
200 for type 4fdn like this:
201 {\small
202 \begin{verbatim}
203 [ virtual_sites4 ]
204 ; Site from funct a b c
205 5 1 2 3 4 2 1.0 0.9 0.105
206 \end{verbatim}}
208 This will result in the construction of a virtual site, number 5
209 (first column `{\tt Site}'), based on the positions of the atoms
210 whose indices are 1 and 2 or 1, 2 and 3 or 1, 2, 3 and 4 (next two,
211 three or four columns `{\tt from}') following the rules determined by the function number
212 (next column `{\tt funct}') with the parameters specified (last one,
213 two or three columns `{\tt a b} . .'). Obviously, the atom numbers
214 (including virtual site number) depend
215 on the molecule. It may be instructive to study the topologies for
216 TIP4P or TIP5P water models that are included with the {\gromacs} distribution.
218 {\bf Note} that if any constant bonded interactions are defined between
219 virtual sites and/or normal atoms, they will be removed by {\tt grompp}
220 (unless the option {tt -normvsbds} is used).
221 This removal of bonded interactions is done after generating exclusions,
222 as the generation of exclusions is based on ``chemically'' bonded interactions.
224 Virtual sites can be constructed in a more generic way using basic geometric
225 parameters. The directive that can be used is {\tt [ virtual_sitesn ]}. Required
226 parameters are listed in~\tabref{topfile2}. An example entry for defining a virtual
227 site at the center of geometry of a given set of atoms might be:
229 {\small
230 \begin{verbatim}
231 [ virtual_sitesn ]
232 ; Site funct from
233 5 1 1 2 3 4
234 \end{verbatim}}
236 \section{Parameter files}
238 \label{sec:paramfiles}
240 \subsection{Atoms}
241 The {\em static} properties (see \tabref{statprop} assigned to the
242 atom types are assigned based on data in several places.
243 The mass is listed in {\tt atomtypes.atp}
244 (see~\ssecref{atomtype}), whereas the charge is listed in {\tt *.rtp}
245 (.rtp = {\bf r}esidue {\bf t}opology {\bf p}arameter file,
246 see~\ssecref{rtp}). This implies that the charges are only defined in
247 the \normindex{building block}s of amino acids, nucleic acids or
248 otherwise, as defined by the user. When generating a topology
249 ({\tt *.top}) using the {\tt \normindex{pdb2gmx}} program, the
250 information from these files is combined.
252 \begin{table}
253 \centerline{
254 \begin{tabular}{|l|c|c|}
255 \dline
256 Property & Symbol & Unit \\
257 \hline
258 Type & - & - \\
259 Mass & m & a.m.u. \\
260 Charge & q & electron \\
261 epsilon & $\epsilon$ & kJ/mol \\
262 sigma & $\sigma$ & nm \\
263 \dline
264 \end{tabular}
266 \caption{Static atom type properties in {\gromacs}}
267 \label{tab:statprop}
268 \end{table}
270 %The following {\em dynamic} quantities are associated with an atom
271 %\begin{itemize}
272 %\item Position {\bf x}
273 %\item Velocity {\bf v}
274 %\end{itemize}
275 %These quantities are listed in the coordinate file, {\tt *.gro}
276 %(see section~\ssecref{grofile}).
278 \subsection{Non-bonded parameters}
279 \label{subsec:nbpar}
280 The \swapindex{non-bonded}{parameter}s consist of the van der Waals
281 parameters V ({\tt c6} or $\sigma$, depending on the combination rule) and W
282 ({\tt c12} or $\epsilon$), as listed in the file {\tt ffnonbonded.itp}, where
283 {\tt ptype} is the particle type (see \tabref{ptype}). As with the bonded parameters, entries in {\tt [~*type~]} directives
284 are applied to their counterparts in the topology file. Missing parameters
285 generate warnings, except as noted below in section~\ssecref{pairinteractions}.
287 {\small
288 \begin{verbatim}
289 [ atomtypes ]
290 ;name at.num mass charge ptype V(c6) W(c12)
291 O 8 15.99940 0.000 A 0.22617E-02 0.74158E-06
292 OM 8 15.99940 0.000 A 0.22617E-02 0.74158E-06
293 .....
295 [ nonbond_params ]
296 ; i j func V(c6) W(c12)
297 O O 1 0.22617E-02 0.74158E-06
298 O OA 1 0.22617E-02 0.13807E-05
299 .....
300 \end{verbatim}}
302 {\bf Note} that most of the included force fields also include the {\tt at.num.} column,
303 but this same information is implied in the OPLS-AA {\tt bond_type} column.
304 The interpretation of the parameters V and W depends on the combination rule
305 that was chosen in the {\tt [~defaults~]} section of the topology file
306 (see~\ssecref{topfile}):
307 \begin{eqnarray}
308 \mbox{for combination rule 1}: & &
309 \begin{array}{llllll}
310 \mbox{V}_{ii} & = & C^{(6)}_{i} & = & 4\,\epsilon_i\sigma_i^{6} &
311 \mbox{[ kJ mol$^{-1}$ nm$^{6}$ ]}\\
312 \mbox{W}_{ii} & = & C^{(12)}_{i} & = & 4\,\epsilon_i\sigma_i^{12} &
313 \mbox{[ kJ mol$^{-1}$ nm$^{12}$ ]}\\
314 \end{array}
316 \mbox{for combination rules 2 and 3}: & &
317 \begin{array}{llll}
318 \mbox{V}_{ii} & = & \sigma_i & \mbox{[ nm ]} \\
319 \mbox{W}_{ii} & = & \epsilon_i & \mbox{[ kJ mol$^{-1}$ ]}
320 \end{array}
321 \end{eqnarray}
322 Some or all combinations for different atom types can be given in the
323 {\tt [~nonbond_params~]} section, again with parameters V and W as defined
324 above. Any combination that is not given will be computed from the parameters
325 for the corresponding atom types, according to the \normindex{combination rule}:
326 \begin{eqnarray}
327 \mbox{for combination rules 1 and 3}: & &
328 \begin{array}{lll}
329 C^{(6)}_{ij} & = & \left(C^{(6)}_i\,C^{(6)}_j\right)^{\frac{1}{2}} \\
330 C^{(12)}_{ij} & = & \left(C^{(12)}_i\,C^{(12)}_j\right)^{\frac{1}{2}}
331 \end{array}
333 \mbox{for combination rule 2}: & &
334 \begin{array}{lll}
335 \sigma_{ij} & = & \frac{1}{2}(\sigma_i+\sigma_j) \\
336 \epsilon_{ij} & = & \sqrt{\epsilon_i\,\epsilon_j}
337 \end{array}
338 \end{eqnarray}
339 When $\sigma$ and $\epsilon$ need to be supplied (rules 2 and 3),
340 it would seem it is impossible to have a non-zero $C^{12}$ combined
341 with a zero $C^6$ parameter. However, providing a negative $\sigma$
342 will do exactly that, such that $C^6$ is set to zero and $C^{12}$ is
343 calculated normally. This situation represents a special case in reading
344 the value of $\sigma$, and nothing more.
346 There is only one set of \normindex{combination rule}s
347 for Buckingham potentials:
348 \beq
349 \begin{array}{rcl}
350 A_{ij} &=& \left(A_{ii} \, A_{jj}\right)^{1/2} \\
351 B_{ij} &=& 2 / \left(\frac{1}{B_{ii}} + \frac{1}{B_{jj}}\right) \\
352 C_{ij} &=& \left(C_{ii} \, C_{jj}\right)^{1/2}
353 \end{array}
354 \eeq
356 \subsection{Bonded parameters}
357 \label{subsec:bondparam}
358 The \swapindex{bonded}{parameter}s ({\ie} bonds, bond angles, improper and proper
359 dihedrals) are listed in {\tt ffbonded.itp}.~
360 % The term {\tt func} is 1 for
361 % harmonic and 2 for \gromosv{96} bond and angle potentials.
362 % For the dihedral, this is explained after this listing.
363 The entries in this database describe, respectively, the atom types
364 in the interactions, the type of the interaction, and the parameters
365 associated with that interaction. These parameters are then read
366 by {\tt \normindex{grompp}} when processing a topology and applied
367 to the relevant bonded parameters, {\ie} {\tt bondtypes} are applied to
368 entries in the {\tt [~bonds~]} directive, etc. Any bonded parameter that is
369 missing from the relevant {\tt [~*type~]} directive generates a fatal error.
370 The types of interactions are listed in \tabref{topfile2}.
371 Example excerpts from such files follow:
373 {\small
374 \begin{verbatim}
375 [ bondtypes ]
376 ; i j func b0 kb
377 C O 1 0.12300 502080.
378 C OM 1 0.12500 418400.
379 ......
381 [ angletypes ]
382 ; i j k func th0 cth
383 HO OA C 1 109.500 397.480
384 HO OA CH1 1 109.500 397.480
385 ......
387 [ dihedraltypes ]
388 ; i l func q0 cq
389 NR5* NR5 2 0.000 167.360
390 NR5* NR5* 2 0.000 167.360
391 ......
393 [ dihedraltypes ]
394 ; j k func phi0 cp mult
395 C OA 1 180.000 16.736 2
396 C N 1 180.000 33.472 2
397 ......
399 [ dihedraltypes ]
401 ; Ryckaert-Bellemans Dihedrals
403 ; aj ak funct
404 CP2 CP2 3 9.2789 12.156 -13.120 -3.0597 26.240 -31.495
405 \end{verbatim}}
407 In the {\tt ffbonded.itp} file, you can add bonded parameters. If you
408 want to include parameters for new atom types, make sure you define
409 them in {\tt atomtypes.atp} as well.
411 For most interaction types, bonded parameters are searched and assigned
412 using an exact match for all type names and allowing only a single set
413 of parameters. The exception to this rule are \normindex{dihedral} parameters.
414 For {\tt [ dihedraltypes ]} wildcard atom type names can be specified
415 with the letter {\tt X} in one or more of the four positions. Thus one
416 can for example assign proper dihedral parameters based on the types of
417 the middle two atoms. The parameters for the entry with the most exact matches,
418 i.e. the least wildcard matches, will be used. Note that {\gromacs} versions
419 older than 5.1.3 used the first match, which means that a full match would be
420 ignored if it is preceded by an entry that matches on wildcards. Thus it
421 is suggested to put wildcard entries at the end, in case someone might
422 use a forcefield with older versions of {\gromacs}.
423 In addition there is a dihedral type 9 which adds the possibility of
424 assigning multiple dihedral potentials, useful for combining terms with
425 different multiplicities. The different dihedral potential parameter
426 sets should be on directly adjacent lines in the {\tt [ dihedraltypes ]}
427 section.
429 \section{Molecule definition\index{molecule definition}}
431 \subsection{Moleculetype entries}
432 An organizational structure that usually corresponds to molecules is
433 the {\tt [ moleculetype ]} entry. This entry serves two main purposes. One is
434 to give structure to the topology file(s), usually corresponding to real
435 molecules. This makes the topology easier to read and writing it less labor
436 intensive. A second purpose is computational efficiency. The system definition
437 that is kept in memory is proportional in size of the {\tt moleculetype}
438 definitions. If a molecule is present in 100000 copies, this saves a factor
439 of 100000 in memory, which means the system usually fits in cache, which
440 can improve performance tremendously. Interactions that correspond to chemical
441 bonds, that generate exclusions, can only be defined between atoms within
442 a {\tt moleculetype}. It is allowed to have multiple molecules which are
443 not covalently bonded in one {\tt moleculetype} definition. Molecules can
444 be made infinitely long by connecting to themselves over periodic boundaries.
445 When such periodic molecules are present, an option in the {\tt mdp} file
446 needs to be set to tell {\gromacs} not to attempt to make molecules
447 that are broken over periodic boundaries whole again.
449 \subsection{Intermolecular interactions\index{intermolecular interaction}}
450 In some cases, one would like atoms in different molecules to also interact
451 with other interactions than the usual non-bonded interactions. This is often
452 the case in binding studies. When the molecules are covalently bound, e.g.
453 a ligand binding covalently to a protein, they are effectively one molecule
454 and they should be defined in one {\tt [ moleculetype ]} entry. Note that
455 {\tt pdb2gmx} has an option to put two or more molecules in one
456 {\tt [ moleculetype ]} entry. When molecules are not covalently bound,
457 it is much more convenient to use separate {\tt moleculetype} definitions
458 and specify the intermolecular interactions in the
459 {\tt [ intermolecular\_interactions] } section. In this section, which is
460 placed at the end of the topology (see \tabref{topfile1}), normal bonded
461 interactions can be specified using global atom indices. The only restrictions
462 are that no interactions can be used that generates exclusions and no
463 constraints can be used.
465 \subsection{Intramolecular pair interactions\index{intramolecular pair interaction}}
466 \label{subsec:pairinteractions}
467 Extra Lennard-Jones and electrostatic interactions between pairs
468 of atoms in a molecule can be added in the {\tt [~pairs~]} section of
469 a molecule definition. The parameters for these interactions can
470 be set independently from the non-bonded interaction parameters.
471 In the {\gromos} force fields, pairs are only used
472 to modify the \normindex{1-4 interaction}s (interactions of atoms
473 separated by three bonds). In these force fields the 1-4 interactions
474 are excluded from the non-bonded interactions (see \secref{excl}).
476 {\small
477 \begin{verbatim}
479 [ pairtypes ]
480 ; i j func cs6 cs12 ; THESE ARE 1-4 INTERACTIONS
481 O O 1 0.22617E-02 0.74158E-06
482 O OM 1 0.22617E-02 0.74158E-06
483 .....
484 \end{verbatim}}
486 The pair interaction parameters for the atom types
487 in {\tt ffnonbonded.itp} are listed in the {\tt [~pairtypes~]} section.
488 The {\gromos} force fields list all these interaction parameters
489 explicitly, but this section might be empty for force fields like
490 OPLS that calculate the \normindex{1-4 interaction}s by uniformly scaling the parameters.
491 Pair parameters that are not present in the {\tt [~pairtypes~]} section
492 are only generated when {\tt gen-pairs} is set to ``yes'' in the {\tt [~defaults~]}
493 directive of {\tt forcefield.itp} (see \ssecref{topfile}).
494 When {\tt gen-pairs} is set to ``no,'' {\tt \normindex{grompp}}
495 will give a warning for each pair type for which no parameters are given.
497 The normal pair interactions, intended for \normindex{1-4 interaction}s,
498 have function type 1. Function type 2 and the {\tt [~pairs_nb~]} are intended
499 for free-energy simulations. When determining hydration
500 free energies, the solute needs to be decoupled from the solvent.
501 This can be done by adding a B-state topology (see \secref{fecalc})
502 that uses zero for all solute non-bonded parameters, {\ie} charges and LJ parameters.
503 However, the free energy difference between the A and
504 B states is not the total hydration free energy. One has to
505 add the free energy for reintroducing the internal Coulomb and
506 LJ interactions in the solute when in vacuum. This second step can be combined with
507 the first step when the Coulomb and LJ interactions within
508 the solute are not modified. For this purpose, there is a pairs
509 function type 2, which is identical to function type 1, except
510 that the B-state parameters are always identical to the A-state
511 parameters. For searching the parameters in the {\tt [~pairtypes~]} section,
512 no distinction is made between function type 1 and 2.
513 The pairs section {\tt [~pairs_nb~]} is intended to replace the non-bonded interaction.
514 It uses the unscaled charges and the non-bonded LJ parameters;
515 it also only uses the A-state parameters. {\bf Note} that
516 one should add exclusions for all atom pairs listed in {\tt [~pairs_nb~]},
517 otherwise such pairs will also end up in the normal neighbor lists.
519 Alternatively, this same behavior can be achieved without ever
520 touching the topology, by using the {\tt couple-moltype}, {\tt
521 couple-lambda0}, {\tt couple-lambda1}, and {\tt couple-intramol}
522 keywords. See sections \secref{fecalc} and \secref{dgimplement} for
523 more information.
525 All three pair types always use plain Coulomb interactions,
526 even when Reaction-field, PME, Ewald or shifted Coulomb interactions
527 are selected for the non-bonded interactions.
528 Energies for types 1 and 2 are written to the energy and log file
529 in separate ``LJ-14'' and ``Coulomb-14'' entries per energy group pair.
530 Energies for {\tt [~pairs_nb~]} are added to the ``LJ-(SR)'' and ``Coulomb-(SR)'' terms.
533 \subsection{Exclusions}
534 \label{sec:excl}
535 The \normindex{exclusions} for non-bonded interactions are generated by {\tt
536 grompp} for neighboring atoms up to a certain number of bonds away, as
537 defined in the {\tt [~moleculetype~]} section in the topology file
538 (see \ssecref{topfile}). Particles are considered bonded when they are
539 connected by ``chemical'' bonds ({\tt [~bonds~]} types 1 to 5, 7 or 8)
540 or constraints ({\tt [~constraints~]} type 1).
541 Type 5 {\tt [~bonds~]} can be used to create a \normindex{connection}
542 between two atoms without creating an interaction.
543 There is a \normindex{harmonic interaction}
544 ({\tt [~bonds~]} type 6) that does not connect the atoms by a chemical bond.
545 There is also a second constraint type ({\tt [~constraints~]} type 2)
546 that fixes the distance, but does not connect
547 the atoms by a chemical bond.
548 For a complete list of all these interactions, see \tabref{topfile2}.
550 Extra exclusions within a molecule can be added manually
551 in a {\tt [~exclusions~]} section. Each line should start with one
552 atom index, followed by one or more atom indices. All non-bonded
553 interactions between the first atom and the other atoms will be excluded.
555 When all non-bonded interactions within or between groups of atoms need
556 to be excluded, is it more convenient and much more efficient to use
557 energy monitor group exclusions (see \secref{groupconcept}).
560 \section{Constraint algorithms\index{constraint algorithms}}
561 \label{sec:constraints}
562 Constraints are defined in the {\tt [~constraints~]} section.
563 The format is two atom numbers followed by the function type,
564 which can be 1 or 2, and the constraint distance.
565 The only difference between the two types is that type 1 is used
566 for generating exclusions and type 2 is not (see \secref{excl}).
567 The distances are constrained using the LINCS or the SHAKE algorithm,
568 which can be selected in the {\tt *.mdp} file.
569 Both types of constraints can be perturbed in free-energy calculations
570 by adding a second constraint distance (see \ssecref{constraintforce}).
571 Several types of bonds and angles (see \tabref{topfile2}) can
572 be converted automatically to constraints by {\tt grompp}.
573 There are several options for this in the {\tt *.mdp} file.
575 We have also implemented the \normindex{SETTLE} algorithm~\cite{Miyamoto92},
576 which is an analytical solution of SHAKE, specifically for water.
577 SETTLE can be selected in the topology file. See, for instance, the
578 SPC molecule definition:
580 {\small
581 \begin{verbatim}
582 [ moleculetype ]
583 ; molname nrexcl
584 SOL 1
586 [ atoms ]
587 ; nr at type res nr ren nm at nm cg nr charge
588 1 OW 1 SOL OW1 1 -0.82
589 2 HW 1 SOL HW2 1 0.41
590 3 HW 1 SOL HW3 1 0.41
592 [ settles ]
593 ; OW funct doh dhh
594 1 1 0.1 0.16333
596 [ exclusions ]
597 1 2 3
598 2 1 3
599 3 1 2
600 \end{verbatim}}
602 The {\tt [~settles~]} directive defines the first atom of the water molecule.
603 The settle funct is always 1, and the distance between O-H and H-H distances
604 must be given. {\bf Note} that the algorithm can also be used
605 for TIP3P and TIP4P~\cite{Jorgensen83}.
606 TIP3P just has another geometry. TIP4P has a virtual site, but since
607 that is generated it does not need to be shaken (nor stirred).
609 \section{\normindex{pdb2gmx} input files}
610 \label{sec:pdb2gmxfiles}
611 The {\gromacs} program {\tt pdb2gmx} generates a topology for
612 the input coordinate file. Several formats are supported for
613 that coordinate file, but {\tt *.pdb} is the most commonly-used format
614 (hence the name {\tt pdb2gmx}).
615 {\tt pdb2gmx} searches for force fields in sub-directories of the {\gromacs} {\tt share/top}
616 directory and your working directory. Force fields are recognized from
617 the file {\tt forcefield.itp} in a directory with the extension {\tt .ff}.
618 The file {\tt forcefield.doc} may be present, and if so, its first line
619 will be used by {\tt pdb2gmx} to present a short description to the
620 user to help in choosing a force field. Otherwise, the user can
621 choose a force field with the {\tt -ff xxx} command-line argument
622 to {\tt pdb2gmx}, which indicates that a force field in a
623 {\tt xxx.ff} directory is desired. {\tt pdb2gmx} will search first in the
624 working directory, then in the {\gromacs} {\tt share/top} directory, and
625 use the first matching {\tt xxx.ff} directory found.
627 Two general files are read by {\tt pdb2gmx}: an atom type file
628 (extension {\tt .atp}, see~\ssecref{atomtype}) from the force-field directory,
629 and a file called {\tt residuetypes.dat} from either the working directory, or
630 the {\gromacs} {\tt share/top} directory. {\tt residuetypes.dat}
631 determines which residue names are considered protein, DNA, RNA,
632 water, and ions.
634 {\tt pdb2gmx} can read one or multiple databases with topological information
635 for different types of molecules. A set of files belonging to one database
636 should have the same basename, preferably telling something about the type
637 of molecules ({\eg} aminoacids, rna, dna). The possible files are:
638 \begin{itemize}
639 \item {\tt <basename>.rtp}
640 \item {\tt <basename>.r2b} (optional)
641 \item {\tt <basename>.arn} (optional)
642 \item {\tt <basename>.hdb} (optional)
643 \item {\tt <basename>.n.tdb} (optional)
644 \item {\tt <basename>.c.tdb} (optional)
645 \end{itemize}
646 Only the {\tt .rtp} file, which contains the topologies of the building
647 blocks, is mandatory. Information from other files will only be used
648 for building blocks that come from an {\tt .rtp} file with the same base name.
649 The user can add building blocks to a force field by having additional
650 files with the same base name in their working directory. By default, only
651 extra building blocks can be defined, but calling {\tt pdb2gmx} with
652 the {\tt -rtpo} option will allow building blocks in a local file
653 to replace the default ones in the force field.
656 \subsection{Residue database}
657 \label{subsec:rtp}
658 The files holding the residue databases have the extension {\tt .rtp}.
659 Originally this file contained building blocks (amino acids) for proteins,
660 and is the {\gromacs} interpretation of the {\tt rt37c4.dat} file of {\gromos}.
661 So the residue database file contains information (bonds, charges, charge groups,
662 and improper dihedrals) for a frequently-used building block. It is
663 better {\em not} to change this file because it is standard input for
664 {\tt pdb2gmx}, but if changes are needed make them in the
665 {\tt *.top} file (see~\ssecref{topfile}), or in a {\tt .rtp} file
666 in the working directory as explained in \secref{pdb2gmxfiles}.
667 Defining topologies of new small molecules is probably easier
668 by writing an include topology file {\tt *.itp} directly.
669 This will be discussed in section~\ssecref{molitp}.
670 When adding a new protein residue to the database, don't forget to
671 add the residue name to the {\tt \normindex{residuetypes.dat}} file,
672 so that {\tt grompp}, {\tt make_ndx} and analysis tools can recognize
673 the residue as a protein residue (see \ssecref{defaultgroups}).
675 The {\tt .rtp} files are only used by {\tt pdb2gmx}.
676 As mentioned before, the only extra information this
677 program needs from the {\tt .rtp} database is bonds, charges of atoms,
678 charge groups, and improper dihedrals, because the rest is read from
679 the coordinate input file.
680 Some proteins contain residues that are not standard, but are
681 listed in the coordinate file. You have to construct a building block
682 for this ``strange'' residue, otherwise you will not obtain a
683 {\tt *.top} file. This also holds for molecules in the
684 coordinate file such as ligands, polyatomic ions, crystallization co-solvents, etc.
685 The residue database is constructed in the following way:
687 {\small
688 \begin{verbatim}
689 [ bondedtypes ] ; mandatory
690 ; bonds angles dihedrals impropers
691 1 1 1 2 ; mandatory
693 [ GLY ] ; mandatory
695 [ atoms ] ; mandatory
696 ; name type charge chargegroup
697 N N -0.280 0
698 H H 0.280 0
699 CA CH2 0.000 1
700 C C 0.380 2
701 O O -0.380 2
703 [ bonds ] ; optional
704 ;atom1 atom2 b0 kb
706 N CA
707 CA C
709 -C N
711 [ exclusions ] ; optional
712 ;atom1 atom2
714 [ angles ] ; optional
715 ;atom1 atom2 atom3 th0 cth
717 [ dihedrals ] ; optional
718 ;atom1 atom2 atom3 atom4 phi0 cp mult
720 [ impropers ] ; optional
721 ;atom1 atom2 atom3 atom4 q0 cq
722 N -C CA H
723 -C -CA N -O
725 [ ZN ]
727 [ atoms ]
728 ZN ZN 2.000 0
729 \end{verbatim}}
731 The file is free format; the only restriction is that there can be at
732 most one entry on a line. The first field in the file is the
733 {\tt [~bondedtypes~]} field, which is followed by four numbers,
734 indicating the interaction type for bonds, angles, dihedrals, and
735 improper dihedrals. The file contains residue entries, which consist
736 of atoms and (optionally) bonds, angles, dihedrals, and impropers. The
737 charge group codes denote the charge group numbers. Atoms in the same
738 charge group should always be ordered consecutively. When using the
739 hydrogen database with {\tt pdb2gmx} for adding missing hydrogens
740 (see~\ssecref{hdb}), the atom names defined in the {\tt .rtp} entry
741 should correspond exactly to the naming convention used in the
742 hydrogen database. The atom names in the bonded interaction can be
743 preceded by a minus or a plus, indicating that the atom is in the
744 preceding or following residue respectively. Explicit parameters added
745 to bonds, angles, dihedrals, and impropers override
746 the standard parameters in the {\tt .itp} files. This should only be
747 used in special cases. Instead of parameters, a string can be added
748 for each bonded interaction. This is used in \gromosv{96} {\tt .rtp}
749 files. These strings are copied to the topology file and can be
750 replaced by force-field parameters by the C-preprocessor in {\tt grompp}
751 using {\tt \#define} statements.
753 {\tt pdb2gmx} automatically generates all angles. This means that for
754 most force fields the {\tt [~angles~]} field is only useful for overriding
755 {\tt .itp} parameters. For the \gromosv{96} force field the interaction
756 number of all angles needs to be specified.
758 {\tt pdb2gmx} automatically generates one proper dihedral for every rotatable
759 bond, preferably on heavy atoms. When the {\tt [~dihedrals~]} field is used,
760 no other dihedrals will be generated for the bonds corresponding to the
761 specified dihedrals. It is possible to put more than one dihedral
762 function on a rotatable bond. In the case of CHARMM27 FF {\tt pdb2gmx}
763 can add correction maps to the dihedrals using the default {\tt -cmap} option.
764 Please refer to \ssecref{charmmff} for more information.
766 {\tt pdb2gmx} sets the number of exclusions to 3, which
767 means that interactions between atoms connected by at most 3 bonds are
768 excluded. Pair interactions are generated for all pairs of atoms that are
769 separated by 3 bonds (except pairs of hydrogens).
770 When more interactions need to be excluded, or some pair interactions should
771 not be generated, an {\tt [~exclusions~]} field can be added, followed by
772 pairs of atom names on separate lines. All non-bonded and pair interactions
773 between these atoms will be excluded.
775 \subsection{Residue to building block database}
776 Each force field has its own naming convention for residues.
777 Most residues have consistent naming, but some, especially those
778 with different protonation states, can have many different names.
779 The {\tt .r2b} files are used to convert standard residue names to
780 the force-field build block names. If no {\tt .r2b} is present
781 in the force-field directory or a residue is not listed, the building
782 block name is assumed to be identical to the residue name.
783 The {\tt .r2b} can contain 2 or 5 columns. The 2-column format
784 has the residue name in the first column and the building block name
785 in the second. The 5-column format has 3 additional columns with
786 the building block for the residue occurring in the N-terminus, C-terminus
787 and both termini at the same time (single residue molecule).
788 This is useful for, for instance, the AMBER force fields.
789 If one or more of the terminal versions are not present, a dash should be entered
790 in the corresponding column.
792 There is a {\gromacs} naming convention for residues which is only
793 apparent (except for the {\tt pdb2gmx} code) through the {\tt .r2b} file
794 and {\tt specbond.dat} files.
795 This convention is only of importance when you are adding residue types
796 to an {\tt .rtp} file. The convention is listed in \tabref{r2b}.
797 For special bonds with, for instance, a heme group, the {\gromacs} naming
798 convention is introduced through {\tt specbond.dat} (see~\ssecref{specbond}), which can
799 subsequently be translated by the {\tt .r2b} file, if required.
801 \begin{table}
802 \centerline{
803 \begin{tabular}{|ll|}
804 \dline
805 ARG & protonated arginine \\
806 ARGN & neutral arginine \\
807 ASP & negatively charged aspartic acid \\
808 ASPH & neutral aspartic acid \\
809 CYS & neutral cysteine \\
810 CYS2 & cysteine with sulfur bound to another cysteine or a heme \\
811 GLU & negatively charged glutamic acid \\
812 GLUH & neutral glutamic acid \\
813 HISD & neutral histidine with N$_\delta$ protonated \\
814 HISE & neutral histidine with N$_\epsilon$ protonated \\
815 HISH & positive histidine with both N$_\delta$ and N$_\epsilon$ protonated \\
816 HIS1 & histidine bound to a heme \\
817 LYSN & neutral lysine \\
818 LYS & protonated lysine \\
819 HEME & heme \\
820 \dline
821 \end{tabular}
823 \caption{Internal {\gromacs} residue naming convention.}
824 \label{tab:r2b}
825 \end{table}
827 \subsection{Atom renaming database}
828 Force fields often use atom names that do not follow IUPAC or PDB convention.
829 The {\tt .arn} database is used to translate the atom names in the coordinate
830 file to the force-field names. Atoms that are not listed keep their names.
831 The file has three columns: the building block name,
832 the old atom name, and the new atom name, respectively. The residue name
833 supports question-mark wildcards that match a single character.
835 An additional general atom renaming file called {\tt xlateat.dat} is present
836 in the {\tt share/top} directory, which translates common non-standard
837 atom names in the coordinate file to IUPAC/PDB convention. Thus, when writing
838 force-field files, you can assume standard atom names and no further
839 atom name translation is required, except for translating from standard atom names
840 to the force-field ones.
842 \subsection{Hydrogen database}
843 \label{subsec:hdb}
844 The \swapindex{hydrogen}{database} is stored in {\tt .hdb} files. It
845 contains information for the {\tt pdb2gmx} program on how to connect
846 hydrogen atoms to existing atoms. In versions of the database before
847 {\gromacs} 3.3, hydrogen atoms were named after the atom they are
848 connected to: the first letter of the atom name was replaced by an
849 `H.' In the versions from 3.3 onwards, the H atom has to be listed explicitly,
850 because the old behavior was protein-specific and hence could not
851 be generalized to other molecules.
852 If more than one hydrogen atom is connected to the same atom, a
853 number will be added to the end of the hydrogen atom name. For
854 example, adding two hydrogen atoms to \texttt{ND2} (in asparagine), the
855 hydrogen atoms will be named \texttt{HD21} and \texttt{HD22}. This is
856 important since atom naming in the \texttt{.rtp} file (see~\ssecref{rtp})
857 must be the same. The format of the hydrogen database is as follows:
859 {\small
860 \begin{verbatim}
861 ; res # additions
862 # H add type H i j k
863 ALA 1
864 1 1 H N -C CA
865 ARG 4
866 1 2 H N CA C
867 1 1 HE NE CD CZ
868 2 3 HH1 NH1 CZ NE
869 2 3 HH2 NH2 CZ NE
870 \end{verbatim}}
872 On the first line we see the residue name (ALA or ARG) and the number
873 of kinds of hydrogen atoms that may be added to this residue by the
874 hydrogen database. After that follows one line for each addition, on which
875 we see:
876 \begin{itemize}
877 \item The number of H atoms added
878 \item The method for adding H atoms, which can be any of:
879 \begin{enumerate}
880 \item[1]{\em one planar hydrogen, {\eg} rings or peptide bond}\\
881 One hydrogen atom (n) is generated, lying in the plane of atoms
882 (i,j,k) on the plane bisecting angle (j-i-k) at a distance of 0.1 nm
883 from atom i, such that the angles (n-i-j) and (n-i-k) are $>$ 90$^{\rm o}$.
885 \item[2]{\em one single hydrogen, {\eg} hydroxyl}\\
886 One hydrogen atom (n) is generated at a distance of 0.1 nm from atom
887 i, such that angle (n-i-j)=109.5 degrees and dihedral (n-i-j-k)=trans.
889 \item[3]{\em two planar hydrogens, {\eg} ethylene -C=CH{$_2$}, or amide -C(=O)NH{$_2$}}\\
890 Two hydrogens (n1,n2) are generated at a distance of 0.1 nm from atom
891 i, such that angle (n1-i-j)=(n2-i-j)=120 degrees and dihedral
892 (n1-i-j-k)=cis and (n2-i-j-k)=trans, such that names are according to
893 IUPAC standards~\cite{iupac70}.
895 \item[4]{\em two or three tetrahedral hydrogens, {\eg} -CH{$_3$}}\\
896 Three (n1,n2,n3) or two (n1,n2) hydrogens are generated at a distance
897 of 0.1 nm from atom i, such that angle
898 (n1-i-j)=(n2-i-j)=(n3-i-j)=109.47$^{\rm o}$, dihedral (n1-i-j-k)=trans,
899 (n2-i-j-k)=trans+120 and (n3-i-j-k)=trans+240$^{\rm o}$.
901 \item[5]{\em one tetrahedral hydrogen, {\eg} C{$_3$}CH}\\
902 One hydrogen atom (n$^\prime$) is generated at a distance of 0.1 nm from atom
903 i in tetrahedral conformation such that angle
904 (n$^\prime$-i-j)=(n$^\prime$-i-k)=(n$^\prime$-i-l)=109.47$^{\rm o}$.
906 \item[6]{\em two tetrahedral hydrogens, {\eg} C-CH{$_2$}-C}\\
907 Two hydrogen atoms (n1,n2) are generated at a distance of 0.1 nm from
908 atom i in tetrahedral conformation on the plane bisecting angle j-i-k
909 with angle (n1-i-n2)=(n1-i-j)=(n1-i-k)=109.47$^{\rm o}$.
911 \item[7]{\em two water hydrogens}\\
912 Two hydrogens are generated around atom i according to
913 SPC~\cite{Berendsen81} water geometry. The symmetry axis will
914 alternate between three coordinate axes in both directions.
916 \item[10]{\em three water ``hydrogens''}\\
917 Two hydrogens are generated around atom i according to
918 SPC~\cite{Berendsen81} water geometry. The symmetry axis will
919 alternate between three coordinate axes in both directions. In addition,
920 an extra particle is generated on the position of the oxygen with
921 the first letter of the name replaced by `M'. This is for
922 use with four-atom water models such as TIP4P~\cite{Jorgensen83}.
924 \item[11]{\em four water ``hydrogens''}\\
925 Same as above, except that two additional
926 particles are generated on the position of the oxygen, with names
927 `LP1' and `LP2.' This is for
928 use with five-atom water models such as TIP5P~\cite{Mahoney2000a}.
929 \end{enumerate}
931 \item
932 The name of the new H atom (or its prefix, {\eg} {\tt HD2} for
933 the asparagine example given earlier).
935 \item
936 Three or four control atoms (i,j,k,l), where the first always is the
937 atom to which the H atoms are connected. The other two or three depend
938 on the code selected. For water, there is only one control atom.
939 \end{itemize}
941 Some more exotic cases can be approximately constructed from the above tools,
942 and with suitable use of energy minimization are good enough for beginning
943 MD simulations. For example secondary amine hydrogen, nitrenyl hydrogen
944 (C\nolinebreak[4]=\nolinebreak[4]NH) and even ethynyl hydrogen could be
945 approximately constructed using method 2 above for hydroxyl hydrogen.
947 \subsection{Termini database}
948 \label{subsec:tdb}
949 The \swapindex{termini}{database}s are stored in {\tt aminoacids.n.tdb} and
950 {\tt aminoacids.c.tdb} for the N- and C-termini respectively. They contain
951 information for the {\tt pdb2gmx} program on how to connect new atoms
952 to existing ones, which atoms should be removed or changed, and which
953 bonded interactions should be added. Their format is as follows
954 (from {\tt gromos43a1.ff/aminoacids.c.tdb}):
956 {\small
957 \begin{verbatim}
958 [ None ]
960 [ COO- ]
961 [ replace ]
962 C C C 12.011 0.27
963 O O1 OM 15.9994 -0.635
964 OXT O2 OM 15.9994 -0.635
965 [ add ]
966 2 8 O C CA N
967 OM 15.9994 -0.635
968 [ bonds ]
969 C O1 gb_5
970 C O2 gb_5
971 [ angles ]
972 O1 C O2 ga_37
973 CA C O1 ga_21
974 CA C O2 ga_21
975 [ dihedrals ]
976 N CA C O2 gd_20
977 [ impropers ]
978 C CA O2 O1 gi_1
979 \end{verbatim}}
981 The file is organized in blocks, each with a header specifying the
982 name of the block. These blocks correspond to different types of
983 termini that can be added to a molecule. In this example {\tt [~COO-~]}
984 is the first block, corresponding to changing the terminal carbon
985 atom into a deprotonated carboxyl group. {\tt [~None~]} is the
986 second terminus type, corresponding to a terminus that leaves
987 the molecule as it is. Block names cannot be any of the following:
988 {\tt replace}, {\tt add}, {\tt delete}, {\tt bonds}, {\tt angles},
989 {\tt dihedrals}, {\tt impropers}. Doing so would interfere with
990 the parameters of the block, and would probably also be very confusing
991 to human readers.
993 For each block the following options are present:
994 \begin{itemize}
995 \item {\tt [~replace~]} \\
996 Replace an existing atom by one with a different atom type, atom name,
997 charge, and/or mass. This entry can be used to replace an atom that is
998 present both in the input coordinates and in the {\tt .rtp} database,
999 but also to only rename an atom in the input coordinates such that
1000 it matches the name in the force field. In the latter case, there
1001 should also be a corresponding {\tt [~add~]} section present that
1002 gives instructions to add the same atom, such that the position in the sequence
1003 and the bonding is known. Such an atom can be present in the input
1004 coordinates and kept, or not present and constructed by {\tt pdb2gmx}.
1005 For each atom to be replaced on line should be
1006 entered with the following fields:
1007 \begin{itemize}
1008 \item name of the atom to be replaced
1009 \item new atom name (optional)
1010 \item new atom type
1011 \item new mass
1012 \item new charge
1013 \end{itemize}
1014 \item {\tt [~add~]} \\
1015 Add new atoms. For each (group of) added atom(s), a two-line entry is
1016 necessary. The first line contains the same fields as an entry in the
1017 hydrogen database (name of the new atom,
1018 number of atoms, type of addition, control atoms,
1019 see~\ssecref{hdb}), but the possible types of addition are extended
1020 by two more, specifically for C-terminal additions:
1021 \begin{enumerate}
1022 \item[8]{\em two carboxyl oxygens, -COO{$^-$}}\\
1023 Two oxygens (n1,n2) are generated according to rule 3, at a distance
1024 of 0.136 nm from atom i and an angle (n1-i-j)=(n2-i-j)=117 degrees
1025 \item[9]{\em carboxyl oxygens and hydrogen, -COOH}\\
1026 Two oxygens (n1,n2) are generated according to rule 3, at distances of
1027 0.123 nm and 0.125 nm from atom i for n1 and n2, respectively, and angles
1028 (n1-i-j)=121 and (n2-i-j)=115 degrees. One hydrogen (n$^\prime$) is generated
1029 around n2 according to rule 2, where n-i-j and n-i-j-k should be read
1030 as n$^\prime$-n2-i and n$^\prime$-n2-i-j, respectively.
1031 \end{enumerate}
1032 After this line, another line follows that specifies the details of
1033 the added atom(s), in the same way as for replacing atoms, {\ie}:
1034 \begin{itemize}
1035 \item atom type
1036 \item mass
1037 \item charge
1038 \item charge group (optional)
1039 \end{itemize}
1040 Like in the hydrogen database (see~\ssecref{rtp}), when more than
1041 one atom is connected to an existing one, a number will be appended to
1042 the end of the atom name. {\bf Note} that, like in the hydrogen database, the
1043 atom name is now on the same line as the control atoms, whereas it was
1044 at the beginning of the second line prior to {\gromacs} version 3.3.
1045 When the charge group field is left out, the added atom will have
1046 the same charge group number as the atom that it is bonded to.
1047 \item {\tt [~delete~]}\\
1048 Delete existing atoms. One atom name per line.
1049 \item {\tt [~bonds~]}, {\tt [~angles~]}, {\tt [~dihedrals~]} and {\tt [~impropers~]}\\
1050 Add additional bonded parameters. The format is identical to that used
1051 in the {\tt *.rtp} file, see~\ssecref{rtp}.
1052 \end{itemize}
1054 \subsection{Virtual site database}
1055 Since we cannot rely on the positions of hydrogens in input files, we need a special
1056 input file to decide the geometries and parameters with which to add virtual site
1057 hydrogens. For more complex virtual site constructs ({\eg} when entire aromatic side chains
1058 are made rigid) we also need information about the equilibrium bond lengths and angles
1059 for all atoms in the side chain. This information is specified in the {\tt .vsd} file for each force
1060 field. Just as for the termini, there is one such file for each class of residues in
1061 the {\tt .rtp} file.
1063 The virtual site database is not really a very simple list of information. The first couple of sections
1064 specify which mass centers (typically called MCH$_3$/MNH$_3$) to use for CH$_3$, NH$_3$,
1065 and NH$_2$ groups. Depending on the
1066 equilibrium bond lengths and angles between the hydrogens and heavy atoms we need to apply
1067 slightly different constraint distances between these mass centers. {\bf Note} that we do {\em not} have to
1068 specify the actual parameters (that is automatic), just the type of mass center to use. To accomplish this,
1069 there are three sections names \verb+[ CH3 ]+, \verb+[ NH3 ]+, and \verb+[ NH2 ]+. For each of these we
1070 expect three columns. The first column is the atom type bound to the 2/3 hydrogens, the second column
1071 is the next heavy atom type which this is bound, and the third column the type of mass center to use.
1072 As a special case, in the \verb+[ NH2 ]+ section it is also possible to specify \verb+planar+ in the second
1073 column, which will use a different construction without mass center. There are currently different opinions
1074 in some force fields whether an NH$_2$ group should be planar or not, but we try hard to stick to the
1075 default equilibrium parameters of the force field.
1077 The second part of the virtual site database contains explicit equilibrium bond lengths and angles
1078 for pairs/triplets of atoms in aromatic side chains. These entries are currently read by specific routines
1079 in the virtual site generation code, so if you would like to extend it {\eg} to nucleic acids you would also
1080 need to write new code there. These sections are named after the short amino acid names
1081 (\verb+[ PHE ]+, \verb+[ TYR ]+, \verb+[ TRP ]+, \verb+[ HID ]+, \verb+[ HIE ]+, \verb+[ HIP ]+), and simply
1082 contain 2 or 3 columns with atom names, followed by a number specifying the bond length (in nm) or angle
1083 (in degrees). {\bf Note} that these are approximations of the equilibrated geometry for the entire molecule,
1084 which might not be identical to the equilibrium value for a single bond/angle if the molecule is strained.
1086 \subsection{Special bonds}
1087 \label{subsec:specbond}
1088 The primary mechanism used by {\tt \normindex{pdb2gmx}} to generate
1089 inter-residue bonds relies on head-to-tail linking of backbone atoms
1090 in different residues to build a macromolecule. In some cases ({\eg}
1091 \normindex{disulfide bonds}, a \normindex{heme group},
1092 \normindex{branched polymers}), it is necessary to create
1093 inter-residue bonds that do not lie on the backbone. The file {\tt
1094 \normindex{specbond.dat}} takes care of this function. It is
1095 necessary that the residues belong to the same {\tt [~moleculetype~]}.
1096 The {\tt -merge} and {\tt -chainsep} functions of {\tt pdb2gmx} can be
1097 useful when managing special inter-residue bonds between different
1098 chains.
1100 The first line of {\tt specbond.dat} indicates the number of entries that are in the file. If you
1101 add a new entry, be sure to increment this number. The remaining lines in the file provide the
1102 specifications for creating bonds. The format of the lines is as follows:
1104 {\tt resA atomA nbondsA resB atomB nbondsB length newresA newresB }
1106 The columns indicate:
1107 \begin{enumerate}
1108 \item {\tt resA} The name of residue A that participates in the bond.
1109 \item {\tt atomA} The name of the atom in residue A that forms the bond.
1110 \item {\tt nbondsA} The total number of bonds {\tt atomA} can form.
1111 \item {\tt resB} The name of residue B that participates in the bond.
1112 \item {\tt atomB} The name of the atom in residue B that forms the bond.
1113 \item {\tt nbondsB} The total number of bonds {\tt atomB} can form.
1114 \item {\tt length} The reference length for the bond. If {\tt atomA} and {\tt atomB} are not within
1115 {\tt length} $\pm$ 10\% in the coordinate file supplied to {\tt pdb2gmx}, no bond will be formed.
1116 \item {\tt newresA} The new name of residue A, if necessary. Some force fields use {\eg} CYS2 for
1117 a cysteine in a disulfide or heme linkage.
1118 \item {\tt newresB} The new name of residue B, likewise.
1119 \end{enumerate}
1122 \section{File formats}
1123 \subsection{Topology file\swapindexquiet{topology}{file}}
1124 \label{subsec:topfile}
1125 The topology file is built following the {\gromacs} specification for a
1126 molecular topology. A {\tt *.top} file can be generated by
1127 {\tt pdb2gmx}.
1128 All possible entries in the topology file are listed in
1129 Tables \ref{tab:topfile1} and \ref{tab:topfile2}.
1130 Also tabulated are: all the units
1131 of the parameters, which interactions can be perturbed for free energy
1132 calculations, which bonded interactions are used by {\tt grompp}
1133 for generating exclusions, and which bonded interactions can be converted
1134 to constraints by {\tt grompp}.
1136 %\renewcommand\floatpagefraction{.2}
1138 \newcommand{\tts}{\tt \small}
1140 % move these figures so they end up on facing pages
1141 % (first figure on even page)
1142 \newcommand{\kJmol}{kJ~mol$^{-1}$}
1143 \newcommand{\kJmolnm}[1]{\kJmol~nm$^{#1}$}
1144 \newcommand{\kJmolrad}[1]{\kJmol~rad$^{#1}$}
1145 \newcommand{\kJmoldeg}[1]{\kJmol~deg$^{#1}$}
1147 \begin{table}[p]
1148 \centering{
1149 \begin{tabular}{|l|llllc|}
1150 \multicolumn{6}{c}{\bf \large Parameters} \\
1151 \dline
1152 interaction & directive & \# & f. & parameters & F. E. \\
1153 type & & at. & tp & & \\
1154 \dline
1155 {\em mandatory} & {\tts defaults} & & & non-bonded function type; & \\
1156 & & & & combination rule$^{(cr)}$; &\\
1157 & & & & generate pairs (no/yes); & \\
1158 & & & & fudge LJ (); fudge QQ () & \\
1159 \hline
1160 {\em mandatory} & {\tts atomtypes} & & & atom type; m (u); q (e); particle type; & \\
1161 & & & & V$^{(cr)}$; W$^{(cr)}$ & \\
1162 %\hline
1163 & {\tts bondtypes} & \multicolumn{3}{l}{(see \tabref{topfile2}, directive {\tts bonds})} & \\
1164 & {\tts pairtypes} & \multicolumn{3}{l}{(see \tabref{topfile2}, directive {\tts pairs})} & \\
1165 & {\tts angletypes} & \multicolumn{3}{l}{(see \tabref{topfile2}, directive {\tts angles})} & \\
1166 & {\tts dihedraltypes}$^{(*)}$ & \multicolumn{3}{l}{(see \tabref{topfile2}, directive {\tts dihedrals})}& \\
1167 & {\tts constrainttypes}& \multicolumn{3}{l}{(see \tabref{topfile2}, directive {\tts constraints})} & \\
1168 LJ & {\tts nonbond_params} & 2 & 1 & $V^{(cr)}$; $W^{(cr)}$ & \\
1169 Buckingham & {\tts nonbond_params} & 2 & 2 & $a$ (\kJmol); $b$ (nm$^{-1})$; & \\
1170 & & & & $c_6$ (\kJmolnm{6}) & \\
1171 \dline
1172 \multicolumn{6}{c}{~} \\
1173 \multicolumn{6}{c}{\bf \large Molecule definition(s)} \\
1174 \dline
1175 {\em mandatory} & {\tts moleculetype} & & & molecule name; $n_{ex}^{(nrexcl)}$ & \\
1176 \hline
1177 {\em mandatory} & {\tts atoms} & 1 & & atom type; residue number; & type \\
1178 & & & & residue name; atom name; & \\
1179 & & & & charge group number; $q$ (e); $m$ (u) & $q,m$ \\
1180 \hline
1181 \multicolumn{6}{|c|}{} \\
1182 \multicolumn{6}{|c|}{intra-molecular interaction and geometry definitions as described
1183 in \tabref{topfile2}} \\
1184 \multicolumn{6}{|c|}{} \\
1185 \dline
1186 \multicolumn{6}{c}{~} \\
1187 \multicolumn{6}{c}{\bf \large System} \\
1188 \dline
1189 {\em mandatory} & {\tts system} & & & system name & \\
1190 \hline
1191 {\em mandatory} & {\tts molecules} & & & \multicolumn{2}{l|}{molecule name; number of molecules} \\
1192 \dline
1193 \multicolumn{6}{c}{~} \\
1194 \multicolumn{6}{c}{\bf \large Inter-molecular interactions} \\
1195 \dline
1196 {\em optional} & \multicolumn{4}{l}{\tts intermolecular_interactions} & \\
1197 \hline
1198 \multicolumn{6}{|c|}{one or more bonded interactions as described in \tabref{topfile2}, with two or more atoms,} \\
1199 \multicolumn{6}{|c|}{no interactions that generate exclusions, no constraints, use global atom numbers} \\
1200 \dline
1201 \multicolumn{6}{c}{~} \\
1202 \multicolumn{6}{l}{`\# at' is the required number of atom type indices for this directive} \\
1203 \multicolumn{6}{l}{`f. tp' is the value used to select this function type} \\
1204 \multicolumn{6}{l}{`F. E.' indicates which of the parameters can be interpolated in free energy calculations} \\
1205 \multicolumn{6}{l}{~$^{(cr)}$ the combination rule determines the type of LJ parameters, see~\ssecref{nbpar}}\\
1206 \multicolumn{6}{l}{~$^{(*)}$ for {\tts dihedraltypes} one can specify 4 atoms or the inner (outer for improper) 2 atoms}\\
1207 \multicolumn{6}{l}{~$^{(nrexcl)}$ exclude neighbors $n_{ex}$ bonds away for non-bonded interactions}\\
1208 \multicolumn{6}{l}{For free energy calculations, type, $q$ and $m$ or no parameters should be added}\\
1209 \multicolumn{6}{l}{for topology `B' ($\lambda = 1$) on the same line, after the normal parameters.}
1210 \end{tabular}
1212 \caption{The topology ({\tts *.top}) file.}
1213 \label{tab:topfile1}
1214 \end{table}
1216 \newcommand{\fnm}[1]{\footnotemark[#1]}
1217 \renewcommand{\thefootnote}{\fnsymbol{footnote}}
1218 %\renewcommand{\tts}{\tt \small}
1219 \newcommand{\ttss}{\tt \scriptsize}
1221 \begin{landscape}
1222 \begin{longtable}{|p{1.8in}|lcc>{\raggedright}p{2.5in}cc|}
1223 \caption{Details of {\tt [~moleculetype~]} directives}\\
1224 \dline
1225 Name of interaction & Topology file directive & num. & func. & Order of parameters and their units & use in & Cross- \\
1226 & & atoms\fnm{1} & type\fnm{2} & & F.E.?\fnm{3} & references \\
1227 \dline
1228 \endhead
1229 \dline
1230 \endfoot
1231 % The footnotetext fields only work inside the body, and not from a
1232 % column with ``p'' formatting'!
1233 bond & {\tts bonds}\fnm{4},\fnm{5} & 2 & 1 & $b_0$ (nm); $k_b$ (\kJmolnm{-2}) & all & \ssecref{harmonicbond}
1234 \label{tab:topfile2} \footnotetext[1]{The required number of atom indices for this directive}\footnotetext[2]{The index to use to select this function type}\footnotetext[3]{Indicates which of the parameters can be interpolated in free energy calculations}\footnotetext[4]{This interaction type will be used by {{\tts grompp}} for generating exclusions}\footnotetext[5]{This interaction type can be converted to constraints by {{\tts grompp}}}\footnotetext[7]{The combination rule determines the type of LJ parameters, see~\ssecref{nbpar}}\footnotetext[6]{No connection, and so no exclusions, are generated for this interaction}
1236 G96 bond & {\tts bonds}\fnm{4},\fnm{5} & 2 & 2 & $b_0$ (nm); $k_b$ (\kJmolnm{-4}) & all & \ssecref{G96bond} \\
1237 Morse & {\tts bonds}\fnm{4},\fnm{5} & 2 & 3 & $b_0$ (nm); $D$ (\kJmol); $\beta$ (nm$^{-1}$) & all & \ssecref{Morsebond} \\
1238 cubic bond & {\tts bonds}\fnm{4},\fnm{5} & 2 & 4 & $b_0$ (nm); $C_{i=2,3}$ (\kJmolnm{-i}) & & \ssecref{cubicbond} \\
1239 connection & {\tts bonds}\fnm{4} & 2 & 5 & & & \tsecref{excl} \\
1240 harmonic potential & {\tts bonds} & 2 & 6 & $b_0$ (nm); $k_b$ (\kJmolnm{-2}) & all & \ssecref{harmonicbond},\tsecref{excl} \\
1241 FENE bond & {\tts bonds}\fnm{4} & 2 & 7 & $b_m$ (nm); $k_b$ (\kJmolnm{-2}) & & \ssecref{FENEbond} \\
1242 tabulated bond & {\tts bonds}\fnm{4} & 2 & 8 & table number ($\geq 0$); $k$ (\kJmol) & $k$ & \ssecref{tabulatedinteraction} \\
1243 tabulated bond\fnm{6} & {\tts bonds} & 2 & 9 & table number ($\geq 0$); $k$ (\kJmol) & $k$ & \ssecref{tabulatedinteraction},\tsecref{excl} \\
1244 restraint potential & {\tts bonds} & 2 & 10 & low, up$_1$, up$_2$ (nm); $k_{dr}$ (\kJmolnm{-2}) & all & \ssecref{harmonicrestraint} \\
1245 extra LJ or Coulomb & {\tts pairs} & 2 & 1 & $V$\fnm{7}; $W$\fnm{7} & all & \ssecref{pairinteractions} \\
1246 extra LJ or Coulomb & {\tts pairs} & 2 & 2 & fudge QQ (); $q_i$, $q_j$ (e), $V$\fnm{7}; $W$\fnm{7} & & \ssecref{pairinteractions} \\
1247 extra LJ or Coulomb & {\tts pairs_nb} & 2 & 1 & $q_i$, $q_j$ (e); $V$\fnm{7}; $W$\fnm{7} & & \ssecref{pairinteractions} \\
1248 angle & {\tts angles}\fnm{5} & 3 & 1 & $\theta_0$ (deg); $k_\theta$ (\kJmolrad{-2}) & all & \ssecref{harmonicangle} \\
1249 G96 angle & {\tts angles}\fnm{5} & 3 & 2 & $\theta_0$ (deg); $k_\theta$ (\kJmol) & all & \ssecref{G96angle} \\
1250 cross bond-bond & {\tts angles} & 3 & 3 & $r_{1e}$, $r_{2e}$ (nm); $k_{rr'}$ (\kJmolnm{-2}) & & \ssecref{bondbondcross} \\
1251 cross bond-angle & {\tts angles} & 3 & 4 & $r_{1e}$, $r_{2e}$ $r_{3e}$ (nm); $k_{r\theta}$ (\kJmolnm{-2}) & & \ssecref{bondanglecross} \\
1252 Urey-Bradley & {\tts angles}\fnm{5} & 3 & 5 & $\theta_0$ (deg); $k_\theta$ (\kJmolrad{-2}); $r_{13}$ (nm); $k_{UB}$ (\kJmolnm{-2}) & all & \ssecref{Urey-Bradley} \\
1253 quartic angle & {\tts angles}\fnm{5} & 3 & 6 & $\theta_0$ (deg); $C_{i=0,1,2,3,4}$ (\kJmolrad{-i}) & & \ssecref{quarticangle} \\
1254 tabulated angle & {\tts angles} & 3 & 8 & table number ($\geq 0$); $k$ (\kJmol) & $k$ & \ssecref{tabulatedinteraction} \\
1255 restricted bending potential & {\tts angles} & 3 & 10 & $\theta_0$ (deg); $k_\theta$ (\kJmol) & & \ssecref{ReB} \\
1256 proper dihedral & {\tts dihedrals} & 4 & 1 & $\phi_s$ (deg); $k_\phi$ (\kJmol); multiplicity & $\phi,k$ & \ssecref{properdihedral} \\
1257 improper dihedral & {\tts dihedrals} & 4 & 2 & $\xi_0$ (deg); $k_\xi$ (\kJmolrad{-2}) & all & \ssecref{harmonicimproperdihedral} \\
1258 Ryckaert-Bellemans dihedral & {\tts dihedrals} & 4 & 3 & $C_0$, $C_1$, $C_2$, $C_3$, $C_4$, $C_5$ (\kJmol) & all & \ssecref{RBdihedral} \\
1259 periodic improper dihedral & {\tts dihedrals} & 4 & 4 & $\phi_s$ (deg); $k_\phi$ (\kJmol); multiplicity & $\phi,k$ & \ssecref{periodicimproperdihedral} \\
1260 Fourier dihedral & {\tts dihedrals} & 4 & 5 & $C_1$, $C_2$, $C_3$, $C_4$ (\kJmol) & all & \ssecref{Fourierdihedral} \\
1261 tabulated dihedral & {\tts dihedrals} & 4 & 8 & table number ($\geq 0$); $k$ (\kJmol) & $k$ & \ssecref{tabulatedinteraction} \\
1262 proper dihedral (multiple) & {\tts dihedrals} & 4 & 9 & $\phi_s$ (deg); $k_\phi$ (\kJmol); multiplicity & $\phi,k$ & \ssecref{properdihedral} \\
1263 restricted dihedral & {\tts dihedrals} & 4 & 10 & $\phi_0$ (deg); $k_\phi$ (\kJmol) & & \ssecref{ReT} \\
1264 combined bending-torsion potential & {\tts dihedrals} & 4 & 11 & $a_0$, $a_1$, $a_2$, $a_3$, $a_4$ (\kJmol) & & \ssecref{CBT} \\
1265 exclusions & {\tts exclusions} & 1 & & one or more atom indices & & \tsecref{excl} \\
1266 constraint & {\tts constraints}\fnm{4} & 2 & 1 & $b_0$ (nm) & all & \sssecref{constraints},\tsecref{constraints} \\
1267 constraint\fnm{6} & {\tts constraints} & 2 & 2 & $b_0$ (nm) & all & \sssecref{constraints},\tsecref{constraints},\tsecref{excl} \\
1268 SETTLE & {\tts settles} & 1 & 1 & $d_{\mbox{\sc oh}}$, $d_{\mbox{\sc hh}}$ (nm) & & \ssecref{SETTLE},\tsecref{constraints} \\
1269 2-body virtual site & {\tts virtual_sites2} & 3 & 1 & $a$ () & & \ssecref{vsite2} \\
1270 3-body virtual site & {\tts virtual_sites3} & 4 & 1 & $a$, $b$ () & & \ssecref{vsite3} \\
1271 3-body virtual site (fd) & {\tts virtual_sites3} & 4 & 2 & $a$ (); $d$ (nm) & & \ssecref{vsite3fd} \\
1272 3-body virtual site (fad) & {\tts virtual_sites3} & 4 & 3 & $\theta$ (deg); $d$ (nm) & & \ssecref{vsite3fad} \\
1273 3-body virtual site (out) & {\tts virtual_sites3} & 4 & 4 & $a$, $b$ (); $c$ (nm$^{-1}$) & & \ssecref{vsite3out} \\
1274 4-body virtual site (fdn) & {\tts virtual_sites4} & 5 & 2 & $a$, $b$ (); $c$ (nm) & & \ssecref{vsite4fdn} \\
1275 N-body virtual site (COG) & {\tts virtual_sitesn} & 1 & 1 & one or more constructing atom indices & & \ssecref{vsiteN} \\
1276 N-body virtual site (COM) & {\tts virtual_sitesn} & 1 & 2 & one or more constructing atom indices & & \ssecref{vsiteN} \\
1277 N-body virtual site (COW) & {\tts virtual_sitesn} & 1 & 3 & one or more pairs consisting of constructing atom index and weight & & \ssecref{vsiteN} \\
1278 position restraint & {\ttss position_restraints} & 1 & 1 & $k_{x}$, $k_{y}$, $k_{z}$ (\kJmolnm{-2}) & all & \ssecref{positionrestraint} \\
1279 flat-bottomed position restraint & {\ttss position_restraints} & 1 & 2 & $g$, $r$ (nm), $k$ (\kJmolnm{-2}) & & \ssecref{fbpositionrestraint} \\
1280 %restraint potential & {\tts bonds} & 2 & 10 & low, up$_1$, up$_2$ (nm); $k_{dr}$ (\kJmolnm{-2}) & & \ssecref{} \\
1281 distance restraint & {\ttss distance_restraints} & 2 & 1 & type; label; low, up$_1$, up$_2$ (nm); weight () & & \ssecref{distancerestraint} \\
1282 dihedral restraint & {\ttss dihedral_restraints} & 4 & 1 & $\phi_0$ (deg); $\Delta\phi$ (deg); $k_\mathrm{dihr}$ (\kJmolrad{-2}) & all & \ssecref{dihedralrestraint} \\
1283 orientation restraint & {\ttss orientation_restraints} & 2 & 1 & exp.; label; $\alpha$; $c$ (U nm$^\alpha$); obs. (U); weight (U$^{-1}$) & & \ssecref{orientationrestraint} \\
1284 angle restraint & {\ttss angle_restraints} & 4 & 1 & $\theta_0$ (deg); $k_c$ (\kJmol); multiplicity & $\theta,k$ & \ssecref{anglerestraint} \\
1285 angle restraint (z) & {\ttss angle_restraints_z} & 2 & 1 & $\theta_0$ (deg); $k_c$ (\kJmol); multiplicity & $\theta,k$ & \ssecref{anglerestraint} \\
1286 \end{longtable}
1287 \end{landscape}
1289 \renewcommand{\thefootnote}{\arabic{footnote}}
1291 %\renewcommand\floatpagefraction{.5}
1294 Description of the file layout:
1295 \begin{itemize}
1296 \item Semicolon (;) and newline characters surround comments
1297 \item On a line ending with $\backslash$ the newline character is ignored.
1298 \item Directives are surrounded by {\tt [} and {\tt ]}
1299 \item The topology hierarchy (which must be followed) consists of three levels:
1300 \begin{itemize}
1301 \item the parameter level, which defines certain force-field specifications
1302 (see~\tabref{topfile1})
1303 \item the molecule level, which should contain one or more molecule
1304 definitions (see~\tabref{topfile2})
1305 \item the system level, containing only system-specific information
1306 ({\tt [~system~]} and {\tt [~molecules~]})
1307 \end{itemize}
1308 \item Items should be separated by spaces or tabs, not commas
1309 \item Atoms in molecules should be numbered consecutively starting at 1
1310 \item Atoms in the same charge group must be listed consecutively
1311 \item The file is parsed only once, which implies that no forward
1312 references can be treated: items must be defined before they
1313 can be used
1314 \item Exclusions can be generated from the bonds or
1315 overridden manually
1316 \item The bonded force types can be generated from the atom types or
1317 overridden per bond
1318 \item It is possible to apply multiple bonded interactions of the same type
1319 on the same atoms
1320 \item Descriptive comment lines and empty lines are highly recommended
1321 \item Starting with {\gromacs} version 3.1.3, all directives at the
1322 parameter level can be used multiple times and there are no
1323 restrictions on the order, except that an atom type needs to be
1324 defined before it can be used in other parameter definitions
1325 \item If parameters for a certain interaction are defined multiple times
1326 for the same combination of atom types the last definition is used;
1327 starting with {\gromacs} version 3.1.3 {\tt grompp} generates a
1328 warning for parameter redefinitions with different values
1329 \item Using one of the {\tt [~atoms~]}, {\tt [~bonds~]},
1330 {\tt [~pairs~]}, {\tt [~angles~]}, etc. without having used
1331 {\tt [~moleculetype~]}
1332 before is meaningless and generates a warning
1333 \item Using {\tt [~molecules~]} without having used
1334 {\tt [~system~]} before is meaningless and generates a warning.
1335 \item After {\tt [~system~]} the only allowed directive is {\tt [~molecules~]}
1336 \item Using an unknown string in {\tt [ ]} causes all the data until
1337 the next directive to be ignored and generates a warning
1338 \end{itemize}
1340 Here is an example of a topology file, {\tt urea.top}:
1342 {\small
1343 \begin{verbatim}
1345 ; Example topology file
1347 ; The force-field files to be included
1348 #include "amber99.ff/forcefield.itp"
1350 [ moleculetype ]
1351 ; name nrexcl
1352 Urea 3
1354 [ atoms ]
1355 1 C 1 URE C 1 0.880229 12.01000 ; amber C type
1356 2 O 1 URE O 2 -0.613359 16.00000 ; amber O type
1357 3 N 1 URE N1 3 -0.923545 14.01000 ; amber N type
1358 4 H 1 URE H11 4 0.395055 1.00800 ; amber H type
1359 5 H 1 URE H12 5 0.395055 1.00800 ; amber H type
1360 6 N 1 URE N2 6 -0.923545 14.01000 ; amber N type
1361 7 H 1 URE H21 7 0.395055 1.00800 ; amber H type
1362 8 H 1 URE H22 8 0.395055 1.00800 ; amber H type
1364 [ bonds ]
1366 1 3
1373 [ dihedrals ]
1374 ; ai aj ak al funct definition
1375 2 1 3 4 9
1376 2 1 3 5 9
1377 2 1 6 7 9
1378 2 1 6 8 9
1379 3 1 6 7 9
1380 3 1 6 8 9
1381 6 1 3 4 9
1382 6 1 3 5 9
1384 [ dihedrals ]
1385 3 6 1 2 4
1386 1 4 3 5 4
1387 1 7 6 8 4
1389 [ position_restraints ]
1390 ; you wouldn't normally use this for a molecule like Urea,
1391 ; but we include it here for didactic purposes
1392 ; ai funct fc
1393 1 1 1000 1000 1000 ; Restrain to a point
1394 2 1 1000 0 1000 ; Restrain to a line (Y-axis)
1395 3 1 1000 0 0 ; Restrain to a plane (Y-Z-plane)
1397 [ dihedral_restraints ]
1398 ; ai aj ak al type phi dphi fc
1399 3 6 1 2 1 180 0 10
1400 1 4 3 5 1 180 0 10
1402 ; Include TIP3P water topology
1403 #include "amber99/tip3p.itp"
1405 [ system ]
1406 Urea in Water
1408 [ molecules ]
1409 ;molecule name nr.
1410 Urea 1
1411 SOL 1000
1412 \end{verbatim}}
1414 Here follows the explanatory text.
1416 {\bf {\tt \#include "amber99.ff/forcefield.itp"} :} this includes the
1417 information for the force field you are using, including
1418 bonded and non-bonded parameters. This example uses the AMBER99 force
1419 field, but your simulation may use a different force field.
1420 {\tt grompp} will automatically go and find this file and copy-and-paste
1421 its content. That content can be seen in
1422 \linebreak {\tt share/top/amber99.ff/forcefield.itp}, and it is
1424 {\small
1425 \begin{verbatim}
1426 #define _FF_AMBER
1427 #define _FF_AMBER99
1429 [ defaults ]
1430 ; nbfunc comb-rule gen-pairs fudgeLJ fudgeQQ
1431 1 2 yes 0.5 0.8333
1433 #include "ffnonbonded.itp"
1434 #include "ffbonded.itp"
1435 \end{verbatim}}
1437 The two {\tt \#define} statements set up the conditions so that
1438 future parts of the topology can know that the AMBER 99 force
1439 field is in use.
1441 {\bf {\tt [~defaults~]} :}
1442 \begin{itemize}
1443 \item {\tt nbfunc} is the non-bonded function type. Use 1 (Lennard-Jones) or 2 (Buckingham)
1444 \item {\tt comb-rule} is the number of the \normindex{combination rule} (see \ssecref{nbpar}).
1445 \item {\tt gen-pairs} is for pair generation. The default is `no', {\ie}
1446 get 1-4 parameters from the pairtypes list. When parameters
1447 are not present in the list, stop with a fatal error.
1448 Setting `yes' generates 1-4 parameters that are not present in the pair list
1449 from normal Lennard-Jones parameters using {\tt fudgeLJ}
1450 \item {\tt fudgeLJ} is the factor by which to multiply Lennard-Jones 1-4 interactions, default 1
1451 \item {\tt fudgeQQ} is the factor by which to multiply electrostatic 1-4 interactions, default 1
1452 \item $N$ is the power for the repulsion term in a 6-$N$ potential (with
1453 nonbonded-type Lennard-Jones only), starting with {\gromacs} version 4.5,
1454 {\tt mdrun} also reads and applies $N$, for values not equal to 12 tabulated
1455 interaction functions are used
1456 (in older version you would have to use user tabulated interactions).
1457 \end{itemize}
1458 {\bf Note} that {\tt gen-pairs}, {\tt fudgeLJ}, {\tt fudgeQQ}, and $N$ are optional.
1459 {\tt fudgeLJ} is only used when generate pairs is set to `yes', and
1460 {\tt fudgeQQ} is always used. However, if you
1461 want to specify $N$ you need to give a value for the other parameters as well.
1463 Then some other {\tt \#include} statements add in the large amount of data needed
1464 to describe the rest of the force field. We will skip these and return to {\tt urea.top}.
1465 There we will see
1467 % move these figures so they end up on facing pages
1468 % (first figure on even page)
1469 %\input{topolfig}
1471 {\bf {\tt [~moleculetype~]} :} defines the name of your molecule in
1472 this {\tt *.top} and nrexcl = 3 stands for excluding non-bonded
1473 interactions between atoms that are no further than 3 bonds away.
1475 {\bf {\tt [~atoms~]} :} defines the molecule, where {\tt nr} and
1476 {\tt type} are fixed, the rest is user defined. So {\tt atom} can be named
1477 as you like, {\tt cgnr} made larger or smaller (if possible, the total
1478 charge of a charge group should be zero), and charges can be changed
1479 here too.
1481 {\bf {\tt [~bonds~]} :} no comment.
1483 {\bf {\tt [~pairs~]} :} LJ and Coulomb 1-4 interactions
1485 {\bf {\tt [~angles~]} :} no comment
1487 {\bf {\tt [~dihedrals~]} :} in this case there are 9 proper dihedrals
1488 (funct = 1), 3 improper (funct = 4) and no Ryckaert-Bellemans type
1489 dihedrals. If you want to include Ryckaert-Bellemans type dihedrals
1490 in a topology, do the following (in case of {\eg} decane):
1491 \begin{verbatim}
1492 [ dihedrals ]
1493 ; ai aj ak al funct c0 c1 c2
1494 1 2 3 4 3
1495 2 3 4 5 3
1496 \end{verbatim}
1497 In the original implementation of the potential for
1498 alkanes~\cite{Ryckaert78} no 1-4 interactions were used, which means
1499 that in order to implement that particular force field you need to remove the 1-4
1500 interactions from the {\tt [~pairs~]} section of your topology. In
1501 most modern force fields, like OPLS/AA or Amber the rules are
1502 different, and the Ryckaert-Bellemans potential is used as a cosine
1503 series in combination with 1-4 interactions.
1505 {\bf {\tt [~position_restraints~]} :} harmonically restrain the selected particles
1506 to reference positions (\ssecref{positionrestraint}).
1507 The reference positions are read from a
1508 separate coordinate file by {\tt \normindex{grompp}}.
1511 {\bf {\tt [~dihedral_restraints~]} :} restrain selected dihedrals to a reference value.
1512 The implementation of dihedral restraints is described in section \ssecref{dihedralrestraint} of the manual.
1513 The parameters specified in the [dihedral_restraints] directive are as follows:
1514 \begin{itemize}
1515 \item {\tt type} has only one possible value which is 1
1516 \item {\tt phi} is the value of $\phi_0$ in \eqnref{dphi} and \eqnref{dihre} of the manual.
1517 \item {\tt dphi} is the value of $\Delta\phi$ in \eqnref{dihre} of the manual.
1518 \item {\tt fc} is the force constant $k_{dihr}$ in \eqnref{dihre} of the manual.
1519 \end{itemize}
1521 {\bf {\tt \#include "tip3p.itp"} :} includes a topology file that was already
1522 constructed (see section~\ssecref{molitp}).
1524 {\bf {\tt [~system~]} :} title of your system, user-defined
1526 {\bf {\tt [~molecules~]} :} this defines the total number of (sub)molecules
1527 in your system that are defined in this {\tt *.top}. In this
1528 example file, it stands for 1 urea molecule dissolved in 1000 water
1529 molecules. The molecule type SOL is defined in the {\tt tip3p.itp} file.
1530 Each name here must correspond to a name given with {\tt [~moleculetype~]}
1531 earlier in the topology. The order of the blocks of molecule types and
1532 the numbers of such molecules must match the coordinate file that
1533 accompanies the topology when supplied to {\tt \normindex{grompp}}.
1534 The blocks of molecules do not need to be contiguous, but some
1535 tools (e.g. {\tt \normindex{genion}}) may act only on the first or
1536 last such block of a particular molecule type. Also, these blocks
1537 have nothing to do with the definition of \normindex{groups}
1538 (see \secref{groupconcept} and \secref{usinggroups}).
1540 \subsection{Molecule.itp file}
1541 \label{subsec:molitp}
1542 If you construct a topology file you will use frequently (like the water
1543 molecule, {\tt tip3p.itp}, which is already constructed for you) it is
1544 good to make a {\tt molecule.itp} file. This only lists the
1545 information of one particular molecule and allows you to re-use the
1546 {\tt [ moleculetype ]} in multiple systems without re-invoking
1547 {\tt pdb2gmx} or manually copying and pasting. An example
1548 {\tt urea.itp} follows:
1550 {\small
1551 \begin{verbatim}
1552 [ moleculetype ]
1553 ; molname nrexcl
1554 URE 3
1556 [ atoms ]
1557 1 C 1 URE C 1 0.880229 12.01000 ; amber C type
1559 8 H 1 URE H22 8 0.395055 1.00800 ; amber H type
1561 [ bonds ]
1565 [ dihedrals ]
1566 ; ai aj ak al funct definition
1567 2 1 3 4 9
1569 6 1 3 5 9
1570 [ dihedrals ]
1571 3 6 1 2 4
1572 1 4 3 5 4
1573 1 7 6 8 4
1574 \end{verbatim}}
1576 Using {\tt *.itp} files results in a very short {\tt *.top} file:
1578 {\small
1579 \begin{verbatim}
1581 ; Example topology file
1583 ; The force field files to be included
1584 #include "amber99.ff/forcefield.itp"
1586 #include "urea.itp"
1588 ; Include TIP3P water topology
1589 #include "amber99/tip3p.itp"
1591 [ system ]
1592 Urea in Water
1594 [ molecules ]
1595 ;molecule name nr.
1596 Urea 1
1597 SOL 1000
1598 \end{verbatim}}
1600 \subsection{Ifdef statements}
1601 \label{subsec:ifdef}
1602 A very powerful feature in {\gromacs} is the use of {\tt \#ifdef}
1603 statements in your {\tt *.top} file. By making use of this statement,
1604 and associated {\tt \#define} statements like were seen in
1605 \linebreak {\tt amber99.ff/forcefield.itp} earlier,
1606 different parameters for one molecule can be used in the same
1607 {\tt *.top} file. An example is given for TFE, where there is an option to
1608 use different charges on the atoms: charges derived by De Loof
1609 {\etal}~\cite{Loof92} or by Van Buuren and
1610 Berendsen~\cite{Buuren93a}. In fact, you can use much of the functionality of the
1611 C preprocessor, {\tt cpp}, because {\tt grompp} contains similar pre-processing
1612 functions to scan the file. The
1613 way to make use of the {\tt \#ifdef} option is as follows:
1614 \begin{itemize}
1615 \item either use the option {\tt define = -DDeLoof} in the
1616 {\tt *.mdp} file (containing {\tt grompp} input
1617 parameters), or use the line {\tt \#define DeLoof}
1618 early in your {\tt *.top} or {\tt *.itp} file; and
1619 \item put the {\tt \#ifdef} statements in your {\tt *.top}, as
1620 shown below:
1621 \end{itemize}
1623 {\small
1624 \begin{verbatim}
1629 [ atoms ]
1630 ; nr type resnr residu atom cgnr charge mass
1631 #ifdef DeLoof
1632 ; Use Charges from DeLoof
1633 1 C 1 TFE C 1 0.74
1634 2 F 1 TFE F 1 -0.25
1635 3 F 1 TFE F 1 -0.25
1636 4 F 1 TFE F 1 -0.25
1637 5 CH2 1 TFE CH2 1 0.25
1638 6 OA 1 TFE OA 1 -0.65
1639 7 HO 1 TFE HO 1 0.41
1640 #else
1641 ; Use Charges from VanBuuren
1642 1 C 1 TFE C 1 0.59
1643 2 F 1 TFE F 1 -0.2
1644 3 F 1 TFE F 1 -0.2
1645 4 F 1 TFE F 1 -0.2
1646 5 CH2 1 TFE CH2 1 0.26
1647 6 OA 1 TFE OA 1 -0.55
1648 7 HO 1 TFE HO 1 0.3
1649 #endif
1651 [ bonds ]
1652 ; ai aj funct c0 c1
1653 6 7 1 1.000000e-01 3.138000e+05
1654 1 2 1 1.360000e-01 4.184000e+05
1655 1 3 1 1.360000e-01 4.184000e+05
1656 1 4 1 1.360000e-01 4.184000e+05
1657 1 5 1 1.530000e-01 3.347000e+05
1658 5 6 1 1.430000e-01 3.347000e+05
1660 \end{verbatim}}
1662 This mechanism is used by {\tt pdb2gmx} to implement optional position
1663 restraints (\ssecref{positionrestraint}) by {\tt \#include}-ing an {\tt .itp} file whose contents
1664 will be meaningful only if a particular {\tt \#define} is set (and spelled
1665 correctly!)
1667 \subsection{Topologies for free energy calculations}
1668 \index{free energy topologies}
1669 Free energy differences between two systems, A and B, can be calculated as
1670 described in \secref{fecalc}.
1671 Systems A and B are described by topologies
1672 consisting of the same number of molecules with the same number of
1673 atoms. Masses and non-bonded interactions can be perturbed by adding B
1674 parameters under the {\tt [~atoms~]} directive. Bonded interactions can be
1675 perturbed by adding B parameters to the bonded types or the bonded
1676 interactions. The parameters that can be perturbed are listed in
1677 Tables \ref{tab:topfile1} and \ref{tab:topfile2}.
1678 The $\lambda$-dependence of the interactions is described
1679 in section \secref{feia}.
1680 The bonded parameters that are used (on the line of the bonded
1681 interaction definition, or the ones looked up on atom types
1682 in the bonded type lists) is explained in \tabref{topfe}.
1683 In most cases, things should work intuitively.
1684 When the A and B atom types in a bonded interaction
1685 are not all identical and parameters are not present for the B-state,
1686 either on the line or in the bonded types,
1687 {\tt grompp} uses the A-state parameters and issues a warning.
1688 For free energy calculations, all or no parameters for topology B
1689 ($\lambda = 1$) should be added on the same line, after the normal
1690 parameters, in the same order as the normal parameters.
1691 From {\gromacs} 4.6 onward, if $\lambda$ is treated as a vector, then
1692 the {\tt bonded-lambdas} component controls all bonded terms that are
1693 not explicitly labeled as restraints. Restrain terms are controlled
1694 by the {\tt restraint-lambdas} component.
1696 \begin{table}
1697 \centerline{
1698 \begin{tabular}{|c|cc|cc|cc|c|}
1699 \dline
1700 B-state atom types & \multicolumn{2}{c|}{parameters} & \multicolumn{4}{c|}{parameters in bonded types} & \\
1701 all identical to & \multicolumn{2}{c|}{on line} & \multicolumn{2}{c|}{A atom types} & \multicolumn{2}{c|}{B atom types} & message \\
1702 A-state atom types & A & B & A & B & A & B & \\
1703 \dline
1704 & +AB & $-$ & x & x & & & \\
1705 & +A & +B & x & x & & & \\
1706 yes & $-$ & $-$ & $-$ & $-$ & & & error \\
1707 & $-$ & $-$ & +AB & $-$ & & & \\
1708 & $-$ & $-$ & +A & +B & & & \\
1709 \hline
1710 & +AB & $-$ & x & x & x & x & warning \\
1711 & +A & +B & x & x & x & x & \\
1712 & $-$ & $-$ & $-$ & $-$ & x & x & error \\
1713 no & $-$ & $-$ & +AB & $-$ & $-$ & $-$ & warning \\
1714 & $-$ & $-$ & +A & +B & $-$ & $-$ & warning \\
1715 & $-$ & $-$ & +A & x & +B & $-$ & \\
1716 & $-$ & $-$ & +A & x & + & +B & \\
1717 \dline
1718 \end{tabular}
1720 \caption{The bonded parameters that are used for free energy topologies,
1721 on the line of the bonded interaction definition or looked up
1722 in the bond types section based on atom types. A and B indicate the
1723 parameters used for state A and B respectively, + and $-$ indicate
1724 the (non-)presence of parameters in the topology, x indicates that
1725 the presence has no influence.}
1726 \label{tab:topfe}
1727 \end{table}
1729 Below is an example of a topology which changes from 200 propanols to
1730 200 pentanes using the \gromosv{96} force field.\\
1732 {\small
1733 \begin{verbatim}
1735 ; Include force field parameters
1736 #include "gromos43a1.ff/forcefield.itp"
1738 [ moleculetype ]
1739 ; Name nrexcl
1740 PropPent 3
1742 [ atoms ]
1743 ; nr type resnr residue atom cgnr charge mass typeB chargeB massB
1744 1 H 1 PROP PH 1 0.398 1.008 CH3 0.0 15.035
1745 2 OA 1 PROP PO 1 -0.548 15.9994 CH2 0.0 14.027
1746 3 CH2 1 PROP PC1 1 0.150 14.027 CH2 0.0 14.027
1747 4 CH2 1 PROP PC2 2 0.000 14.027
1748 5 CH3 1 PROP PC3 2 0.000 15.035
1750 [ bonds ]
1751 ; ai aj funct par_A par_B
1752 1 2 2 gb_1 gb_26
1753 2 3 2 gb_17 gb_26
1754 3 4 2 gb_26 gb_26
1755 4 5 2 gb_26
1757 [ pairs ]
1758 ; ai aj funct
1759 1 4 1
1760 2 5 1
1762 [ angles ]
1763 ; ai aj ak funct par_A par_B
1764 1 2 3 2 ga_11 ga_14
1765 2 3 4 2 ga_14 ga_14
1766 3 4 5 2 ga_14 ga_14
1768 [ dihedrals ]
1769 ; ai aj ak al funct par_A par_B
1770 1 2 3 4 1 gd_12 gd_17
1771 2 3 4 5 1 gd_17 gd_17
1773 [ system ]
1774 ; Name
1775 Propanol to Pentane
1777 [ molecules ]
1778 ; Compound #mols
1779 PropPent 200
1780 \end{verbatim}}
1782 Atoms that are not perturbed, {\tt PC2} and {\tt PC3}, do not need B-state parameter
1783 specifications, since the B parameters will be copied from the A parameters.
1784 Bonded interactions between atoms that are not perturbed do not need B
1785 parameter specifications, as is the case for the last bond in the example topology.
1786 Topologies using the OPLS/AA force field need no bonded parameters at all,
1787 since both the A and B parameters are determined by the atom types.
1788 Non-bonded interactions involving one or two perturbed atoms use the
1789 free-energy perturbation functional forms.
1790 Non-bonded interactions between two non-perturbed atoms use the normal
1791 functional forms.
1792 This means that when, for instance, only the charge of a particle is
1793 perturbed, its Lennard-Jones interactions will also be affected when
1794 lambda is not equal to zero or one.
1796 {\bf Note} that this topology uses the \gromosv{96} force field, in which the bonded
1797 interactions are not determined by the atom types. The bonded interaction
1798 strings are converted by the C-preprocessor. The force-field parameter
1799 files contain lines like:
1801 {\small
1802 \begin{verbatim}
1803 #define gb_26 0.1530 7.1500e+06
1805 #define gd_17 0.000 5.86 3
1806 \end{verbatim}}
1808 \subsection{Constraint forces\index{constraint force}}
1809 \label{subsec:constraintforce}
1810 The constraint force between two atoms in one molecule can be calculated
1811 with the free energy perturbation code by adding a constraint between the
1812 two atoms, with a different length in the A and B topology. When the B length
1813 is 1 nm longer than the A length and lambda is kept constant at zero,
1814 the derivative of the Hamiltonian with respect to lambda is the constraint
1815 force. For constraints between molecules, the pull code can be used,
1816 see \secref{pull}.
1817 Below is an example for calculating the constraint force at 0.7 nm
1818 between two methanes in water, by combining the two methanes into one ``molecule.''
1819 {\bf Note} that the definition of a ``molecule'' in {\gromacs} does not necessarily
1820 correspond to the chemical definition of a molecule. In {\gromacs}, a ``molecule''
1821 can be defined as any group of atoms that one wishes to consider simultaneously.
1822 The added constraint is of function type 2, which means that it is not
1823 used for generating exclusions (see~\secref{excl}).
1824 Note that the constraint free energy term is included in the derivative term, and is
1825 specifically included in the {\tt bonded-lambdas} component. However, the free
1826 energy for changing constraints is {\em not} included in the potential energy
1827 differences used for BAR and MBAR, as this requires reevaluating the energy at
1828 each of the constraint components. This functionality is planned for later versions.\\
1830 {\small
1831 \begin{verbatim}
1832 ; Include force-field parameters
1833 #include "gromos43a1.ff/forcefield.itp"
1835 [ moleculetype ]
1836 ; Name nrexcl
1837 Methanes 1
1839 [ atoms ]
1840 ; nr type resnr residu atom cgnr charge mass
1841 1 CH4 1 CH4 C1 1 0 16.043
1842 2 CH4 1 CH4 C2 2 0 16.043
1843 [ constraints ]
1844 ; ai aj funct length_A length_B
1845 1 2 2 0.7 1.7
1847 #include "gromos43a1.ff/spc.itp"
1849 [ system ]
1850 ; Name
1851 Methanes in Water
1853 [ molecules ]
1854 ; Compound #mols
1855 Methanes 1
1856 SOL 2002
1857 \end{verbatim}}
1859 \subsection{Coordinate file}
1860 \label{subsec:grofile}
1861 Files with the {\tt .gro} file extension contain a molecular structure in
1862 \gromosv{87} format. A sample piece is included below:
1864 {\small
1865 \begin{verbatim}
1866 MD of 2 waters, reformat step, PA aug-91
1868 1WATER OW1 1 0.126 1.624 1.679 0.1227 -0.0580 0.0434
1869 1WATER HW2 2 0.190 1.661 1.747 0.8085 0.3191 -0.7791
1870 1WATER HW3 3 0.177 1.568 1.613 -0.9045 -2.6469 1.3180
1871 2WATER OW1 4 1.275 0.053 0.622 0.2519 0.3140 -0.1734
1872 2WATER HW2 5 1.337 0.002 0.680 -1.0641 -1.1349 0.0257
1873 2WATER HW3 6 1.326 0.120 0.568 1.9427 -0.8216 -0.0244
1874 1.82060 1.82060 1.82060
1875 \end{verbatim}}
1877 This format is fixed, {\ie} all columns are in a fixed position. If you
1878 want to read such a file in your own program without using the
1879 {\gromacs} libraries you can use the following formats:
1881 {\bf C-format:} {\tt "\%5i\%5s\%5s\%5i\%8.3f\%8.3f\%8.3f\%8.4f\%8.4f\%8.4f"}
1883 Or to be more precise, with title {\em etc.} it looks like this:
1885 \begin{verbatim}
1886 "%s\n", Title
1887 "%5d\n", natoms
1888 for (i=0; (i<natoms); i++) {
1889 "%5d%-5s%5s%5d%8.3f%8.3f%8.3f%8.4f%8.4f%8.4f\n",
1890 residuenr,residuename,atomname,atomnr,x,y,z,vx,vy,vz
1892 "%10.5f%10.5f%10.5f%10.5f%10.5f%10.5f%10.5f%10.5f%10.5f\n",
1893 box[X][X],box[Y][Y],box[Z][Z],
1894 box[X][Y],box[X][Z],box[Y][X],box[Y][Z],box[Z][X],box[Z][Y]
1895 \end{verbatim}
1897 {\bf Fortran format:} {\tt (i5,2a5,i5,3f8.3,3f8.4)}
1899 So {\tt confin.gro} is the {\gromacs} coordinate file and is almost
1900 the same as the \gromosv{87} file (for {\gromos} users: when used with
1901 {\tt ntx=7}). The only difference is the box for which {\gromacs} uses a
1902 tensor, not a vector.
1906 \section{Force field organization \index{force field organization}}
1907 \label{sec:fforganization}
1909 \subsection{Force-field files}
1910 \label{subsec:fffiles}
1911 Many force fields are available by default.
1912 Force fields are detected by the presence of {\tt <name>.ff} directories
1913 in the {\tt \$GMXLIB/share/gromacs/top} sub-directory and/or the working directory.
1914 The information regarding the location of the force field files is printed
1915 by {\tt pdb2gmx} so you can easily keep track of which version of a force field
1916 is being called, in case you have made modifications in one location or another.
1917 The force fields included with {\gromacs} are:
1919 {\small
1920 \begin{itemize}
1921 \item AMBER03 protein, nucleic AMBER94 (Duan et al., J. Comp. Chem. 24, 1999-2012, 2003)
1922 \item AMBER94 force field (Cornell et al., JACS 117, 5179-5197, 1995)
1923 \item AMBER96 protein, nucleic AMBER94 (Kollman et al., Acc. Chem. Res. 29, 461-469, 1996)
1924 \item AMBER99 protein, nucleic AMBER94 (Wang et al., J. Comp. Chem. 21, 1049-1074, 2000)
1925 \item AMBER99SB protein, nucleic AMBER94 (Hornak et al., Proteins 65, 712-725, 2006)
1926 \item AMBER99SB-ILDN protein, nucleic AMBER94 (Lindorff-Larsen et al., Proteins 78, 1950-58, 2010)
1927 \item AMBERGS force field (Garcia \& Sanbonmatsu, PNAS 99, 2782-2787, 2002)
1928 \item CHARMM27 all-atom force field (CHARM22 plus CMAP for proteins)
1929 \item GROMOS96 43a1 force field
1930 \item GROMOS96 43a2 force field (improved alkane dihedrals)
1931 \item GROMOS96 45a3 force field (Schuler JCC 2001 22 1205)
1932 \item GROMOS96 53a5 force field (JCC 2004 vol 25 pag 1656)
1933 \item GROMOS96 53a6 force field (JCC 2004 vol 25 pag 1656)
1934 \item GROMOS96 54a7 force field (Eur. Biophys. J. (2011), 40,, 843-856, DOI: 10.1007/s00249-011-0700-9)
1935 \item OPLS-AA/L all-atom force field (2001 aminoacid dihedrals)
1936 \end{itemize}}
1938 A force field is included at the beginning of a topology file with an
1939 {\tt \#include} statement followed by {\tt <name>.ff/forcefield.itp}.
1940 This statement includes the force-field file,
1941 which, in turn, may include other force-field files. All the force fields
1942 are organized in the same way. An example of the
1943 {\tt amber99.ff/forcefield.itp} was shown in \ssecref{topfile}.
1945 For each force field, there several files which are only used by {\tt pdb2gmx}.
1946 These are: residue databases ({\tt .rtp}, see~\ssecref{rtp})
1947 the hydrogen database ({\tt .hdb}, see~\ssecref{hdb}), two termini databases
1948 ({\tt .n.tdb} and {\tt .c.tdb}, see~\ssecref{tdb}) and
1949 the atom type database ({\tt .atp}, see~\ssecref{atomtype}), which contains only the masses. Other optional
1950 files are described in~\secref{pdb2gmxfiles}.
1953 \subsection{Changing force-field parameters\index{force field}}
1954 If one wants to change the parameters of few bonded interactions in
1955 a molecule, this is most easily accomplished by typing the parameters
1956 behind the definition of the bonded interaction directly in the {\tt *.top} file
1957 under the {\tt [~moleculetype~]} section (see \ssecref{topfile} for the format
1958 and units).
1959 If one wants to change the parameters for all instances of a certain
1960 interaction one can change them in the force-field file or add a
1961 new {\tt [~???types~]} section after including the force field.
1962 When parameters for a certain interaction are defined multiple times,
1963 the last definition is used. As of {\gromacs} version 3.1.3, a warning is
1964 generated when parameters are redefined with a different value.
1965 Changing the Lennard-Jones parameters of an atom type is not
1966 recommended, because in the {\gromos} force fields
1967 the Lennard-Jones parameters for several combinations of atom types
1968 are not generated according to the standard combination rules.
1969 Such combinations (and possibly others that do follow the
1970 combination rules) are defined in the {\tt [~nonbond_params~]}
1971 section, and changing the Lennard-Jones parameters of an atom type
1972 has no effect on these combinations.
1974 \subsection{Adding atom types\swapindexquiet{adding}{atom types}}
1975 As of {\gromacs} version 3.1.3, atom types can be added in an extra
1976 {\tt [~atomtypes~]} section after the the inclusion of the normal
1977 force field. After the definition of the new atom type(s), additional
1978 non-bonded and pair parameters can be defined.
1979 In pre-3.1.3 versions of {\gromacs}, the new atom types needed to be
1980 added in the {\tt [~atomtypes~]} section of the force-field files,
1981 because all non-bonded parameters above the last {\tt [~atomtypes~]}
1982 section would be overwritten using the standard combination rules.
1984 % LocalWords: parameterized fffiles ptype polarizable gromacs atp ype arameter
1985 % LocalWords: lll carboxyl OA hydroxyl NL porphyrin OPLS CP HCR OWT fd funct
1986 % LocalWords: grompp statprop atomtype rtp esidue opology pdb gmx kJ mol gro
1987 % LocalWords: grofile dihedrals bon itp func kb th cth cq cp mult Ryckaert aj
1988 % LocalWords: Bellemans ak alkanes alkane llrllrllr LJ der nb topfile llllll
1989 % LocalWords: llll nonbond params ij pairtypes fecalc moleculetype indices mdp
1990 % LocalWords: constraintforce SPC molname nrexcl nr ren HW doh dhh aminoacids
1991 % LocalWords: dat basename rna dna arn hdb sn rtpo gmxfiles molitp ndx ARG CYS
1992 % LocalWords: defaultgroups impropers chargegroup bondedtypes hydrogens ARGN
1993 % LocalWords: preprocessor protonation specbond protonated arginine aspartic
1994 % LocalWords: ASPH GLU glutamic GLUH HISD histidine HISE HISH LYSN LYS IUPAC
1995 % LocalWords: wildcards xlateat asparagine HD HH cis deprotonated oxygens COOH
1996 % LocalWords: llllc tp cr QQ atomtypes bondtypes angletypes dihedraltypes FENE
1997 % LocalWords: constrainttypes intra nbpar morse dr Coul rr UB dih constr hh ai
1998 % LocalWords: vsite sitesn construc restr ffgmx resnr residu cgnr al fc spc gb
1999 % LocalWords: FudgeLJ FudgeQQ nonbonded mdrun decane posre Ifdef ifdef TFE cpp
2000 % LocalWords: Loof Buuren Berendsen DDeloof DeLoof VanBuuren endif feia topfe
2001 % LocalWords: propanols pentanes ffG PropPent typeB chargeB massB ga gd mols
2002 % LocalWords: Propanol Pentane methanes aug natoms residuenr residuename vx vy
2003 % LocalWords: atomname atomnr vz Fortran confin ntx GROMOS nbfunc GROningen ff
2004 % LocalWords: fudgeLJ fudgeQQ ffgmxnb ffgmxbon tdb ffbonded ffnonbonded nonbond
2005 % LocalWords: MAchine BIOSON Groningen Spoel Drunen Comp Phys Comm trr AA fdn
2006 % LocalWords: aliphatic CHARMM polarisability quadrupole tt normvsbds Waals jj
2007 % LocalWords: pairinteractions num Buckingham rcl trans Intramolecular Lennard
2008 % LocalWords: excl gen solute unscaled moltype intramol dgimplement Qiu HCT rt
2009 % LocalWords: Onufriev OBC LINCS doc xxx residuetypes polyatomic co rotatable
2010 % LocalWords: heme cysteine lysine CH NH LP amine nitrenyl ethynyl vsd MCH MNH
2011 % LocalWords: chainsep resA atomA nbondsA resB atomB nbondsB newresA newresB
2012 % LocalWords: rad deg lcc cc nm intramolecular forcefield PME Ewald
2013 % LocalWords: solvation et groupconcept PHE TYR TRP equilibrated pre
2014 % LocalWords: macromolecule disulfide harmonicbond Morsebond vsiteN
2015 % LocalWords: cubicbond FENEbond tabulatedinteraction harmonicangle
2016 % LocalWords: harmonicrestraint bondbondcross bondanglecross genion
2017 % LocalWords: quarticangle properdihedral harmonicimproperdihedral
2018 % LocalWords: RBdihedral periodicimproperdihedral Fourierdihedral
2019 % LocalWords: positionrestraint distancerestraint dihedralrestraint
2020 % LocalWords: orientationrestraint anglerestraint usinggroups ing
2021 % LocalWords: DDeLoof MBAR Duan JACS Kollman Acc Hornak ILDN AMBERGS
2022 % LocalWords: Lindorff Sanbonmatsu PNAS CMAP Schuler JCC pag
2023 % LocalWords: aminoacid