4 * This source code is part of
8 * GROningen MAchine for Chemical Simulations
12 * Copyright (c) 1991-1999
13 * BIOSON Research Institute, Dept. of Biophysical Chemistry
14 * University of Groningen, The Netherlands
17 * GROMACS: A message-passing parallel molecular dynamics implementation
18 * H.J.C. Berendsen, D. van der Spoel and R. van Drunen
19 * Comp. Phys. Comm. 91, 43-56 (1995)
21 * Also check out our WWW page:
22 * http://md.chem.rug.nl/~gmx
27 * Good ROcking Metal Altar for Chronical Sinners
33 static char *SRCID_grompp_h
= "$Id$";
36 #ident "@(#) grompp.h 1.37 2/2/97"
37 #endif /* HAVE_IDENT */
44 atom_id a
[MAXATOMLIST
]; /* The atom list (eg. bonds: particle */
45 /* i = a[0] (AI), j = a[1] (AJ)) */
46 real c
[MAXFORCEPARAM
]; /* Force parameters (eg. b0 = c[0]) */
47 char *s
; /* A string (instead of parameters), *
48 * read from the .rtp file in pdb2gmx */
52 int nr
; /* The number of bonds in this record */
53 t_param
*param
; /* Array of parameters (dim: nr) */
58 int nrexcl
; /* Number of exclusions per atom */
59 bool excl_set
; /* Have exclusions been generated? */
60 bool bProcessed
; /* Has the mol been processed */
61 t_atoms atoms
; /* Atoms */
62 t_block cgs
; /* Charge groups */
63 t_block mols
; /* Molecules */
64 t_params plist
[F_NRE
]; /* Parameters in old style */
68 int nr
; /* The number of atomtypes */
69 t_atom
*atom
; /* Array of atoms */
70 char ***atomname
; /* Names of the atomtypes */
71 t_param
*nb
; /* Nonbonded force default params */
98 d_position_restraints
,
100 d_angle_restraints_z
,
101 d_distance_restraints
,
107 static char *ds
[d_maxdir
+1] = {
131 "position_restraints",
133 "angle_restraints_z",
134 "distance_restraints",
138 extern void convert_harmonics(int nrmols
,t_molinfo mols
[],t_atomtype
*atype
);
140 #endif /* _grompp_h */