3 * This source code is part of
7 * GROningen MAchine for Chemical Simulations
9 * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
10 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
11 * Copyright (c) 2001-2008, The GROMACS development team,
12 * check out http://www.gromacs.org for more information.
14 * This program is free software; you can redistribute it and/or
15 * modify it under the terms of the GNU General Public License
16 * as published by the Free Software Foundation; either version 2
17 * of the License, or (at your option) any later version.
19 * If you want to redistribute modifications, please consider that
20 * scientific software is very special. Version control is crucial -
21 * bugs must be traceable. We will be happy to consider code for
22 * inclusion in the official distribution, but derived work must not
23 * be called official GROMACS. Details are found in the README & COPYING
24 * files - if they are missing, get the official version at www.gromacs.org.
26 * To help us fund GROMACS development, we humbly ask that you cite
27 * the papers on the package - you can find them in the top README file.
29 * For more info, check our website at http://www.gromacs.org
32 * Gallium Rubidium Oxygen Manganese Argon Carbon Silicon
41 #include "mtop_util.h"
43 int n_bonded_dx(gmx_mtop_t
*mtop
,bool bExcl
)
45 int mb
,nmol
,ftype
,ndxb
,ndx_excl
;
49 /* Count the number of pbc_rvec_sub calls required for bonded interactions.
50 * This number is also roughly proportional to the computational cost.
54 for(mb
=0; mb
<mtop
->nmolblock
; mb
++) {
55 molt
= &mtop
->moltype
[mtop
->molblock
[mb
].type
];
56 nmol
= mtop
->molblock
[mb
].nmol
;
57 for(ftype
=0; ftype
<F_NRE
; ftype
++) {
58 if (interaction_function
[ftype
].flags
& IF_BOND
) {
60 case F_POSRES
: ndxb
= 1; break;
61 case F_CONNBONDS
: ndxb
= 0; break;
62 default: ndxb
= NRAL(ftype
) - 1; break;
64 ndx
+= nmol
*ndxb
*molt
->ilist
[ftype
].nr
/(1 + NRAL(ftype
));
68 ndx_excl
+= nmol
*(molt
->excls
.nra
- molt
->atoms
.nr
)/2;
75 fprintf(debug
,"ndx bonded %d exclusions %d\n",ndx
,ndx_excl
);
82 float pme_load_estimate(gmx_mtop_t
*mtop
,t_inputrec
*ir
,matrix box
)
85 int mb
,nmol
,atnr
,cg
,a
,a0
,ncqlj
,ncq
,nclj
;
86 bool bBHAM
,bLJcut
,bChargePerturbed
,bWater
,bQ
,bLJ
;
87 double nw
,nqlj
,nq
,nlj
,cost_bond
,cost_pp
,cost_spread
,cost_fft
;
88 float fq
,fqlj
,flj
,fljtab
,fqljw
,fqw
,fqspread
,ffft
,fbond
;
93 bBHAM
= (mtop
->ffparams
.functype
[0] == F_BHAM
);
95 bLJcut
= ((ir
->vdwtype
== evdwCUT
) && !bBHAM
);
97 /* Computational cost relative to a tabulated q-q interaction.
98 * This will be machine dependent.
99 * The numbers here are accurate for Intel Core2 and AMD Athlon 64
100 * in single precision. In double precision PME mesh is slightly cheaper,
101 * although not so much that the numbers need to be adjusted.
104 fqlj
= (bLJcut
? 1.5 : 2.0 );
105 flj
= (bLJcut
? 0.5 : 1.5 );
106 /* Cost of 1 water with one Q/LJ atom */
107 fqljw
= (bLJcut
? 1.75 : 2.25);
108 /* Cost of 1 water with one Q atom or with 1/3 water (LJ negligible) */
110 /* Cost of q spreading and force interpolation per charge */
112 /* Cost of fft's + pme_solve, will be multiplied with N log(N) */
114 /* Cost of a bonded interaction divided by the number of (pbc_)dx required */
117 iparams
= mtop
->ffparams
.iparams
;
118 atnr
= mtop
->ffparams
.atnr
;
123 bChargePerturbed
= FALSE
;
124 for(mb
=0; mb
<mtop
->nmolblock
; mb
++) {
125 molt
= &mtop
->moltype
[mtop
->molblock
[mb
].type
];
126 atom
= molt
->atoms
.atom
;
127 nmol
= mtop
->molblock
[mb
].nmol
;
129 for(cg
=0; cg
<molt
->cgs
.nr
; cg
++) {
135 while (a
< molt
->cgs
.index
[cg
+1]) {
136 bQ
= (atom
[a
].q
!= 0 || atom
[a
].qB
!= 0);
137 bLJ
= (iparams
[(atnr
+1)*atom
[a
].type
].lj
.c6
!= 0 ||
138 iparams
[(atnr
+1)*atom
[a
].type
].lj
.c12
!= 0);
139 if (atom
[a
].q
!= atom
[a
].qB
) {
140 bChargePerturbed
= TRUE
;
142 /* This if this atom fits into water optimization */
143 if (!((a
== a0
&& bQ
&& bLJ
) ||
144 (a
== a0
+1 && bQ
&& !bLJ
) ||
145 (a
== a0
+2 && bQ
&& !bLJ
&& atom
[a
].q
== atom
[a
-1].q
) ||
146 (a
== a0
+3 && !bQ
&& bLJ
)))
168 fprintf(debug
,"nw %g nqlj %g nq %g nlj %g\n",nw
,nqlj
,nq
,nlj
);
170 cost_bond
= fbond
*n_bonded_dx(mtop
,TRUE
);
172 /* For the PP non-bonded cost it is (unrealistically) assumed
173 * that all atoms are distributed homogeneously in space.
175 cost_pp
= 0.5*(fqljw
*nw
*nqlj
+
176 fqw
*nw
*(3*nw
+ nq
) +
178 fq
*nq
*(3*nw
+ nqlj
+ nq
) +
179 flj
*nlj
*(nw
+ nqlj
+ nlj
))
180 *4/3*M_PI
*ir
->rlist
*ir
->rlist
*ir
->rlist
/det(box
);
182 cost_spread
= fqspread
*(3*nw
+ nqlj
+ nq
);
183 cost_fft
= ffft
*ir
->nkx
*ir
->nky
*ir
->nkz
*log(ir
->nkx
*ir
->nky
*ir
->nkz
);
185 if (ir
->efep
!= efepNO
&& bChargePerturbed
) {
186 /* All PME work, except the spline coefficient calculation, doubles */
192 (cost_spread
+ cost_fft
)/(cost_bond
+ cost_pp
+ cost_spread
+ cost_fft
);
200 cost_bond
,cost_pp
,cost_spread
,cost_fft
);
202 fprintf(debug
,"Estimate for relative PME load: %.3f\n",ratio
);