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 * Green Red Orange Magenta Azure Cyan Skyblue
30 enum { eNL_VDW
, eNL_QQ
, eNL_FREE
, eNL_VDW_WAT
, eNL_QQ_WAT
, eNL_NR
};
37 /* Dielectric constant resp. multiplication factor for charges */
39 real epsilon_r
,epsfac
;
41 /* Constants for reaction fields */
45 /* Constant for long range dispersion correction (average dispersion) */
57 real
*VFtab14
; /* special 1-4 tables to use when the ordinary
58 * tabulated coulomb interactions are LR shifted.
59 * not a pretty solution to double LJ, but it works.
63 /* PPPM & Shifting stuff */
64 real rcoulomb_switch
,rcoulomb
;
68 real rvdw_switch
,rvdw
;
83 bool bGrid
,bDomDecomp
;
87 /* The actual neighbor lists, short and long range, see enum above
88 * for definition of neighborlist indices.
90 t_nblist nlist_sr
[eNL_NR
];
91 t_nblist nlist_lr
[eNL_NR
];
93 /* This mask array of length nn determines whether or not this bit of the
94 * neighbourlists should be computed. Usually all these are true of course,
95 * but not when shells are used. During minimisation all the forces that
96 * include shells are done, then after minimsation is converged the remaining
97 * forces are computed.
101 /* Twin Range stuff. */
107 /* PME/Ewald stuff */
114 /* Free energy stuff */
120 /* Non bonded Parameter lists */
121 int ntype
; /* Number of atom types */
126 #define C6(nbfp,ntp,ai,aj) (nbfp)[2*((ntp)*(ai)+(aj))]
127 #define C12(nbfp,ntp,ai,aj) (nbfp)[2*((ntp)*(ai)+(aj))+1]
128 #define BHAMC(nbfp,ntp,ai,aj) (nbfp)[3*((ntp)*(ai)+(aj))]
129 #define BHAMA(nbfp,ntp,ai,aj) (nbfp)[3*((ntp)*(ai)+(aj))+1]
130 #define BHAMB(nbfp,ntp,ai,aj) (nbfp)[3*((ntp)*(ai)+(aj))+2]