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_force_h
= "$Id$";
36 #ident "@(#) force.h 1.53 5/15/97"
37 #endif /* HAVE_IDENT */
44 extern void calc_vir(FILE *log
,int nxf
,rvec x
[],rvec f
[],tensor vir
,
46 /* Calculate virial for nxf atoms, and add it to vir */
48 extern void f_calc_vir(FILE *log
,int i0
,int i1
,rvec x
[],rvec f
[],tensor vir
,
49 t_commrec
*cr
,t_graph
*g
,rvec shift_vec
[]);
50 /* Calculate virial taking periodicity into account */
52 extern t_forcerec
*mk_forcerec(void);
54 extern void make_tables(t_forcerec
*fr
,bool bVerbose
);
55 /* Make tables for inner loops. When bVerbose the tables are printed
59 extern void pr_forcerec(FILE *log
,t_forcerec
*fr
,t_commrec
*cr
);
61 extern void init_forcerec(FILE *log
,
72 /* The Force rec struct must be created with mk_forcerec
73 * The booleans have the following meaning:
74 * bSetQ: Copy the charges [ only necessary when they change ]
75 * bMolEpot: Use the free energy stuff per molecule
78 extern void update_forcerec(FILE *log
,t_forcerec
*fr
,matrix box
);
79 /* Updates parameters in the forcerec that are time dependent */
81 extern void set_avcsix(FILE *log
,t_forcerec
*fr
,t_mdatoms
*mdatoms
);
82 /* Compute the average C6 param for LJ corrections */
84 extern void ns(FILE *log
,
99 /* Call the neighborsearcher */
101 extern void force(FILE *log
,
115 real epot
[], bool bVerbose
,
122 /* Call all the force routines */
124 /* Routine from fnbf.m4 */
125 extern void do_fnbf(FILE *log
,t_forcerec
*fr
,
126 rvec x
[],rvec f
[],t_mdatoms
*md
,
127 real egnb
[],real egcoul
[],rvec box_size
,
128 t_nrnb
*nrnb
,real lambda
,real
*dvdlambda
,
131 #endif /* _force_h */