2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
5 * Copyright (c) 2001-2004, The GROMACS development team.
6 * Copyright (c) 2013,2014,2015, by the GROMACS development team, led by
7 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
8 * and including many others, as listed in the AUTHORS file in the
9 * top-level source directory and at http://www.gromacs.org.
11 * GROMACS is free software; you can redistribute it and/or
12 * modify it under the terms of the GNU Lesser General Public License
13 * as published by the Free Software Foundation; either version 2.1
14 * of the License, or (at your option) any later version.
16 * GROMACS is distributed in the hope that it will be useful,
17 * but WITHOUT ANY WARRANTY; without even the implied warranty of
18 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
19 * Lesser General Public License for more details.
21 * You should have received a copy of the GNU Lesser General Public
22 * License along with GROMACS; if not, see
23 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
24 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
26 * If you want to redistribute modifications to GROMACS, please
27 * consider that scientific software is very special. Version
28 * control is crucial - bugs must be traceable. We will be happy to
29 * consider code for inclusion in the official distribution, but
30 * derived work must not be called official GROMACS. Details are found
31 * in the README & COPYING files - if they are missing, get the
32 * official version at http://www.gromacs.org.
34 * To help us fund GROMACS development, we humbly ask that you cite
35 * the research papers on the package. Check out http://www.gromacs.org.
49 #include "gromacs/domdec/domdec.h"
50 #include "gromacs/domdec/domdec_struct.h"
51 #include "gromacs/fileio/txtdump.h"
52 #include "gromacs/gmxlib/network.h"
53 #include "gromacs/gmxlib/nrnb.h"
54 #include "gromacs/gmxlib/nonbonded/nonbonded.h"
55 #include "gromacs/legacyheaders/types/commrec.h"
56 #include "gromacs/math/utilities.h"
57 #include "gromacs/math/vec.h"
58 #include "gromacs/mdlib/force.h"
59 #include "gromacs/mdlib/nsgrid.h"
60 #include "gromacs/mdlib/qmmm.h"
61 #include "gromacs/mdtypes/group.h"
62 #include "gromacs/mdtypes/md_enums.h"
63 #include "gromacs/pbcutil/ishift.h"
64 #include "gromacs/pbcutil/pbc.h"
65 #include "gromacs/topology/mtop_util.h"
66 #include "gromacs/utility/fatalerror.h"
67 #include "gromacs/utility/smalloc.h"
70 * E X C L U S I O N H A N D L I N G
74 static void SETEXCL_(t_excl e
[], int i
, int j
)
78 static void RMEXCL_(t_excl e
[], int i
, int j
)
80 e
[j
] = e
[j
] & ~(1<<i
);
82 static gmx_bool
ISEXCL_(t_excl e
[], int i
, int j
)
84 return (gmx_bool
)(e
[j
] & (1<<i
));
86 static gmx_bool
NOTEXCL_(t_excl e
[], int i
, int j
)
88 return !(ISEXCL(e
, i
, j
));
91 #define SETEXCL(e, i, j) (e)[((int) (j))] |= (1<<((int) (i)))
92 #define RMEXCL(e, i, j) (e)[((int) (j))] &= (~(1<<((int) (i))))
93 #define ISEXCL(e, i, j) (gmx_bool) ((e)[((int) (j))] & (1<<((int) (i))))
94 #define NOTEXCL(e, i, j) !(ISEXCL(e, i, j))
98 round_up_to_simd_width(int length
, int simd_width
)
102 offset
= (simd_width
> 0) ? length
% simd_width
: 0;
104 return (offset
== 0) ? length
: length
-offset
+simd_width
;
106 /************************************************
108 * U T I L I T I E S F O R N S
110 ************************************************/
112 void reallocate_nblist(t_nblist
*nl
)
116 fprintf(debug
, "reallocating neigborlist (ielec=%d, ivdw=%d, igeometry=%d, type=%d), maxnri=%d\n",
117 nl
->ielec
, nl
->ivdw
, nl
->igeometry
, nl
->type
, nl
->maxnri
);
119 srenew(nl
->iinr
, nl
->maxnri
);
120 if (nl
->igeometry
== GMX_NBLIST_GEOMETRY_CG_CG
)
122 srenew(nl
->iinr_end
, nl
->maxnri
);
124 srenew(nl
->gid
, nl
->maxnri
);
125 srenew(nl
->shift
, nl
->maxnri
);
126 srenew(nl
->jindex
, nl
->maxnri
+1);
130 static void init_nblist(FILE *log
, t_nblist
*nl_sr
, t_nblist
*nl_lr
,
131 int maxsr
, int maxlr
,
132 int ivdw
, int ivdwmod
,
133 int ielec
, int ielecmod
,
134 int igeometry
, int type
,
135 gmx_bool bElecAndVdwSwitchDiffers
)
141 for (i
= 0; (i
< 2); i
++)
143 nl
= (i
== 0) ? nl_sr
: nl_lr
;
144 homenr
= (i
== 0) ? maxsr
: maxlr
;
152 /* Set coul/vdw in neighborlist, and for the normal loops we determine
153 * an index of which one to call.
156 nl
->ivdwmod
= ivdwmod
;
158 nl
->ielecmod
= ielecmod
;
160 nl
->igeometry
= igeometry
;
162 if (nl
->type
== GMX_NBLIST_INTERACTION_FREE_ENERGY
)
164 nl
->igeometry
= GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE
;
167 /* This will also set the simd_padding_width field */
168 gmx_nonbonded_set_kernel_pointers( (i
== 0) ? log
: NULL
, nl
, bElecAndVdwSwitchDiffers
);
170 /* maxnri is influenced by the number of shifts (maximum is 8)
171 * and the number of energy groups.
172 * If it is not enough, nl memory will be reallocated during the run.
173 * 4 seems to be a reasonable factor, which only causes reallocation
174 * during runs with tiny and many energygroups.
176 nl
->maxnri
= homenr
*4;
186 reallocate_nblist(nl
);
191 fprintf(debug
, "Initiating neighbourlist (ielec=%d, ivdw=%d, type=%d) for %s interactions,\nwith %d SR, %d LR atoms.\n",
192 nl
->ielec
, nl
->ivdw
, nl
->type
, gmx_nblist_geometry_names
[nl
->igeometry
], maxsr
, maxlr
);
197 void init_neighbor_list(FILE *log
, t_forcerec
*fr
, int homenr
)
199 /* Make maxlr tunable! (does not seem to be a big difference though)
200 * This parameter determines the number of i particles in a long range
201 * neighbourlist. Too few means many function calls, too many means
204 int maxsr
, maxsr_wat
, maxlr
, maxlr_wat
;
205 int ielec
, ivdw
, ielecmod
, ivdwmod
, type
;
206 int igeometry_def
, igeometry_w
, igeometry_ww
;
208 gmx_bool bElecAndVdwSwitchDiffers
;
211 /* maxsr = homenr-fr->nWatMol*3; */
216 gmx_fatal(FARGS
, "%s, %d: Negative number of short range atoms.\n"
217 "Call your GROMACS dealer for assistance.", __FILE__
, __LINE__
);
219 /* This is just for initial allocation, so we do not reallocate
220 * all the nlist arrays many times in a row.
221 * The numbers seem very accurate, but they are uncritical.
223 maxsr_wat
= std::min(fr
->nWatMol
, (homenr
+2)/3);
227 maxlr_wat
= std::min(maxsr_wat
, maxlr
);
231 maxlr
= maxlr_wat
= 0;
234 /* Determine the values for ielec/ivdw. */
235 ielec
= fr
->nbkernel_elec_interaction
;
236 ivdw
= fr
->nbkernel_vdw_interaction
;
237 ielecmod
= fr
->nbkernel_elec_modifier
;
238 ivdwmod
= fr
->nbkernel_vdw_modifier
;
239 type
= GMX_NBLIST_INTERACTION_STANDARD
;
240 bElecAndVdwSwitchDiffers
= ( (fr
->rcoulomb_switch
!= fr
->rvdw_switch
) || (fr
->rcoulomb
!= fr
->rvdw
));
242 fr
->ns
->bCGlist
= (getenv("GMX_NBLISTCG") != 0);
243 if (!fr
->ns
->bCGlist
)
245 igeometry_def
= GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE
;
249 igeometry_def
= GMX_NBLIST_GEOMETRY_CG_CG
;
252 fprintf(log
, "\nUsing charge-group - charge-group neighbor lists and kernels\n\n");
256 if (fr
->solvent_opt
== esolTIP4P
)
258 igeometry_w
= GMX_NBLIST_GEOMETRY_WATER4_PARTICLE
;
259 igeometry_ww
= GMX_NBLIST_GEOMETRY_WATER4_WATER4
;
263 igeometry_w
= GMX_NBLIST_GEOMETRY_WATER3_PARTICLE
;
264 igeometry_ww
= GMX_NBLIST_GEOMETRY_WATER3_WATER3
;
267 for (i
= 0; i
< fr
->nnblists
; i
++)
269 nbl
= &(fr
->nblists
[i
]);
271 init_nblist(log
, &nbl
->nlist_sr
[eNL_VDWQQ
], &nbl
->nlist_lr
[eNL_VDWQQ
],
272 maxsr
, maxlr
, ivdw
, ivdwmod
, ielec
, ielecmod
, igeometry_def
, type
, bElecAndVdwSwitchDiffers
);
273 init_nblist(log
, &nbl
->nlist_sr
[eNL_VDW
], &nbl
->nlist_lr
[eNL_VDW
],
274 maxsr
, maxlr
, ivdw
, ivdwmod
, GMX_NBKERNEL_ELEC_NONE
, eintmodNONE
, igeometry_def
, type
, bElecAndVdwSwitchDiffers
);
275 init_nblist(log
, &nbl
->nlist_sr
[eNL_QQ
], &nbl
->nlist_lr
[eNL_QQ
],
276 maxsr
, maxlr
, GMX_NBKERNEL_VDW_NONE
, eintmodNONE
, ielec
, ielecmod
, igeometry_def
, type
, bElecAndVdwSwitchDiffers
);
277 init_nblist(log
, &nbl
->nlist_sr
[eNL_VDWQQ_WATER
], &nbl
->nlist_lr
[eNL_VDWQQ_WATER
],
278 maxsr_wat
, maxlr_wat
, ivdw
, ivdwmod
, ielec
, ielecmod
, igeometry_w
, type
, bElecAndVdwSwitchDiffers
);
279 init_nblist(log
, &nbl
->nlist_sr
[eNL_QQ_WATER
], &nbl
->nlist_lr
[eNL_QQ_WATER
],
280 maxsr_wat
, maxlr_wat
, GMX_NBKERNEL_VDW_NONE
, eintmodNONE
, ielec
, ielecmod
, igeometry_w
, type
, bElecAndVdwSwitchDiffers
);
281 init_nblist(log
, &nbl
->nlist_sr
[eNL_VDWQQ_WATERWATER
], &nbl
->nlist_lr
[eNL_VDWQQ_WATERWATER
],
282 maxsr_wat
, maxlr_wat
, ivdw
, ivdwmod
, ielec
, ielecmod
, igeometry_ww
, type
, bElecAndVdwSwitchDiffers
);
283 init_nblist(log
, &nbl
->nlist_sr
[eNL_QQ_WATERWATER
], &nbl
->nlist_lr
[eNL_QQ_WATERWATER
],
284 maxsr_wat
, maxlr_wat
, GMX_NBKERNEL_VDW_NONE
, eintmodNONE
, ielec
, ielecmod
, igeometry_ww
, type
, bElecAndVdwSwitchDiffers
);
286 /* Did we get the solvent loops so we can use optimized water kernels? */
287 if (nbl
->nlist_sr
[eNL_VDWQQ_WATER
].kernelptr_vf
== NULL
288 || nbl
->nlist_sr
[eNL_QQ_WATER
].kernelptr_vf
== NULL
289 || nbl
->nlist_sr
[eNL_VDWQQ_WATERWATER
].kernelptr_vf
== NULL
290 || nbl
->nlist_sr
[eNL_QQ_WATERWATER
].kernelptr_vf
== NULL
)
292 fr
->solvent_opt
= esolNO
;
295 fprintf(log
, "Note: The available nonbonded kernels do not support water optimization - disabling.\n");
299 if (fr
->efep
!= efepNO
)
301 init_nblist(log
, &nbl
->nlist_sr
[eNL_VDWQQ_FREE
], &nbl
->nlist_lr
[eNL_VDWQQ_FREE
],
302 maxsr
, maxlr
, ivdw
, ivdwmod
, ielec
, ielecmod
, GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE
, GMX_NBLIST_INTERACTION_FREE_ENERGY
, bElecAndVdwSwitchDiffers
);
303 init_nblist(log
, &nbl
->nlist_sr
[eNL_VDW_FREE
], &nbl
->nlist_lr
[eNL_VDW_FREE
],
304 maxsr
, maxlr
, ivdw
, ivdwmod
, GMX_NBKERNEL_ELEC_NONE
, eintmodNONE
, GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE
, GMX_NBLIST_INTERACTION_FREE_ENERGY
, bElecAndVdwSwitchDiffers
);
305 init_nblist(log
, &nbl
->nlist_sr
[eNL_QQ_FREE
], &nbl
->nlist_lr
[eNL_QQ_FREE
],
306 maxsr
, maxlr
, GMX_NBKERNEL_VDW_NONE
, eintmodNONE
, ielec
, ielecmod
, GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE
, GMX_NBLIST_INTERACTION_FREE_ENERGY
, bElecAndVdwSwitchDiffers
);
310 if (fr
->bQMMM
&& fr
->qr
->QMMMscheme
!= eQMMMschemeoniom
)
312 if (NULL
== fr
->QMMMlist
)
314 snew(fr
->QMMMlist
, 1);
316 init_nblist(log
, fr
->QMMMlist
, NULL
,
317 maxsr
, maxlr
, 0, 0, ielec
, ielecmod
, GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE
, GMX_NBLIST_INTERACTION_STANDARD
, bElecAndVdwSwitchDiffers
);
325 fr
->ns
->nblist_initialized
= TRUE
;
328 static void reset_nblist(t_nblist
*nl
)
338 static void reset_neighbor_lists(t_forcerec
*fr
, gmx_bool bResetSR
, gmx_bool bResetLR
)
344 /* only reset the short-range nblist */
345 reset_nblist(fr
->QMMMlist
);
348 for (n
= 0; n
< fr
->nnblists
; n
++)
350 for (i
= 0; i
< eNL_NR
; i
++)
354 reset_nblist( &(fr
->nblists
[n
].nlist_sr
[i
]) );
358 reset_nblist( &(fr
->nblists
[n
].nlist_lr
[i
]) );
367 static gmx_inline
void new_i_nblist(t_nblist
*nlist
, int i_atom
, int shift
, int gid
)
369 int nri
= nlist
->nri
;
371 /* Check whether we have to increase the i counter */
373 (nlist
->iinr
[nri
] != i_atom
) ||
374 (nlist
->shift
[nri
] != shift
) ||
375 (nlist
->gid
[nri
] != gid
))
377 /* This is something else. Now see if any entries have
378 * been added in the list of the previous atom.
381 ((nlist
->jindex
[nri
+1] > nlist
->jindex
[nri
]) &&
382 (nlist
->gid
[nri
] != -1)))
384 /* If so increase the counter */
387 if (nlist
->nri
>= nlist
->maxnri
)
389 nlist
->maxnri
+= over_alloc_large(nlist
->nri
);
390 reallocate_nblist(nlist
);
393 /* Set the number of neighbours and the atom number */
394 nlist
->jindex
[nri
+1] = nlist
->jindex
[nri
];
395 nlist
->iinr
[nri
] = i_atom
;
396 nlist
->gid
[nri
] = gid
;
397 nlist
->shift
[nri
] = shift
;
401 /* Adding to previous list. First remove possible previous padding */
402 if (nlist
->simd_padding_width
> 1)
404 while (nlist
->nrj
> 0 && nlist
->jjnr
[nlist
->nrj
-1] < 0)
412 static gmx_inline
void close_i_nblist(t_nblist
*nlist
)
414 int nri
= nlist
->nri
;
419 /* Add elements up to padding. Since we allocate memory in units
420 * of the simd_padding width, we do not have to check for possible
421 * list reallocation here.
423 while ((nlist
->nrj
% nlist
->simd_padding_width
) != 0)
425 /* Use -4 here, so we can write forces for 4 atoms before real data */
426 nlist
->jjnr
[nlist
->nrj
++] = -4;
428 nlist
->jindex
[nri
+1] = nlist
->nrj
;
430 len
= nlist
->nrj
- nlist
->jindex
[nri
];
431 /* If there are no j-particles we have to reduce the
432 * number of i-particles again, to prevent errors in the
435 if ((len
== 0) && (nlist
->nri
> 0))
442 static gmx_inline
void close_nblist(t_nblist
*nlist
)
444 /* Only close this nblist when it has been initialized.
445 * Avoid the creation of i-lists with no j-particles.
449 /* Some assembly kernels do not support empty lists,
450 * make sure here that we don't generate any empty lists.
451 * With the current ns code this branch is taken in two cases:
452 * No i-particles at all: nri=-1 here
453 * There are i-particles, but no j-particles; nri=0 here
459 /* Close list number nri by incrementing the count */
464 static gmx_inline
void close_neighbor_lists(t_forcerec
*fr
, gmx_bool bMakeQMMMnblist
)
470 close_nblist(fr
->QMMMlist
);
473 for (n
= 0; n
< fr
->nnblists
; n
++)
475 for (i
= 0; (i
< eNL_NR
); i
++)
477 close_nblist(&(fr
->nblists
[n
].nlist_sr
[i
]));
478 close_nblist(&(fr
->nblists
[n
].nlist_lr
[i
]));
484 static gmx_inline
void add_j_to_nblist(t_nblist
*nlist
, int j_atom
, gmx_bool bLR
)
486 int nrj
= nlist
->nrj
;
488 if (nlist
->nrj
>= nlist
->maxnrj
)
490 nlist
->maxnrj
= round_up_to_simd_width(over_alloc_small(nlist
->nrj
+ 1), nlist
->simd_padding_width
);
494 fprintf(debug
, "Increasing %s nblist (ielec=%d,ivdw=%d,type=%d,igeometry=%d) j size to %d\n",
495 bLR
? "LR" : "SR", nlist
->ielec
, nlist
->ivdw
, nlist
->type
, nlist
->igeometry
, nlist
->maxnrj
);
498 srenew(nlist
->jjnr
, nlist
->maxnrj
);
501 nlist
->jjnr
[nrj
] = j_atom
;
505 static gmx_inline
void add_j_to_nblist_cg(t_nblist
*nlist
,
506 int j_start
, int j_end
,
507 t_excl
*bexcl
, gmx_bool i_is_j
,
510 int nrj
= nlist
->nrj
;
513 if (nlist
->nrj
>= nlist
->maxnrj
)
515 nlist
->maxnrj
= over_alloc_small(nlist
->nrj
+ 1);
518 fprintf(debug
, "Increasing %s nblist (ielec=%d,ivdw=%d,type=%d,igeometry=%d) j size to %d\n",
519 bLR
? "LR" : "SR", nlist
->ielec
, nlist
->ivdw
, nlist
->type
, nlist
->igeometry
, nlist
->maxnrj
);
522 srenew(nlist
->jjnr
, nlist
->maxnrj
);
523 srenew(nlist
->jjnr_end
, nlist
->maxnrj
);
524 srenew(nlist
->excl
, nlist
->maxnrj
*MAX_CGCGSIZE
);
527 nlist
->jjnr
[nrj
] = j_start
;
528 nlist
->jjnr_end
[nrj
] = j_end
;
530 if (j_end
- j_start
> MAX_CGCGSIZE
)
532 gmx_fatal(FARGS
, "The charge-group - charge-group neighborlist do not support charge groups larger than %d, found a charge group of size %d", MAX_CGCGSIZE
, j_end
-j_start
);
535 /* Set the exclusions */
536 for (j
= j_start
; j
< j_end
; j
++)
538 nlist
->excl
[nrj
*MAX_CGCGSIZE
+ j
- j_start
] = bexcl
[j
];
542 /* Avoid double counting of intra-cg interactions */
543 for (j
= 1; j
< j_end
-j_start
; j
++)
545 nlist
->excl
[nrj
*MAX_CGCGSIZE
+ j
] |= (1<<j
) - 1;
553 put_in_list_t (gmx_bool bHaveVdW
[],
570 put_in_list_at(gmx_bool bHaveVdW
[],
586 /* The a[] index has been removed,
587 * to put it back in i_atom should be a[i0] and jj should be a[jj].
592 t_nblist
* vdwc_free
= NULL
;
593 t_nblist
* vdw_free
= NULL
;
594 t_nblist
* coul_free
= NULL
;
595 t_nblist
* vdwc_ww
= NULL
;
596 t_nblist
* coul_ww
= NULL
;
598 int i
, j
, jcg
, igid
, gid
, nbl_ind
;
599 int jj
, jj0
, jj1
, i_atom
;
604 real
*charge
, *chargeB
;
606 gmx_bool bFreeEnergy
, bFree
, bFreeJ
, bNotEx
, *bPert
;
607 gmx_bool bDoVdW_i
, bDoCoul_i
, bDoCoul_i_sol
;
611 /* Copy some pointers */
613 charge
= md
->chargeA
;
614 chargeB
= md
->chargeB
;
617 bPert
= md
->bPerturbed
;
621 nicg
= index
[icg
+1]-i0
;
623 /* Get the i charge group info */
624 igid
= GET_CGINFO_GID(cginfo
[icg
]);
626 iwater
= (solvent_opt
!= esolNO
) ? GET_CGINFO_SOLOPT(cginfo
[icg
]) : esolNO
;
631 /* Check if any of the particles involved are perturbed.
632 * If not we can do the cheaper normal put_in_list
633 * and use more solvent optimization.
635 for (i
= 0; i
< nicg
; i
++)
637 bFreeEnergy
|= bPert
[i0
+i
];
639 /* Loop over the j charge groups */
640 for (j
= 0; (j
< nj
&& !bFreeEnergy
); j
++)
645 /* Finally loop over the atoms in the j-charge group */
646 for (jj
= jj0
; jj
< jj1
; jj
++)
648 bFreeEnergy
|= bPert
[jj
];
653 /* Unpack pointers to neighbourlist structs */
654 if (fr
->nnblists
== 1)
660 nbl_ind
= fr
->gid2nblists
[GID(igid
, jgid
, ngid
)];
664 nlist
= fr
->nblists
[nbl_ind
].nlist_lr
;
668 nlist
= fr
->nblists
[nbl_ind
].nlist_sr
;
671 if (iwater
!= esolNO
)
673 vdwc
= &nlist
[eNL_VDWQQ_WATER
];
674 vdw
= &nlist
[eNL_VDW
];
675 coul
= &nlist
[eNL_QQ_WATER
];
676 vdwc_ww
= &nlist
[eNL_VDWQQ_WATERWATER
];
677 coul_ww
= &nlist
[eNL_QQ_WATERWATER
];
681 vdwc
= &nlist
[eNL_VDWQQ
];
682 vdw
= &nlist
[eNL_VDW
];
683 coul
= &nlist
[eNL_QQ
];
688 if (iwater
!= esolNO
)
690 /* Loop over the atoms in the i charge group */
692 gid
= GID(igid
, jgid
, ngid
);
693 /* Create new i_atom for each energy group */
694 if (bDoCoul
&& bDoVdW
)
696 new_i_nblist(vdwc
, i_atom
, shift
, gid
);
697 new_i_nblist(vdwc_ww
, i_atom
, shift
, gid
);
701 new_i_nblist(vdw
, i_atom
, shift
, gid
);
705 new_i_nblist(coul
, i_atom
, shift
, gid
);
706 new_i_nblist(coul_ww
, i_atom
, shift
, gid
);
708 /* Loop over the j charge groups */
709 for (j
= 0; (j
< nj
); j
++)
719 jwater
= GET_CGINFO_SOLOPT(cginfo
[jcg
]);
721 if (iwater
== esolSPC
&& jwater
== esolSPC
)
723 /* Interaction between two SPC molecules */
726 /* VdW only - only first atoms in each water interact */
727 add_j_to_nblist(vdw
, jj0
, bLR
);
731 /* One entry for the entire water-water interaction */
734 add_j_to_nblist(coul_ww
, jj0
, bLR
);
738 add_j_to_nblist(vdwc_ww
, jj0
, bLR
);
742 else if (iwater
== esolTIP4P
&& jwater
== esolTIP4P
)
744 /* Interaction between two TIP4p molecules */
747 /* VdW only - only first atoms in each water interact */
748 add_j_to_nblist(vdw
, jj0
, bLR
);
752 /* One entry for the entire water-water interaction */
755 add_j_to_nblist(coul_ww
, jj0
, bLR
);
759 add_j_to_nblist(vdwc_ww
, jj0
, bLR
);
765 /* j charge group is not water, but i is.
766 * Add entries to the water-other_atom lists; the geometry of the water
767 * molecule doesn't matter - that is taken care of in the nonbonded kernel,
768 * so we don't care if it is SPC or TIP4P...
775 for (jj
= jj0
; (jj
< jj1
); jj
++)
779 add_j_to_nblist(coul
, jj
, bLR
);
785 for (jj
= jj0
; (jj
< jj1
); jj
++)
787 if (bHaveVdW
[type
[jj
]])
789 add_j_to_nblist(vdw
, jj
, bLR
);
795 /* _charge_ _groups_ interact with both coulomb and LJ */
796 /* Check which atoms we should add to the lists! */
797 for (jj
= jj0
; (jj
< jj1
); jj
++)
799 if (bHaveVdW
[type
[jj
]])
803 add_j_to_nblist(vdwc
, jj
, bLR
);
807 add_j_to_nblist(vdw
, jj
, bLR
);
810 else if (charge
[jj
] != 0)
812 add_j_to_nblist(coul
, jj
, bLR
);
819 close_i_nblist(coul
);
820 close_i_nblist(vdwc
);
821 close_i_nblist(coul_ww
);
822 close_i_nblist(vdwc_ww
);
826 /* no solvent as i charge group */
827 /* Loop over the atoms in the i charge group */
828 for (i
= 0; i
< nicg
; i
++)
831 gid
= GID(igid
, jgid
, ngid
);
834 /* Create new i_atom for each energy group */
835 if (bDoVdW
&& bDoCoul
)
837 new_i_nblist(vdwc
, i_atom
, shift
, gid
);
841 new_i_nblist(vdw
, i_atom
, shift
, gid
);
845 new_i_nblist(coul
, i_atom
, shift
, gid
);
847 bDoVdW_i
= (bDoVdW
&& bHaveVdW
[type
[i_atom
]]);
848 bDoCoul_i
= (bDoCoul
&& qi
!= 0);
850 if (bDoVdW_i
|| bDoCoul_i
)
852 /* Loop over the j charge groups */
853 for (j
= 0; (j
< nj
); j
++)
857 /* Check for large charge groups */
868 /* Finally loop over the atoms in the j-charge group */
869 for (jj
= jj0
; jj
< jj1
; jj
++)
871 bNotEx
= NOTEXCL(bExcl
, i
, jj
);
879 add_j_to_nblist(coul
, jj
, bLR
);
884 if (bHaveVdW
[type
[jj
]])
886 add_j_to_nblist(vdw
, jj
, bLR
);
891 if (bHaveVdW
[type
[jj
]])
895 add_j_to_nblist(vdwc
, jj
, bLR
);
899 add_j_to_nblist(vdw
, jj
, bLR
);
902 else if (charge
[jj
] != 0)
904 add_j_to_nblist(coul
, jj
, bLR
);
912 close_i_nblist(coul
);
913 close_i_nblist(vdwc
);
919 /* we are doing free energy */
920 vdwc_free
= &nlist
[eNL_VDWQQ_FREE
];
921 vdw_free
= &nlist
[eNL_VDW_FREE
];
922 coul_free
= &nlist
[eNL_QQ_FREE
];
923 /* Loop over the atoms in the i charge group */
924 for (i
= 0; i
< nicg
; i
++)
927 gid
= GID(igid
, jgid
, ngid
);
929 qiB
= chargeB
[i_atom
];
931 /* Create new i_atom for each energy group */
932 if (bDoVdW
&& bDoCoul
)
934 new_i_nblist(vdwc
, i_atom
, shift
, gid
);
938 new_i_nblist(vdw
, i_atom
, shift
, gid
);
942 new_i_nblist(coul
, i_atom
, shift
, gid
);
945 new_i_nblist(vdw_free
, i_atom
, shift
, gid
);
946 new_i_nblist(coul_free
, i_atom
, shift
, gid
);
947 new_i_nblist(vdwc_free
, i_atom
, shift
, gid
);
949 bDoVdW_i
= (bDoVdW
&&
950 (bHaveVdW
[type
[i_atom
]] || bHaveVdW
[typeB
[i_atom
]]));
951 bDoCoul_i
= (bDoCoul
&& (qi
!= 0 || qiB
!= 0));
952 /* For TIP4P the first atom does not have a charge,
953 * but the last three do. So we should still put an atom
954 * without LJ but with charge in the water-atom neighborlist
955 * for a TIP4p i charge group.
956 * For SPC type water the first atom has LJ and charge,
957 * so there is no such problem.
959 if (iwater
== esolNO
)
961 bDoCoul_i_sol
= bDoCoul_i
;
965 bDoCoul_i_sol
= bDoCoul
;
968 if (bDoVdW_i
|| bDoCoul_i_sol
)
970 /* Loop over the j charge groups */
971 for (j
= 0; (j
< nj
); j
++)
975 /* Check for large charge groups */
986 /* Finally loop over the atoms in the j-charge group */
987 bFree
= bPert
[i_atom
];
988 for (jj
= jj0
; (jj
< jj1
); jj
++)
990 bFreeJ
= bFree
|| bPert
[jj
];
991 /* Complicated if, because the water H's should also
992 * see perturbed j-particles
994 if (iwater
== esolNO
|| i
== 0 || bFreeJ
)
996 bNotEx
= NOTEXCL(bExcl
, i
, jj
);
1004 if (charge
[jj
] != 0 || chargeB
[jj
] != 0)
1006 add_j_to_nblist(coul_free
, jj
, bLR
);
1009 else if (!bDoCoul_i
)
1011 if (bHaveVdW
[type
[jj
]] || bHaveVdW
[typeB
[jj
]])
1013 add_j_to_nblist(vdw_free
, jj
, bLR
);
1018 if (bHaveVdW
[type
[jj
]] || bHaveVdW
[typeB
[jj
]])
1020 if (charge
[jj
] != 0 || chargeB
[jj
] != 0)
1022 add_j_to_nblist(vdwc_free
, jj
, bLR
);
1026 add_j_to_nblist(vdw_free
, jj
, bLR
);
1029 else if (charge
[jj
] != 0 || chargeB
[jj
] != 0)
1031 add_j_to_nblist(coul_free
, jj
, bLR
);
1037 /* This is done whether or not bWater is set */
1038 if (charge
[jj
] != 0)
1040 add_j_to_nblist(coul
, jj
, bLR
);
1043 else if (!bDoCoul_i_sol
)
1045 if (bHaveVdW
[type
[jj
]])
1047 add_j_to_nblist(vdw
, jj
, bLR
);
1052 if (bHaveVdW
[type
[jj
]])
1054 if (charge
[jj
] != 0)
1056 add_j_to_nblist(vdwc
, jj
, bLR
);
1060 add_j_to_nblist(vdw
, jj
, bLR
);
1063 else if (charge
[jj
] != 0)
1065 add_j_to_nblist(coul
, jj
, bLR
);
1073 close_i_nblist(vdw
);
1074 close_i_nblist(coul
);
1075 close_i_nblist(vdwc
);
1076 close_i_nblist(vdw_free
);
1077 close_i_nblist(coul_free
);
1078 close_i_nblist(vdwc_free
);
1084 put_in_list_qmmm(gmx_bool gmx_unused bHaveVdW
[],
1086 t_mdatoms gmx_unused
* md
,
1096 gmx_bool gmx_unused bDoVdW
,
1097 gmx_bool gmx_unused bDoCoul
,
1098 int gmx_unused solvent_opt
)
1101 int i
, j
, jcg
, igid
, gid
;
1102 int jj
, jj0
, jj1
, i_atom
;
1106 /* Get atom range */
1108 nicg
= index
[icg
+1]-i0
;
1110 /* Get the i charge group info */
1111 igid
= GET_CGINFO_GID(fr
->cginfo
[icg
]);
1113 coul
= fr
->QMMMlist
;
1115 /* Loop over atoms in the ith charge group */
1116 for (i
= 0; i
< nicg
; i
++)
1119 gid
= GID(igid
, jgid
, ngid
);
1120 /* Create new i_atom for each energy group */
1121 new_i_nblist(coul
, i_atom
, shift
, gid
);
1123 /* Loop over the j charge groups */
1124 for (j
= 0; j
< nj
; j
++)
1128 /* Charge groups cannot have QM and MM atoms simultaneously */
1133 /* Finally loop over the atoms in the j-charge group */
1134 for (jj
= jj0
; jj
< jj1
; jj
++)
1136 bNotEx
= NOTEXCL(bExcl
, i
, jj
);
1139 add_j_to_nblist(coul
, jj
, bLR
);
1144 close_i_nblist(coul
);
1149 put_in_list_cg(gmx_bool gmx_unused bHaveVdW
[],
1151 t_mdatoms gmx_unused
* md
,
1161 gmx_bool gmx_unused bDoVdW
,
1162 gmx_bool gmx_unused bDoCoul
,
1163 int gmx_unused solvent_opt
)
1166 int igid
, gid
, nbl_ind
;
1170 cginfo
= fr
->cginfo
[icg
];
1172 igid
= GET_CGINFO_GID(cginfo
);
1173 gid
= GID(igid
, jgid
, ngid
);
1175 /* Unpack pointers to neighbourlist structs */
1176 if (fr
->nnblists
== 1)
1182 nbl_ind
= fr
->gid2nblists
[gid
];
1186 vdwc
= &fr
->nblists
[nbl_ind
].nlist_lr
[eNL_VDWQQ
];
1190 vdwc
= &fr
->nblists
[nbl_ind
].nlist_sr
[eNL_VDWQQ
];
1193 /* Make a new neighbor list for charge group icg.
1194 * Currently simply one neighbor list is made with LJ and Coulomb.
1195 * If required, zero interactions could be removed here
1196 * or in the force loop.
1198 new_i_nblist(vdwc
, index
[icg
], shift
, gid
);
1199 vdwc
->iinr_end
[vdwc
->nri
] = index
[icg
+1];
1201 for (j
= 0; (j
< nj
); j
++)
1204 /* Skip the icg-icg pairs if all self interactions are excluded */
1205 if (!(jcg
== icg
&& GET_CGINFO_EXCL_INTRA(cginfo
)))
1207 /* Here we add the j charge group jcg to the list,
1208 * exclusions are also added to the list.
1210 add_j_to_nblist_cg(vdwc
, index
[jcg
], index
[jcg
+1], bExcl
, icg
== jcg
, bLR
);
1214 close_i_nblist(vdwc
);
1217 static void setexcl(int start
, int end
, t_blocka
*excl
, gmx_bool b
,
1224 for (i
= start
; i
< end
; i
++)
1226 for (k
= excl
->index
[i
]; k
< excl
->index
[i
+1]; k
++)
1228 SETEXCL(bexcl
, i
-start
, excl
->a
[k
]);
1234 for (i
= start
; i
< end
; i
++)
1236 for (k
= excl
->index
[i
]; k
< excl
->index
[i
+1]; k
++)
1238 RMEXCL(bexcl
, i
-start
, excl
->a
[k
]);
1244 int calc_naaj(int icg
, int cgtot
)
1248 if ((cgtot
% 2) == 1)
1250 /* Odd number of charge groups, easy */
1251 naaj
= 1 + (cgtot
/2);
1253 else if ((cgtot
% 4) == 0)
1255 /* Multiple of four is hard */
1292 fprintf(log
, "naaj=%d\n", naaj
);
1298 /************************************************
1300 * S I M P L E C O R E S T U F F
1302 ************************************************/
1304 static real
calc_image_tric(rvec xi
, rvec xj
, matrix box
,
1305 rvec b_inv
, int *shift
)
1307 /* This code assumes that the cut-off is smaller than
1308 * a half times the smallest diagonal element of the box.
1310 const real h25
= 2.5;
1315 /* Compute diff vector */
1316 dz
= xj
[ZZ
] - xi
[ZZ
];
1317 dy
= xj
[YY
] - xi
[YY
];
1318 dx
= xj
[XX
] - xi
[XX
];
1320 /* Perform NINT operation, using trunc operation, therefore
1321 * we first add 2.5 then subtract 2 again
1323 tz
= static_cast<int>(dz
*b_inv
[ZZ
] + h25
);
1325 dz
-= tz
*box
[ZZ
][ZZ
];
1326 dy
-= tz
*box
[ZZ
][YY
];
1327 dx
-= tz
*box
[ZZ
][XX
];
1329 ty
= static_cast<int>(dy
*b_inv
[YY
] + h25
);
1331 dy
-= ty
*box
[YY
][YY
];
1332 dx
-= ty
*box
[YY
][XX
];
1334 tx
= static_cast<int>(dx
*b_inv
[XX
]+h25
);
1336 dx
-= tx
*box
[XX
][XX
];
1338 /* Distance squared */
1339 r2
= (dx
*dx
) + (dy
*dy
) + (dz
*dz
);
1341 *shift
= XYZ2IS(tx
, ty
, tz
);
1346 static real
calc_image_rect(rvec xi
, rvec xj
, rvec box_size
,
1347 rvec b_inv
, int *shift
)
1349 const real h15
= 1.5;
1355 /* Compute diff vector */
1356 dx
= xj
[XX
] - xi
[XX
];
1357 dy
= xj
[YY
] - xi
[YY
];
1358 dz
= xj
[ZZ
] - xi
[ZZ
];
1360 /* Perform NINT operation, using trunc operation, therefore
1361 * we first add 1.5 then subtract 1 again
1363 tx
= static_cast<int>(dx
*b_inv
[XX
] + h15
);
1364 ty
= static_cast<int>(dy
*b_inv
[YY
] + h15
);
1365 tz
= static_cast<int>(dz
*b_inv
[ZZ
] + h15
);
1370 /* Correct diff vector for translation */
1371 ddx
= tx
*box_size
[XX
] - dx
;
1372 ddy
= ty
*box_size
[YY
] - dy
;
1373 ddz
= tz
*box_size
[ZZ
] - dz
;
1375 /* Distance squared */
1376 r2
= (ddx
*ddx
) + (ddy
*ddy
) + (ddz
*ddz
);
1378 *shift
= XYZ2IS(tx
, ty
, tz
);
1383 static void add_simple(t_ns_buf
* nsbuf
, int nrj
, int cg_j
,
1384 gmx_bool bHaveVdW
[], int ngid
, t_mdatoms
*md
,
1385 int icg
, int jgid
, t_block
*cgs
, t_excl bexcl
[],
1386 int shift
, t_forcerec
*fr
, put_in_list_t
*put_in_list
)
1388 if (nsbuf
->nj
+ nrj
> MAX_CG
)
1390 put_in_list(bHaveVdW
, ngid
, md
, icg
, jgid
, nsbuf
->ncg
, nsbuf
->jcg
,
1391 cgs
->index
, bexcl
, shift
, fr
, FALSE
, TRUE
, TRUE
, fr
->solvent_opt
);
1392 /* Reset buffer contents */
1393 nsbuf
->ncg
= nsbuf
->nj
= 0;
1395 nsbuf
->jcg
[nsbuf
->ncg
++] = cg_j
;
1399 static void ns_inner_tric(rvec x
[], int icg
, int *i_egp_flags
,
1400 int njcg
, int jcg
[],
1401 matrix box
, rvec b_inv
, real rcut2
,
1402 t_block
*cgs
, t_ns_buf
**ns_buf
,
1403 gmx_bool bHaveVdW
[], int ngid
, t_mdatoms
*md
,
1404 t_excl bexcl
[], t_forcerec
*fr
,
1405 put_in_list_t
*put_in_list
)
1409 int *cginfo
= fr
->cginfo
;
1412 cgindex
= cgs
->index
;
1414 for (j
= 0; (j
< njcg
); j
++)
1417 nrj
= cgindex
[cg_j
+1]-cgindex
[cg_j
];
1418 if (calc_image_tric(x
[icg
], x
[cg_j
], box
, b_inv
, &shift
) < rcut2
)
1420 jgid
= GET_CGINFO_GID(cginfo
[cg_j
]);
1421 if (!(i_egp_flags
[jgid
] & EGP_EXCL
))
1423 add_simple(&ns_buf
[jgid
][shift
], nrj
, cg_j
,
1424 bHaveVdW
, ngid
, md
, icg
, jgid
, cgs
, bexcl
, shift
, fr
,
1431 static void ns_inner_rect(rvec x
[], int icg
, int *i_egp_flags
,
1432 int njcg
, int jcg
[],
1433 gmx_bool bBox
, rvec box_size
, rvec b_inv
, real rcut2
,
1434 t_block
*cgs
, t_ns_buf
**ns_buf
,
1435 gmx_bool bHaveVdW
[], int ngid
, t_mdatoms
*md
,
1436 t_excl bexcl
[], t_forcerec
*fr
,
1437 put_in_list_t
*put_in_list
)
1441 int *cginfo
= fr
->cginfo
;
1444 cgindex
= cgs
->index
;
1448 for (j
= 0; (j
< njcg
); j
++)
1451 nrj
= cgindex
[cg_j
+1]-cgindex
[cg_j
];
1452 if (calc_image_rect(x
[icg
], x
[cg_j
], box_size
, b_inv
, &shift
) < rcut2
)
1454 jgid
= GET_CGINFO_GID(cginfo
[cg_j
]);
1455 if (!(i_egp_flags
[jgid
] & EGP_EXCL
))
1457 add_simple(&ns_buf
[jgid
][shift
], nrj
, cg_j
,
1458 bHaveVdW
, ngid
, md
, icg
, jgid
, cgs
, bexcl
, shift
, fr
,
1466 for (j
= 0; (j
< njcg
); j
++)
1469 nrj
= cgindex
[cg_j
+1]-cgindex
[cg_j
];
1470 if ((rcut2
== 0) || (distance2(x
[icg
], x
[cg_j
]) < rcut2
))
1472 jgid
= GET_CGINFO_GID(cginfo
[cg_j
]);
1473 if (!(i_egp_flags
[jgid
] & EGP_EXCL
))
1475 add_simple(&ns_buf
[jgid
][CENTRAL
], nrj
, cg_j
,
1476 bHaveVdW
, ngid
, md
, icg
, jgid
, cgs
, bexcl
, CENTRAL
, fr
,
1484 /* ns_simple_core needs to be adapted for QMMM still 2005 */
1486 static int ns_simple_core(t_forcerec
*fr
,
1487 gmx_localtop_t
*top
,
1489 matrix box
, rvec box_size
,
1490 t_excl bexcl
[], int *aaj
,
1491 int ngid
, t_ns_buf
**ns_buf
,
1492 put_in_list_t
*put_in_list
, gmx_bool bHaveVdW
[])
1496 int nsearch
, icg
, igid
, nn
;
1500 t_block
*cgs
= &(top
->cgs
);
1501 t_blocka
*excl
= &(top
->excls
);
1504 gmx_bool bBox
, bTriclinic
;
1507 rlist2
= sqr(fr
->rlist
);
1509 bBox
= (fr
->ePBC
!= epbcNONE
);
1512 for (m
= 0; (m
< DIM
); m
++)
1514 if (gmx_numzero(box_size
[m
]))
1516 gmx_fatal(FARGS
, "Dividing by zero box size!");
1518 b_inv
[m
] = 1.0/box_size
[m
];
1520 bTriclinic
= TRICLINIC(box
);
1527 cginfo
= fr
->cginfo
;
1530 for (icg
= fr
->cg0
; (icg
< fr
->hcg
); icg
++)
1533 i0 = cgs->index[icg];
1534 nri = cgs->index[icg+1]-i0;
1535 i_atoms = &(cgs->a[i0]);
1536 i_eg_excl = fr->eg_excl + ngid*md->cENER[*i_atoms];
1537 setexcl(nri,i_atoms,excl,TRUE,bexcl);
1539 igid
= GET_CGINFO_GID(cginfo
[icg
]);
1540 i_egp_flags
= fr
->egp_flags
+ ngid
*igid
;
1541 setexcl(cgs
->index
[icg
], cgs
->index
[icg
+1], excl
, TRUE
, bexcl
);
1543 naaj
= calc_naaj(icg
, cgs
->nr
);
1546 ns_inner_tric(fr
->cg_cm
, icg
, i_egp_flags
, naaj
, &(aaj
[icg
]),
1547 box
, b_inv
, rlist2
, cgs
, ns_buf
,
1548 bHaveVdW
, ngid
, md
, bexcl
, fr
, put_in_list
);
1552 ns_inner_rect(fr
->cg_cm
, icg
, i_egp_flags
, naaj
, &(aaj
[icg
]),
1553 bBox
, box_size
, b_inv
, rlist2
, cgs
, ns_buf
,
1554 bHaveVdW
, ngid
, md
, bexcl
, fr
, put_in_list
);
1558 for (nn
= 0; (nn
< ngid
); nn
++)
1560 for (k
= 0; (k
< SHIFTS
); k
++)
1562 nsbuf
= &(ns_buf
[nn
][k
]);
1565 put_in_list(bHaveVdW
, ngid
, md
, icg
, nn
, nsbuf
->ncg
, nsbuf
->jcg
,
1566 cgs
->index
, bexcl
, k
, fr
, FALSE
, TRUE
, TRUE
, fr
->solvent_opt
);
1567 nsbuf
->ncg
= nsbuf
->nj
= 0;
1571 /* setexcl(nri,i_atoms,excl,FALSE,bexcl); */
1572 setexcl(cgs
->index
[icg
], cgs
->index
[icg
+1], excl
, FALSE
, bexcl
);
1574 close_neighbor_lists(fr
, FALSE
);
1579 /************************************************
1581 * N S 5 G R I D S T U F F
1583 ************************************************/
1585 static gmx_inline
void get_dx_dd(int Nx
, real gridx
, real rc2
, int xgi
, real x
,
1586 int ncpddc
, int shift_min
, int shift_max
,
1587 int *g0
, int *g1
, real
*dcx2
)
1590 int g_min
, g_max
, shift_home
;
1623 g_min
= (shift_min
== shift_home
? 0 : ncpddc
);
1624 g_max
= (shift_max
== shift_home
? ncpddc
- 1 : Nx
- 1);
1631 else if (shift_max
< 0)
1646 /* Check one grid cell down */
1647 dcx
= ((*g0
- 1) + 1)*gridx
- x
;
1659 /* Check one grid cell up */
1660 dcx
= (*g1
+ 1)*gridx
- x
;
1672 #define sqr(x) ((x)*(x))
1673 #define calc_dx2(XI, YI, ZI, y) (sqr(XI-y[XX]) + sqr(YI-y[YY]) + sqr(ZI-y[ZZ]))
1674 #define calc_cyl_dx2(XI, YI, y) (sqr(XI-y[XX]) + sqr(YI-y[YY]))
1675 /****************************************************
1677 * F A S T N E I G H B O R S E A R C H I N G
1679 * Optimized neighboursearching routine using grid
1680 * at least 1x1x1, see GROMACS manual
1682 ****************************************************/
1685 static void get_cutoff2(t_forcerec
*fr
, gmx_bool bDoLongRange
,
1686 real
*rvdw2
, real
*rcoul2
,
1687 real
*rs2
, real
*rm2
, real
*rl2
)
1689 *rs2
= sqr(fr
->rlist
);
1691 if (bDoLongRange
&& fr
->bTwinRange
)
1693 /* With plain cut-off or RF we need to make the list exactly
1694 * up to the cut-off and the cut-off's can be different,
1695 * so we can not simply set them to rlistlong.
1696 * To keep this code compatible with (exotic) old cases,
1697 * we also create lists up to rvdw/rcoulomb for PME and Ewald.
1698 * The interaction check should correspond to:
1699 * !ir_vdw/coulomb_might_be_zero_at_cutoff from inputrec.c.
1701 if (((fr
->vdwtype
== evdwCUT
|| fr
->vdwtype
== evdwPME
) &&
1702 fr
->vdw_modifier
== eintmodNONE
) ||
1703 fr
->rvdw
<= fr
->rlist
)
1705 *rvdw2
= sqr(fr
->rvdw
);
1709 *rvdw2
= sqr(fr
->rlistlong
);
1711 if (((fr
->eeltype
== eelCUT
||
1712 (EEL_RF(fr
->eeltype
) && fr
->eeltype
!= eelRF_ZERO
) ||
1713 fr
->eeltype
== eelPME
||
1714 fr
->eeltype
== eelEWALD
) &&
1715 fr
->coulomb_modifier
== eintmodNONE
) ||
1716 fr
->rcoulomb
<= fr
->rlist
)
1718 *rcoul2
= sqr(fr
->rcoulomb
);
1722 *rcoul2
= sqr(fr
->rlistlong
);
1727 /* Workaround for a gcc -O3 or -ffast-math problem */
1731 *rm2
= std::min(*rvdw2
, *rcoul2
);
1732 *rl2
= std::max(*rvdw2
, *rcoul2
);
1735 static void init_nsgrid_lists(t_forcerec
*fr
, int ngid
, gmx_ns_t
*ns
)
1737 real rvdw2
, rcoul2
, rs2
, rm2
, rl2
;
1740 get_cutoff2(fr
, TRUE
, &rvdw2
, &rcoul2
, &rs2
, &rm2
, &rl2
);
1742 /* Short range buffers */
1743 snew(ns
->nl_sr
, ngid
);
1745 snew(ns
->nsr
, ngid
);
1746 snew(ns
->nlr_ljc
, ngid
);
1747 snew(ns
->nlr_one
, ngid
);
1749 /* Always allocate both list types, since rcoulomb might now change with PME load balancing */
1750 /* Long range VdW and Coul buffers */
1751 snew(ns
->nl_lr_ljc
, ngid
);
1752 /* Long range VdW or Coul only buffers */
1753 snew(ns
->nl_lr_one
, ngid
);
1755 for (j
= 0; (j
< ngid
); j
++)
1757 snew(ns
->nl_sr
[j
], MAX_CG
);
1758 snew(ns
->nl_lr_ljc
[j
], MAX_CG
);
1759 snew(ns
->nl_lr_one
[j
], MAX_CG
);
1764 "ns5_core: rs2 = %g, rm2 = %g, rl2 = %g (nm^2)\n",
1769 static int nsgrid_core(t_commrec
*cr
, t_forcerec
*fr
,
1770 matrix box
, int ngid
,
1771 gmx_localtop_t
*top
,
1773 t_excl bexcl
[], gmx_bool
*bExcludeAlleg
,
1775 put_in_list_t
*put_in_list
,
1776 gmx_bool bHaveVdW
[],
1777 gmx_bool bDoLongRange
, gmx_bool bMakeQMMMnblist
)
1780 int **nl_lr_ljc
, **nl_lr_one
, **nl_sr
;
1781 int *nlr_ljc
, *nlr_one
, *nsr
;
1783 t_block
*cgs
= &(top
->cgs
);
1784 int *cginfo
= fr
->cginfo
;
1785 /* int *i_atoms,*cgsindex=cgs->index; */
1787 int cell_x
, cell_y
, cell_z
;
1788 int d
, tx
, ty
, tz
, dx
, dy
, dz
, cj
;
1789 #ifdef ALLOW_OFFDIAG_LT_HALFDIAG
1790 int zsh_ty
, zsh_tx
, ysh_tx
;
1792 int dx0
, dx1
, dy0
, dy1
, dz0
, dz1
;
1793 int Nx
, Ny
, Nz
, shift
= -1, j
, nrj
, nns
, nn
= -1;
1794 real gridx
, gridy
, gridz
, grid_x
, grid_y
;
1795 real
*dcx2
, *dcy2
, *dcz2
;
1797 int cg0
, cg1
, icg
= -1, cgsnr
, i0
, igid
, naaj
, max_jcg
;
1798 int jcg0
, jcg1
, jjcg
, cgj0
, jgid
;
1799 int *grida
, *gridnra
, *gridind
;
1800 gmx_bool rvdw_lt_rcoul
, rcoul_lt_rvdw
;
1801 rvec
*cgcm
, grid_offset
;
1802 real r2
, rs2
, rvdw2
, rcoul2
, rm2
, rl2
, XI
, YI
, ZI
, tmp1
, tmp2
;
1804 gmx_bool bDomDec
, bTriclinicX
, bTriclinicY
;
1809 bDomDec
= DOMAINDECOMP(cr
);
1812 bTriclinicX
= ((YY
< grid
->npbcdim
&&
1813 (!bDomDec
|| dd
->nc
[YY
] == 1) && box
[YY
][XX
] != 0) ||
1814 (ZZ
< grid
->npbcdim
&&
1815 (!bDomDec
|| dd
->nc
[ZZ
] == 1) && box
[ZZ
][XX
] != 0));
1816 bTriclinicY
= (ZZ
< grid
->npbcdim
&&
1817 (!bDomDec
|| dd
->nc
[ZZ
] == 1) && box
[ZZ
][YY
] != 0);
1821 get_cutoff2(fr
, bDoLongRange
, &rvdw2
, &rcoul2
, &rs2
, &rm2
, &rl2
);
1823 rvdw_lt_rcoul
= (rvdw2
>= rcoul2
);
1824 rcoul_lt_rvdw
= (rcoul2
>= rvdw2
);
1826 if (bMakeQMMMnblist
)
1834 nl_lr_ljc
= ns
->nl_lr_ljc
;
1835 nl_lr_one
= ns
->nl_lr_one
;
1836 nlr_ljc
= ns
->nlr_ljc
;
1837 nlr_one
= ns
->nlr_one
;
1845 gridind
= grid
->index
;
1846 gridnra
= grid
->nra
;
1849 gridx
= grid
->cell_size
[XX
];
1850 gridy
= grid
->cell_size
[YY
];
1851 gridz
= grid
->cell_size
[ZZ
];
1854 copy_rvec(grid
->cell_offset
, grid_offset
);
1855 copy_ivec(grid
->ncpddc
, ncpddc
);
1860 #ifdef ALLOW_OFFDIAG_LT_HALFDIAG
1861 zsh_ty
= floor(-box
[ZZ
][YY
]/box
[YY
][YY
]+0.5);
1862 zsh_tx
= floor(-box
[ZZ
][XX
]/box
[XX
][XX
]+0.5);
1863 ysh_tx
= floor(-box
[YY
][XX
]/box
[XX
][XX
]+0.5);
1864 if (zsh_tx
!= 0 && ysh_tx
!= 0)
1866 /* This could happen due to rounding, when both ratios are 0.5 */
1873 /* We only want a list for the test particle */
1882 /* Set the shift range */
1883 for (d
= 0; d
< DIM
; d
++)
1887 /* Check if we need periodicity shifts.
1888 * Without PBC or with domain decomposition we don't need them.
1890 if (d
>= ePBC2npbcdim(fr
->ePBC
) || (bDomDec
&& dd
->nc
[d
] > 1))
1897 box
[XX
][XX
] - fabs(box
[YY
][XX
]) - fabs(box
[ZZ
][XX
]) < std::sqrt(rl2
))
1908 /* Loop over charge groups */
1909 for (icg
= cg0
; (icg
< cg1
); icg
++)
1911 igid
= GET_CGINFO_GID(cginfo
[icg
]);
1912 /* Skip this charge group if all energy groups are excluded! */
1913 if (bExcludeAlleg
[igid
])
1918 i0
= cgs
->index
[icg
];
1920 if (bMakeQMMMnblist
)
1922 /* Skip this charge group if it is not a QM atom while making a
1923 * QM/MM neighbourlist
1925 if (md
->bQM
[i0
] == FALSE
)
1927 continue; /* MM particle, go to next particle */
1930 /* Compute the number of charge groups that fall within the control
1933 naaj
= calc_naaj(icg
, cgsnr
);
1940 /* make a normal neighbourlist */
1944 /* Get the j charge-group and dd cell shift ranges */
1945 dd_get_ns_ranges(cr
->dd
, icg
, &jcg0
, &jcg1
, sh0
, sh1
);
1950 /* Compute the number of charge groups that fall within the control
1953 naaj
= calc_naaj(icg
, cgsnr
);
1959 /* The i-particle is awlways the test particle,
1960 * so we want all j-particles
1962 max_jcg
= cgsnr
- 1;
1966 max_jcg
= jcg1
- cgsnr
;
1971 i_egp_flags
= fr
->egp_flags
+ igid
*ngid
;
1973 /* Set the exclusions for the atoms in charge group icg using a bitmask */
1974 setexcl(i0
, cgs
->index
[icg
+1], &top
->excls
, TRUE
, bexcl
);
1976 ci2xyz(grid
, icg
, &cell_x
, &cell_y
, &cell_z
);
1978 /* Changed iicg to icg, DvdS 990115
1979 * (but see consistency check above, DvdS 990330)
1982 fprintf(log
, "icg=%5d, naaj=%5d, cell %d %d %d\n",
1983 icg
, naaj
, cell_x
, cell_y
, cell_z
);
1985 /* Loop over shift vectors in three dimensions */
1986 for (tz
= -shp
[ZZ
]; tz
<= shp
[ZZ
]; tz
++)
1988 ZI
= cgcm
[icg
][ZZ
]+tz
*box
[ZZ
][ZZ
];
1989 /* Calculate range of cells in Z direction that have the shift tz */
1990 zgi
= cell_z
+ tz
*Nz
;
1991 get_dx_dd(Nz
, gridz
, rl2
, zgi
, ZI
-grid_offset
[ZZ
],
1992 ncpddc
[ZZ
], sh0
[ZZ
], sh1
[ZZ
], &dz0
, &dz1
, dcz2
);
1997 for (ty
= -shp
[YY
]; ty
<= shp
[YY
]; ty
++)
1999 YI
= cgcm
[icg
][YY
]+ty
*box
[YY
][YY
]+tz
*box
[ZZ
][YY
];
2000 /* Calculate range of cells in Y direction that have the shift ty */
2003 ygi
= (int)(Ny
+ (YI
- grid_offset
[YY
])*grid_y
) - Ny
;
2007 ygi
= cell_y
+ ty
*Ny
;
2009 get_dx_dd(Ny
, gridy
, rl2
, ygi
, YI
-grid_offset
[YY
],
2010 ncpddc
[YY
], sh0
[YY
], sh1
[YY
], &dy0
, &dy1
, dcy2
);
2015 for (tx
= -shp
[XX
]; tx
<= shp
[XX
]; tx
++)
2017 XI
= cgcm
[icg
][XX
]+tx
*box
[XX
][XX
]+ty
*box
[YY
][XX
]+tz
*box
[ZZ
][XX
];
2018 /* Calculate range of cells in X direction that have the shift tx */
2021 xgi
= (int)(Nx
+ (XI
- grid_offset
[XX
])*grid_x
) - Nx
;
2025 xgi
= cell_x
+ tx
*Nx
;
2027 get_dx_dd(Nx
, gridx
, rl2
, xgi
, XI
-grid_offset
[XX
],
2028 ncpddc
[XX
], sh0
[XX
], sh1
[XX
], &dx0
, &dx1
, dcx2
);
2033 /* Get shift vector */
2034 shift
= XYZ2IS(tx
, ty
, tz
);
2036 range_check(shift
, 0, SHIFTS
);
2038 for (nn
= 0; (nn
< ngid
); nn
++)
2045 fprintf(log
, "shift: %2d, dx0,1: %2d,%2d, dy0,1: %2d,%2d, dz0,1: %2d,%2d\n",
2046 shift
, dx0
, dx1
, dy0
, dy1
, dz0
, dz1
);
2047 fprintf(log
, "cgcm: %8.3f %8.3f %8.3f\n", cgcm
[icg
][XX
],
2048 cgcm
[icg
][YY
], cgcm
[icg
][ZZ
]);
2049 fprintf(log
, "xi: %8.3f %8.3f %8.3f\n", XI
, YI
, ZI
);
2051 for (dx
= dx0
; (dx
<= dx1
); dx
++)
2053 tmp1
= rl2
- dcx2
[dx
];
2054 for (dy
= dy0
; (dy
<= dy1
); dy
++)
2056 tmp2
= tmp1
- dcy2
[dy
];
2059 for (dz
= dz0
; (dz
<= dz1
); dz
++)
2061 if (tmp2
> dcz2
[dz
])
2063 /* Find grid-cell cj in which possible neighbours are */
2064 cj
= xyz2ci(Ny
, Nz
, dx
, dy
, dz
);
2066 /* Check out how many cgs (nrj) there in this cell */
2069 /* Find the offset in the cg list */
2072 /* Check if all j's are out of range so we
2073 * can skip the whole cell.
2074 * Should save some time, especially with DD.
2077 (grida
[cgj0
] >= max_jcg
&&
2078 (grida
[cgj0
] >= jcg1
|| grida
[cgj0
+nrj
-1] < jcg0
)))
2084 for (j
= 0; (j
< nrj
); j
++)
2086 jjcg
= grida
[cgj0
+j
];
2088 /* check whether this guy is in range! */
2089 if ((jjcg
>= jcg0
&& jjcg
< jcg1
) ||
2092 r2
= calc_dx2(XI
, YI
, ZI
, cgcm
[jjcg
]);
2095 /* jgid = gid[cgsatoms[cgsindex[jjcg]]]; */
2096 jgid
= GET_CGINFO_GID(cginfo
[jjcg
]);
2097 /* check energy group exclusions */
2098 if (!(i_egp_flags
[jgid
] & EGP_EXCL
))
2102 if (nsr
[jgid
] >= MAX_CG
)
2104 /* Add to short-range list */
2105 put_in_list(bHaveVdW
, ngid
, md
, icg
, jgid
,
2106 nsr
[jgid
], nl_sr
[jgid
],
2107 cgs
->index
, /* cgsatoms, */ bexcl
,
2108 shift
, fr
, FALSE
, TRUE
, TRUE
, fr
->solvent_opt
);
2111 nl_sr
[jgid
][nsr
[jgid
]++] = jjcg
;
2115 if (nlr_ljc
[jgid
] >= MAX_CG
)
2117 /* Add to LJ+coulomb long-range list */
2118 put_in_list(bHaveVdW
, ngid
, md
, icg
, jgid
,
2119 nlr_ljc
[jgid
], nl_lr_ljc
[jgid
], top
->cgs
.index
,
2120 bexcl
, shift
, fr
, TRUE
, TRUE
, TRUE
, fr
->solvent_opt
);
2123 nl_lr_ljc
[jgid
][nlr_ljc
[jgid
]++] = jjcg
;
2127 if (nlr_one
[jgid
] >= MAX_CG
)
2129 /* Add to long-range list with only coul, or only LJ */
2130 put_in_list(bHaveVdW
, ngid
, md
, icg
, jgid
,
2131 nlr_one
[jgid
], nl_lr_one
[jgid
], top
->cgs
.index
,
2132 bexcl
, shift
, fr
, TRUE
, rvdw_lt_rcoul
, rcoul_lt_rvdw
, fr
->solvent_opt
);
2135 nl_lr_one
[jgid
][nlr_one
[jgid
]++] = jjcg
;
2147 /* CHECK whether there is anything left in the buffers */
2148 for (nn
= 0; (nn
< ngid
); nn
++)
2152 put_in_list(bHaveVdW
, ngid
, md
, icg
, nn
, nsr
[nn
], nl_sr
[nn
],
2153 cgs
->index
, /* cgsatoms, */ bexcl
,
2154 shift
, fr
, FALSE
, TRUE
, TRUE
, fr
->solvent_opt
);
2157 if (nlr_ljc
[nn
] > 0)
2159 put_in_list(bHaveVdW
, ngid
, md
, icg
, nn
, nlr_ljc
[nn
],
2160 nl_lr_ljc
[nn
], top
->cgs
.index
,
2161 bexcl
, shift
, fr
, TRUE
, TRUE
, TRUE
, fr
->solvent_opt
);
2164 if (nlr_one
[nn
] > 0)
2166 put_in_list(bHaveVdW
, ngid
, md
, icg
, nn
, nlr_one
[nn
],
2167 nl_lr_one
[nn
], top
->cgs
.index
,
2168 bexcl
, shift
, fr
, TRUE
, rvdw_lt_rcoul
, rcoul_lt_rvdw
, fr
->solvent_opt
);
2174 setexcl(cgs
->index
[icg
], cgs
->index
[icg
+1], &top
->excls
, FALSE
, bexcl
);
2176 /* No need to perform any left-over force calculations anymore (as we used to do here)
2177 * since we now save the proper long-range lists for later evaluation.
2180 /* Close neighbourlists */
2181 close_neighbor_lists(fr
, bMakeQMMMnblist
);
2186 void ns_realloc_natoms(gmx_ns_t
*ns
, int natoms
)
2190 if (natoms
> ns
->nra_alloc
)
2192 ns
->nra_alloc
= over_alloc_dd(natoms
);
2193 srenew(ns
->bexcl
, ns
->nra_alloc
);
2194 for (i
= 0; i
< ns
->nra_alloc
; i
++)
2201 void init_ns(FILE *fplog
, const t_commrec
*cr
,
2202 gmx_ns_t
*ns
, t_forcerec
*fr
,
2203 const gmx_mtop_t
*mtop
)
2205 int mt
, icg
, nr_in_cg
, maxcg
, i
, j
, jcg
, ngid
, ncg
;
2208 /* Compute largest charge groups size (# atoms) */
2210 for (mt
= 0; mt
< mtop
->nmoltype
; mt
++)
2212 cgs
= &mtop
->moltype
[mt
].cgs
;
2213 for (icg
= 0; (icg
< cgs
->nr
); icg
++)
2215 nr_in_cg
= std::max(nr_in_cg
, (int)(cgs
->index
[icg
+1]-cgs
->index
[icg
]));
2219 /* Verify whether largest charge group is <= max cg.
2220 * This is determined by the type of the local exclusion type
2221 * Exclusions are stored in bits. (If the type is not large
2222 * enough, enlarge it, unsigned char -> unsigned short -> unsigned long)
2224 maxcg
= sizeof(t_excl
)*8;
2225 if (nr_in_cg
> maxcg
)
2227 gmx_fatal(FARGS
, "Max #atoms in a charge group: %d > %d\n",
2231 ngid
= mtop
->groups
.grps
[egcENER
].nr
;
2232 snew(ns
->bExcludeAlleg
, ngid
);
2233 for (i
= 0; i
< ngid
; i
++)
2235 ns
->bExcludeAlleg
[i
] = TRUE
;
2236 for (j
= 0; j
< ngid
; j
++)
2238 if (!(fr
->egp_flags
[i
*ngid
+j
] & EGP_EXCL
))
2240 ns
->bExcludeAlleg
[i
] = FALSE
;
2248 ns
->grid
= init_grid(fplog
, fr
);
2249 init_nsgrid_lists(fr
, ngid
, ns
);
2254 snew(ns
->ns_buf
, ngid
);
2255 for (i
= 0; (i
< ngid
); i
++)
2257 snew(ns
->ns_buf
[i
], SHIFTS
);
2259 ncg
= ncg_mtop(mtop
);
2260 snew(ns
->simple_aaj
, 2*ncg
);
2261 for (jcg
= 0; (jcg
< ncg
); jcg
++)
2263 ns
->simple_aaj
[jcg
] = jcg
;
2264 ns
->simple_aaj
[jcg
+ncg
] = jcg
;
2268 /* Create array that determines whether or not atoms have VdW */
2269 snew(ns
->bHaveVdW
, fr
->ntype
);
2270 for (i
= 0; (i
< fr
->ntype
); i
++)
2272 for (j
= 0; (j
< fr
->ntype
); j
++)
2274 ns
->bHaveVdW
[i
] = (ns
->bHaveVdW
[i
] ||
2276 ((BHAMA(fr
->nbfp
, fr
->ntype
, i
, j
) != 0) ||
2277 (BHAMB(fr
->nbfp
, fr
->ntype
, i
, j
) != 0) ||
2278 (BHAMC(fr
->nbfp
, fr
->ntype
, i
, j
) != 0)) :
2279 ((C6(fr
->nbfp
, fr
->ntype
, i
, j
) != 0) ||
2280 (C12(fr
->nbfp
, fr
->ntype
, i
, j
) != 0))));
2285 pr_bvec(debug
, 0, "bHaveVdW", ns
->bHaveVdW
, fr
->ntype
, TRUE
);
2290 if (!DOMAINDECOMP(cr
))
2292 ns_realloc_natoms(ns
, mtop
->natoms
);
2295 ns
->nblist_initialized
= FALSE
;
2297 /* nbr list debug dump */
2299 char *ptr
= getenv("GMX_DUMP_NL");
2302 ns
->dump_nl
= strtol(ptr
, NULL
, 10);
2305 fprintf(fplog
, "GMX_DUMP_NL = %d", ns
->dump_nl
);
2316 int search_neighbours(FILE *log
, t_forcerec
*fr
,
2318 gmx_localtop_t
*top
,
2319 gmx_groups_t
*groups
,
2321 t_nrnb
*nrnb
, t_mdatoms
*md
,
2323 gmx_bool bDoLongRangeNS
)
2325 t_block
*cgs
= &(top
->cgs
);
2326 rvec box_size
, grid_x0
, grid_x1
;
2328 real min_size
, grid_dens
;
2334 gmx_domdec_zones_t
*dd_zones
;
2335 put_in_list_t
*put_in_list
;
2339 /* Set some local variables */
2341 ngid
= groups
->grps
[egcENER
].nr
;
2343 for (m
= 0; (m
< DIM
); m
++)
2345 box_size
[m
] = box
[m
][m
];
2348 if (fr
->ePBC
!= epbcNONE
)
2350 if (sqr(fr
->rlistlong
) >= max_cutoff2(fr
->ePBC
, box
))
2352 gmx_fatal(FARGS
, "One of the box vectors has become shorter than twice the cut-off length or box_yy-|box_zy| or box_zz has become smaller than the cut-off.");
2356 min_size
= std::min(box_size
[XX
], std::min(box_size
[YY
], box_size
[ZZ
]));
2357 if (2*fr
->rlistlong
>= min_size
)
2359 gmx_fatal(FARGS
, "One of the box diagonal elements has become smaller than twice the cut-off length.");
2364 if (DOMAINDECOMP(cr
))
2366 ns_realloc_natoms(ns
, cgs
->index
[cgs
->nr
]);
2369 /* Reset the neighbourlists */
2370 reset_neighbor_lists(fr
, TRUE
, TRUE
);
2372 if (bGrid
&& bFillGrid
)
2376 if (DOMAINDECOMP(cr
))
2378 dd_zones
= domdec_zones(cr
->dd
);
2384 get_nsgrid_boundaries(grid
->nboundeddim
, box
, NULL
, NULL
, NULL
, NULL
,
2385 cgs
->nr
, fr
->cg_cm
, grid_x0
, grid_x1
, &grid_dens
);
2387 grid_first(log
, grid
, NULL
, NULL
, box
, grid_x0
, grid_x1
,
2388 fr
->rlistlong
, grid_dens
);
2394 if (DOMAINDECOMP(cr
))
2397 fill_grid(dd_zones
, grid
, end
, -1, end
, fr
->cg_cm
);
2399 grid
->icg1
= dd_zones
->izone
[dd_zones
->nizone
-1].cg1
;
2403 fill_grid(NULL
, grid
, cgs
->nr
, fr
->cg0
, fr
->hcg
, fr
->cg_cm
);
2404 grid
->icg0
= fr
->cg0
;
2405 grid
->icg1
= fr
->hcg
;
2408 calc_elemnr(grid
, start
, end
, cgs
->nr
);
2410 grid_last(grid
, start
, end
, cgs
->nr
);
2415 print_grid(debug
, grid
);
2420 /* Set the grid cell index for the test particle only.
2421 * The cell to cg index is not corrected, but that does not matter.
2423 fill_grid(NULL
, ns
->grid
, fr
->hcg
, fr
->hcg
-1, fr
->hcg
, fr
->cg_cm
);
2426 if (!fr
->ns
->bCGlist
)
2428 put_in_list
= put_in_list_at
;
2432 put_in_list
= put_in_list_cg
;
2439 nsearch
= nsgrid_core(cr
, fr
, box
, ngid
, top
,
2440 grid
, ns
->bexcl
, ns
->bExcludeAlleg
,
2441 md
, put_in_list
, ns
->bHaveVdW
,
2442 bDoLongRangeNS
, FALSE
);
2444 /* neighbour searching withouth QMMM! QM atoms have zero charge in
2445 * the classical calculation. The charge-charge interaction
2446 * between QM and MM atoms is handled in the QMMM core calculation
2447 * (see QMMM.c). The VDW however, we'd like to compute classically
2448 * and the QM MM atom pairs have just been put in the
2449 * corresponding neighbourlists. in case of QMMM we still need to
2450 * fill a special QMMM neighbourlist that contains all neighbours
2451 * of the QM atoms. If bQMMM is true, this list will now be made:
2453 if (fr
->bQMMM
&& fr
->qr
->QMMMscheme
!= eQMMMschemeoniom
)
2455 nsearch
+= nsgrid_core(cr
, fr
, box
, ngid
, top
,
2456 grid
, ns
->bexcl
, ns
->bExcludeAlleg
,
2457 md
, put_in_list_qmmm
, ns
->bHaveVdW
,
2458 bDoLongRangeNS
, TRUE
);
2463 nsearch
= ns_simple_core(fr
, top
, md
, box
, box_size
,
2464 ns
->bexcl
, ns
->simple_aaj
,
2465 ngid
, ns
->ns_buf
, put_in_list
, ns
->bHaveVdW
);
2472 inc_nrnb(nrnb
, eNR_NS
, nsearch
);
2473 /* inc_nrnb(nrnb,eNR_LR,fr->nlr); */