e0b6fd2416b36477db9e9d53ffe72e865a754f26
[alexxy/gromacs.git] / src / gromacs / nbnxm / pairlist.cpp
1 /*
2  * This file is part of the GROMACS molecular simulation package.
3  *
4  * Copyright (c) 2012,2013,2014,2015,2016,2017,2018,2019, by the GROMACS development team, led by
5  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6  * and including many others, as listed in the AUTHORS file in the
7  * top-level source directory and at http://www.gromacs.org.
8  *
9  * GROMACS is free software; you can redistribute it and/or
10  * modify it under the terms of the GNU Lesser General Public License
11  * as published by the Free Software Foundation; either version 2.1
12  * of the License, or (at your option) any later version.
13  *
14  * GROMACS is distributed in the hope that it will be useful,
15  * but WITHOUT ANY WARRANTY; without even the implied warranty of
16  * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
17  * Lesser General Public License for more details.
18  *
19  * You should have received a copy of the GNU Lesser General Public
20  * License along with GROMACS; if not, see
21  * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22  * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
23  *
24  * If you want to redistribute modifications to GROMACS, please
25  * consider that scientific software is very special. Version
26  * control is crucial - bugs must be traceable. We will be happy to
27  * consider code for inclusion in the official distribution, but
28  * derived work must not be called official GROMACS. Details are found
29  * in the README & COPYING files - if they are missing, get the
30  * official version at http://www.gromacs.org.
31  *
32  * To help us fund GROMACS development, we humbly ask that you cite
33  * the research papers on the package. Check out http://www.gromacs.org.
34  */
35
36 #include "gmxpre.h"
37
38 #include "pairlist.h"
39
40 #include "config.h"
41
42 #include <cassert>
43 #include <cmath>
44 #include <cstring>
45
46 #include <algorithm>
47
48 #include "gromacs/domdec/domdec_struct.h"
49 #include "gromacs/gmxlib/nrnb.h"
50 #include "gromacs/math/functions.h"
51 #include "gromacs/math/utilities.h"
52 #include "gromacs/math/vec.h"
53 #include "gromacs/mdlib/gmx_omp_nthreads.h"
54 #include "gromacs/mdlib/ns.h"
55 #include "gromacs/mdtypes/group.h"
56 #include "gromacs/mdtypes/md_enums.h"
57 #include "gromacs/nbnxm/atomdata.h"
58 #include "gromacs/nbnxm/gpu_data_mgmt.h"
59 #include "gromacs/nbnxm/nbnxm.h"
60 #include "gromacs/nbnxm/nbnxm_geometry.h"
61 #include "gromacs/nbnxm/nbnxm_simd.h"
62 #include "gromacs/pbcutil/ishift.h"
63 #include "gromacs/pbcutil/pbc.h"
64 #include "gromacs/simd/simd.h"
65 #include "gromacs/simd/vector_operations.h"
66 #include "gromacs/topology/block.h"
67 #include "gromacs/utility/exceptions.h"
68 #include "gromacs/utility/fatalerror.h"
69 #include "gromacs/utility/gmxomp.h"
70 #include "gromacs/utility/smalloc.h"
71
72 #include "gridset.h"
73 #include "pairlistset.h"
74 #include "pairlistsets.h"
75 #include "pairlistwork.h"
76 #include "pairsearch.h"
77
78 using namespace gmx;                        // TODO: Remove when this file is moved into gmx namespace
79
80 using BoundingBox   = Nbnxm::BoundingBox;   // TODO: Remove when refactoring this file
81 using BoundingBox1D = Nbnxm::BoundingBox1D; // TODO: Remove when refactoring this file
82
83 using Grid          = Nbnxm::Grid;          // TODO: Remove when refactoring this file
84
85 // Convience alias for partial Nbnxn namespace usage
86 using InteractionLocality = Nbnxm::InteractionLocality;
87
88 /* We shift the i-particles backward for PBC.
89  * This leads to more conditionals than shifting forward.
90  * We do this to get more balanced pair lists.
91  */
92 constexpr bool c_pbcShiftBackward = true;
93
94 /* Layout for the nonbonded NxN pair lists */
95 enum class NbnxnLayout
96 {
97     NoSimd4x4, // i-cluster size 4, j-cluster size 4
98     Simd4xN,   // i-cluster size 4, j-cluster size SIMD width
99     Simd2xNN,  // i-cluster size 4, j-cluster size half SIMD width
100     Gpu8x8x8   // i-cluster size 8, j-cluster size 8 + super-clustering
101 };
102
103 #if GMX_SIMD
104 /* Returns the j-cluster size */
105 template <NbnxnLayout layout>
106 static constexpr int jClusterSize()
107 {
108     static_assert(layout == NbnxnLayout::NoSimd4x4 || layout == NbnxnLayout::Simd4xN || layout == NbnxnLayout::Simd2xNN, "Currently jClusterSize only supports CPU layouts");
109
110     return layout == NbnxnLayout::Simd4xN ? GMX_SIMD_REAL_WIDTH : (layout == NbnxnLayout::Simd2xNN ? GMX_SIMD_REAL_WIDTH/2 : c_nbnxnCpuIClusterSize);
111 }
112
113 /*! \brief Returns the j-cluster index given the i-cluster index.
114  *
115  * \tparam    jClusterSize      The number of atoms in a j-cluster
116  * \tparam    jSubClusterIndex  The j-sub-cluster index (0/1), used when size(j-cluster) < size(i-cluster)
117  * \param[in] ci                The i-cluster index
118  */
119 template <int jClusterSize, int jSubClusterIndex>
120 static inline int cjFromCi(int ci)
121 {
122     static_assert(jClusterSize == c_nbnxnCpuIClusterSize/2 || jClusterSize == c_nbnxnCpuIClusterSize || jClusterSize == c_nbnxnCpuIClusterSize*2, "Only j-cluster sizes 2, 4 and 8 are currently implemented");
123
124     static_assert(jSubClusterIndex == 0 || jSubClusterIndex == 1,
125                   "Only sub-cluster indices 0 and 1 are supported");
126
127     if (jClusterSize == c_nbnxnCpuIClusterSize/2)
128     {
129         if (jSubClusterIndex == 0)
130         {
131             return ci << 1;
132         }
133         else
134         {
135             return ((ci + 1) << 1) - 1;
136         }
137     }
138     else if (jClusterSize == c_nbnxnCpuIClusterSize)
139     {
140         return ci;
141     }
142     else
143     {
144         return ci >> 1;
145     }
146 }
147
148 /*! \brief Returns the j-cluster index given the i-cluster index.
149  *
150  * \tparam    layout            The pair-list layout
151  * \tparam    jSubClusterIndex  The j-sub-cluster index (0/1), used when size(j-cluster) < size(i-cluster)
152  * \param[in] ci                The i-cluster index
153  */
154 template <NbnxnLayout layout, int jSubClusterIndex>
155 static inline int cjFromCi(int ci)
156 {
157     constexpr int clusterSize = jClusterSize<layout>();
158
159     return cjFromCi<clusterSize, jSubClusterIndex>(ci);
160 }
161
162 /* Returns the nbnxn coordinate data index given the i-cluster index */
163 template <NbnxnLayout layout>
164 static inline int xIndexFromCi(int ci)
165 {
166     constexpr int clusterSize = jClusterSize<layout>();
167
168     static_assert(clusterSize == c_nbnxnCpuIClusterSize/2 || clusterSize == c_nbnxnCpuIClusterSize || clusterSize == c_nbnxnCpuIClusterSize*2, "Only j-cluster sizes 2, 4 and 8 are currently implemented");
169
170     if (clusterSize <= c_nbnxnCpuIClusterSize)
171     {
172         /* Coordinates are stored packed in groups of 4 */
173         return ci*STRIDE_P4;
174     }
175     else
176     {
177         /* Coordinates packed in 8, i-cluster size is half the packing width */
178         return (ci >> 1)*STRIDE_P8 + (ci & 1)*(c_packX8 >> 1);
179     }
180 }
181
182 /* Returns the nbnxn coordinate data index given the j-cluster index */
183 template <NbnxnLayout layout>
184 static inline int xIndexFromCj(int cj)
185 {
186     constexpr int clusterSize = jClusterSize<layout>();
187
188     static_assert(clusterSize == c_nbnxnCpuIClusterSize/2 || clusterSize == c_nbnxnCpuIClusterSize || clusterSize == c_nbnxnCpuIClusterSize*2, "Only j-cluster sizes 2, 4 and 8 are currently implemented");
189
190     if (clusterSize == c_nbnxnCpuIClusterSize/2)
191     {
192         /* Coordinates are stored packed in groups of 4 */
193         return (cj >> 1)*STRIDE_P4 + (cj & 1)*(c_packX4 >> 1);
194     }
195     else if (clusterSize == c_nbnxnCpuIClusterSize)
196     {
197         /* Coordinates are stored packed in groups of 4 */
198         return cj*STRIDE_P4;
199     }
200     else
201     {
202         /* Coordinates are stored packed in groups of 8 */
203         return cj*STRIDE_P8;
204     }
205 }
206 #endif //GMX_SIMD
207
208
209 void nbnxn_init_pairlist_fep(t_nblist *nl)
210 {
211     nl->type        = GMX_NBLIST_INTERACTION_FREE_ENERGY;
212     nl->igeometry   = GMX_NBLIST_GEOMETRY_PARTICLE_PARTICLE;
213     /* The interaction functions are set in the free energy kernel fuction */
214     nl->ivdw        = -1;
215     nl->ivdwmod     = -1;
216     nl->ielec       = -1;
217     nl->ielecmod    = -1;
218
219     nl->maxnri      = 0;
220     nl->maxnrj      = 0;
221     nl->nri         = 0;
222     nl->nrj         = 0;
223     nl->iinr        = nullptr;
224     nl->gid         = nullptr;
225     nl->shift       = nullptr;
226     nl->jindex      = nullptr;
227     nl->jjnr        = nullptr;
228     nl->excl_fep    = nullptr;
229
230 }
231
232 static void init_buffer_flags(nbnxn_buffer_flags_t *flags,
233                               int                   natoms)
234 {
235     flags->nflag = (natoms + NBNXN_BUFFERFLAG_SIZE - 1)/NBNXN_BUFFERFLAG_SIZE;
236     if (flags->nflag > flags->flag_nalloc)
237     {
238         flags->flag_nalloc = over_alloc_large(flags->nflag);
239         srenew(flags->flag, flags->flag_nalloc);
240     }
241     for (int b = 0; b < flags->nflag; b++)
242     {
243         bitmask_clear(&(flags->flag[b]));
244     }
245 }
246
247 /* Returns the pair-list cutoff between a bounding box and a grid cell given an atom-to-atom pair-list cutoff
248  *
249  * Given a cutoff distance between atoms, this functions returns the cutoff
250  * distance2 between a bounding box of a group of atoms and a grid cell.
251  * Since atoms can be geometrically outside of the cell they have been
252  * assigned to (when atom groups instead of individual atoms are assigned
253  * to cells), this distance returned can be larger than the input.
254  */
255 static real
256 listRangeForBoundingBoxToGridCell(real                    rlist,
257                                   const Grid::Dimensions &gridDims)
258 {
259     return rlist + gridDims.maxAtomGroupRadius;
260
261 }
262 /* Returns the pair-list cutoff between a grid cells given an atom-to-atom pair-list cutoff
263  *
264  * Given a cutoff distance between atoms, this functions returns the cutoff
265  * distance2 between two grid cells.
266  * Since atoms can be geometrically outside of the cell they have been
267  * assigned to (when atom groups instead of individual atoms are assigned
268  * to cells), this distance returned can be larger than the input.
269  */
270 static real
271 listRangeForGridCellToGridCell(real                    rlist,
272                                const Grid::Dimensions &iGridDims,
273                                const Grid::Dimensions &jGridDims)
274 {
275     return rlist + iGridDims.maxAtomGroupRadius + jGridDims.maxAtomGroupRadius;
276 }
277
278 /* Determines the cell range along one dimension that
279  * the bounding box b0 - b1 sees.
280  */
281 template<int dim>
282 static void get_cell_range(real b0, real b1,
283                            const Grid::Dimensions &jGridDims,
284                            real d2, real rlist, int *cf, int *cl)
285 {
286     real listRangeBBToCell2 = gmx::square(listRangeForBoundingBoxToGridCell(rlist, jGridDims));
287     real distanceInCells    = (b0 - jGridDims.lowerCorner[dim])*jGridDims.invCellSize[dim];
288     *cf                     = std::max(static_cast<int>(distanceInCells), 0);
289
290     while (*cf > 0 &&
291            d2 + gmx::square((b0 - jGridDims.lowerCorner[dim]) - (*cf - 1 + 1)*jGridDims.cellSize[dim]) < listRangeBBToCell2)
292     {
293         (*cf)--;
294     }
295
296     *cl = std::min(static_cast<int>((b1 - jGridDims.lowerCorner[dim])*jGridDims.invCellSize[dim]), jGridDims.numCells[dim] - 1);
297     while (*cl < jGridDims.numCells[dim] - 1 &&
298            d2 + gmx::square((*cl + 1)*jGridDims.cellSize[dim] - (b1 - jGridDims.lowerCorner[dim])) < listRangeBBToCell2)
299     {
300         (*cl)++;
301     }
302 }
303
304 /* Reference code calculating the distance^2 between two bounding boxes */
305 /*
306    static float box_dist2(float bx0, float bx1, float by0,
307                        float by1, float bz0, float bz1,
308                        const BoundingBox *bb)
309    {
310     float d2;
311     float dl, dh, dm, dm0;
312
313     d2 = 0;
314
315     dl  = bx0 - bb->upper.x;
316     dh  = bb->lower.x - bx1;
317     dm  = std::max(dl, dh);
318     dm0 = std::max(dm, 0.0f);
319     d2 += dm0*dm0;
320
321     dl  = by0 - bb->upper.y;
322     dh  = bb->lower.y - by1;
323     dm  = std::max(dl, dh);
324     dm0 = std::max(dm, 0.0f);
325     d2 += dm0*dm0;
326
327     dl  = bz0 - bb->upper.z;
328     dh  = bb->lower.z - bz1;
329     dm  = std::max(dl, dh);
330     dm0 = std::max(dm, 0.0f);
331     d2 += dm0*dm0;
332
333     return d2;
334    }
335  */
336
337 #if !NBNXN_SEARCH_BB_SIMD4
338
339 /*! \brief Plain C code calculating the distance^2 between two bounding boxes in xyz0 format
340  *
341  * \param[in] bb_i  First bounding box
342  * \param[in] bb_j  Second bounding box
343  */
344 static float clusterBoundingBoxDistance2(const BoundingBox &bb_i,
345                                          const BoundingBox &bb_j)
346 {
347     float dl   = bb_i.lower.x - bb_j.upper.x;
348     float dh   = bb_j.lower.x - bb_i.upper.x;
349     float dm   = std::max(dl, dh);
350     float dm0  = std::max(dm, 0.0f);
351     float d2   = dm0*dm0;
352
353     dl         = bb_i.lower.y - bb_j.upper.y;
354     dh         = bb_j.lower.y - bb_i.upper.y;
355     dm         = std::max(dl, dh);
356     dm0        = std::max(dm, 0.0f);
357     d2        += dm0*dm0;
358
359     dl         = bb_i.lower.z - bb_j.upper.z;
360     dh         = bb_j.lower.z - bb_i.upper.z;
361     dm         = std::max(dl, dh);
362     dm0        = std::max(dm, 0.0f);
363     d2        += dm0*dm0;
364
365     return d2;
366 }
367
368 #else /* NBNXN_SEARCH_BB_SIMD4 */
369
370 /*! \brief 4-wide SIMD code calculating the distance^2 between two bounding boxes in xyz0 format
371  *
372  * \param[in] bb_i  First bounding box, should be aligned for 4-wide SIMD
373  * \param[in] bb_j  Second bounding box, should be aligned for 4-wide SIMD
374  */
375 static float clusterBoundingBoxDistance2(const BoundingBox &bb_i,
376                                          const BoundingBox &bb_j)
377 {
378     // TODO: During SIMDv2 transition only some archs use namespace (remove when done)
379     using namespace gmx;
380
381     const Simd4Float bb_i_S0 = load4(bb_i.lower.ptr());
382     const Simd4Float bb_i_S1 = load4(bb_i.upper.ptr());
383     const Simd4Float bb_j_S0 = load4(bb_j.lower.ptr());
384     const Simd4Float bb_j_S1 = load4(bb_j.upper.ptr());
385
386     const Simd4Float dl_S    = bb_i_S0 - bb_j_S1;
387     const Simd4Float dh_S    = bb_j_S0 - bb_i_S1;
388
389     const Simd4Float dm_S    = max(dl_S, dh_S);
390     const Simd4Float dm0_S   = max(dm_S, simd4SetZeroF());
391
392     return dotProduct(dm0_S, dm0_S);
393 }
394
395 /* Calculate bb bounding distances of bb_i[si,...,si+3] and store them in d2 */
396 template <int boundingBoxStart>
397 static inline void gmx_simdcall
398 clusterBoundingBoxDistance2_xxxx_simd4_inner(const float      *bb_i,
399                                              float            *d2,
400                                              const Simd4Float  xj_l,
401                                              const Simd4Float  yj_l,
402                                              const Simd4Float  zj_l,
403                                              const Simd4Float  xj_h,
404                                              const Simd4Float  yj_h,
405                                              const Simd4Float  zj_h)
406 {
407     constexpr int    stride = c_packedBoundingBoxesDimSize;
408
409     const int        shi  = boundingBoxStart*Nbnxm::c_numBoundingBoxBounds1D*DIM;
410
411     const Simd4Float zero = setZero();
412
413     const Simd4Float xi_l = load4(bb_i + shi + 0*stride);
414     const Simd4Float yi_l = load4(bb_i + shi + 1*stride);
415     const Simd4Float zi_l = load4(bb_i + shi + 2*stride);
416     const Simd4Float xi_h = load4(bb_i + shi + 3*stride);
417     const Simd4Float yi_h = load4(bb_i + shi + 4*stride);
418     const Simd4Float zi_h = load4(bb_i + shi + 5*stride);
419
420     const Simd4Float dx_0 = xi_l - xj_h;
421     const Simd4Float dy_0 = yi_l - yj_h;
422     const Simd4Float dz_0 = zi_l - zj_h;
423
424     const Simd4Float dx_1 = xj_l - xi_h;
425     const Simd4Float dy_1 = yj_l - yi_h;
426     const Simd4Float dz_1 = zj_l - zi_h;
427
428     const Simd4Float mx   = max(dx_0, dx_1);
429     const Simd4Float my   = max(dy_0, dy_1);
430     const Simd4Float mz   = max(dz_0, dz_1);
431
432     const Simd4Float m0x  = max(mx, zero);
433     const Simd4Float m0y  = max(my, zero);
434     const Simd4Float m0z  = max(mz, zero);
435
436     const Simd4Float d2x  = m0x * m0x;
437     const Simd4Float d2y  = m0y * m0y;
438     const Simd4Float d2z  = m0z * m0z;
439
440     const Simd4Float d2s  = d2x + d2y;
441     const Simd4Float d2t  = d2s + d2z;
442
443     store4(d2 + boundingBoxStart, d2t);
444 }
445
446 /* 4-wide SIMD code for nsi bb distances for bb format xxxxyyyyzzzz */
447 static void
448 clusterBoundingBoxDistance2_xxxx_simd4(const float *bb_j,
449                                        const int    nsi,
450                                        const float *bb_i,
451                                        float       *d2)
452 {
453     constexpr int    stride = c_packedBoundingBoxesDimSize;
454
455     // TODO: During SIMDv2 transition only some archs use namespace (remove when done)
456     using namespace gmx;
457
458     const Simd4Float xj_l = Simd4Float(bb_j[0*stride]);
459     const Simd4Float yj_l = Simd4Float(bb_j[1*stride]);
460     const Simd4Float zj_l = Simd4Float(bb_j[2*stride]);
461     const Simd4Float xj_h = Simd4Float(bb_j[3*stride]);
462     const Simd4Float yj_h = Simd4Float(bb_j[4*stride]);
463     const Simd4Float zj_h = Simd4Float(bb_j[5*stride]);
464
465     /* Here we "loop" over si (0,stride) from 0 to nsi with step stride.
466      * But as we know the number of iterations is 1 or 2, we unroll manually.
467      */
468     clusterBoundingBoxDistance2_xxxx_simd4_inner<0>(bb_i, d2,
469                                                     xj_l, yj_l, zj_l,
470                                                     xj_h, yj_h, zj_h);
471     if (stride < nsi)
472     {
473         clusterBoundingBoxDistance2_xxxx_simd4_inner<stride>(bb_i, d2,
474                                                              xj_l, yj_l, zj_l,
475                                                              xj_h, yj_h, zj_h);
476     }
477 }
478
479 #endif /* NBNXN_SEARCH_BB_SIMD4 */
480
481
482 /* Returns if any atom pair from two clusters is within distance sqrt(rlist2) */
483 static inline gmx_bool
484 clusterpair_in_range(const NbnxnPairlistGpuWork &work,
485                      int si,
486                      int csj, int stride, const real *x_j,
487                      real rlist2)
488 {
489 #if !GMX_SIMD4_HAVE_REAL
490
491     /* Plain C version.
492      * All coordinates are stored as xyzxyz...
493      */
494
495     const real *x_i = work.iSuperClusterData.x.data();
496
497     for (int i = 0; i < c_nbnxnGpuClusterSize; i++)
498     {
499         int i0 = (si*c_nbnxnGpuClusterSize + i)*DIM;
500         for (int j = 0; j < c_nbnxnGpuClusterSize; j++)
501         {
502             int  j0 = (csj*c_nbnxnGpuClusterSize + j)*stride;
503
504             real d2 = gmx::square(x_i[i0  ] - x_j[j0  ]) + gmx::square(x_i[i0+1] - x_j[j0+1]) + gmx::square(x_i[i0+2] - x_j[j0+2]);
505
506             if (d2 < rlist2)
507             {
508                 return TRUE;
509             }
510         }
511     }
512
513     return FALSE;
514
515 #else /* !GMX_SIMD4_HAVE_REAL */
516
517     /* 4-wide SIMD version.
518      * The coordinates x_i are stored as xxxxyyyy..., x_j is stored xyzxyz...
519      * Using 8-wide AVX(2) is not faster on Intel Sandy Bridge and Haswell.
520      */
521     static_assert(c_nbnxnGpuClusterSize == 8 || c_nbnxnGpuClusterSize == 4,
522                   "A cluster is hard-coded to 4/8 atoms.");
523
524     Simd4Real   rc2_S      = Simd4Real(rlist2);
525
526     const real *x_i        = work.iSuperClusterData.xSimd.data();
527
528     int         dim_stride = c_nbnxnGpuClusterSize*DIM;
529     Simd4Real   ix_S0      = load4(x_i + si*dim_stride + 0*GMX_SIMD4_WIDTH);
530     Simd4Real   iy_S0      = load4(x_i + si*dim_stride + 1*GMX_SIMD4_WIDTH);
531     Simd4Real   iz_S0      = load4(x_i + si*dim_stride + 2*GMX_SIMD4_WIDTH);
532
533     Simd4Real   ix_S1, iy_S1, iz_S1;
534     if (c_nbnxnGpuClusterSize == 8)
535     {
536         ix_S1      = load4(x_i + si*dim_stride + 3*GMX_SIMD4_WIDTH);
537         iy_S1      = load4(x_i + si*dim_stride + 4*GMX_SIMD4_WIDTH);
538         iz_S1      = load4(x_i + si*dim_stride + 5*GMX_SIMD4_WIDTH);
539     }
540     /* We loop from the outer to the inner particles to maximize
541      * the chance that we find a pair in range quickly and return.
542      */
543     int j0 = csj*c_nbnxnGpuClusterSize;
544     int j1 = j0 + c_nbnxnGpuClusterSize - 1;
545     while (j0 < j1)
546     {
547         Simd4Real jx0_S, jy0_S, jz0_S;
548         Simd4Real jx1_S, jy1_S, jz1_S;
549
550         Simd4Real dx_S0, dy_S0, dz_S0;
551         Simd4Real dx_S1, dy_S1, dz_S1;
552         Simd4Real dx_S2, dy_S2, dz_S2;
553         Simd4Real dx_S3, dy_S3, dz_S3;
554
555         Simd4Real rsq_S0;
556         Simd4Real rsq_S1;
557         Simd4Real rsq_S2;
558         Simd4Real rsq_S3;
559
560         Simd4Bool wco_S0;
561         Simd4Bool wco_S1;
562         Simd4Bool wco_S2;
563         Simd4Bool wco_S3;
564         Simd4Bool wco_any_S01, wco_any_S23, wco_any_S;
565
566         jx0_S = Simd4Real(x_j[j0*stride+0]);
567         jy0_S = Simd4Real(x_j[j0*stride+1]);
568         jz0_S = Simd4Real(x_j[j0*stride+2]);
569
570         jx1_S = Simd4Real(x_j[j1*stride+0]);
571         jy1_S = Simd4Real(x_j[j1*stride+1]);
572         jz1_S = Simd4Real(x_j[j1*stride+2]);
573
574         /* Calculate distance */
575         dx_S0            = ix_S0 - jx0_S;
576         dy_S0            = iy_S0 - jy0_S;
577         dz_S0            = iz_S0 - jz0_S;
578         dx_S2            = ix_S0 - jx1_S;
579         dy_S2            = iy_S0 - jy1_S;
580         dz_S2            = iz_S0 - jz1_S;
581         if (c_nbnxnGpuClusterSize == 8)
582         {
583             dx_S1            = ix_S1 - jx0_S;
584             dy_S1            = iy_S1 - jy0_S;
585             dz_S1            = iz_S1 - jz0_S;
586             dx_S3            = ix_S1 - jx1_S;
587             dy_S3            = iy_S1 - jy1_S;
588             dz_S3            = iz_S1 - jz1_S;
589         }
590
591         /* rsq = dx*dx+dy*dy+dz*dz */
592         rsq_S0           = norm2(dx_S0, dy_S0, dz_S0);
593         rsq_S2           = norm2(dx_S2, dy_S2, dz_S2);
594         if (c_nbnxnGpuClusterSize == 8)
595         {
596             rsq_S1           = norm2(dx_S1, dy_S1, dz_S1);
597             rsq_S3           = norm2(dx_S3, dy_S3, dz_S3);
598         }
599
600         wco_S0           = (rsq_S0 < rc2_S);
601         wco_S2           = (rsq_S2 < rc2_S);
602         if (c_nbnxnGpuClusterSize == 8)
603         {
604             wco_S1           = (rsq_S1 < rc2_S);
605             wco_S3           = (rsq_S3 < rc2_S);
606         }
607         if (c_nbnxnGpuClusterSize == 8)
608         {
609             wco_any_S01      = wco_S0 || wco_S1;
610             wco_any_S23      = wco_S2 || wco_S3;
611             wco_any_S        = wco_any_S01 || wco_any_S23;
612         }
613         else
614         {
615             wco_any_S = wco_S0 || wco_S2;
616         }
617
618         if (anyTrue(wco_any_S))
619         {
620             return TRUE;
621         }
622
623         j0++;
624         j1--;
625     }
626
627     return FALSE;
628
629 #endif /* !GMX_SIMD4_HAVE_REAL */
630 }
631
632 /* Returns the j-cluster index for index cjIndex in a cj list */
633 static inline int nblCj(gmx::ArrayRef<const nbnxn_cj_t> cjList,
634                         int                             cjIndex)
635 {
636     return cjList[cjIndex].cj;
637 }
638
639 /* Returns the j-cluster index for index cjIndex in a cj4 list */
640 static inline int nblCj(gmx::ArrayRef<const nbnxn_cj4_t> cj4List,
641                         int                              cjIndex)
642 {
643     return cj4List[cjIndex/c_nbnxnGpuJgroupSize].cj[cjIndex & (c_nbnxnGpuJgroupSize - 1)];
644 }
645
646 /* Returns the i-interaction mask of the j sub-cell for index cj_ind */
647 static unsigned int nbl_imask0(const NbnxnPairlistGpu *nbl, int cj_ind)
648 {
649     return nbl->cj4[cj_ind/c_nbnxnGpuJgroupSize].imei[0].imask;
650 }
651
652 NbnxnPairlistCpu::NbnxnPairlistCpu() :
653     na_ci(c_nbnxnCpuIClusterSize),
654     na_cj(0),
655     rlist(0),
656     ncjInUse(0),
657     nci_tot(0),
658     work(std::make_unique<NbnxnPairlistCpuWork>())
659 {
660 }
661
662 NbnxnPairlistGpu::NbnxnPairlistGpu(gmx::PinningPolicy pinningPolicy) :
663     na_ci(c_nbnxnGpuClusterSize),
664     na_cj(c_nbnxnGpuClusterSize),
665     na_sc(c_gpuNumClusterPerCell*c_nbnxnGpuClusterSize),
666     rlist(0),
667     sci({}, {pinningPolicy}),
668     cj4({}, {pinningPolicy}),
669     excl({}, {pinningPolicy}),
670     nci_tot(0),
671     work(std::make_unique<NbnxnPairlistGpuWork>())
672 {
673     static_assert(c_nbnxnGpuNumClusterPerSupercluster == c_gpuNumClusterPerCell,
674                   "The search code assumes that the a super-cluster matches a search grid cell");
675
676     static_assert(sizeof(cj4[0].imei[0].imask)*8 >= c_nbnxnGpuJgroupSize*c_gpuNumClusterPerCell,
677                   "The i super-cluster cluster interaction mask does not contain a sufficient number of bits");
678
679     static_assert(sizeof(excl[0])*8 >= c_nbnxnGpuJgroupSize*c_gpuNumClusterPerCell, "The GPU exclusion mask does not contain a sufficient number of bits");
680
681     // We always want a first entry without any exclusions
682     excl.resize(1);
683 }
684
685 // TODO: Move to pairlistset.cpp
686 PairlistSet::PairlistSet(const Nbnxm::InteractionLocality  locality,
687                          const PairlistParams             &pairlistParams) :
688     locality_(locality),
689     params_(pairlistParams)
690 {
691     isCpuType_ =
692         (params_.pairlistType == PairlistType::Simple4x2 ||
693          params_.pairlistType == PairlistType::Simple4x4 ||
694          params_.pairlistType == PairlistType::Simple4x8);
695     // Currently GPU lists are always combined
696     combineLists_ = !isCpuType_;
697
698     const int numLists = gmx_omp_nthreads_get(emntNonbonded);
699
700     if (!combineLists_ &&
701         numLists > NBNXN_BUFFERFLAG_MAX_THREADS)
702     {
703         gmx_fatal(FARGS, "%d OpenMP threads were requested. Since the non-bonded force buffer reduction is prohibitively slow with more than %d threads, we do not allow this. Use %d or less OpenMP threads.",
704                   numLists, NBNXN_BUFFERFLAG_MAX_THREADS, NBNXN_BUFFERFLAG_MAX_THREADS);
705     }
706
707     if (isCpuType_)
708     {
709         cpuLists_.resize(numLists);
710         if (numLists > 1)
711         {
712             cpuListsWork_.resize(numLists);
713         }
714     }
715     else
716     {
717         /* Only list 0 is used on the GPU, use normal allocation for i>0 */
718         gpuLists_.emplace_back(gmx::PinningPolicy::PinnedIfSupported);
719         /* Lists 0 to numLists are use for constructing lists in parallel
720          * on the CPU using numLists threads (and then merged into list 0).
721          */
722         for (int i = 1; i < numLists; i++)
723         {
724             gpuLists_.emplace_back(gmx::PinningPolicy::CannotBePinned);
725         }
726     }
727     if (params_.haveFep)
728     {
729         fepLists_.resize(numLists);
730
731         /* Execute in order to avoid memory interleaving between threads */
732 #pragma omp parallel for num_threads(numLists) schedule(static)
733         for (int i = 0; i < numLists; i++)
734         {
735             try
736             {
737                 /* We used to allocate all normal lists locally on each thread
738                  * as well. The question is if allocating the object on the
739                  * master thread (but all contained list memory thread local)
740                  * impacts performance.
741                  */
742                 snew(fepLists_[i], 1);
743                 nbnxn_init_pairlist_fep(fepLists_[i]);
744             }
745             GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
746         }
747     }
748 }
749
750 /* Print statistics of a pair list, used for debug output */
751 static void print_nblist_statistics(FILE                   *fp,
752                                     const NbnxnPairlistCpu &nbl,
753                                     const Nbnxm::GridSet   &gridSet,
754                                     const real              rl)
755 {
756     const Grid             &grid = gridSet.grids()[0];
757     const Grid::Dimensions &dims = grid.dimensions();
758
759     fprintf(fp, "nbl nci %zu ncj %d\n",
760             nbl.ci.size(), nbl.ncjInUse);
761     const int    numAtomsJCluster = grid.geometry().numAtomsJCluster;
762     const double numAtomsPerCell  = nbl.ncjInUse/static_cast<double>(grid.numCells())*numAtomsJCluster;
763     fprintf(fp, "nbl na_cj %d rl %g ncp %d per cell %.1f atoms %.1f ratio %.2f\n",
764             nbl.na_cj, rl, nbl.ncjInUse, nbl.ncjInUse/static_cast<double>(grid.numCells()),
765             numAtomsPerCell,
766             numAtomsPerCell/(0.5*4.0/3.0*M_PI*rl*rl*rl*grid.numCells()*numAtomsJCluster/(dims.gridSize[XX]*dims.gridSize[YY]*dims.gridSize[ZZ])));
767
768     fprintf(fp, "nbl average j cell list length %.1f\n",
769             0.25*nbl.ncjInUse/std::max(static_cast<double>(nbl.ci.size()), 1.0));
770
771     int cs[SHIFTS] = { 0 };
772     int npexcl     = 0;
773     for (const nbnxn_ci_t &ciEntry : nbl.ci)
774     {
775         cs[ciEntry.shift & NBNXN_CI_SHIFT] +=
776             ciEntry.cj_ind_end - ciEntry.cj_ind_start;
777
778         int j = ciEntry.cj_ind_start;
779         while (j < ciEntry.cj_ind_end &&
780                nbl.cj[j].excl != NBNXN_INTERACTION_MASK_ALL)
781         {
782             npexcl++;
783             j++;
784         }
785     }
786     fprintf(fp, "nbl cell pairs, total: %zu excl: %d %.1f%%\n",
787             nbl.cj.size(), npexcl, 100*npexcl/std::max(static_cast<double>(nbl.cj.size()), 1.0));
788     for (int s = 0; s < SHIFTS; s++)
789     {
790         if (cs[s] > 0)
791         {
792             fprintf(fp, "nbl shift %2d ncj %3d\n", s, cs[s]);
793         }
794     }
795 }
796
797 /* Print statistics of a pair lists, used for debug output */
798 static void print_nblist_statistics(FILE                   *fp,
799                                     const NbnxnPairlistGpu &nbl,
800                                     const Nbnxm::GridSet   &gridSet,
801                                     const real              rl)
802 {
803     const Grid             &grid = gridSet.grids()[0];
804     const Grid::Dimensions &dims = grid.dimensions();
805
806     fprintf(fp, "nbl nsci %zu ncj4 %zu nsi %d excl4 %zu\n",
807             nbl.sci.size(), nbl.cj4.size(), nbl.nci_tot, nbl.excl.size());
808     const int    numAtomsCluster = grid.geometry().numAtomsICluster;
809     const double numAtomsPerCell = nbl.nci_tot/static_cast<double>(grid.numClusters())*numAtomsCluster;
810     fprintf(fp, "nbl na_c %d rl %g ncp %d per cell %.1f atoms %.1f ratio %.2f\n",
811             nbl.na_ci, rl, nbl.nci_tot, nbl.nci_tot/static_cast<double>(grid.numClusters()),
812             numAtomsPerCell,
813             numAtomsPerCell/(0.5*4.0/3.0*M_PI*rl*rl*rl*grid.numClusters()*numAtomsCluster/(dims.gridSize[XX]*dims.gridSize[YY]*dims.gridSize[ZZ])));
814
815     double sum_nsp  = 0;
816     double sum_nsp2 = 0;
817     int    nsp_max  = 0;
818     int    c[c_gpuNumClusterPerCell + 1] = { 0 };
819     for (const nbnxn_sci_t &sci : nbl.sci)
820     {
821         int nsp = 0;
822         for (int j4 = sci.cj4_ind_start; j4 < sci.cj4_ind_end; j4++)
823         {
824             for (int j = 0; j < c_nbnxnGpuJgroupSize; j++)
825             {
826                 int b = 0;
827                 for (int si = 0; si < c_gpuNumClusterPerCell; si++)
828                 {
829                     if (nbl.cj4[j4].imei[0].imask & (1U << (j*c_gpuNumClusterPerCell + si)))
830                     {
831                         b++;
832                     }
833                 }
834                 nsp += b;
835                 c[b]++;
836             }
837         }
838         sum_nsp  += nsp;
839         sum_nsp2 += nsp*nsp;
840         nsp_max   = std::max(nsp_max, nsp);
841     }
842     if (!nbl.sci.empty())
843     {
844         sum_nsp  /= nbl.sci.size();
845         sum_nsp2 /= nbl.sci.size();
846     }
847     fprintf(fp, "nbl #cluster-pairs: av %.1f stddev %.1f max %d\n",
848             sum_nsp, std::sqrt(sum_nsp2 - sum_nsp*sum_nsp), nsp_max);
849
850     if (!nbl.cj4.empty())
851     {
852         for (int b = 0; b <= c_gpuNumClusterPerCell; b++)
853         {
854             fprintf(fp, "nbl j-list #i-subcell %d %7d %4.1f\n",
855                     b, c[b], 100.0*c[b]/size_t {nbl.cj4.size()*c_nbnxnGpuJgroupSize});
856         }
857     }
858 }
859
860 /* Returns a pointer to the exclusion mask for j-cluster-group \p cj4 and warp \p warp
861  * Generates a new exclusion entry when the j-cluster-group uses
862  * the default all-interaction mask at call time, so the returned mask
863  * can be modified when needed.
864  */
865 static nbnxn_excl_t *get_exclusion_mask(NbnxnPairlistGpu *nbl,
866                                         int               cj4,
867                                         int               warp)
868 {
869     if (nbl->cj4[cj4].imei[warp].excl_ind == 0)
870     {
871         /* No exclusions set, make a new list entry */
872         const size_t oldSize = nbl->excl.size();
873         GMX_ASSERT(oldSize >= 1, "We should always have entry [0]");
874         /* Add entry with default values: no exclusions */
875         nbl->excl.resize(oldSize + 1);
876         nbl->cj4[cj4].imei[warp].excl_ind = oldSize;
877     }
878
879     return &nbl->excl[nbl->cj4[cj4].imei[warp].excl_ind];
880 }
881
882 static void set_self_and_newton_excls_supersub(NbnxnPairlistGpu *nbl,
883                                                int cj4_ind, int sj_offset,
884                                                int i_cluster_in_cell)
885 {
886     nbnxn_excl_t *excl[c_nbnxnGpuClusterpairSplit];
887
888     /* Here we only set the set self and double pair exclusions */
889
890     /* Reserve extra elements, so the resize() in get_exclusion_mask()
891      * will not invalidate excl entries in the loop below
892      */
893     nbl->excl.reserve(nbl->excl.size() + c_nbnxnGpuClusterpairSplit);
894     for (int w = 0; w < c_nbnxnGpuClusterpairSplit; w++)
895     {
896         excl[w] = get_exclusion_mask(nbl, cj4_ind, w);
897     }
898
899     /* Only minor < major bits set */
900     for (int ej = 0; ej < nbl->na_ci; ej++)
901     {
902         int w = (ej>>2);
903         for (int ei = ej; ei < nbl->na_ci; ei++)
904         {
905             excl[w]->pair[(ej & (c_nbnxnGpuJgroupSize-1))*nbl->na_ci + ei] &=
906                 ~(1U << (sj_offset*c_gpuNumClusterPerCell + i_cluster_in_cell));
907         }
908     }
909 }
910
911 /* Returns a diagonal or off-diagonal interaction mask for plain C lists */
912 static unsigned int get_imask(gmx_bool rdiag, int ci, int cj)
913 {
914     return (rdiag && ci == cj ? NBNXN_INTERACTION_MASK_DIAG : NBNXN_INTERACTION_MASK_ALL);
915 }
916
917 /* Returns a diagonal or off-diagonal interaction mask for cj-size=2 */
918 gmx_unused static unsigned int get_imask_simd_j2(gmx_bool rdiag, int ci, int cj)
919 {
920     return (rdiag && ci*2 == cj ? NBNXN_INTERACTION_MASK_DIAG_J2_0 :
921             (rdiag && ci*2+1 == cj ? NBNXN_INTERACTION_MASK_DIAG_J2_1 :
922              NBNXN_INTERACTION_MASK_ALL));
923 }
924
925 /* Returns a diagonal or off-diagonal interaction mask for cj-size=4 */
926 gmx_unused static unsigned int get_imask_simd_j4(gmx_bool rdiag, int ci, int cj)
927 {
928     return (rdiag && ci == cj ? NBNXN_INTERACTION_MASK_DIAG : NBNXN_INTERACTION_MASK_ALL);
929 }
930
931 /* Returns a diagonal or off-diagonal interaction mask for cj-size=8 */
932 gmx_unused static unsigned int get_imask_simd_j8(gmx_bool rdiag, int ci, int cj)
933 {
934     return (rdiag && ci == cj*2 ? NBNXN_INTERACTION_MASK_DIAG_J8_0 :
935             (rdiag && ci == cj*2+1 ? NBNXN_INTERACTION_MASK_DIAG_J8_1 :
936              NBNXN_INTERACTION_MASK_ALL));
937 }
938
939 #if GMX_SIMD
940 #if GMX_SIMD_REAL_WIDTH == 2
941 #define get_imask_simd_4xn  get_imask_simd_j2
942 #endif
943 #if GMX_SIMD_REAL_WIDTH == 4
944 #define get_imask_simd_4xn  get_imask_simd_j4
945 #endif
946 #if GMX_SIMD_REAL_WIDTH == 8
947 #define get_imask_simd_4xn  get_imask_simd_j8
948 #define get_imask_simd_2xnn get_imask_simd_j4
949 #endif
950 #if GMX_SIMD_REAL_WIDTH == 16
951 #define get_imask_simd_2xnn get_imask_simd_j8
952 #endif
953 #endif
954
955 /* Plain C code for checking and adding cluster-pairs to the list.
956  *
957  * \param[in]     gridj               The j-grid
958  * \param[in,out] nbl                 The pair-list to store the cluster pairs in
959  * \param[in]     icluster            The index of the i-cluster
960  * \param[in]     jclusterFirst       The first cluster in the j-range
961  * \param[in]     jclusterLast        The last cluster in the j-range
962  * \param[in]     excludeSubDiagonal  Exclude atom pairs with i-index > j-index
963  * \param[in]     x_j                 Coordinates for the j-atom, in xyz format
964  * \param[in]     rlist2              The squared list cut-off
965  * \param[in]     rbb2                The squared cut-off for putting cluster-pairs in the list based on bounding box distance only
966  * \param[in,out] numDistanceChecks   The number of distance checks performed
967  */
968 static void
969 makeClusterListSimple(const Grid               &jGrid,
970                       NbnxnPairlistCpu *        nbl,
971                       int                       icluster,
972                       int                       jclusterFirst,
973                       int                       jclusterLast,
974                       bool                      excludeSubDiagonal,
975                       const real * gmx_restrict x_j,
976                       real                      rlist2,
977                       float                     rbb2,
978                       int * gmx_restrict        numDistanceChecks)
979 {
980     const BoundingBox * gmx_restrict bb_ci = nbl->work->iClusterData.bb.data();
981     const real * gmx_restrict        x_ci  = nbl->work->iClusterData.x.data();
982
983     gmx_bool                         InRange;
984
985     InRange = FALSE;
986     while (!InRange && jclusterFirst <= jclusterLast)
987     {
988         real d2  = clusterBoundingBoxDistance2(bb_ci[0], jGrid.jBoundingBoxes()[jclusterFirst]);
989         *numDistanceChecks += 2;
990
991         /* Check if the distance is within the distance where
992          * we use only the bounding box distance rbb,
993          * or within the cut-off and there is at least one atom pair
994          * within the cut-off.
995          */
996         if (d2 < rbb2)
997         {
998             InRange = TRUE;
999         }
1000         else if (d2 < rlist2)
1001         {
1002             int cjf_gl = jGrid.cellOffset() + jclusterFirst;
1003             for (int i = 0; i < c_nbnxnCpuIClusterSize && !InRange; i++)
1004             {
1005                 for (int j = 0; j < c_nbnxnCpuIClusterSize; j++)
1006                 {
1007                     InRange = InRange ||
1008                         (gmx::square(x_ci[i*STRIDE_XYZ+XX] - x_j[(cjf_gl*c_nbnxnCpuIClusterSize+j)*STRIDE_XYZ+XX]) +
1009                          gmx::square(x_ci[i*STRIDE_XYZ+YY] - x_j[(cjf_gl*c_nbnxnCpuIClusterSize+j)*STRIDE_XYZ+YY]) +
1010                          gmx::square(x_ci[i*STRIDE_XYZ+ZZ] - x_j[(cjf_gl*c_nbnxnCpuIClusterSize+j)*STRIDE_XYZ+ZZ]) < rlist2);
1011                 }
1012             }
1013             *numDistanceChecks += c_nbnxnCpuIClusterSize*c_nbnxnCpuIClusterSize;
1014         }
1015         if (!InRange)
1016         {
1017             jclusterFirst++;
1018         }
1019     }
1020     if (!InRange)
1021     {
1022         return;
1023     }
1024
1025     InRange = FALSE;
1026     while (!InRange && jclusterLast > jclusterFirst)
1027     {
1028         real d2  = clusterBoundingBoxDistance2(bb_ci[0], jGrid.jBoundingBoxes()[jclusterLast]);
1029         *numDistanceChecks += 2;
1030
1031         /* Check if the distance is within the distance where
1032          * we use only the bounding box distance rbb,
1033          * or within the cut-off and there is at least one atom pair
1034          * within the cut-off.
1035          */
1036         if (d2 < rbb2)
1037         {
1038             InRange = TRUE;
1039         }
1040         else if (d2 < rlist2)
1041         {
1042             int cjl_gl = jGrid.cellOffset() + jclusterLast;
1043             for (int i = 0; i < c_nbnxnCpuIClusterSize && !InRange; i++)
1044             {
1045                 for (int j = 0; j < c_nbnxnCpuIClusterSize; j++)
1046                 {
1047                     InRange = InRange ||
1048                         (gmx::square(x_ci[i*STRIDE_XYZ+XX] - x_j[(cjl_gl*c_nbnxnCpuIClusterSize+j)*STRIDE_XYZ+XX]) +
1049                          gmx::square(x_ci[i*STRIDE_XYZ+YY] - x_j[(cjl_gl*c_nbnxnCpuIClusterSize+j)*STRIDE_XYZ+YY]) +
1050                          gmx::square(x_ci[i*STRIDE_XYZ+ZZ] - x_j[(cjl_gl*c_nbnxnCpuIClusterSize+j)*STRIDE_XYZ+ZZ]) < rlist2);
1051                 }
1052             }
1053             *numDistanceChecks += c_nbnxnCpuIClusterSize*c_nbnxnCpuIClusterSize;
1054         }
1055         if (!InRange)
1056         {
1057             jclusterLast--;
1058         }
1059     }
1060
1061     if (jclusterFirst <= jclusterLast)
1062     {
1063         for (int jcluster = jclusterFirst; jcluster <= jclusterLast; jcluster++)
1064         {
1065             /* Store cj and the interaction mask */
1066             nbnxn_cj_t cjEntry;
1067             cjEntry.cj   = jGrid.cellOffset() + jcluster;
1068             cjEntry.excl = get_imask(excludeSubDiagonal, icluster, jcluster);
1069             nbl->cj.push_back(cjEntry);
1070         }
1071         /* Increase the closing index in the i list */
1072         nbl->ci.back().cj_ind_end = nbl->cj.size();
1073     }
1074 }
1075
1076 #ifdef GMX_NBNXN_SIMD_4XN
1077 #include "gromacs/nbnxm/pairlist_simd_4xm.h"
1078 #endif
1079 #ifdef GMX_NBNXN_SIMD_2XNN
1080 #include "gromacs/nbnxm/pairlist_simd_2xmm.h"
1081 #endif
1082
1083 /* Plain C or SIMD4 code for making a pair list of super-cell sci vs scj.
1084  * Checks bounding box distances and possibly atom pair distances.
1085  */
1086 static void make_cluster_list_supersub(const Grid         &iGrid,
1087                                        const Grid         &jGrid,
1088                                        NbnxnPairlistGpu   *nbl,
1089                                        const int           sci,
1090                                        const int           scj,
1091                                        const bool          excludeSubDiagonal,
1092                                        const int           stride,
1093                                        const real         *x,
1094                                        const real          rlist2,
1095                                        const float         rbb2,
1096                                        int                *numDistanceChecks)
1097 {
1098     NbnxnPairlistGpuWork &work   = *nbl->work;
1099
1100 #if NBNXN_BBXXXX
1101     const float          *pbb_ci = work.iSuperClusterData.bbPacked.data();
1102 #else
1103     const BoundingBox    *bb_ci  = work.iSuperClusterData.bb.data();
1104 #endif
1105
1106     assert(c_nbnxnGpuClusterSize == iGrid.geometry().numAtomsICluster);
1107     assert(c_nbnxnGpuClusterSize == jGrid.geometry().numAtomsICluster);
1108
1109     /* We generate the pairlist mainly based on bounding-box distances
1110      * and do atom pair distance based pruning on the GPU.
1111      * Only if a j-group contains a single cluster-pair, we try to prune
1112      * that pair based on atom distances on the CPU to avoid empty j-groups.
1113      */
1114 #define PRUNE_LIST_CPU_ONE 1
1115 #define PRUNE_LIST_CPU_ALL 0
1116
1117 #if PRUNE_LIST_CPU_ONE
1118     int  ci_last = -1;
1119 #endif
1120
1121     float *d2l = work.distanceBuffer.data();
1122
1123     for (int subc = 0; subc < jGrid.numClustersPerCell()[scj]; subc++)
1124     {
1125         const int    cj4_ind   = work.cj_ind/c_nbnxnGpuJgroupSize;
1126         const int    cj_offset = work.cj_ind - cj4_ind*c_nbnxnGpuJgroupSize;
1127         const int    cj        = scj*c_gpuNumClusterPerCell + subc;
1128
1129         const int    cj_gl     = jGrid.cellOffset()*c_gpuNumClusterPerCell + cj;
1130
1131         int          ci1;
1132         if (excludeSubDiagonal && sci == scj)
1133         {
1134             ci1 = subc + 1;
1135         }
1136         else
1137         {
1138             ci1 = iGrid.numClustersPerCell()[sci];
1139         }
1140
1141 #if NBNXN_BBXXXX
1142         /* Determine all ci1 bb distances in one call with SIMD4 */
1143         const int offset = packedBoundingBoxesIndex(cj) + (cj & (c_packedBoundingBoxesDimSize - 1));
1144         clusterBoundingBoxDistance2_xxxx_simd4(jGrid.packedBoundingBoxes().data() + offset,
1145                                                ci1, pbb_ci, d2l);
1146         *numDistanceChecks += c_nbnxnGpuClusterSize*2;
1147 #endif
1148
1149         int          npair = 0;
1150         unsigned int imask = 0;
1151         /* We use a fixed upper-bound instead of ci1 to help optimization */
1152         for (int ci = 0; ci < c_gpuNumClusterPerCell; ci++)
1153         {
1154             if (ci == ci1)
1155             {
1156                 break;
1157             }
1158
1159 #if !NBNXN_BBXXXX
1160             /* Determine the bb distance between ci and cj */
1161             d2l[ci]             = clusterBoundingBoxDistance2(bb_ci[ci], jGrid.jBoundingBoxes()[cj]);
1162             *numDistanceChecks += 2;
1163 #endif
1164             float d2 = d2l[ci];
1165
1166 #if PRUNE_LIST_CPU_ALL
1167             /* Check if the distance is within the distance where
1168              * we use only the bounding box distance rbb,
1169              * or within the cut-off and there is at least one atom pair
1170              * within the cut-off. This check is very costly.
1171              */
1172             *numDistanceChecks += c_nbnxnGpuClusterSize*c_nbnxnGpuClusterSize;
1173             if (d2 < rbb2 ||
1174                 (d2 < rlist2 &&
1175                  clusterpair_in_range(work, ci, cj_gl, stride, x, rlist2)))
1176 #else
1177             /* Check if the distance between the two bounding boxes
1178              * in within the pair-list cut-off.
1179              */
1180             if (d2 < rlist2)
1181 #endif
1182             {
1183                 /* Flag this i-subcell to be taken into account */
1184                 imask |= (1U << (cj_offset*c_gpuNumClusterPerCell + ci));
1185
1186 #if PRUNE_LIST_CPU_ONE
1187                 ci_last = ci;
1188 #endif
1189
1190                 npair++;
1191             }
1192         }
1193
1194 #if PRUNE_LIST_CPU_ONE
1195         /* If we only found 1 pair, check if any atoms are actually
1196          * within the cut-off, so we could get rid of it.
1197          */
1198         if (npair == 1 && d2l[ci_last] >= rbb2 &&
1199             !clusterpair_in_range(work, ci_last, cj_gl, stride, x, rlist2))
1200         {
1201             imask &= ~(1U << (cj_offset*c_gpuNumClusterPerCell + ci_last));
1202             npair--;
1203         }
1204 #endif
1205
1206         if (npair > 0)
1207         {
1208             /* We have at least one cluster pair: add a j-entry */
1209             if (static_cast<size_t>(cj4_ind) == nbl->cj4.size())
1210             {
1211                 nbl->cj4.resize(nbl->cj4.size() + 1);
1212             }
1213             nbnxn_cj4_t *cj4   = &nbl->cj4[cj4_ind];
1214
1215             cj4->cj[cj_offset] = cj_gl;
1216
1217             /* Set the exclusions for the ci==sj entry.
1218              * Here we don't bother to check if this entry is actually flagged,
1219              * as it will nearly always be in the list.
1220              */
1221             if (excludeSubDiagonal && sci == scj)
1222             {
1223                 set_self_and_newton_excls_supersub(nbl, cj4_ind, cj_offset, subc);
1224             }
1225
1226             /* Copy the cluster interaction mask to the list */
1227             for (int w = 0; w < c_nbnxnGpuClusterpairSplit; w++)
1228             {
1229                 cj4->imei[w].imask |= imask;
1230             }
1231
1232             nbl->work->cj_ind++;
1233
1234             /* Keep the count */
1235             nbl->nci_tot += npair;
1236
1237             /* Increase the closing index in i super-cell list */
1238             nbl->sci.back().cj4_ind_end =
1239                 (nbl->work->cj_ind + c_nbnxnGpuJgroupSize - 1)/c_nbnxnGpuJgroupSize;
1240         }
1241     }
1242 }
1243
1244 /* Returns how many contiguous j-clusters we have starting in the i-list */
1245 template <typename CjListType>
1246 static int numContiguousJClusters(const int                       cjIndexStart,
1247                                   const int                       cjIndexEnd,
1248                                   gmx::ArrayRef<const CjListType> cjList)
1249 {
1250     const int firstJCluster = nblCj(cjList, cjIndexStart);
1251
1252     int       numContiguous = 0;
1253
1254     while (cjIndexStart + numContiguous < cjIndexEnd &&
1255            nblCj(cjList, cjIndexStart + numContiguous) == firstJCluster + numContiguous)
1256     {
1257         numContiguous++;
1258     }
1259
1260     return numContiguous;
1261 }
1262
1263 /*! \internal
1264  * \brief Helper struct for efficient searching for excluded atoms in a j-list
1265  */
1266 struct JListRanges
1267 {
1268     /*! \brief Constructs a j-list range from \p cjList with the given index range */
1269     template <typename CjListType>
1270     JListRanges(int                             cjIndexStart,
1271                 int                             cjIndexEnd,
1272                 gmx::ArrayRef<const CjListType> cjList);
1273
1274     int cjIndexStart; //!< The start index in the j-list
1275     int cjIndexEnd;   //!< The end index in the j-list
1276     int cjFirst;      //!< The j-cluster with index cjIndexStart
1277     int cjLast;       //!< The j-cluster with index cjIndexEnd-1
1278     int numDirect;    //!< Up to cjIndexStart+numDirect the j-clusters are cjFirst + the index offset
1279 };
1280
1281 #ifndef DOXYGEN
1282 template <typename CjListType>
1283 JListRanges::JListRanges(int                             cjIndexStart,
1284                          int                             cjIndexEnd,
1285                          gmx::ArrayRef<const CjListType> cjList) :
1286     cjIndexStart(cjIndexStart),
1287     cjIndexEnd(cjIndexEnd)
1288 {
1289     GMX_ASSERT(cjIndexEnd > cjIndexStart, "JListRanges should only be called with non-empty lists");
1290
1291     cjFirst   = nblCj(cjList, cjIndexStart);
1292     cjLast    = nblCj(cjList, cjIndexEnd - 1);
1293
1294     /* Determine how many contiguous j-cells we have starting
1295      * from the first i-cell. This number can be used to directly
1296      * calculate j-cell indices for excluded atoms.
1297      */
1298     numDirect = numContiguousJClusters(cjIndexStart, cjIndexEnd, cjList);
1299 }
1300 #endif // !DOXYGEN
1301
1302 /* Return the index of \p jCluster in the given range or -1 when not present
1303  *
1304  * Note: This code is executed very often and therefore performance is
1305  *       important. It should be inlined and fully optimized.
1306  */
1307 template <typename CjListType>
1308 static inline int
1309 findJClusterInJList(int                              jCluster,
1310                     const JListRanges               &ranges,
1311                     gmx::ArrayRef<const CjListType>  cjList)
1312 {
1313     int index;
1314
1315     if (jCluster < ranges.cjFirst + ranges.numDirect)
1316     {
1317         /* We can calculate the index directly using the offset */
1318         index = ranges.cjIndexStart + jCluster - ranges.cjFirst;
1319     }
1320     else
1321     {
1322         /* Search for jCluster using bisection */
1323         index           = -1;
1324         int rangeStart  = ranges.cjIndexStart + ranges.numDirect;
1325         int rangeEnd    = ranges.cjIndexEnd;
1326         int rangeMiddle;
1327         while (index == -1 && rangeStart < rangeEnd)
1328         {
1329             rangeMiddle = (rangeStart + rangeEnd) >> 1;
1330
1331             const int clusterMiddle = nblCj(cjList, rangeMiddle);
1332
1333             if (jCluster == clusterMiddle)
1334             {
1335                 index      = rangeMiddle;
1336             }
1337             else if (jCluster < clusterMiddle)
1338             {
1339                 rangeEnd   = rangeMiddle;
1340             }
1341             else
1342             {
1343                 rangeStart = rangeMiddle + 1;
1344             }
1345         }
1346     }
1347
1348     return index;
1349 }
1350
1351 // TODO: Get rid of the two functions below by renaming sci to ci (or something better)
1352
1353 /* Return the i-entry in the list we are currently operating on */
1354 static nbnxn_ci_t *getOpenIEntry(NbnxnPairlistCpu *nbl)
1355 {
1356     return &nbl->ci.back();
1357 }
1358
1359 /* Return the i-entry in the list we are currently operating on */
1360 static nbnxn_sci_t *getOpenIEntry(NbnxnPairlistGpu *nbl)
1361 {
1362     return &nbl->sci.back();
1363 }
1364
1365 /* Set all atom-pair exclusions for a simple type list i-entry
1366  *
1367  * Set all atom-pair exclusions from the topology stored in exclusions
1368  * as masks in the pair-list for simple list entry iEntry.
1369  */
1370 static void
1371 setExclusionsForIEntry(const Nbnxm::GridSet &gridSet,
1372                        NbnxnPairlistCpu     *nbl,
1373                        gmx_bool              diagRemoved,
1374                        int                   na_cj_2log,
1375                        const nbnxn_ci_t     &iEntry,
1376                        const t_blocka       &exclusions)
1377 {
1378     if (iEntry.cj_ind_end == iEntry.cj_ind_start)
1379     {
1380         /* Empty list: no exclusions */
1381         return;
1382     }
1383
1384     const JListRanges        ranges(iEntry.cj_ind_start, iEntry.cj_ind_end, gmx::makeConstArrayRef(nbl->cj));
1385
1386     const int                iCluster = iEntry.ci;
1387
1388     gmx::ArrayRef<const int> cell        = gridSet.cells();
1389     gmx::ArrayRef<const int> atomIndices = gridSet.atomIndices();
1390
1391     /* Loop over the atoms in the i-cluster */
1392     for (int i = 0; i < nbl->na_ci; i++)
1393     {
1394         const int iIndex = iCluster*nbl->na_ci + i;
1395         const int iAtom  = atomIndices[iIndex];
1396         if (iAtom >= 0)
1397         {
1398             /* Loop over the topology-based exclusions for this i-atom */
1399             for (int exclIndex = exclusions.index[iAtom]; exclIndex < exclusions.index[iAtom + 1]; exclIndex++)
1400             {
1401                 const int jAtom = exclusions.a[exclIndex];
1402
1403                 if (jAtom == iAtom)
1404                 {
1405                     /* The self exclusion are already set, save some time */
1406                     continue;
1407                 }
1408
1409                 /* Get the index of the j-atom in the nbnxn atom data */
1410                 const int jIndex = cell[jAtom];
1411
1412                 /* Without shifts we only calculate interactions j>i
1413                  * for one-way pair-lists.
1414                  */
1415                 if (diagRemoved && jIndex <= iIndex)
1416                 {
1417                     continue;
1418                 }
1419
1420                 const int jCluster = (jIndex >> na_cj_2log);
1421
1422                 /* Could the cluster se be in our list? */
1423                 if (jCluster >= ranges.cjFirst && jCluster <= ranges.cjLast)
1424                 {
1425                     const int index =
1426                         findJClusterInJList(jCluster, ranges,
1427                                             gmx::makeConstArrayRef(nbl->cj));
1428
1429                     if (index >= 0)
1430                     {
1431                         /* We found an exclusion, clear the corresponding
1432                          * interaction bit.
1433                          */
1434                         const int innerJ     = jIndex - (jCluster << na_cj_2log);
1435
1436                         nbl->cj[index].excl &= ~(1U << ((i << na_cj_2log) + innerJ));
1437                     }
1438                 }
1439             }
1440         }
1441     }
1442 }
1443
1444 /* Add a new i-entry to the FEP list and copy the i-properties */
1445 static inline void fep_list_new_nri_copy(t_nblist *nlist)
1446 {
1447     /* Add a new i-entry */
1448     nlist->nri++;
1449
1450     assert(nlist->nri < nlist->maxnri);
1451
1452     /* Duplicate the last i-entry, except for jindex, which continues */
1453     nlist->iinr[nlist->nri]   = nlist->iinr[nlist->nri-1];
1454     nlist->shift[nlist->nri]  = nlist->shift[nlist->nri-1];
1455     nlist->gid[nlist->nri]    = nlist->gid[nlist->nri-1];
1456     nlist->jindex[nlist->nri] = nlist->nrj;
1457 }
1458
1459 /* For load balancing of the free-energy lists over threads, we set
1460  * the maximum nrj size of an i-entry to 40. This leads to good
1461  * load balancing in the worst case scenario of a single perturbed
1462  * particle on 16 threads, while not introducing significant overhead.
1463  * Note that half of the perturbed pairs will anyhow end up in very small lists,
1464  * since non perturbed i-particles will see few perturbed j-particles).
1465  */
1466 const int max_nrj_fep = 40;
1467
1468 /* Exclude the perturbed pairs from the Verlet list. This is only done to avoid
1469  * singularities for overlapping particles (0/0), since the charges and
1470  * LJ parameters have been zeroed in the nbnxn data structure.
1471  * Simultaneously make a group pair list for the perturbed pairs.
1472  */
1473 static void make_fep_list(gmx::ArrayRef<const int>  atomIndices,
1474                           const nbnxn_atomdata_t   *nbat,
1475                           NbnxnPairlistCpu         *nbl,
1476                           gmx_bool                  bDiagRemoved,
1477                           nbnxn_ci_t               *nbl_ci,
1478                           real gmx_unused           shx,
1479                           real gmx_unused           shy,
1480                           real gmx_unused           shz,
1481                           real gmx_unused           rlist_fep2,
1482                           const Grid               &iGrid,
1483                           const Grid               &jGrid,
1484                           t_nblist                 *nlist)
1485 {
1486     int      ci, cj_ind_start, cj_ind_end, cja, cjr;
1487     int      nri_max;
1488     int      gid_i = 0, gid_j, gid;
1489     int      egp_shift, egp_mask;
1490     int      gid_cj = 0;
1491     int      ind_i, ind_j, ai, aj;
1492     int      nri;
1493     gmx_bool bFEP_i, bFEP_i_all;
1494
1495     if (nbl_ci->cj_ind_end == nbl_ci->cj_ind_start)
1496     {
1497         /* Empty list */
1498         return;
1499     }
1500
1501     ci = nbl_ci->ci;
1502
1503     cj_ind_start = nbl_ci->cj_ind_start;
1504     cj_ind_end   = nbl_ci->cj_ind_end;
1505
1506     /* In worst case we have alternating energy groups
1507      * and create #atom-pair lists, which means we need the size
1508      * of a cluster pair (na_ci*na_cj) times the number of cj's.
1509      */
1510     nri_max = nbl->na_ci*nbl->na_cj*(cj_ind_end - cj_ind_start);
1511     if (nlist->nri + nri_max > nlist->maxnri)
1512     {
1513         nlist->maxnri = over_alloc_large(nlist->nri + nri_max);
1514         reallocate_nblist(nlist);
1515     }
1516
1517     const int numAtomsJCluster = jGrid.geometry().numAtomsJCluster;
1518
1519     const nbnxn_atomdata_t::Params &nbatParams = nbat->params();
1520
1521     const int ngid = nbatParams.nenergrp;
1522
1523     /* TODO: Consider adding a check in grompp and changing this to an assert */
1524     const int numBitsInEnergyGroupIdsForAtomsInJCluster = sizeof(gid_cj)*8;
1525     if (ngid*numAtomsJCluster > numBitsInEnergyGroupIdsForAtomsInJCluster)
1526     {
1527         gmx_fatal(FARGS, "The Verlet scheme with %dx%d kernels and free-energy only supports up to %zu energy groups",
1528                   iGrid.geometry().numAtomsICluster, numAtomsJCluster,
1529                   (sizeof(gid_cj)*8)/numAtomsJCluster);
1530     }
1531
1532     egp_shift = nbatParams.neg_2log;
1533     egp_mask  = (1 << egp_shift) - 1;
1534
1535     /* Loop over the atoms in the i sub-cell */
1536     bFEP_i_all = TRUE;
1537     for (int i = 0; i < nbl->na_ci; i++)
1538     {
1539         ind_i = ci*nbl->na_ci + i;
1540         ai    = atomIndices[ind_i];
1541         if (ai >= 0)
1542         {
1543             nri                  = nlist->nri;
1544             nlist->jindex[nri+1] = nlist->jindex[nri];
1545             nlist->iinr[nri]     = ai;
1546             /* The actual energy group pair index is set later */
1547             nlist->gid[nri]      = 0;
1548             nlist->shift[nri]    = nbl_ci->shift & NBNXN_CI_SHIFT;
1549
1550             bFEP_i = iGrid.atomIsPerturbed(ci - iGrid.cellOffset(), i);
1551
1552             bFEP_i_all = bFEP_i_all && bFEP_i;
1553
1554             if (nlist->nrj + (cj_ind_end - cj_ind_start)*nbl->na_cj > nlist->maxnrj)
1555             {
1556                 nlist->maxnrj = over_alloc_small(nlist->nrj + (cj_ind_end - cj_ind_start)*nbl->na_cj);
1557                 srenew(nlist->jjnr,     nlist->maxnrj);
1558                 srenew(nlist->excl_fep, nlist->maxnrj);
1559             }
1560
1561             if (ngid > 1)
1562             {
1563                 gid_i = (nbatParams.energrp[ci] >> (egp_shift*i)) & egp_mask;
1564             }
1565
1566             for (int cj_ind = cj_ind_start; cj_ind < cj_ind_end; cj_ind++)
1567             {
1568                 unsigned int fep_cj;
1569
1570                 cja = nbl->cj[cj_ind].cj;
1571
1572                 if (numAtomsJCluster == jGrid.geometry().numAtomsICluster)
1573                 {
1574                     cjr    = cja - jGrid.cellOffset();
1575                     fep_cj = jGrid.fepBits(cjr);
1576                     if (ngid > 1)
1577                     {
1578                         gid_cj = nbatParams.energrp[cja];
1579                     }
1580                 }
1581                 else if (2*numAtomsJCluster == jGrid.geometry().numAtomsICluster)
1582                 {
1583                     cjr    = cja - jGrid.cellOffset()*2;
1584                     /* Extract half of the ci fep/energrp mask */
1585                     fep_cj = (jGrid.fepBits(cjr >> 1) >> ((cjr & 1)*numAtomsJCluster)) & ((1 << numAtomsJCluster) - 1);
1586                     if (ngid > 1)
1587                     {
1588                         gid_cj = nbatParams.energrp[cja >> 1] >> ((cja & 1)*numAtomsJCluster*egp_shift) & ((1 << (numAtomsJCluster*egp_shift)) - 1);
1589                     }
1590                 }
1591                 else
1592                 {
1593                     cjr    = cja - (jGrid.cellOffset() >> 1);
1594                     /* Combine two ci fep masks/energrp */
1595                     fep_cj = jGrid.fepBits(cjr*2) + (jGrid.fepBits(cjr*2 + 1) << jGrid.geometry().numAtomsICluster);
1596                     if (ngid > 1)
1597                     {
1598                         gid_cj = nbatParams.energrp[cja*2] + (nbatParams.energrp[cja*2+1] << (jGrid.geometry().numAtomsICluster*egp_shift));
1599                     }
1600                 }
1601
1602                 if (bFEP_i || fep_cj != 0)
1603                 {
1604                     for (int j = 0; j < nbl->na_cj; j++)
1605                     {
1606                         /* Is this interaction perturbed and not excluded? */
1607                         ind_j = cja*nbl->na_cj + j;
1608                         aj    = atomIndices[ind_j];
1609                         if (aj >= 0 &&
1610                             (bFEP_i || (fep_cj & (1 << j))) &&
1611                             (!bDiagRemoved || ind_j >= ind_i))
1612                         {
1613                             if (ngid > 1)
1614                             {
1615                                 gid_j = (gid_cj >> (j*egp_shift)) & egp_mask;
1616                                 gid   = GID(gid_i, gid_j, ngid);
1617
1618                                 if (nlist->nrj > nlist->jindex[nri] &&
1619                                     nlist->gid[nri] != gid)
1620                                 {
1621                                     /* Energy group pair changed: new list */
1622                                     fep_list_new_nri_copy(nlist);
1623                                     nri = nlist->nri;
1624                                 }
1625                                 nlist->gid[nri] = gid;
1626                             }
1627
1628                             if (nlist->nrj - nlist->jindex[nri] >= max_nrj_fep)
1629                             {
1630                                 fep_list_new_nri_copy(nlist);
1631                                 nri = nlist->nri;
1632                             }
1633
1634                             /* Add it to the FEP list */
1635                             nlist->jjnr[nlist->nrj]     = aj;
1636                             nlist->excl_fep[nlist->nrj] = (nbl->cj[cj_ind].excl >> (i*nbl->na_cj + j)) & 1;
1637                             nlist->nrj++;
1638
1639                             /* Exclude it from the normal list.
1640                              * Note that the charge has been set to zero,
1641                              * but we need to avoid 0/0, as perturbed atoms
1642                              * can be on top of each other.
1643                              */
1644                             nbl->cj[cj_ind].excl &= ~(1U << (i*nbl->na_cj + j));
1645                         }
1646                     }
1647                 }
1648             }
1649
1650             if (nlist->nrj > nlist->jindex[nri])
1651             {
1652                 /* Actually add this new, non-empty, list */
1653                 nlist->nri++;
1654                 nlist->jindex[nlist->nri] = nlist->nrj;
1655             }
1656         }
1657     }
1658
1659     if (bFEP_i_all)
1660     {
1661         /* All interactions are perturbed, we can skip this entry */
1662         nbl_ci->cj_ind_end = cj_ind_start;
1663         nbl->ncjInUse     -= cj_ind_end - cj_ind_start;
1664     }
1665 }
1666
1667 /* Return the index of atom a within a cluster */
1668 static inline int cj_mod_cj4(int cj)
1669 {
1670     return cj & (c_nbnxnGpuJgroupSize - 1);
1671 }
1672
1673 /* Convert a j-cluster to a cj4 group */
1674 static inline int cj_to_cj4(int cj)
1675 {
1676     return cj/c_nbnxnGpuJgroupSize;
1677 }
1678
1679 /* Return the index of an j-atom within a warp */
1680 static inline int a_mod_wj(int a)
1681 {
1682     return a & (c_nbnxnGpuClusterSize/c_nbnxnGpuClusterpairSplit - 1);
1683 }
1684
1685 /* As make_fep_list above, but for super/sub lists. */
1686 static void make_fep_list(gmx::ArrayRef<const int>  atomIndices,
1687                           const nbnxn_atomdata_t   *nbat,
1688                           NbnxnPairlistGpu         *nbl,
1689                           gmx_bool                  bDiagRemoved,
1690                           const nbnxn_sci_t        *nbl_sci,
1691                           real                      shx,
1692                           real                      shy,
1693                           real                      shz,
1694                           real                      rlist_fep2,
1695                           const Grid               &iGrid,
1696                           const Grid               &jGrid,
1697                           t_nblist                 *nlist)
1698 {
1699     int                nri_max;
1700     int                c_abs;
1701     int                ind_i, ind_j, ai, aj;
1702     int                nri;
1703     gmx_bool           bFEP_i;
1704     real               xi, yi, zi;
1705     const nbnxn_cj4_t *cj4;
1706
1707     const int          numJClusterGroups = nbl_sci->numJClusterGroups();
1708     if (numJClusterGroups == 0)
1709     {
1710         /* Empty list */
1711         return;
1712     }
1713
1714     const int sci           = nbl_sci->sci;
1715
1716     const int cj4_ind_start = nbl_sci->cj4_ind_start;
1717     const int cj4_ind_end   = nbl_sci->cj4_ind_end;
1718
1719     /* Here we process one super-cell, max #atoms na_sc, versus a list
1720      * cj4 entries, each with max c_nbnxnGpuJgroupSize cj's, each
1721      * of size na_cj atoms.
1722      * On the GPU we don't support energy groups (yet).
1723      * So for each of the na_sc i-atoms, we need max one FEP list
1724      * for each max_nrj_fep j-atoms.
1725      */
1726     nri_max = nbl->na_sc*nbl->na_cj*(1 + (numJClusterGroups*c_nbnxnGpuJgroupSize)/max_nrj_fep);
1727     if (nlist->nri + nri_max > nlist->maxnri)
1728     {
1729         nlist->maxnri = over_alloc_large(nlist->nri + nri_max);
1730         reallocate_nblist(nlist);
1731     }
1732
1733     /* Loop over the atoms in the i super-cluster */
1734     for (int c = 0; c < c_gpuNumClusterPerCell; c++)
1735     {
1736         c_abs = sci*c_gpuNumClusterPerCell + c;
1737
1738         for (int i = 0; i < nbl->na_ci; i++)
1739         {
1740             ind_i = c_abs*nbl->na_ci + i;
1741             ai    = atomIndices[ind_i];
1742             if (ai >= 0)
1743             {
1744                 nri                  = nlist->nri;
1745                 nlist->jindex[nri+1] = nlist->jindex[nri];
1746                 nlist->iinr[nri]     = ai;
1747                 /* With GPUs, energy groups are not supported */
1748                 nlist->gid[nri]      = 0;
1749                 nlist->shift[nri]    = nbl_sci->shift & NBNXN_CI_SHIFT;
1750
1751                 bFEP_i = iGrid.atomIsPerturbed(c_abs - iGrid.cellOffset()*c_gpuNumClusterPerCell, i);
1752
1753                 xi = nbat->x()[ind_i*nbat->xstride+XX] + shx;
1754                 yi = nbat->x()[ind_i*nbat->xstride+YY] + shy;
1755                 zi = nbat->x()[ind_i*nbat->xstride+ZZ] + shz;
1756
1757                 const int nrjMax = nlist->nrj + numJClusterGroups*c_nbnxnGpuJgroupSize*nbl->na_cj;
1758                 if (nrjMax > nlist->maxnrj)
1759                 {
1760                     nlist->maxnrj = over_alloc_small(nrjMax);
1761                     srenew(nlist->jjnr,     nlist->maxnrj);
1762                     srenew(nlist->excl_fep, nlist->maxnrj);
1763                 }
1764
1765                 for (int cj4_ind = cj4_ind_start; cj4_ind < cj4_ind_end; cj4_ind++)
1766                 {
1767                     cj4 = &nbl->cj4[cj4_ind];
1768
1769                     for (int gcj = 0; gcj < c_nbnxnGpuJgroupSize; gcj++)
1770                     {
1771                         if ((cj4->imei[0].imask & (1U << (gcj*c_gpuNumClusterPerCell + c))) == 0)
1772                         {
1773                             /* Skip this ci for this cj */
1774                             continue;
1775                         }
1776
1777                         const int cjr =
1778                             cj4->cj[gcj] - jGrid.cellOffset()*c_gpuNumClusterPerCell;
1779
1780                         if (bFEP_i || jGrid.clusterIsPerturbed(cjr))
1781                         {
1782                             for (int j = 0; j < nbl->na_cj; j++)
1783                             {
1784                                 /* Is this interaction perturbed and not excluded? */
1785                                 ind_j = (jGrid.cellOffset()*c_gpuNumClusterPerCell + cjr)*nbl->na_cj + j;
1786                                 aj    = atomIndices[ind_j];
1787                                 if (aj >= 0 &&
1788                                     (bFEP_i || jGrid.atomIsPerturbed(cjr, j)) &&
1789                                     (!bDiagRemoved || ind_j >= ind_i))
1790                                 {
1791                                     int           excl_pair;
1792                                     unsigned int  excl_bit;
1793                                     real          dx, dy, dz;
1794
1795                                     const int     jHalf = j/(c_nbnxnGpuClusterSize/c_nbnxnGpuClusterpairSplit);
1796                                     nbnxn_excl_t *excl  =
1797                                         get_exclusion_mask(nbl, cj4_ind, jHalf);
1798
1799                                     excl_pair = a_mod_wj(j)*nbl->na_ci + i;
1800                                     excl_bit  = (1U << (gcj*c_gpuNumClusterPerCell + c));
1801
1802                                     dx = nbat->x()[ind_j*nbat->xstride+XX] - xi;
1803                                     dy = nbat->x()[ind_j*nbat->xstride+YY] - yi;
1804                                     dz = nbat->x()[ind_j*nbat->xstride+ZZ] - zi;
1805
1806                                     /* The unpruned GPU list has more than 2/3
1807                                      * of the atom pairs beyond rlist. Using
1808                                      * this list will cause a lot of overhead
1809                                      * in the CPU FEP kernels, especially
1810                                      * relative to the fast GPU kernels.
1811                                      * So we prune the FEP list here.
1812                                      */
1813                                     if (dx*dx + dy*dy + dz*dz < rlist_fep2)
1814                                     {
1815                                         if (nlist->nrj - nlist->jindex[nri] >= max_nrj_fep)
1816                                         {
1817                                             fep_list_new_nri_copy(nlist);
1818                                             nri = nlist->nri;
1819                                         }
1820
1821                                         /* Add it to the FEP list */
1822                                         nlist->jjnr[nlist->nrj]     = aj;
1823                                         nlist->excl_fep[nlist->nrj] = (excl->pair[excl_pair] & excl_bit) ? 1 : 0;
1824                                         nlist->nrj++;
1825                                     }
1826
1827                                     /* Exclude it from the normal list.
1828                                      * Note that the charge and LJ parameters have
1829                                      * been set to zero, but we need to avoid 0/0,
1830                                      * as perturbed atoms can be on top of each other.
1831                                      */
1832                                     excl->pair[excl_pair] &= ~excl_bit;
1833                                 }
1834                             }
1835
1836                             /* Note that we could mask out this pair in imask
1837                              * if all i- and/or all j-particles are perturbed.
1838                              * But since the perturbed pairs on the CPU will
1839                              * take an order of magnitude more time, the GPU
1840                              * will finish before the CPU and there is no gain.
1841                              */
1842                         }
1843                     }
1844                 }
1845
1846                 if (nlist->nrj > nlist->jindex[nri])
1847                 {
1848                     /* Actually add this new, non-empty, list */
1849                     nlist->nri++;
1850                     nlist->jindex[nlist->nri] = nlist->nrj;
1851                 }
1852             }
1853         }
1854     }
1855 }
1856
1857 /* Set all atom-pair exclusions for a GPU type list i-entry
1858  *
1859  * Sets all atom-pair exclusions from the topology stored in exclusions
1860  * as masks in the pair-list for i-super-cluster list entry iEntry.
1861  */
1862 static void
1863 setExclusionsForIEntry(const Nbnxm::GridSet &gridSet,
1864                        NbnxnPairlistGpu     *nbl,
1865                        gmx_bool              diagRemoved,
1866                        int gmx_unused        na_cj_2log,
1867                        const nbnxn_sci_t    &iEntry,
1868                        const t_blocka       &exclusions)
1869 {
1870     if (iEntry.numJClusterGroups() == 0)
1871     {
1872         /* Empty list */
1873         return;
1874     }
1875
1876     /* Set the search ranges using start and end j-cluster indices.
1877      * Note that here we can not use cj4_ind_end, since the last cj4
1878      * can be only partially filled, so we use cj_ind.
1879      */
1880     const JListRanges ranges(iEntry.cj4_ind_start*c_nbnxnGpuJgroupSize,
1881                              nbl->work->cj_ind,
1882                              gmx::makeConstArrayRef(nbl->cj4));
1883
1884     GMX_ASSERT(nbl->na_ci == c_nbnxnGpuClusterSize, "na_ci should match the GPU cluster size");
1885     constexpr int            c_clusterSize      = c_nbnxnGpuClusterSize;
1886     constexpr int            c_superClusterSize = c_nbnxnGpuNumClusterPerSupercluster*c_nbnxnGpuClusterSize;
1887
1888     const int                iSuperCluster = iEntry.sci;
1889
1890     gmx::ArrayRef<const int> atomIndices   = gridSet.atomIndices();
1891     gmx::ArrayRef<const int> cell          = gridSet.cells();
1892
1893     /* Loop over the atoms in the i super-cluster */
1894     for (int i = 0; i < c_superClusterSize; i++)
1895     {
1896         const int iIndex = iSuperCluster*c_superClusterSize + i;
1897         const int iAtom  = atomIndices[iIndex];
1898         if (iAtom >= 0)
1899         {
1900             const int iCluster = i/c_clusterSize;
1901
1902             /* Loop over the topology-based exclusions for this i-atom */
1903             for (int exclIndex = exclusions.index[iAtom]; exclIndex < exclusions.index[iAtom + 1]; exclIndex++)
1904             {
1905                 const int jAtom = exclusions.a[exclIndex];
1906
1907                 if (jAtom == iAtom)
1908                 {
1909                     /* The self exclusions are already set, save some time */
1910                     continue;
1911                 }
1912
1913                 /* Get the index of the j-atom in the nbnxn atom data */
1914                 const int jIndex = cell[jAtom];
1915
1916                 /* Without shifts we only calculate interactions j>i
1917                  * for one-way pair-lists.
1918                  */
1919                 /* NOTE: We would like to use iIndex on the right hand side,
1920                  * but that makes this routine 25% slower with gcc6/7.
1921                  * Even using c_superClusterSize makes it slower.
1922                  * Either of these changes triggers peeling of the exclIndex
1923                  * loop, which apparently leads to far less efficient code.
1924                  */
1925                 if (diagRemoved && jIndex <= iSuperCluster*nbl->na_sc + i)
1926                 {
1927                     continue;
1928                 }
1929
1930                 const int jCluster = jIndex/c_clusterSize;
1931
1932                 /* Check whether the cluster is in our list? */
1933                 if (jCluster >= ranges.cjFirst && jCluster <= ranges.cjLast)
1934                 {
1935                     const int index =
1936                         findJClusterInJList(jCluster, ranges,
1937                                             gmx::makeConstArrayRef(nbl->cj4));
1938
1939                     if (index >= 0)
1940                     {
1941                         /* We found an exclusion, clear the corresponding
1942                          * interaction bit.
1943                          */
1944                         const unsigned int pairMask = (1U << (cj_mod_cj4(index)*c_gpuNumClusterPerCell + iCluster));
1945                         /* Check if the i-cluster interacts with the j-cluster */
1946                         if (nbl_imask0(nbl, index) & pairMask)
1947                         {
1948                             const int innerI = (i      & (c_clusterSize - 1));
1949                             const int innerJ = (jIndex & (c_clusterSize - 1));
1950
1951                             /* Determine which j-half (CUDA warp) we are in */
1952                             const int     jHalf = innerJ/(c_clusterSize/c_nbnxnGpuClusterpairSplit);
1953
1954                             nbnxn_excl_t *interactionMask =
1955                                 get_exclusion_mask(nbl, cj_to_cj4(index), jHalf);
1956
1957                             interactionMask->pair[a_mod_wj(innerJ)*c_clusterSize + innerI] &= ~pairMask;
1958                         }
1959                     }
1960                 }
1961             }
1962         }
1963     }
1964 }
1965
1966 /* Make a new ci entry at the back of nbl->ci */
1967 static void addNewIEntry(NbnxnPairlistCpu *nbl, int ci, int shift, int flags)
1968 {
1969     nbnxn_ci_t ciEntry;
1970     ciEntry.ci            = ci;
1971     ciEntry.shift         = shift;
1972     /* Store the interaction flags along with the shift */
1973     ciEntry.shift        |= flags;
1974     ciEntry.cj_ind_start  = nbl->cj.size();
1975     ciEntry.cj_ind_end    = nbl->cj.size();
1976     nbl->ci.push_back(ciEntry);
1977 }
1978
1979 /* Make a new sci entry at index nbl->nsci */
1980 static void addNewIEntry(NbnxnPairlistGpu *nbl, int sci, int shift, int gmx_unused flags)
1981 {
1982     nbnxn_sci_t sciEntry;
1983     sciEntry.sci           = sci;
1984     sciEntry.shift         = shift;
1985     sciEntry.cj4_ind_start = nbl->cj4.size();
1986     sciEntry.cj4_ind_end   = nbl->cj4.size();
1987
1988     nbl->sci.push_back(sciEntry);
1989 }
1990
1991 /* Sort the simple j-list cj on exclusions.
1992  * Entries with exclusions will all be sorted to the beginning of the list.
1993  */
1994 static void sort_cj_excl(nbnxn_cj_t *cj, int ncj,
1995                          NbnxnPairlistCpuWork *work)
1996 {
1997     work->cj.resize(ncj);
1998
1999     /* Make a list of the j-cells involving exclusions */
2000     int jnew = 0;
2001     for (int j = 0; j < ncj; j++)
2002     {
2003         if (cj[j].excl != NBNXN_INTERACTION_MASK_ALL)
2004         {
2005             work->cj[jnew++] = cj[j];
2006         }
2007     }
2008     /* Check if there are exclusions at all or not just the first entry */
2009     if (!((jnew == 0) ||
2010           (jnew == 1 && cj[0].excl != NBNXN_INTERACTION_MASK_ALL)))
2011     {
2012         for (int j = 0; j < ncj; j++)
2013         {
2014             if (cj[j].excl == NBNXN_INTERACTION_MASK_ALL)
2015             {
2016                 work->cj[jnew++] = cj[j];
2017             }
2018         }
2019         for (int j = 0; j < ncj; j++)
2020         {
2021             cj[j] = work->cj[j];
2022         }
2023     }
2024 }
2025
2026 /* Close this simple list i entry */
2027 static void closeIEntry(NbnxnPairlistCpu    *nbl,
2028                         int gmx_unused       sp_max_av,
2029                         gmx_bool gmx_unused  progBal,
2030                         float gmx_unused     nsp_tot_est,
2031                         int gmx_unused       thread,
2032                         int gmx_unused       nthread)
2033 {
2034     nbnxn_ci_t &ciEntry = nbl->ci.back();
2035
2036     /* All content of the new ci entry have already been filled correctly,
2037      * we only need to sort and increase counts or remove the entry when empty.
2038      */
2039     const int jlen = ciEntry.cj_ind_end - ciEntry.cj_ind_start;
2040     if (jlen > 0)
2041     {
2042         sort_cj_excl(nbl->cj.data() + ciEntry.cj_ind_start, jlen, nbl->work.get());
2043
2044         /* The counts below are used for non-bonded pair/flop counts
2045          * and should therefore match the available kernel setups.
2046          */
2047         if (!(ciEntry.shift & NBNXN_CI_DO_COUL(0)))
2048         {
2049             nbl->work->ncj_noq += jlen;
2050         }
2051         else if ((ciEntry.shift & NBNXN_CI_HALF_LJ(0)) ||
2052                  !(ciEntry.shift & NBNXN_CI_DO_LJ(0)))
2053         {
2054             nbl->work->ncj_hlj += jlen;
2055         }
2056     }
2057     else
2058     {
2059         /* Entry is empty: remove it  */
2060         nbl->ci.pop_back();
2061     }
2062 }
2063
2064 /* Split sci entry for load balancing on the GPU.
2065  * Splitting ensures we have enough lists to fully utilize the whole GPU.
2066  * With progBal we generate progressively smaller lists, which improves
2067  * load balancing. As we only know the current count on our own thread,
2068  * we will need to estimate the current total amount of i-entries.
2069  * As the lists get concatenated later, this estimate depends
2070  * both on nthread and our own thread index.
2071  */
2072 static void split_sci_entry(NbnxnPairlistGpu *nbl,
2073                             int nsp_target_av,
2074                             gmx_bool progBal, float nsp_tot_est,
2075                             int thread, int nthread)
2076 {
2077     int nsp_max;
2078
2079     if (progBal)
2080     {
2081         float nsp_est;
2082
2083         /* Estimate the total numbers of ci's of the nblist combined
2084          * over all threads using the target number of ci's.
2085          */
2086         nsp_est = (nsp_tot_est*thread)/nthread + nbl->nci_tot;
2087
2088         /* The first ci blocks should be larger, to avoid overhead.
2089          * The last ci blocks should be smaller, to improve load balancing.
2090          * The factor 3/2 makes the first block 3/2 times the target average
2091          * and ensures that the total number of blocks end up equal to
2092          * that of equally sized blocks of size nsp_target_av.
2093          */
2094         nsp_max = static_cast<int>(nsp_target_av*(nsp_tot_est*1.5/(nsp_est + nsp_tot_est)));
2095     }
2096     else
2097     {
2098         nsp_max = nsp_target_av;
2099     }
2100
2101     const int cj4_start = nbl->sci.back().cj4_ind_start;
2102     const int cj4_end   = nbl->sci.back().cj4_ind_end;
2103     const int j4len     = cj4_end - cj4_start;
2104
2105     if (j4len > 1 && j4len*c_gpuNumClusterPerCell*c_nbnxnGpuJgroupSize > nsp_max)
2106     {
2107         /* Modify the last ci entry and process the cj4's again */
2108
2109         int nsp        = 0;
2110         int nsp_sci    = 0;
2111         int nsp_cj4_e  = 0;
2112         int nsp_cj4    = 0;
2113         for (int cj4 = cj4_start; cj4 < cj4_end; cj4++)
2114         {
2115             int nsp_cj4_p = nsp_cj4;
2116             /* Count the number of cluster pairs in this cj4 group */
2117             nsp_cj4   = 0;
2118             for (int p = 0; p < c_gpuNumClusterPerCell*c_nbnxnGpuJgroupSize; p++)
2119             {
2120                 nsp_cj4 += (nbl->cj4[cj4].imei[0].imask >> p) & 1;
2121             }
2122
2123             /* If adding the current cj4 with nsp_cj4 pairs get us further
2124              * away from our target nsp_max, split the list before this cj4.
2125              */
2126             if (nsp > 0 && nsp_max - nsp < nsp + nsp_cj4 - nsp_max)
2127             {
2128                 /* Split the list at cj4 */
2129                 nbl->sci.back().cj4_ind_end = cj4;
2130                 /* Create a new sci entry */
2131                 nbnxn_sci_t sciNew;
2132                 sciNew.sci           = nbl->sci.back().sci;
2133                 sciNew.shift         = nbl->sci.back().shift;
2134                 sciNew.cj4_ind_start = cj4;
2135                 nbl->sci.push_back(sciNew);
2136
2137                 nsp_sci              = nsp;
2138                 nsp_cj4_e            = nsp_cj4_p;
2139                 nsp                  = 0;
2140             }
2141             nsp += nsp_cj4;
2142         }
2143
2144         /* Put the remaining cj4's in the last sci entry */
2145         nbl->sci.back().cj4_ind_end = cj4_end;
2146
2147         /* Possibly balance out the last two sci's
2148          * by moving the last cj4 of the second last sci.
2149          */
2150         if (nsp_sci - nsp_cj4_e >= nsp + nsp_cj4_e)
2151         {
2152             GMX_ASSERT(nbl->sci.size() >= 2, "We expect at least two elements");
2153             nbl->sci[nbl->sci.size() - 2].cj4_ind_end--;
2154             nbl->sci[nbl->sci.size() - 1].cj4_ind_start--;
2155         }
2156     }
2157 }
2158
2159 /* Clost this super/sub list i entry */
2160 static void closeIEntry(NbnxnPairlistGpu *nbl,
2161                         int nsp_max_av,
2162                         gmx_bool progBal, float nsp_tot_est,
2163                         int thread, int nthread)
2164 {
2165     nbnxn_sci_t &sciEntry = *getOpenIEntry(nbl);
2166
2167     /* All content of the new ci entry have already been filled correctly,
2168      * we only need to, potentially, split or remove the entry when empty.
2169      */
2170     int j4len = sciEntry.numJClusterGroups();
2171     if (j4len > 0)
2172     {
2173         /* We can only have complete blocks of 4 j-entries in a list,
2174          * so round the count up before closing.
2175          */
2176         int ncj4          = (nbl->work->cj_ind + c_nbnxnGpuJgroupSize - 1)/c_nbnxnGpuJgroupSize;
2177         nbl->work->cj_ind = ncj4*c_nbnxnGpuJgroupSize;
2178
2179         if (nsp_max_av > 0)
2180         {
2181             /* Measure the size of the new entry and potentially split it */
2182             split_sci_entry(nbl, nsp_max_av, progBal, nsp_tot_est,
2183                             thread, nthread);
2184         }
2185     }
2186     else
2187     {
2188         /* Entry is empty: remove it  */
2189         nbl->sci.pop_back();
2190     }
2191 }
2192
2193 /* Syncs the working array before adding another grid pair to the GPU list */
2194 static void sync_work(NbnxnPairlistCpu gmx_unused *nbl)
2195 {
2196 }
2197
2198 /* Syncs the working array before adding another grid pair to the GPU list */
2199 static void sync_work(NbnxnPairlistGpu *nbl)
2200 {
2201     nbl->work->cj_ind   = nbl->cj4.size()*c_nbnxnGpuJgroupSize;
2202 }
2203
2204 /* Clears an NbnxnPairlistCpu data structure */
2205 static void clear_pairlist(NbnxnPairlistCpu *nbl)
2206 {
2207     nbl->ci.clear();
2208     nbl->cj.clear();
2209     nbl->ncjInUse      = 0;
2210     nbl->nci_tot       = 0;
2211     nbl->ciOuter.clear();
2212     nbl->cjOuter.clear();
2213
2214     nbl->work->ncj_noq = 0;
2215     nbl->work->ncj_hlj = 0;
2216 }
2217
2218 /* Clears an NbnxnPairlistGpu data structure */
2219 static void clear_pairlist(NbnxnPairlistGpu *nbl)
2220 {
2221     nbl->sci.clear();
2222     nbl->cj4.clear();
2223     nbl->excl.resize(1);
2224     nbl->nci_tot = 0;
2225 }
2226
2227 /* Clears a group scheme pair list */
2228 static void clear_pairlist_fep(t_nblist *nl)
2229 {
2230     nl->nri = 0;
2231     nl->nrj = 0;
2232     if (nl->jindex == nullptr)
2233     {
2234         snew(nl->jindex, 1);
2235     }
2236     nl->jindex[0] = 0;
2237 }
2238
2239 /* Sets a simple list i-cell bounding box, including PBC shift */
2240 static inline void set_icell_bb_simple(gmx::ArrayRef<const BoundingBox> bb,
2241                                        int ci,
2242                                        real shx, real shy, real shz,
2243                                        BoundingBox *bb_ci)
2244 {
2245     bb_ci->lower.x = bb[ci].lower.x + shx;
2246     bb_ci->lower.y = bb[ci].lower.y + shy;
2247     bb_ci->lower.z = bb[ci].lower.z + shz;
2248     bb_ci->upper.x = bb[ci].upper.x + shx;
2249     bb_ci->upper.y = bb[ci].upper.y + shy;
2250     bb_ci->upper.z = bb[ci].upper.z + shz;
2251 }
2252
2253 /* Sets a simple list i-cell bounding box, including PBC shift */
2254 static inline void set_icell_bb(const Grid &iGrid,
2255                                 int ci,
2256                                 real shx, real shy, real shz,
2257                                 NbnxnPairlistCpuWork *work)
2258 {
2259     set_icell_bb_simple(iGrid.iBoundingBoxes(), ci, shx, shy, shz,
2260                         &work->iClusterData.bb[0]);
2261 }
2262
2263 #if NBNXN_BBXXXX
2264 /* Sets a super-cell and sub cell bounding boxes, including PBC shift */
2265 static void set_icell_bbxxxx_supersub(gmx::ArrayRef<const float> bb,
2266                                       int ci,
2267                                       real shx, real shy, real shz,
2268                                       float *bb_ci)
2269 {
2270     constexpr int cellBBStride = packedBoundingBoxesIndex(c_gpuNumClusterPerCell);
2271     constexpr int pbbStride    = c_packedBoundingBoxesDimSize;
2272     const int     ia           = ci*cellBBStride;
2273     for (int m = 0; m < cellBBStride; m += c_packedBoundingBoxesSize)
2274     {
2275         for (int i = 0; i < pbbStride; i++)
2276         {
2277             bb_ci[m + 0*pbbStride + i] = bb[ia + m + 0*pbbStride + i] + shx;
2278             bb_ci[m + 1*pbbStride + i] = bb[ia + m + 1*pbbStride + i] + shy;
2279             bb_ci[m + 2*pbbStride + i] = bb[ia + m + 2*pbbStride + i] + shz;
2280             bb_ci[m + 3*pbbStride + i] = bb[ia + m + 3*pbbStride + i] + shx;
2281             bb_ci[m + 4*pbbStride + i] = bb[ia + m + 4*pbbStride + i] + shy;
2282             bb_ci[m + 5*pbbStride + i] = bb[ia + m + 5*pbbStride + i] + shz;
2283         }
2284     }
2285 }
2286 #endif
2287
2288 /* Sets a super-cell and sub cell bounding boxes, including PBC shift */
2289 gmx_unused static void set_icell_bb_supersub(gmx::ArrayRef<const BoundingBox> bb,
2290                                              int ci,
2291                                              real shx, real shy, real shz,
2292                                              BoundingBox *bb_ci)
2293 {
2294     for (int i = 0; i < c_gpuNumClusterPerCell; i++)
2295     {
2296         set_icell_bb_simple(bb, ci*c_gpuNumClusterPerCell+i,
2297                             shx, shy, shz,
2298                             &bb_ci[i]);
2299     }
2300 }
2301
2302 /* Sets a super-cell and sub cell bounding boxes, including PBC shift */
2303 gmx_unused static void set_icell_bb(const Grid &iGrid,
2304                                     int ci,
2305                                     real shx, real shy, real shz,
2306                                     NbnxnPairlistGpuWork *work)
2307 {
2308 #if NBNXN_BBXXXX
2309     set_icell_bbxxxx_supersub(iGrid.packedBoundingBoxes(), ci, shx, shy, shz,
2310                               work->iSuperClusterData.bbPacked.data());
2311 #else
2312     set_icell_bb_supersub(iGrid.iBoundingBoxes(), ci, shx, shy, shz,
2313                           work->iSuperClusterData.bb.data());
2314 #endif
2315 }
2316
2317 /* Copies PBC shifted i-cell atom coordinates x,y,z to working array */
2318 static void icell_set_x_simple(int ci,
2319                                real shx, real shy, real shz,
2320                                int stride, const real *x,
2321                                NbnxnPairlistCpuWork::IClusterData *iClusterData)
2322 {
2323     const int ia = ci*c_nbnxnCpuIClusterSize;
2324
2325     for (int i = 0; i < c_nbnxnCpuIClusterSize; i++)
2326     {
2327         iClusterData->x[i*STRIDE_XYZ+XX] = x[(ia+i)*stride+XX] + shx;
2328         iClusterData->x[i*STRIDE_XYZ+YY] = x[(ia+i)*stride+YY] + shy;
2329         iClusterData->x[i*STRIDE_XYZ+ZZ] = x[(ia+i)*stride+ZZ] + shz;
2330     }
2331 }
2332
2333 static void icell_set_x(int ci,
2334                         real shx, real shy, real shz,
2335                         int stride, const real *x,
2336                         const Nbnxm::KernelType kernelType,
2337                         NbnxnPairlistCpuWork *work)
2338 {
2339     switch (kernelType)
2340     {
2341 #if GMX_SIMD
2342 #ifdef GMX_NBNXN_SIMD_4XN
2343         case Nbnxm::KernelType::Cpu4xN_Simd_4xN:
2344             icell_set_x_simd_4xn(ci, shx, shy, shz, stride, x, work);
2345             break;
2346 #endif
2347 #ifdef GMX_NBNXN_SIMD_2XNN
2348         case Nbnxm::KernelType::Cpu4xN_Simd_2xNN:
2349             icell_set_x_simd_2xnn(ci, shx, shy, shz, stride, x, work);
2350             break;
2351 #endif
2352 #endif
2353         case Nbnxm::KernelType::Cpu4x4_PlainC:
2354             icell_set_x_simple(ci, shx, shy, shz, stride, x, &work->iClusterData);
2355             break;
2356         default:
2357             GMX_ASSERT(false, "Unhandled case");
2358             break;
2359     }
2360 }
2361
2362 /* Copies PBC shifted super-cell atom coordinates x,y,z to working array */
2363 static void icell_set_x(int ci,
2364                         real shx, real shy, real shz,
2365                         int stride, const real *x,
2366                         Nbnxm::KernelType gmx_unused kernelType,
2367                         NbnxnPairlistGpuWork *work)
2368 {
2369 #if !GMX_SIMD4_HAVE_REAL
2370
2371     real * x_ci = work->iSuperClusterData.x.data();
2372
2373     int    ia = ci*c_gpuNumClusterPerCell*c_nbnxnGpuClusterSize;
2374     for (int i = 0; i < c_gpuNumClusterPerCell*c_nbnxnGpuClusterSize; i++)
2375     {
2376         x_ci[i*DIM + XX] = x[(ia+i)*stride + XX] + shx;
2377         x_ci[i*DIM + YY] = x[(ia+i)*stride + YY] + shy;
2378         x_ci[i*DIM + ZZ] = x[(ia+i)*stride + ZZ] + shz;
2379     }
2380
2381 #else /* !GMX_SIMD4_HAVE_REAL */
2382
2383     real * x_ci = work->iSuperClusterData.xSimd.data();
2384
2385     for (int si = 0; si < c_gpuNumClusterPerCell; si++)
2386     {
2387         for (int i = 0; i < c_nbnxnGpuClusterSize; i += GMX_SIMD4_WIDTH)
2388         {
2389             int io = si*c_nbnxnGpuClusterSize + i;
2390             int ia = ci*c_gpuNumClusterPerCell*c_nbnxnGpuClusterSize + io;
2391             for (int j = 0; j < GMX_SIMD4_WIDTH; j++)
2392             {
2393                 x_ci[io*DIM + j + XX*GMX_SIMD4_WIDTH] = x[(ia + j)*stride + XX] + shx;
2394                 x_ci[io*DIM + j + YY*GMX_SIMD4_WIDTH] = x[(ia + j)*stride + YY] + shy;
2395                 x_ci[io*DIM + j + ZZ*GMX_SIMD4_WIDTH] = x[(ia + j)*stride + ZZ] + shz;
2396             }
2397         }
2398     }
2399
2400 #endif /* !GMX_SIMD4_HAVE_REAL */
2401 }
2402
2403 static real minimum_subgrid_size_xy(const Grid &grid)
2404 {
2405     const Grid::Dimensions &dims = grid.dimensions();
2406
2407     if (grid.geometry().isSimple)
2408     {
2409         return std::min(dims.cellSize[XX], dims.cellSize[YY]);
2410     }
2411     else
2412     {
2413         return std::min(dims.cellSize[XX]/c_gpuNumClusterPerCellX,
2414                         dims.cellSize[YY]/c_gpuNumClusterPerCellY);
2415     }
2416 }
2417
2418 static real effective_buffer_1x1_vs_MxN(const Grid &iGrid,
2419                                         const Grid &jGrid)
2420 {
2421     const real eff_1x1_buffer_fac_overest = 0.1;
2422
2423     /* Determine an atom-pair list cut-off buffer size for atom pairs,
2424      * to be added to rlist (including buffer) used for MxN.
2425      * This is for converting an MxN list to a 1x1 list. This means we can't
2426      * use the normal buffer estimate, as we have an MxN list in which
2427      * some atom pairs beyond rlist are missing. We want to capture
2428      * the beneficial effect of buffering by extra pairs just outside rlist,
2429      * while removing the useless pairs that are further away from rlist.
2430      * (Also the buffer could have been set manually not using the estimate.)
2431      * This buffer size is an overestimate.
2432      * We add 10% of the smallest grid sub-cell dimensions.
2433      * Note that the z-size differs per cell and we don't use this,
2434      * so we overestimate.
2435      * With PME, the 10% value gives a buffer that is somewhat larger
2436      * than the effective buffer with a tolerance of 0.005 kJ/mol/ps.
2437      * Smaller tolerances or using RF lead to a smaller effective buffer,
2438      * so 10% gives a safe overestimate.
2439      */
2440     return eff_1x1_buffer_fac_overest*(minimum_subgrid_size_xy(iGrid) +
2441                                        minimum_subgrid_size_xy(jGrid));
2442 }
2443
2444 /* Estimates the interaction volume^2 for non-local interactions */
2445 static real nonlocal_vol2(const struct gmx_domdec_zones_t *zones, const rvec ls, real r)
2446 {
2447     real cl, ca, za;
2448     real vold_est;
2449     real vol2_est_tot;
2450
2451     vol2_est_tot = 0;
2452
2453     /* Here we simply add up the volumes of 1, 2 or 3 1D decomposition
2454      * not home interaction volume^2. As these volumes are not additive,
2455      * this is an overestimate, but it would only be significant in the limit
2456      * of small cells, where we anyhow need to split the lists into
2457      * as small parts as possible.
2458      */
2459
2460     for (int z = 0; z < zones->n; z++)
2461     {
2462         if (zones->shift[z][XX] + zones->shift[z][YY] + zones->shift[z][ZZ] == 1)
2463         {
2464             cl = 0;
2465             ca = 1;
2466             za = 1;
2467             for (int d = 0; d < DIM; d++)
2468             {
2469                 if (zones->shift[z][d] == 0)
2470                 {
2471                     cl += 0.5*ls[d];
2472                     ca *= ls[d];
2473                     za *= zones->size[z].x1[d] - zones->size[z].x0[d];
2474                 }
2475             }
2476
2477             /* 4 octants of a sphere */
2478             vold_est  = 0.25*M_PI*r*r*r*r;
2479             /* 4 quarter pie slices on the edges */
2480             vold_est += 4*cl*M_PI/6.0*r*r*r;
2481             /* One rectangular volume on a face */
2482             vold_est += ca*0.5*r*r;
2483
2484             vol2_est_tot += vold_est*za;
2485         }
2486     }
2487
2488     return vol2_est_tot;
2489 }
2490
2491 /* Estimates the average size of a full j-list for super/sub setup */
2492 static void get_nsubpair_target(const Nbnxm::GridSet      &gridSet,
2493                                 const InteractionLocality  iloc,
2494                                 const real                 rlist,
2495                                 const int                  min_ci_balanced,
2496                                 int                       *nsubpair_target,
2497                                 float                     *nsubpair_tot_est)
2498 {
2499     /* The target value of 36 seems to be the optimum for Kepler.
2500      * Maxwell is less sensitive to the exact value.
2501      */
2502     const int           nsubpair_target_min = 36;
2503     real                r_eff_sup, vol_est, nsp_est, nsp_est_nl;
2504
2505     const Grid         &grid = gridSet.grids()[0];
2506
2507     /* We don't need to balance list sizes if:
2508      * - We didn't request balancing.
2509      * - The number of grid cells >= the number of lists requested,
2510      *   since we will always generate at least #cells lists.
2511      * - We don't have any cells, since then there won't be any lists.
2512      */
2513     if (min_ci_balanced <= 0 || grid.numCells() >= min_ci_balanced || grid.numCells() == 0)
2514     {
2515         /* nsubpair_target==0 signals no balancing */
2516         *nsubpair_target  = 0;
2517         *nsubpair_tot_est = 0;
2518
2519         return;
2520     }
2521
2522     gmx::RVec               ls;
2523     const int               numAtomsCluster = grid.geometry().numAtomsICluster;
2524     const Grid::Dimensions &dims            = grid.dimensions();
2525
2526     ls[XX] = dims.cellSize[XX]/c_gpuNumClusterPerCellX;
2527     ls[YY] = dims.cellSize[YY]/c_gpuNumClusterPerCellY;
2528     ls[ZZ] = numAtomsCluster/(dims.atomDensity*ls[XX]*ls[YY]);
2529
2530     /* The formulas below are a heuristic estimate of the average nsj per si*/
2531     r_eff_sup = rlist + nbnxn_get_rlist_effective_inc(numAtomsCluster, ls);
2532
2533     if (!gridSet.domainSetup().haveMultipleDomains ||
2534         gridSet.domainSetup().zones->n == 1)
2535     {
2536         nsp_est_nl = 0;
2537     }
2538     else
2539     {
2540         nsp_est_nl =
2541             gmx::square(dims.atomDensity/numAtomsCluster)*
2542             nonlocal_vol2(gridSet.domainSetup().zones, ls, r_eff_sup);
2543     }
2544
2545     if (iloc == InteractionLocality::Local)
2546     {
2547         /* Sub-cell interacts with itself */
2548         vol_est  = ls[XX]*ls[YY]*ls[ZZ];
2549         /* 6/2 rectangular volume on the faces */
2550         vol_est += (ls[XX]*ls[YY] + ls[XX]*ls[ZZ] + ls[YY]*ls[ZZ])*r_eff_sup;
2551         /* 12/2 quarter pie slices on the edges */
2552         vol_est += 2*(ls[XX] + ls[YY] + ls[ZZ])*0.25*M_PI*gmx::square(r_eff_sup);
2553         /* 4 octants of a sphere */
2554         vol_est += 0.5*4.0/3.0*M_PI*gmx::power3(r_eff_sup);
2555
2556         /* Estimate the number of cluster pairs as the local number of
2557          * clusters times the volume they interact with times the density.
2558          */
2559         nsp_est = grid.numClusters()*vol_est*dims.atomDensity/numAtomsCluster;
2560
2561         /* Subtract the non-local pair count */
2562         nsp_est -= nsp_est_nl;
2563
2564         /* For small cut-offs nsp_est will be an underesimate.
2565          * With DD nsp_est_nl is an overestimate so nsp_est can get negative.
2566          * So to avoid too small or negative nsp_est we set a minimum of
2567          * all cells interacting with all 3^3 direct neighbors (3^3-1)/2+1=14.
2568          * This might be a slight overestimate for small non-periodic groups of
2569          * atoms as will occur for a local domain with DD, but for small
2570          * groups of atoms we'll anyhow be limited by nsubpair_target_min,
2571          * so this overestimation will not matter.
2572          */
2573         nsp_est = std::max(nsp_est, grid.numClusters()*14._real);
2574
2575         if (debug)
2576         {
2577             fprintf(debug, "nsp_est local %5.1f non-local %5.1f\n",
2578                     nsp_est, nsp_est_nl);
2579         }
2580     }
2581     else
2582     {
2583         nsp_est = nsp_est_nl;
2584     }
2585
2586     /* Thus the (average) maximum j-list size should be as follows.
2587      * Since there is overhead, we shouldn't make the lists too small
2588      * (and we can't chop up j-groups) so we use a minimum target size of 36.
2589      */
2590     *nsubpair_target  = std::max(nsubpair_target_min,
2591                                  roundToInt(nsp_est/min_ci_balanced));
2592     *nsubpair_tot_est = static_cast<int>(nsp_est);
2593
2594     if (debug)
2595     {
2596         fprintf(debug, "nbl nsp estimate %.1f, nsubpair_target %d\n",
2597                 nsp_est, *nsubpair_target);
2598     }
2599 }
2600
2601 /* Debug list print function */
2602 static void print_nblist_ci_cj(FILE                   *fp,
2603                                const NbnxnPairlistCpu &nbl)
2604 {
2605     for (const nbnxn_ci_t &ciEntry : nbl.ci)
2606     {
2607         fprintf(fp, "ci %4d  shift %2d  ncj %3d\n",
2608                 ciEntry.ci, ciEntry.shift,
2609                 ciEntry.cj_ind_end - ciEntry.cj_ind_start);
2610
2611         for (int j = ciEntry.cj_ind_start; j < ciEntry.cj_ind_end; j++)
2612         {
2613             fprintf(fp, "  cj %5d  imask %x\n",
2614                     nbl.cj[j].cj,
2615                     nbl.cj[j].excl);
2616         }
2617     }
2618 }
2619
2620 /* Debug list print function */
2621 static void print_nblist_sci_cj(FILE                   *fp,
2622                                 const NbnxnPairlistGpu &nbl)
2623 {
2624     for (const nbnxn_sci_t &sci : nbl.sci)
2625     {
2626         fprintf(fp, "ci %4d  shift %2d  ncj4 %2d\n",
2627                 sci.sci, sci.shift,
2628                 sci.numJClusterGroups());
2629
2630         int ncp = 0;
2631         for (int j4 = sci.cj4_ind_start; j4 < sci.cj4_ind_end; j4++)
2632         {
2633             for (int j = 0; j < c_nbnxnGpuJgroupSize; j++)
2634             {
2635                 fprintf(fp, "  sj %5d  imask %x\n",
2636                         nbl.cj4[j4].cj[j],
2637                         nbl.cj4[j4].imei[0].imask);
2638                 for (int si = 0; si < c_gpuNumClusterPerCell; si++)
2639                 {
2640                     if (nbl.cj4[j4].imei[0].imask & (1U << (j*c_gpuNumClusterPerCell + si)))
2641                     {
2642                         ncp++;
2643                     }
2644                 }
2645             }
2646         }
2647         fprintf(fp, "ci %4d  shift %2d  ncj4 %2d ncp %3d\n",
2648                 sci.sci, sci.shift,
2649                 sci.numJClusterGroups(),
2650                 ncp);
2651     }
2652 }
2653
2654 /* Combine pair lists *nbl generated on multiple threads nblc */
2655 static void combine_nblists(gmx::ArrayRef<const NbnxnPairlistGpu>  nbls,
2656                             NbnxnPairlistGpu                      *nblc)
2657 {
2658     int nsci  = nblc->sci.size();
2659     int ncj4  = nblc->cj4.size();
2660     int nexcl = nblc->excl.size();
2661     for (auto &nbl : nbls)
2662     {
2663         nsci  += nbl.sci.size();
2664         ncj4  += nbl.cj4.size();
2665         nexcl += nbl.excl.size();
2666     }
2667
2668     /* Resize with the final, combined size, so we can fill in parallel */
2669     /* NOTE: For better performance we should use default initialization */
2670     nblc->sci.resize(nsci);
2671     nblc->cj4.resize(ncj4);
2672     nblc->excl.resize(nexcl);
2673
2674     /* Each thread should copy its own data to the combined arrays,
2675      * as otherwise data will go back and forth between different caches.
2676      */
2677 #if GMX_OPENMP && !(defined __clang_analyzer__)
2678     int nthreads = gmx_omp_nthreads_get(emntPairsearch);
2679 #endif
2680
2681 #pragma omp parallel for num_threads(nthreads) schedule(static)
2682     for (int n = 0; n < nbls.ssize(); n++)
2683     {
2684         try
2685         {
2686             /* Determine the offset in the combined data for our thread.
2687              * Note that the original sizes in nblc are lost.
2688              */
2689             int sci_offset  = nsci;
2690             int cj4_offset  = ncj4;
2691             int excl_offset = nexcl;
2692
2693             for (int i = n; i < nbls.ssize(); i++)
2694             {
2695                 sci_offset  -= nbls[i].sci.size();
2696                 cj4_offset  -= nbls[i].cj4.size();
2697                 excl_offset -= nbls[i].excl.size();
2698             }
2699
2700             const NbnxnPairlistGpu &nbli = nbls[n];
2701
2702             for (size_t i = 0; i < nbli.sci.size(); i++)
2703             {
2704                 nblc->sci[sci_offset + i]                = nbli.sci[i];
2705                 nblc->sci[sci_offset + i].cj4_ind_start += cj4_offset;
2706                 nblc->sci[sci_offset + i].cj4_ind_end   += cj4_offset;
2707             }
2708
2709             for (size_t j4 = 0; j4 < nbli.cj4.size(); j4++)
2710             {
2711                 nblc->cj4[cj4_offset + j4]                   = nbli.cj4[j4];
2712                 nblc->cj4[cj4_offset + j4].imei[0].excl_ind += excl_offset;
2713                 nblc->cj4[cj4_offset + j4].imei[1].excl_ind += excl_offset;
2714             }
2715
2716             for (size_t j4 = 0; j4 < nbli.excl.size(); j4++)
2717             {
2718                 nblc->excl[excl_offset + j4] = nbli.excl[j4];
2719             }
2720         }
2721         GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
2722     }
2723
2724     for (auto &nbl : nbls)
2725     {
2726         nblc->nci_tot += nbl.nci_tot;
2727     }
2728 }
2729
2730 static void balance_fep_lists(gmx::ArrayRef<t_nblist *>      fepLists,
2731                               gmx::ArrayRef<PairsearchWork>  work)
2732 {
2733     const int numLists = fepLists.ssize();
2734
2735     if (numLists == 1)
2736     {
2737         /* Nothing to balance */
2738         return;
2739     }
2740
2741     /* Count the total i-lists and pairs */
2742     int nri_tot = 0;
2743     int nrj_tot = 0;
2744     for (auto list : fepLists)
2745     {
2746         nri_tot += list->nri;
2747         nrj_tot += list->nrj;
2748     }
2749
2750     const int nrj_target = (nrj_tot + numLists - 1)/numLists;
2751
2752     GMX_ASSERT(gmx_omp_nthreads_get(emntNonbonded) == numLists,
2753                "We should have as many work objects as FEP lists");
2754
2755 #pragma omp parallel for schedule(static) num_threads(numLists)
2756     for (int th = 0; th < numLists; th++)
2757     {
2758         try
2759         {
2760             t_nblist *nbl = work[th].nbl_fep.get();
2761
2762             /* Note that here we allocate for the total size, instead of
2763              * a per-thread esimate (which is hard to obtain).
2764              */
2765             if (nri_tot > nbl->maxnri)
2766             {
2767                 nbl->maxnri = over_alloc_large(nri_tot);
2768                 reallocate_nblist(nbl);
2769             }
2770             if (nri_tot > nbl->maxnri || nrj_tot > nbl->maxnrj)
2771             {
2772                 nbl->maxnrj = over_alloc_small(nrj_tot);
2773                 srenew(nbl->jjnr, nbl->maxnrj);
2774                 srenew(nbl->excl_fep, nbl->maxnrj);
2775             }
2776
2777             clear_pairlist_fep(nbl);
2778         }
2779         GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
2780     }
2781
2782     /* Loop over the source lists and assign and copy i-entries */
2783     int       th_dest = 0;
2784     t_nblist *nbld    = work[th_dest].nbl_fep.get();
2785     for (int th = 0; th < numLists; th++)
2786     {
2787         t_nblist *nbls = fepLists[th];
2788
2789         for (int i = 0; i < nbls->nri; i++)
2790         {
2791             int nrj;
2792
2793             /* The number of pairs in this i-entry */
2794             nrj = nbls->jindex[i+1] - nbls->jindex[i];
2795
2796             /* Decide if list th_dest is too large and we should procede
2797              * to the next destination list.
2798              */
2799             if (th_dest + 1 < numLists && nbld->nrj > 0 &&
2800                 nbld->nrj + nrj - nrj_target > nrj_target - nbld->nrj)
2801             {
2802                 th_dest++;
2803                 nbld = work[th_dest].nbl_fep.get();
2804             }
2805
2806             nbld->iinr[nbld->nri]  = nbls->iinr[i];
2807             nbld->gid[nbld->nri]   = nbls->gid[i];
2808             nbld->shift[nbld->nri] = nbls->shift[i];
2809
2810             for (int j = nbls->jindex[i]; j < nbls->jindex[i+1]; j++)
2811             {
2812                 nbld->jjnr[nbld->nrj]     = nbls->jjnr[j];
2813                 nbld->excl_fep[nbld->nrj] = nbls->excl_fep[j];
2814                 nbld->nrj++;
2815             }
2816             nbld->nri++;
2817             nbld->jindex[nbld->nri] = nbld->nrj;
2818         }
2819     }
2820
2821     /* Swap the list pointers */
2822     for (int th = 0; th < numLists; th++)
2823     {
2824         t_nblist *nbl_tmp = work[th].nbl_fep.release();
2825         work[th].nbl_fep.reset(fepLists[th]);
2826         fepLists[th]      = nbl_tmp;
2827
2828         if (debug)
2829         {
2830             fprintf(debug, "nbl_fep[%d] nri %4d nrj %4d\n",
2831                     th,
2832                     fepLists[th]->nri,
2833                     fepLists[th]->nrj);
2834         }
2835     }
2836 }
2837
2838 /* Returns the next ci to be processes by our thread */
2839 static gmx_bool next_ci(const Grid &grid,
2840                         int nth, int ci_block,
2841                         int *ci_x, int *ci_y,
2842                         int *ci_b, int *ci)
2843 {
2844     (*ci_b)++;
2845     (*ci)++;
2846
2847     if (*ci_b == ci_block)
2848     {
2849         /* Jump to the next block assigned to this task */
2850         *ci   += (nth - 1)*ci_block;
2851         *ci_b  = 0;
2852     }
2853
2854     if (*ci >= grid.numCells())
2855     {
2856         return FALSE;
2857     }
2858
2859     while (*ci >= grid.firstCellInColumn(*ci_x*grid.dimensions().numCells[YY] + *ci_y + 1))
2860     {
2861         *ci_y += 1;
2862         if (*ci_y == grid.dimensions().numCells[YY])
2863         {
2864             *ci_x += 1;
2865             *ci_y  = 0;
2866         }
2867     }
2868
2869     return TRUE;
2870 }
2871
2872 /* Returns the distance^2 for which we put cell pairs in the list
2873  * without checking atom pair distances. This is usually < rlist^2.
2874  */
2875 static float boundingbox_only_distance2(const Grid::Dimensions &iGridDims,
2876                                         const Grid::Dimensions &jGridDims,
2877                                         real                    rlist,
2878                                         gmx_bool                simple)
2879 {
2880     /* If the distance between two sub-cell bounding boxes is less
2881      * than this distance, do not check the distance between
2882      * all particle pairs in the sub-cell, since then it is likely
2883      * that the box pair has atom pairs within the cut-off.
2884      * We use the nblist cut-off minus 0.5 times the average x/y diagonal
2885      * spacing of the sub-cells. Around 40% of the checked pairs are pruned.
2886      * Using more than 0.5 gains at most 0.5%.
2887      * If forces are calculated more than twice, the performance gain
2888      * in the force calculation outweighs the cost of checking.
2889      * Note that with subcell lists, the atom-pair distance check
2890      * is only performed when only 1 out of 8 sub-cells in within range,
2891      * this is because the GPU is much faster than the cpu.
2892      */
2893     real bbx, bby;
2894     real rbb2;
2895
2896     bbx = 0.5*(iGridDims.cellSize[XX] + jGridDims.cellSize[XX]);
2897     bby = 0.5*(iGridDims.cellSize[YY] + jGridDims.cellSize[YY]);
2898     if (!simple)
2899     {
2900         bbx /= c_gpuNumClusterPerCellX;
2901         bby /= c_gpuNumClusterPerCellY;
2902     }
2903
2904     rbb2 = std::max(0.0, rlist - 0.5*std::sqrt(bbx*bbx + bby*bby));
2905     rbb2 = rbb2 * rbb2;
2906
2907 #if !GMX_DOUBLE
2908     return rbb2;
2909 #else
2910     return (float)((1+GMX_FLOAT_EPS)*rbb2);
2911 #endif
2912 }
2913
2914 static int get_ci_block_size(const Grid &iGrid,
2915                              const bool  haveMultipleDomains,
2916                              const int   numLists)
2917 {
2918     const int ci_block_enum      = 5;
2919     const int ci_block_denom     = 11;
2920     const int ci_block_min_atoms = 16;
2921     int       ci_block;
2922
2923     /* Here we decide how to distribute the blocks over the threads.
2924      * We use prime numbers to try to avoid that the grid size becomes
2925      * a multiple of the number of threads, which would lead to some
2926      * threads getting "inner" pairs and others getting boundary pairs,
2927      * which in turns will lead to load imbalance between threads.
2928      * Set the block size as 5/11/ntask times the average number of cells
2929      * in a y,z slab. This should ensure a quite uniform distribution
2930      * of the grid parts of the different thread along all three grid
2931      * zone boundaries with 3D domain decomposition. At the same time
2932      * the blocks will not become too small.
2933      */
2934     GMX_ASSERT(iGrid.dimensions().numCells[XX] > 0, "Grid can't be empty");
2935     GMX_ASSERT(numLists > 0, "We need at least one list");
2936     ci_block = (iGrid.numCells()*ci_block_enum)/(ci_block_denom*iGrid.dimensions().numCells[XX]*numLists);
2937
2938     const int numAtomsPerCell = iGrid.geometry().numAtomsPerCell;
2939
2940     /* Ensure the blocks are not too small: avoids cache invalidation */
2941     if (ci_block*numAtomsPerCell < ci_block_min_atoms)
2942     {
2943         ci_block = (ci_block_min_atoms + numAtomsPerCell - 1)/numAtomsPerCell;
2944     }
2945
2946     /* Without domain decomposition
2947      * or with less than 3 blocks per task, divide in nth blocks.
2948      */
2949     if (!haveMultipleDomains || numLists*3*ci_block > iGrid.numCells())
2950     {
2951         ci_block = (iGrid.numCells() + numLists - 1)/numLists;
2952     }
2953
2954     if (ci_block > 1 && (numLists - 1)*ci_block >= iGrid.numCells())
2955     {
2956         /* Some threads have no work. Although reducing the block size
2957          * does not decrease the block count on the first few threads,
2958          * with GPUs better mixing of "upper" cells that have more empty
2959          * clusters results in a somewhat lower max load over all threads.
2960          * Without GPUs the regime of so few atoms per thread is less
2961          * performance relevant, but with 8-wide SIMD the same reasoning
2962          * applies, since the pair list uses 4 i-atom "sub-clusters".
2963          */
2964         ci_block--;
2965     }
2966
2967     return ci_block;
2968 }
2969
2970 /* Returns the number of bits to right-shift a cluster index to obtain
2971  * the corresponding force buffer flag index.
2972  */
2973 static int getBufferFlagShift(int numAtomsPerCluster)
2974 {
2975     int bufferFlagShift = 0;
2976     while ((numAtomsPerCluster << bufferFlagShift) < NBNXN_BUFFERFLAG_SIZE)
2977     {
2978         bufferFlagShift++;
2979     }
2980
2981     return bufferFlagShift;
2982 }
2983
2984 static bool pairlistIsSimple(const NbnxnPairlistCpu gmx_unused &pairlist)
2985 {
2986     return true;
2987 }
2988
2989 static bool pairlistIsSimple(const NbnxnPairlistGpu gmx_unused &pairlist)
2990 {
2991     return false;
2992 }
2993
2994 static void makeClusterListWrapper(NbnxnPairlistCpu       *nbl,
2995                                    const Grid gmx_unused  &iGrid,
2996                                    const int               ci,
2997                                    const Grid             &jGrid,
2998                                    const int               firstCell,
2999                                    const int               lastCell,
3000                                    const bool              excludeSubDiagonal,
3001                                    const nbnxn_atomdata_t *nbat,
3002                                    const real              rlist2,
3003                                    const real              rbb2,
3004                                    const Nbnxm::KernelType kernelType,
3005                                    int                    *numDistanceChecks)
3006 {
3007     switch (kernelType)
3008     {
3009         case Nbnxm::KernelType::Cpu4x4_PlainC:
3010             makeClusterListSimple(jGrid,
3011                                   nbl, ci, firstCell, lastCell,
3012                                   excludeSubDiagonal,
3013                                   nbat->x().data(),
3014                                   rlist2, rbb2,
3015                                   numDistanceChecks);
3016             break;
3017 #ifdef GMX_NBNXN_SIMD_4XN
3018         case Nbnxm::KernelType::Cpu4xN_Simd_4xN:
3019             makeClusterListSimd4xn(jGrid,
3020                                    nbl, ci, firstCell, lastCell,
3021                                    excludeSubDiagonal,
3022                                    nbat->x().data(),
3023                                    rlist2, rbb2,
3024                                    numDistanceChecks);
3025             break;
3026 #endif
3027 #ifdef GMX_NBNXN_SIMD_2XNN
3028         case Nbnxm::KernelType::Cpu4xN_Simd_2xNN:
3029             makeClusterListSimd2xnn(jGrid,
3030                                     nbl, ci, firstCell, lastCell,
3031                                     excludeSubDiagonal,
3032                                     nbat->x().data(),
3033                                     rlist2, rbb2,
3034                                     numDistanceChecks);
3035             break;
3036 #endif
3037         default:
3038             GMX_ASSERT(false, "Unhandled kernel type");
3039     }
3040 }
3041
3042 static void makeClusterListWrapper(NbnxnPairlistGpu             *nbl,
3043                                    const Grid &gmx_unused        iGrid,
3044                                    const int                     ci,
3045                                    const Grid                   &jGrid,
3046                                    const int                     firstCell,
3047                                    const int                     lastCell,
3048                                    const bool                    excludeSubDiagonal,
3049                                    const nbnxn_atomdata_t       *nbat,
3050                                    const real                    rlist2,
3051                                    const real                    rbb2,
3052                                    Nbnxm::KernelType gmx_unused  kernelType,
3053                                    int                          *numDistanceChecks)
3054 {
3055     for (int cj = firstCell; cj <= lastCell; cj++)
3056     {
3057         make_cluster_list_supersub(iGrid, jGrid,
3058                                    nbl, ci, cj,
3059                                    excludeSubDiagonal,
3060                                    nbat->xstride, nbat->x().data(),
3061                                    rlist2, rbb2,
3062                                    numDistanceChecks);
3063     }
3064 }
3065
3066 static int getNumSimpleJClustersInList(const NbnxnPairlistCpu &nbl)
3067 {
3068     return nbl.cj.size();
3069 }
3070
3071 static int getNumSimpleJClustersInList(const gmx_unused NbnxnPairlistGpu &nbl)
3072 {
3073     return 0;
3074 }
3075
3076 static void incrementNumSimpleJClustersInList(NbnxnPairlistCpu *nbl,
3077                                               int               ncj_old_j)
3078 {
3079     nbl->ncjInUse += nbl->cj.size() - ncj_old_j;
3080 }
3081
3082 static void incrementNumSimpleJClustersInList(NbnxnPairlistGpu gmx_unused *nbl,
3083                                               int              gmx_unused  ncj_old_j)
3084 {
3085 }
3086
3087 static void checkListSizeConsistency(const NbnxnPairlistCpu &nbl,
3088                                      const bool              haveFreeEnergy)
3089 {
3090     GMX_RELEASE_ASSERT(static_cast<size_t>(nbl.ncjInUse) == nbl.cj.size() || haveFreeEnergy,
3091                        "Without free-energy all cj pair-list entries should be in use. "
3092                        "Note that subsequent code does not make use of the equality, "
3093                        "this check is only here to catch bugs");
3094 }
3095
3096 static void checkListSizeConsistency(const NbnxnPairlistGpu gmx_unused &nbl,
3097                                      bool gmx_unused                    haveFreeEnergy)
3098 {
3099     /* We currently can not check consistency here */
3100 }
3101
3102 /* Set the buffer flags for newly added entries in the list */
3103 static void setBufferFlags(const NbnxnPairlistCpu &nbl,
3104                            const int               ncj_old_j,
3105                            const int               gridj_flag_shift,
3106                            gmx_bitmask_t          *gridj_flag,
3107                            const int               th)
3108 {
3109     if (gmx::ssize(nbl.cj) > ncj_old_j)
3110     {
3111         int cbFirst = nbl.cj[ncj_old_j].cj >> gridj_flag_shift;
3112         int cbLast  = nbl.cj.back().cj >> gridj_flag_shift;
3113         for (int cb = cbFirst; cb <= cbLast; cb++)
3114         {
3115             bitmask_init_bit(&gridj_flag[cb], th);
3116         }
3117     }
3118 }
3119
3120 static void setBufferFlags(const NbnxnPairlistGpu gmx_unused &nbl,
3121                            int gmx_unused                     ncj_old_j,
3122                            int gmx_unused                     gridj_flag_shift,
3123                            gmx_bitmask_t gmx_unused          *gridj_flag,
3124                            int gmx_unused                     th)
3125 {
3126     GMX_ASSERT(false, "This function should never be called");
3127 }
3128
3129 /* Generates the part of pair-list nbl assigned to our thread */
3130 template <typename T>
3131 static void nbnxn_make_pairlist_part(const Nbnxm::GridSet &gridSet,
3132                                      const Grid &iGrid,
3133                                      const Grid &jGrid,
3134                                      PairsearchWork *work,
3135                                      const nbnxn_atomdata_t *nbat,
3136                                      const t_blocka &exclusions,
3137                                      real rlist,
3138                                      const Nbnxm::KernelType kernelType,
3139                                      int ci_block,
3140                                      gmx_bool bFBufferFlag,
3141                                      int nsubpair_max,
3142                                      gmx_bool progBal,
3143                                      float nsubpair_tot_est,
3144                                      int th, int nth,
3145                                      T *nbl,
3146                                      t_nblist *nbl_fep)
3147 {
3148     int               na_cj_2log;
3149     matrix            box;
3150     real              rl_fep2 = 0;
3151     float             rbb2;
3152     int               ci_b, ci, ci_x, ci_y, ci_xy;
3153     ivec              shp;
3154     real              bx0, bx1, by0, by1, bz0, bz1;
3155     real              bz1_frac;
3156     real              d2cx, d2z, d2z_cx, d2z_cy, d2zx, d2zxy, d2xy;
3157     int               cxf, cxl, cyf, cyf_x, cyl;
3158     int               numDistanceChecks;
3159     int               gridi_flag_shift = 0, gridj_flag_shift = 0;
3160     gmx_bitmask_t    *gridj_flag       = nullptr;
3161     int               ncj_old_i, ncj_old_j;
3162
3163     if (jGrid.geometry().isSimple != pairlistIsSimple(*nbl) ||
3164         iGrid.geometry().isSimple != pairlistIsSimple(*nbl))
3165     {
3166         gmx_incons("Grid incompatible with pair-list");
3167     }
3168
3169     sync_work(nbl);
3170     GMX_ASSERT(nbl->na_ci == jGrid.geometry().numAtomsICluster,
3171                "The cluster sizes in the list and grid should match");
3172     nbl->na_cj = Nbnxm::JClusterSizePerKernelType[kernelType];
3173     na_cj_2log = get_2log(nbl->na_cj);
3174
3175     nbl->rlist  = rlist;
3176
3177     if (bFBufferFlag)
3178     {
3179         /* Determine conversion of clusters to flag blocks */
3180         gridi_flag_shift = getBufferFlagShift(nbl->na_ci);
3181         gridj_flag_shift = getBufferFlagShift(nbl->na_cj);
3182
3183         gridj_flag       = work->buffer_flags.flag;
3184     }
3185
3186     gridSet.getBox(box);
3187
3188     const bool            haveFep = gridSet.haveFep();
3189
3190     const real            rlist2  = nbl->rlist*nbl->rlist;
3191
3192     if (haveFep && !pairlistIsSimple(*nbl))
3193     {
3194         /* Determine an atom-pair list cut-off distance for FEP atom pairs.
3195          * We should not simply use rlist, since then we would not have
3196          * the small, effective buffering of the NxN lists.
3197          * The buffer is on overestimate, but the resulting cost for pairs
3198          * beyond rlist is neglible compared to the FEP pairs within rlist.
3199          */
3200         rl_fep2 = nbl->rlist + effective_buffer_1x1_vs_MxN(iGrid, jGrid);
3201
3202         if (debug)
3203         {
3204             fprintf(debug, "nbl_fep atom-pair rlist %f\n", rl_fep2);
3205         }
3206         rl_fep2 = rl_fep2*rl_fep2;
3207     }
3208
3209     const Grid::Dimensions &iGridDims = iGrid.dimensions();
3210     const Grid::Dimensions &jGridDims = jGrid.dimensions();
3211
3212     rbb2 = boundingbox_only_distance2(iGridDims, jGridDims, nbl->rlist, pairlistIsSimple(*nbl));
3213
3214     if (debug)
3215     {
3216         fprintf(debug, "nbl bounding box only distance %f\n", std::sqrt(rbb2));
3217     }
3218
3219     const bool isIntraGridList = (&iGrid == &jGrid);
3220
3221     /* Set the shift range */
3222     for (int d = 0; d < DIM; d++)
3223     {
3224         /* Check if we need periodicity shifts.
3225          * Without PBC or with domain decomposition we don't need them.
3226          */
3227         if (d >= ePBC2npbcdim(gridSet.domainSetup().ePBC) ||
3228             gridSet.domainSetup().haveMultipleDomainsPerDim[d])
3229         {
3230             shp[d] = 0;
3231         }
3232         else
3233         {
3234             const real listRangeCellToCell =
3235                 listRangeForGridCellToGridCell(rlist, iGrid.dimensions(), jGrid.dimensions());
3236             if (d == XX &&
3237                 box[XX][XX] - fabs(box[YY][XX]) - fabs(box[ZZ][XX]) < listRangeCellToCell)
3238             {
3239                 shp[d] = 2;
3240             }
3241             else
3242             {
3243                 shp[d] = 1;
3244             }
3245         }
3246     }
3247     const bool bSimple = pairlistIsSimple(*nbl);
3248     gmx::ArrayRef<const BoundingBox> bb_i;
3249 #if NBNXN_BBXXXX
3250     gmx::ArrayRef<const float>       pbb_i;
3251     if (bSimple)
3252     {
3253         bb_i  = iGrid.iBoundingBoxes();
3254     }
3255     else
3256     {
3257         pbb_i = iGrid.packedBoundingBoxes();
3258     }
3259 #else
3260     /* We use the normal bounding box format for both grid types */
3261     bb_i  = iGrid.iBoundingBoxes();
3262 #endif
3263     gmx::ArrayRef<const BoundingBox1D> bbcz_i  = iGrid.zBoundingBoxes();
3264     gmx::ArrayRef<const int>           flags_i = iGrid.clusterFlags();
3265     gmx::ArrayRef<const BoundingBox1D> bbcz_j  = jGrid.zBoundingBoxes();
3266     int                                cell0_i = iGrid.cellOffset();
3267
3268     if (debug)
3269     {
3270         fprintf(debug, "nbl nc_i %d col.av. %.1f ci_block %d\n",
3271                 iGrid.numCells(), iGrid.numCells()/static_cast<double>(iGrid.numColumns()), ci_block);
3272     }
3273
3274     numDistanceChecks = 0;
3275
3276     const real listRangeBBToJCell2 = gmx::square(listRangeForBoundingBoxToGridCell(rlist, jGrid.dimensions()));
3277
3278     /* Initially ci_b and ci to 1 before where we want them to start,
3279      * as they will both be incremented in next_ci.
3280      */
3281     ci_b = -1;
3282     ci   = th*ci_block - 1;
3283     ci_x = 0;
3284     ci_y = 0;
3285     while (next_ci(iGrid, nth, ci_block, &ci_x, &ci_y, &ci_b, &ci))
3286     {
3287         if (bSimple && flags_i[ci] == 0)
3288         {
3289             continue;
3290         }
3291
3292         ncj_old_i = getNumSimpleJClustersInList(*nbl);
3293
3294         d2cx = 0;
3295         if (!isIntraGridList && shp[XX] == 0)
3296         {
3297             if (bSimple)
3298             {
3299                 bx1 = bb_i[ci].upper.x;
3300             }
3301             else
3302             {
3303                 bx1 = iGridDims.lowerCorner[XX] + (ci_x+1)*iGridDims.cellSize[XX];
3304             }
3305             if (bx1 < jGridDims.lowerCorner[XX])
3306             {
3307                 d2cx = gmx::square(jGridDims.lowerCorner[XX] - bx1);
3308
3309                 if (d2cx >= listRangeBBToJCell2)
3310                 {
3311                     continue;
3312                 }
3313             }
3314         }
3315
3316         ci_xy = ci_x*iGridDims.numCells[YY] + ci_y;
3317
3318         /* Loop over shift vectors in three dimensions */
3319         for (int tz = -shp[ZZ]; tz <= shp[ZZ]; tz++)
3320         {
3321             const real shz = tz*box[ZZ][ZZ];
3322
3323             bz0 = bbcz_i[ci].lower + shz;
3324             bz1 = bbcz_i[ci].upper + shz;
3325
3326             if (tz == 0)
3327             {
3328                 d2z = 0;
3329             }
3330             else if (tz < 0)
3331             {
3332                 d2z = gmx::square(bz1);
3333             }
3334             else
3335             {
3336                 d2z = gmx::square(bz0 - box[ZZ][ZZ]);
3337             }
3338
3339             d2z_cx = d2z + d2cx;
3340
3341             if (d2z_cx >= rlist2)
3342             {
3343                 continue;
3344             }
3345
3346             bz1_frac = bz1/iGrid.numCellsInColumn(ci_xy);
3347             if (bz1_frac < 0)
3348             {
3349                 bz1_frac = 0;
3350             }
3351             /* The check with bz1_frac close to or larger than 1 comes later */
3352
3353             for (int ty = -shp[YY]; ty <= shp[YY]; ty++)
3354             {
3355                 const real shy = ty*box[YY][YY] + tz*box[ZZ][YY];
3356
3357                 if (bSimple)
3358                 {
3359                     by0 = bb_i[ci].lower.y + shy;
3360                     by1 = bb_i[ci].upper.y + shy;
3361                 }
3362                 else
3363                 {
3364                     by0 = iGridDims.lowerCorner[YY] + (ci_y    )*iGridDims.cellSize[YY] + shy;
3365                     by1 = iGridDims.lowerCorner[YY] + (ci_y + 1)*iGridDims.cellSize[YY] + shy;
3366                 }
3367
3368                 get_cell_range<YY>(by0, by1,
3369                                    jGridDims,
3370                                    d2z_cx, rlist,
3371                                    &cyf, &cyl);
3372
3373                 if (cyf > cyl)
3374                 {
3375                     continue;
3376                 }
3377
3378                 d2z_cy = d2z;
3379                 if (by1 < jGridDims.lowerCorner[YY])
3380                 {
3381                     d2z_cy += gmx::square(jGridDims.lowerCorner[YY] - by1);
3382                 }
3383                 else if (by0 > jGridDims.upperCorner[YY])
3384                 {
3385                     d2z_cy += gmx::square(by0 - jGridDims.upperCorner[YY]);
3386                 }
3387
3388                 for (int tx = -shp[XX]; tx <= shp[XX]; tx++)
3389                 {
3390                     const int  shift              = XYZ2IS(tx, ty, tz);
3391
3392                     const bool excludeSubDiagonal = (isIntraGridList && shift == CENTRAL);
3393
3394                     if (c_pbcShiftBackward && isIntraGridList && shift > CENTRAL)
3395                     {
3396                         continue;
3397                     }
3398
3399                     const real shx = tx*box[XX][XX] + ty*box[YY][XX] + tz*box[ZZ][XX];
3400
3401                     if (bSimple)
3402                     {
3403                         bx0 = bb_i[ci].lower.x + shx;
3404                         bx1 = bb_i[ci].upper.x + shx;
3405                     }
3406                     else
3407                     {
3408                         bx0 = iGridDims.lowerCorner[XX] + (ci_x  )*iGridDims.cellSize[XX] + shx;
3409                         bx1 = iGridDims.lowerCorner[XX] + (ci_x+1)*iGridDims.cellSize[XX] + shx;
3410                     }
3411
3412                     get_cell_range<XX>(bx0, bx1,
3413                                        jGridDims,
3414                                        d2z_cy, rlist,
3415                                        &cxf, &cxl);
3416
3417                     if (cxf > cxl)
3418                     {
3419                         continue;
3420                     }
3421
3422                     addNewIEntry(nbl, cell0_i+ci, shift, flags_i[ci]);
3423
3424                     if ((!c_pbcShiftBackward || excludeSubDiagonal) &&
3425                         cxf < ci_x)
3426                     {
3427                         /* Leave the pairs with i > j.
3428                          * x is the major index, so skip half of it.
3429                          */
3430                         cxf = ci_x;
3431                     }
3432
3433                     set_icell_bb(iGrid, ci, shx, shy, shz,
3434                                  nbl->work.get());
3435
3436                     icell_set_x(cell0_i+ci, shx, shy, shz,
3437                                 nbat->xstride, nbat->x().data(),
3438                                 kernelType,
3439                                 nbl->work.get());
3440
3441                     for (int cx = cxf; cx <= cxl; cx++)
3442                     {
3443                         d2zx = d2z;
3444                         if (jGridDims.lowerCorner[XX] + cx*jGridDims.cellSize[XX] > bx1)
3445                         {
3446                             d2zx += gmx::square(jGridDims.lowerCorner[XX] + cx*jGridDims.cellSize[XX] - bx1);
3447                         }
3448                         else if (jGridDims.lowerCorner[XX] + (cx+1)*jGridDims.cellSize[XX] < bx0)
3449                         {
3450                             d2zx += gmx::square(jGridDims.lowerCorner[XX] + (cx+1)*jGridDims.cellSize[XX] - bx0);
3451                         }
3452
3453                         if (isIntraGridList &&
3454                             cx == 0 &&
3455                             (!c_pbcShiftBackward || shift == CENTRAL) &&
3456                             cyf < ci_y)
3457                         {
3458                             /* Leave the pairs with i > j.
3459                              * Skip half of y when i and j have the same x.
3460                              */
3461                             cyf_x = ci_y;
3462                         }
3463                         else
3464                         {
3465                             cyf_x = cyf;
3466                         }
3467
3468                         for (int cy = cyf_x; cy <= cyl; cy++)
3469                         {
3470                             const int columnStart = jGrid.firstCellInColumn(cx*jGridDims.numCells[YY] + cy);
3471                             const int columnEnd   = jGrid.firstCellInColumn(cx*jGridDims.numCells[YY] + cy + 1);
3472
3473                             d2zxy = d2zx;
3474                             if (jGridDims.lowerCorner[YY] + cy*jGridDims.cellSize[YY] > by1)
3475                             {
3476                                 d2zxy += gmx::square(jGridDims.lowerCorner[YY] + cy*jGridDims.cellSize[YY] - by1);
3477                             }
3478                             else if (jGridDims.lowerCorner[YY] + (cy + 1)*jGridDims.cellSize[YY] < by0)
3479                             {
3480                                 d2zxy += gmx::square(jGridDims.lowerCorner[YY] + (cy + 1)*jGridDims.cellSize[YY] - by0);
3481                             }
3482                             if (columnStart < columnEnd && d2zxy < listRangeBBToJCell2)
3483                             {
3484                                 /* To improve efficiency in the common case
3485                                  * of a homogeneous particle distribution,
3486                                  * we estimate the index of the middle cell
3487                                  * in range (midCell). We search down and up
3488                                  * starting from this index.
3489                                  *
3490                                  * Note that the bbcz_j array contains bounds
3491                                  * for i-clusters, thus for clusters of 4 atoms.
3492                                  * For the common case where the j-cluster size
3493                                  * is 8, we could step with a stride of 2,
3494                                  * but we do not do this because it would
3495                                  * complicate this code even more.
3496                                  */
3497                                 int midCell = columnStart + static_cast<int>(bz1_frac*(columnEnd - columnStart));
3498                                 if (midCell >= columnEnd)
3499                                 {
3500                                     midCell = columnEnd - 1;
3501                                 }
3502
3503                                 d2xy = d2zxy - d2z;
3504
3505                                 /* Find the lowest cell that can possibly
3506                                  * be within range.
3507                                  * Check if we hit the bottom of the grid,
3508                                  * if the j-cell is below the i-cell and if so,
3509                                  * if it is within range.
3510                                  */
3511                                 int downTestCell = midCell;
3512                                 while (downTestCell >= columnStart &&
3513                                        (bbcz_j[downTestCell].upper >= bz0 ||
3514                                         d2xy + gmx::square(bbcz_j[downTestCell].upper - bz0) < rlist2))
3515                                 {
3516                                     downTestCell--;
3517                                 }
3518                                 int firstCell = downTestCell + 1;
3519
3520                                 /* Find the highest cell that can possibly
3521                                  * be within range.
3522                                  * Check if we hit the top of the grid,
3523                                  * if the j-cell is above the i-cell and if so,
3524                                  * if it is within range.
3525                                  */
3526                                 int upTestCell = midCell + 1;
3527                                 while (upTestCell < columnEnd &&
3528                                        (bbcz_j[upTestCell].lower <= bz1 ||
3529                                         d2xy + gmx::square(bbcz_j[upTestCell].lower - bz1) < rlist2))
3530                                 {
3531                                     upTestCell++;
3532                                 }
3533                                 int lastCell = upTestCell - 1;
3534
3535 #define NBNXN_REFCODE 0
3536 #if NBNXN_REFCODE
3537                                 {
3538                                     /* Simple reference code, for debugging,
3539                                      * overrides the more complex code above.
3540                                      */
3541                                     firstCell = columnEnd;
3542                                     lastCell  = -1;
3543                                     for (int k = columnStart; k < columnEnd; k++)
3544                                     {
3545                                         if (d2xy + gmx::square(bbcz_j[k*NNBSBB_D + 1] - bz0) < rlist2 &&
3546                                             k < firstCell)
3547                                         {
3548                                             firstCell = k;
3549                                         }
3550                                         if (d2xy + gmx::square(bbcz_j[k*NNBSBB_D] - bz1) < rlist2 &&
3551                                             k > lastCell)
3552                                         {
3553                                             lastCell = k;
3554                                         }
3555                                     }
3556                                 }
3557 #endif
3558
3559                                 if (isIntraGridList)
3560                                 {
3561                                     /* We want each atom/cell pair only once,
3562                                      * only use cj >= ci.
3563                                      */
3564                                     if (!c_pbcShiftBackward || shift == CENTRAL)
3565                                     {
3566                                         firstCell = std::max(firstCell, ci);
3567                                     }
3568                                 }
3569
3570                                 if (firstCell <= lastCell)
3571                                 {
3572                                     GMX_ASSERT(firstCell >= columnStart && lastCell < columnEnd, "The range should reside within the current grid column");
3573
3574                                     /* For f buffer flags with simple lists */
3575                                     ncj_old_j = getNumSimpleJClustersInList(*nbl);
3576
3577                                     makeClusterListWrapper(nbl,
3578                                                            iGrid, ci,
3579                                                            jGrid, firstCell, lastCell,
3580                                                            excludeSubDiagonal,
3581                                                            nbat,
3582                                                            rlist2, rbb2,
3583                                                            kernelType,
3584                                                            &numDistanceChecks);
3585
3586                                     if (bFBufferFlag)
3587                                     {
3588                                         setBufferFlags(*nbl, ncj_old_j, gridj_flag_shift,
3589                                                        gridj_flag, th);
3590                                     }
3591
3592                                     incrementNumSimpleJClustersInList(nbl, ncj_old_j);
3593                                 }
3594                             }
3595                         }
3596                     }
3597
3598                     /* Set the exclusions for this ci list */
3599                     setExclusionsForIEntry(gridSet,
3600                                            nbl,
3601                                            excludeSubDiagonal,
3602                                            na_cj_2log,
3603                                            *getOpenIEntry(nbl),
3604                                            exclusions);
3605
3606                     if (haveFep)
3607                     {
3608                         make_fep_list(gridSet.atomIndices(), nbat, nbl,
3609                                       excludeSubDiagonal,
3610                                       getOpenIEntry(nbl),
3611                                       shx, shy, shz,
3612                                       rl_fep2,
3613                                       iGrid, jGrid, nbl_fep);
3614                     }
3615
3616                     /* Close this ci list */
3617                     closeIEntry(nbl,
3618                                 nsubpair_max,
3619                                 progBal, nsubpair_tot_est,
3620                                 th, nth);
3621                 }
3622             }
3623         }
3624
3625         if (bFBufferFlag && getNumSimpleJClustersInList(*nbl) > ncj_old_i)
3626         {
3627             bitmask_init_bit(&(work->buffer_flags.flag[(iGrid.cellOffset() + ci) >> gridi_flag_shift]), th);
3628         }
3629     }
3630
3631     work->ndistc = numDistanceChecks;
3632
3633     checkListSizeConsistency(*nbl, haveFep);
3634
3635     if (debug)
3636     {
3637         fprintf(debug, "number of distance checks %d\n", numDistanceChecks);
3638
3639         print_nblist_statistics(debug, *nbl, gridSet, rlist);
3640
3641         if (haveFep)
3642         {
3643             fprintf(debug, "nbl FEP list pairs: %d\n", nbl_fep->nrj);
3644         }
3645     }
3646 }
3647
3648 static void reduce_buffer_flags(gmx::ArrayRef<PairsearchWork>  searchWork,
3649                                 int                            nsrc,
3650                                 const nbnxn_buffer_flags_t    *dest)
3651 {
3652     for (int s = 0; s < nsrc; s++)
3653     {
3654         gmx_bitmask_t * flag = searchWork[s].buffer_flags.flag;
3655
3656         for (int b = 0; b < dest->nflag; b++)
3657         {
3658             bitmask_union(&(dest->flag[b]), flag[b]);
3659         }
3660     }
3661 }
3662
3663 static void print_reduction_cost(const nbnxn_buffer_flags_t *flags, int nout)
3664 {
3665     int           nelem, nkeep, ncopy, nred, out;
3666     gmx_bitmask_t mask_0;
3667
3668     nelem = 0;
3669     nkeep = 0;
3670     ncopy = 0;
3671     nred  = 0;
3672     bitmask_init_bit(&mask_0, 0);
3673     for (int b = 0; b < flags->nflag; b++)
3674     {
3675         if (bitmask_is_equal(flags->flag[b], mask_0))
3676         {
3677             /* Only flag 0 is set, no copy of reduction required */
3678             nelem++;
3679             nkeep++;
3680         }
3681         else if (!bitmask_is_zero(flags->flag[b]))
3682         {
3683             int c = 0;
3684             for (out = 0; out < nout; out++)
3685             {
3686                 if (bitmask_is_set(flags->flag[b], out))
3687                 {
3688                     c++;
3689                 }
3690             }
3691             nelem += c;
3692             if (c == 1)
3693             {
3694                 ncopy++;
3695             }
3696             else
3697             {
3698                 nred += c;
3699             }
3700         }
3701     }
3702
3703     fprintf(debug, "nbnxn reduction: #flag %d #list %d elem %4.2f, keep %4.2f copy %4.2f red %4.2f\n",
3704             flags->nflag, nout,
3705             nelem/static_cast<double>(flags->nflag),
3706             nkeep/static_cast<double>(flags->nflag),
3707             ncopy/static_cast<double>(flags->nflag),
3708             nred/static_cast<double>(flags->nflag));
3709 }
3710
3711 /* Copies the list entries from src to dest when cjStart <= *cjGlobal < cjEnd.
3712  * *cjGlobal is updated with the cj count in src.
3713  * When setFlags==true, flag bit t is set in flag for all i and j clusters.
3714  */
3715 template<bool setFlags>
3716 static void copySelectedListRange(const nbnxn_ci_t * gmx_restrict srcCi,
3717                                   const NbnxnPairlistCpu * gmx_restrict src,
3718                                   NbnxnPairlistCpu * gmx_restrict dest,
3719                                   gmx_bitmask_t *flag,
3720                                   int iFlagShift, int jFlagShift, int t)
3721 {
3722     const int ncj = srcCi->cj_ind_end - srcCi->cj_ind_start;
3723
3724     dest->ci.push_back(*srcCi);
3725     dest->ci.back().cj_ind_start = dest->cj.size();
3726     dest->ci.back().cj_ind_end   = dest->cj.size() + ncj;
3727
3728     if (setFlags)
3729     {
3730         bitmask_init_bit(&flag[srcCi->ci >> iFlagShift], t);
3731     }
3732
3733     for (int j = srcCi->cj_ind_start; j < srcCi->cj_ind_end; j++)
3734     {
3735         dest->cj.push_back(src->cj[j]);
3736
3737         if (setFlags)
3738         {
3739             /* NOTE: This is relatively expensive, since this
3740              * operation is done for all elements in the list,
3741              * whereas at list generation this is done only
3742              * once for each flag entry.
3743              */
3744             bitmask_init_bit(&flag[src->cj[j].cj >> jFlagShift], t);
3745         }
3746     }
3747 }
3748
3749 /* This routine re-balances the pairlists such that all are nearly equally
3750  * sized. Only whole i-entries are moved between lists. These are moved
3751  * between the ends of the lists, such that the buffer reduction cost should
3752  * not change significantly.
3753  * Note that all original reduction flags are currently kept. This can lead
3754  * to reduction of parts of the force buffer that could be avoided. But since
3755  * the original lists are quite balanced, this will only give minor overhead.
3756  */
3757 static void rebalanceSimpleLists(gmx::ArrayRef<const NbnxnPairlistCpu> srcSet,
3758                                  gmx::ArrayRef<NbnxnPairlistCpu>       destSet,
3759                                  gmx::ArrayRef<PairsearchWork>         searchWork)
3760 {
3761     int ncjTotal = 0;
3762     for (auto &src : srcSet)
3763     {
3764         ncjTotal += src.ncjInUse;
3765     }
3766     const int numLists  = srcSet.ssize();
3767     const int ncjTarget = (ncjTotal + numLists - 1)/numLists;
3768
3769 #pragma omp parallel num_threads(numLists)
3770     {
3771         int t       = gmx_omp_get_thread_num();
3772
3773         int cjStart = ncjTarget* t;
3774         int cjEnd   = ncjTarget*(t + 1);
3775
3776         /* The destination pair-list for task/thread t */
3777         NbnxnPairlistCpu &dest = destSet[t];
3778
3779         clear_pairlist(&dest);
3780         dest.na_cj = srcSet[0].na_cj;
3781
3782         /* Note that the flags in the work struct (still) contain flags
3783          * for all entries that are present in srcSet->nbl[t].
3784          */
3785         gmx_bitmask_t *flag       = searchWork[t].buffer_flags.flag;
3786
3787         int            iFlagShift = getBufferFlagShift(dest.na_ci);
3788         int            jFlagShift = getBufferFlagShift(dest.na_cj);
3789
3790         int            cjGlobal   = 0;
3791         for (int s = 0; s < numLists && cjGlobal < cjEnd; s++)
3792         {
3793             const NbnxnPairlistCpu *src = &srcSet[s];
3794
3795             if (cjGlobal + src->ncjInUse > cjStart)
3796             {
3797                 for (gmx::index i = 0; i < gmx::ssize(src->ci) && cjGlobal < cjEnd; i++)
3798                 {
3799                     const nbnxn_ci_t *srcCi = &src->ci[i];
3800                     int               ncj   = srcCi->cj_ind_end - srcCi->cj_ind_start;
3801                     if (cjGlobal >= cjStart)
3802                     {
3803                         /* If the source list is not our own, we need to set
3804                          * extra flags (the template bool parameter).
3805                          */
3806                         if (s != t)
3807                         {
3808                             copySelectedListRange
3809                             <true>
3810                                 (srcCi, src, &dest,
3811                                 flag, iFlagShift, jFlagShift, t);
3812                         }
3813                         else
3814                         {
3815                             copySelectedListRange
3816                             <false>
3817                                 (srcCi, src,
3818                                 &dest, flag, iFlagShift, jFlagShift, t);
3819                         }
3820                     }
3821                     cjGlobal += ncj;
3822                 }
3823             }
3824             else
3825             {
3826                 cjGlobal += src->ncjInUse;
3827             }
3828         }
3829
3830         dest.ncjInUse = dest.cj.size();
3831     }
3832
3833 #ifndef NDEBUG
3834     int ncjTotalNew = 0;
3835     for (auto &dest : destSet)
3836     {
3837         ncjTotalNew += dest.ncjInUse;
3838     }
3839     GMX_RELEASE_ASSERT(ncjTotalNew == ncjTotal, "The total size of the lists before and after rebalancing should match");
3840 #endif
3841 }
3842
3843 /* Returns if the pairlists are so imbalanced that it is worth rebalancing. */
3844 static bool checkRebalanceSimpleLists(gmx::ArrayRef<const NbnxnPairlistCpu> lists)
3845 {
3846     int numLists = lists.ssize();
3847     int ncjMax   = 0;
3848     int ncjTotal = 0;
3849     for (int s = 0; s < numLists; s++)
3850     {
3851         ncjMax    = std::max(ncjMax, lists[s].ncjInUse);
3852         ncjTotal += lists[s].ncjInUse;
3853     }
3854     if (debug)
3855     {
3856         fprintf(debug, "Pair-list ncjMax %d ncjTotal %d\n", ncjMax, ncjTotal);
3857     }
3858     /* The rebalancing adds 3% extra time to the search. Heuristically we
3859      * determined that under common conditions the non-bonded kernel balance
3860      * improvement will outweigh this when the imbalance is more than 3%.
3861      * But this will, obviously, depend on search vs kernel time and nstlist.
3862      */
3863     const real rebalanceTolerance = 1.03;
3864
3865     return numLists*ncjMax > ncjTotal*rebalanceTolerance;
3866 }
3867
3868 /* Perform a count (linear) sort to sort the smaller lists to the end.
3869  * This avoids load imbalance on the GPU, as large lists will be
3870  * scheduled and executed first and the smaller lists later.
3871  * Load balancing between multi-processors only happens at the end
3872  * and there smaller lists lead to more effective load balancing.
3873  * The sorting is done on the cj4 count, not on the actual pair counts.
3874  * Not only does this make the sort faster, but it also results in
3875  * better load balancing than using a list sorted on exact load.
3876  * This function swaps the pointer in the pair list to avoid a copy operation.
3877  */
3878 static void sort_sci(NbnxnPairlistGpu *nbl)
3879 {
3880     if (nbl->cj4.size() <= nbl->sci.size())
3881     {
3882         /* nsci = 0 or all sci have size 1, sorting won't change the order */
3883         return;
3884     }
3885
3886     NbnxnPairlistGpuWork &work = *nbl->work;
3887
3888     /* We will distinguish differences up to double the average */
3889     const int m = (2*nbl->cj4.size())/nbl->sci.size();
3890
3891     /* Resize work.sci_sort so we can sort into it */
3892     work.sci_sort.resize(nbl->sci.size());
3893
3894     std::vector<int> &sort = work.sortBuffer;
3895     /* Set up m + 1 entries in sort, initialized at 0 */
3896     sort.clear();
3897     sort.resize(m + 1, 0);
3898     /* Count the entries of each size */
3899     for (const nbnxn_sci_t &sci : nbl->sci)
3900     {
3901         int i = std::min(m, sci.numJClusterGroups());
3902         sort[i]++;
3903     }
3904     /* Calculate the offset for each count */
3905     int s0  = sort[m];
3906     sort[m] = 0;
3907     for (int i = m - 1; i >= 0; i--)
3908     {
3909         int s1  = sort[i];
3910         sort[i] = sort[i + 1] + s0;
3911         s0      = s1;
3912     }
3913
3914     /* Sort entries directly into place */
3915     gmx::ArrayRef<nbnxn_sci_t> sci_sort = work.sci_sort;
3916     for (const nbnxn_sci_t &sci : nbl->sci)
3917     {
3918         int i = std::min(m, sci.numJClusterGroups());
3919         sci_sort[sort[i]++] = sci;
3920     }
3921
3922     /* Swap the sci pointers so we use the new, sorted list */
3923     std::swap(nbl->sci, work.sci_sort);
3924 }
3925
3926 //! Prepares CPU lists produced by the search for dynamic pruning
3927 static void prepareListsForDynamicPruning(gmx::ArrayRef<NbnxnPairlistCpu> lists);
3928
3929 void
3930 PairlistSet::constructPairlists(const Nbnxm::GridSet          &gridSet,
3931                                 gmx::ArrayRef<PairsearchWork>  searchWork,
3932                                 nbnxn_atomdata_t              *nbat,
3933                                 const t_blocka                *excl,
3934                                 const Nbnxm::KernelType        kernelType,
3935                                 const int                      minimumIlistCountForGpuBalancing,
3936                                 t_nrnb                        *nrnb,
3937                                 SearchCycleCounting           *searchCycleCounting)
3938 {
3939     const real         rlist    = params_.rlistOuter;
3940
3941     int                nsubpair_target;
3942     float              nsubpair_tot_est;
3943     int                ci_block;
3944     gmx_bool           progBal;
3945     int                np_tot, np_noq, np_hlj, nap;
3946
3947     const int          numLists = (isCpuType_ ? cpuLists_.size() : gpuLists_.size());
3948
3949     if (debug)
3950     {
3951         fprintf(debug, "ns making %d nblists\n", numLists);
3952     }
3953
3954     nbat->bUseBufferFlags = (nbat->out.size() > 1);
3955     /* We should re-init the flags before making the first list */
3956     if (nbat->bUseBufferFlags && locality_ == InteractionLocality::Local)
3957     {
3958         init_buffer_flags(&nbat->buffer_flags, nbat->numAtoms());
3959     }
3960
3961     int nzi;
3962     if (locality_ == InteractionLocality::Local)
3963     {
3964         /* Only zone (grid) 0 vs 0 */
3965         nzi = 1;
3966     }
3967     else
3968     {
3969         nzi = gridSet.domainSetup().zones->nizone;
3970     }
3971
3972     if (!isCpuType_ && minimumIlistCountForGpuBalancing > 0)
3973     {
3974         get_nsubpair_target(gridSet, locality_, rlist, minimumIlistCountForGpuBalancing,
3975                             &nsubpair_target, &nsubpair_tot_est);
3976     }
3977     else
3978     {
3979         nsubpair_target  = 0;
3980         nsubpair_tot_est = 0;
3981     }
3982
3983     /* Clear all pair-lists */
3984     for (int th = 0; th < numLists; th++)
3985     {
3986         if (isCpuType_)
3987         {
3988             clear_pairlist(&cpuLists_[th]);
3989         }
3990         else
3991         {
3992             clear_pairlist(&gpuLists_[th]);
3993         }
3994
3995         if (params_.haveFep)
3996         {
3997             clear_pairlist_fep(fepLists_[th]);
3998         }
3999     }
4000
4001     const gmx_domdec_zones_t *ddZones = gridSet.domainSetup().zones;
4002
4003     for (int zi = 0; zi < nzi; zi++)
4004     {
4005         const Grid &iGrid = gridSet.grids()[zi];
4006
4007         int                 zj0;
4008         int                 zj1;
4009         if (locality_ == InteractionLocality::Local)
4010         {
4011             zj0 = 0;
4012             zj1 = 1;
4013         }
4014         else
4015         {
4016             zj0 = ddZones->izone[zi].j0;
4017             zj1 = ddZones->izone[zi].j1;
4018             if (zi == 0)
4019             {
4020                 zj0++;
4021             }
4022         }
4023         for (int zj = zj0; zj < zj1; zj++)
4024         {
4025             const Grid &jGrid = gridSet.grids()[zj];
4026
4027             if (debug)
4028             {
4029                 fprintf(debug, "ns search grid %d vs %d\n", zi, zj);
4030             }
4031
4032             searchCycleCounting->start(enbsCCsearch);
4033
4034             ci_block = get_ci_block_size(iGrid, gridSet.domainSetup().haveMultipleDomains, numLists);
4035
4036             /* With GPU: generate progressively smaller lists for
4037              * load balancing for local only or non-local with 2 zones.
4038              */
4039             progBal = (locality_ == InteractionLocality::Local || ddZones->n <= 2);
4040
4041 #pragma omp parallel for num_threads(numLists) schedule(static)
4042             for (int th = 0; th < numLists; th++)
4043             {
4044                 try
4045                 {
4046                     /* Re-init the thread-local work flag data before making
4047                      * the first list (not an elegant conditional).
4048                      */
4049                     if (nbat->bUseBufferFlags && ((zi == 0 && zj == 0)))
4050                     {
4051                         init_buffer_flags(&searchWork[th].buffer_flags, nbat->numAtoms());
4052                     }
4053
4054                     if (combineLists_ && th > 0)
4055                     {
4056                         GMX_ASSERT(!isCpuType_, "Can only combine GPU lists");
4057
4058                         clear_pairlist(&gpuLists_[th]);
4059                     }
4060
4061                     PairsearchWork &work = searchWork[th];
4062
4063                     work.cycleCounter.start();
4064
4065                     t_nblist *fepListPtr = (fepLists_.empty() ? nullptr : fepLists_[th]);
4066
4067                     /* Divide the i cells equally over the pairlists */
4068                     if (isCpuType_)
4069                     {
4070                         nbnxn_make_pairlist_part(gridSet, iGrid, jGrid,
4071                                                  &work, nbat, *excl,
4072                                                  rlist,
4073                                                  kernelType,
4074                                                  ci_block,
4075                                                  nbat->bUseBufferFlags,
4076                                                  nsubpair_target,
4077                                                  progBal, nsubpair_tot_est,
4078                                                  th, numLists,
4079                                                  &cpuLists_[th],
4080                                                  fepListPtr);
4081                     }
4082                     else
4083                     {
4084                         nbnxn_make_pairlist_part(gridSet, iGrid, jGrid,
4085                                                  &work, nbat, *excl,
4086                                                  rlist,
4087                                                  kernelType,
4088                                                  ci_block,
4089                                                  nbat->bUseBufferFlags,
4090                                                  nsubpair_target,
4091                                                  progBal, nsubpair_tot_est,
4092                                                  th, numLists,
4093                                                  &gpuLists_[th],
4094                                                  fepListPtr);
4095                     }
4096
4097                     work.cycleCounter.stop();
4098                 }
4099                 GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
4100             }
4101             searchCycleCounting->stop(enbsCCsearch);
4102
4103             np_tot = 0;
4104             np_noq = 0;
4105             np_hlj = 0;
4106             for (int th = 0; th < numLists; th++)
4107             {
4108                 inc_nrnb(nrnb, eNR_NBNXN_DIST2, searchWork[th].ndistc);
4109
4110                 if (isCpuType_)
4111                 {
4112                     const NbnxnPairlistCpu &nbl = cpuLists_[th];
4113                     np_tot += nbl.cj.size();
4114                     np_noq += nbl.work->ncj_noq;
4115                     np_hlj += nbl.work->ncj_hlj;
4116                 }
4117                 else
4118                 {
4119                     const NbnxnPairlistGpu &nbl = gpuLists_[th];
4120                     /* This count ignores potential subsequent pair pruning */
4121                     np_tot += nbl.nci_tot;
4122                 }
4123             }
4124             if (isCpuType_)
4125             {
4126                 nap      = cpuLists_[0].na_ci*cpuLists_[0].na_cj;
4127             }
4128             else
4129             {
4130                 nap      = gmx::square(gpuLists_[0].na_ci);
4131             }
4132             natpair_ljq_ = (np_tot - np_noq)*nap - np_hlj*nap/2;
4133             natpair_lj_  = np_noq*nap;
4134             natpair_q_   = np_hlj*nap/2;
4135
4136             if (combineLists_ && numLists > 1)
4137             {
4138                 GMX_ASSERT(!isCpuType_, "Can only combine GPU lists");
4139
4140                 searchCycleCounting->start(enbsCCcombine);
4141
4142                 combine_nblists(gmx::constArrayRefFromArray(&gpuLists_[1], numLists - 1),
4143                                 &gpuLists_[0]);
4144
4145                 searchCycleCounting->stop(enbsCCcombine);
4146             }
4147         }
4148     }
4149
4150     if (isCpuType_)
4151     {
4152         if (numLists > 1 && checkRebalanceSimpleLists(cpuLists_))
4153         {
4154             rebalanceSimpleLists(cpuLists_, cpuListsWork_, searchWork);
4155
4156             /* Swap the sets of pair lists */
4157             cpuLists_.swap(cpuListsWork_);
4158         }
4159     }
4160     else
4161     {
4162         /* Sort the entries on size, large ones first */
4163         if (combineLists_ || gpuLists_.size() == 1)
4164         {
4165             sort_sci(&gpuLists_[0]);
4166         }
4167         else
4168         {
4169 #pragma omp parallel for num_threads(numLists) schedule(static)
4170             for (int th = 0; th < numLists; th++)
4171             {
4172                 try
4173                 {
4174                     sort_sci(&gpuLists_[th]);
4175                 }
4176                 GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
4177             }
4178         }
4179     }
4180
4181     if (nbat->bUseBufferFlags)
4182     {
4183         reduce_buffer_flags(searchWork, numLists, &nbat->buffer_flags);
4184     }
4185
4186     if (gridSet.haveFep())
4187     {
4188         /* Balance the free-energy lists over all the threads */
4189         balance_fep_lists(fepLists_, searchWork);
4190     }
4191
4192     if (isCpuType_)
4193     {
4194         /* This is a fresh list, so not pruned, stored using ci.
4195          * ciOuter is invalid at this point.
4196          */
4197         GMX_ASSERT(cpuLists_[0].ciOuter.empty(), "ciOuter is invalid so it should be empty");
4198     }
4199
4200     /* If we have more than one list, they either got rebalancing (CPU)
4201      * or combined (GPU), so we should dump the final result to debug.
4202      */
4203     if (debug)
4204     {
4205         if (isCpuType_ && cpuLists_.size() > 1)
4206         {
4207             for (auto &cpuList : cpuLists_)
4208             {
4209                 print_nblist_statistics(debug, cpuList, gridSet, rlist);
4210             }
4211         }
4212         else if (!isCpuType_ && gpuLists_.size() > 1)
4213         {
4214             print_nblist_statistics(debug, gpuLists_[0], gridSet, rlist);
4215         }
4216     }
4217
4218     if (debug)
4219     {
4220         if (gmx_debug_at)
4221         {
4222             if (isCpuType_)
4223             {
4224                 for (auto &cpuList : cpuLists_)
4225                 {
4226                     print_nblist_ci_cj(debug, cpuList);
4227                 }
4228             }
4229             else
4230             {
4231                 print_nblist_sci_cj(debug, gpuLists_[0]);
4232             }
4233         }
4234
4235         if (nbat->bUseBufferFlags)
4236         {
4237             print_reduction_cost(&nbat->buffer_flags, numLists);
4238         }
4239     }
4240
4241     if (params_.useDynamicPruning && isCpuType_)
4242     {
4243         prepareListsForDynamicPruning(cpuLists_);
4244     }
4245 }
4246
4247 void
4248 PairlistSets::construct(const InteractionLocality  iLocality,
4249                         PairSearch                *pairSearch,
4250                         nbnxn_atomdata_t          *nbat,
4251                         const t_blocka            *excl,
4252                         const Nbnxm::KernelType    kernelType,
4253                         const int64_t              step,
4254                         t_nrnb                    *nrnb)
4255 {
4256     pairlistSet(iLocality).constructPairlists(pairSearch->gridSet(), pairSearch->work(),
4257                                               nbat, excl, kernelType, minimumIlistCountForGpuBalancing_,
4258                                               nrnb, &pairSearch->cycleCounting_);
4259
4260     if (iLocality == Nbnxm::InteractionLocality::Local)
4261     {
4262         outerListCreationStep_ = step;
4263     }
4264     else
4265     {
4266         GMX_RELEASE_ASSERT(outerListCreationStep_ == step,
4267                            "Outer list should be created at the same step as the inner list");
4268     }
4269
4270     /* Special performance logging stuff (env.var. GMX_NBNXN_CYCLE) */
4271     if (iLocality == InteractionLocality::Local)
4272     {
4273         pairSearch->cycleCounting_.searchCount_++;
4274     }
4275     if (pairSearch->cycleCounting_.recordCycles_ &&
4276         (!pairSearch->gridSet().domainSetup().haveMultipleDomains || iLocality == InteractionLocality::NonLocal) &&
4277         pairSearch->cycleCounting_.searchCount_ % 100 == 0)
4278     {
4279         pairSearch->cycleCounting_.printCycles(stderr, pairSearch->work());
4280     }
4281 }
4282
4283 void
4284 nonbonded_verlet_t::constructPairlist(const Nbnxm::InteractionLocality  iLocality,
4285                                       const t_blocka                   *excl,
4286                                       int64_t                           step,
4287                                       t_nrnb                           *nrnb)
4288 {
4289     pairlistSets_->construct(iLocality, pairSearch_.get(), nbat.get(), excl,
4290                              kernelSetup_.kernelType,
4291                              step, nrnb);
4292
4293     if (useGpu())
4294     {
4295         /* Launch the transfer of the pairlist to the GPU.
4296          *
4297          * NOTE: The launch overhead is currently not timed separately
4298          */
4299         Nbnxm::gpu_init_pairlist(gpu_nbv,
4300                                  pairlistSets().pairlistSet(iLocality).gpuList(),
4301                                  iLocality);
4302     }
4303 }
4304
4305 static void prepareListsForDynamicPruning(gmx::ArrayRef<NbnxnPairlistCpu> lists)
4306 {
4307     /* TODO: Restructure the lists so we have actual outer and inner
4308      *       list objects so we can set a single pointer instead of
4309      *       swapping several pointers.
4310      */
4311
4312     for (auto &list : lists)
4313     {
4314         /* The search produced a list in ci/cj.
4315          * Swap the list pointers so we get the outer list is ciOuter,cjOuter
4316          * and we can prune that to get an inner list in ci/cj.
4317          */
4318         GMX_RELEASE_ASSERT(list.ciOuter.empty() && list.cjOuter.empty(),
4319                            "The outer lists should be empty before preparation");
4320
4321         std::swap(list.ci, list.ciOuter);
4322         std::swap(list.cj, list.cjOuter);
4323     }
4324 }