Clean up calc_verlet_buffer_size()
[alexxy/gromacs.git] / src / gromacs / nbnxm / pairlist_tuning.cpp
1 /*
2  * This file is part of the GROMACS molecular simulation package.
3  *
4  * Copyright (c) 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 /*! \internal \file
37  *
38  * \brief Implements functions for tuning adjustable parameters for the nbnxn non-bonded search and interaction kernels
39  *
40  * \author Berk Hess <hess@kth.se>
41  * \ingroup __module_nb_verlet
42  */
43
44 #include "gmxpre.h"
45
46 #include "pairlist_tuning.h"
47
48 #include <cassert>
49 #include <cmath>
50 #include <cstdlib>
51
52 #include <algorithm>
53 #include <string>
54
55 #include "gromacs/domdec/domdec.h"
56 #include "gromacs/hardware/cpuinfo.h"
57 #include "gromacs/math/vec.h"
58 #include "gromacs/mdlib/calc_verletbuf.h"
59 #include "gromacs/mdtypes/commrec.h"
60 #include "gromacs/mdtypes/inputrec.h"
61 #include "gromacs/mdtypes/interaction_const.h"
62 #include "gromacs/mdtypes/state.h"
63 #include "gromacs/nbnxm/nbnxm.h"
64 #include "gromacs/nbnxm/nbnxm_geometry.h"
65 #include "gromacs/pbcutil/pbc.h"
66 #include "gromacs/topology/topology.h"
67 #include "gromacs/utility/cstringutil.h"
68 #include "gromacs/utility/fatalerror.h"
69 #include "gromacs/utility/gmxassert.h"
70 #include "gromacs/utility/logger.h"
71 #include "gromacs/utility/strconvert.h"
72 #include "gromacs/utility/stringutil.h"
73
74 /*! \brief Returns if we can (heuristically) change nstlist and rlist
75  *
76  * \param [in] ir  The input parameter record
77  */
78 static bool supportsDynamicPairlistGenerationInterval(const t_inputrec &ir)
79 {
80     return
81         ir.cutoff_scheme == ecutsVERLET &&
82         EI_DYNAMICS(ir.eI) &&
83         !(EI_MD(ir.eI) && ir.etc == etcNO) &&
84         ir.verletbuf_tol > 0;
85 }
86
87 /*! \brief Cost of non-bonded kernels
88  *
89  * We determine the extra cost of the non-bonded kernels compared to
90  * a reference nstlist value of 10 (which is the default in grompp).
91  */
92 static const int    nbnxnReferenceNstlist = 10;
93 //! The values to try when switching
94 const int           nstlist_try[] = { 20, 25, 40, 50, 80, 100 };
95 //! Number of elements in the neighborsearch list trials.
96 #define NNSTL  (sizeof(nstlist_try)/sizeof(nstlist_try[0]))
97 /* Increase nstlist until the size of the pair-list increased by
98  * \p c_nbnxnListSizeFactor??? or more, but never more than
99  * \p c_nbnxnListSizeFactor??? + \p c_nbnxnListSizeFactorMargin.
100  * Since we have dynamic pair list pruning, the force kernel cost depends
101  * only very weakly on nstlist. It depends strongly on nstlistPrune.
102  * Increasing nstlist mainly affects the cost of the pair search (down due
103  * to lower frequency, up due to larger list) and the list pruning kernel.
104  * We increase nstlist conservatively with regard to kernel performance.
105  * In serial the search cost is not high and thus we don't gain much by
106  * increasing nstlist a lot. In parallel the MPI and CPU-GPU communication
107  * volume as well as the communication buffer preparation and reduction time
108  * increase quickly with rlist and thus nslist. Therefore we should avoid
109  * large nstlist, even if that also reduces the domain decomposition cost.
110  * With GPUs we perform the dynamic pruning in a rolling fashion and this
111  * overlaps with the update on the CPU, which allows even larger nstlist.
112  */
113 // CPU: pair-search is a factor ~1.5 slower than the non-bonded kernel.
114 //! Target pair-list size increase ratio for CPU
115 static const float c_nbnxnListSizeFactorCpu           = 1.25;
116 // Intel KNL: pair-search is a factor ~2-3 slower than the non-bonded kernel.
117 //! Target pair-list size increase ratio for Intel KNL
118 static const float c_nbnxnListSizeFactorIntelXeonPhi  = 1.4;
119 // GPU: pair-search is a factor 1.5-3 slower than the non-bonded kernel.
120 //! Target pair-list size increase ratio for GPU
121 static const float c_nbnxnListSizeFactorGPU           = 1.4;
122 //! Never increase the size of the pair-list more than the factor above plus this margin
123 static const float c_nbnxnListSizeFactorMargin        = 0.1;
124
125 void increaseNstlist(FILE *fp, t_commrec *cr,
126                      t_inputrec *ir, int nstlist_cmdline,
127                      const gmx_mtop_t *mtop,
128                      const matrix box,
129                      bool useOrEmulateGpuForNonbondeds,
130                      const gmx::CpuInfo &cpuinfo)
131 {
132     if (!EI_DYNAMICS(ir->eI))
133     {
134         /* Can only increase nstlist with dynamics */
135         return;
136     }
137
138     float                  listfac_ok, listfac_max;
139     int                    nstlist_orig, nstlist_prev;
140     real                   rlist_inc, rlist_ok, rlist_max;
141     real                   rlist_new, rlist_prev;
142     size_t                 nstlist_ind = 0;
143     gmx_bool               bBox, bDD, bCont;
144     const char            *nstl_gpu = "\nFor optimal performance with a GPU nstlist (now %d) should be larger.\nThe optimum depends on your CPU and GPU resources.\nYou might want to try several nstlist values.\n";
145     const char            *nve_err  = "Can not increase nstlist because an NVE ensemble is used";
146     const char            *vbd_err  = "Can not increase nstlist because verlet-buffer-tolerance is not set or used";
147     const char            *box_err  = "Can not increase nstlist because the box is too small";
148     const char            *dd_err   = "Can not increase nstlist because of domain decomposition limitations";
149     char                   buf[STRLEN];
150
151     if (nstlist_cmdline <= 0)
152     {
153         if (ir->nstlist == 1)
154         {
155             /* The user probably set nstlist=1 for a reason,
156              * don't mess with the settings.
157              */
158             return;
159         }
160
161         /* With a GPU and fixed nstlist suggest tuning nstlist */
162         if (fp != nullptr &&
163             useOrEmulateGpuForNonbondeds &&
164             ir->nstlist < nstlist_try[0] &&
165             !supportsDynamicPairlistGenerationInterval(*ir))
166         {
167             fprintf(fp, nstl_gpu, ir->nstlist);
168         }
169
170         nstlist_ind = 0;
171         while (nstlist_ind < NNSTL && ir->nstlist >= nstlist_try[nstlist_ind])
172         {
173             nstlist_ind++;
174         }
175         if (nstlist_ind == NNSTL)
176         {
177             /* There are no larger nstlist value to try */
178             return;
179         }
180     }
181
182     if (EI_MD(ir->eI) && ir->etc == etcNO)
183     {
184         if (MASTER(cr))
185         {
186             fprintf(stderr, "%s\n", nve_err);
187         }
188         if (fp != nullptr)
189         {
190             fprintf(fp, "%s\n", nve_err);
191         }
192
193         return;
194     }
195
196     if (ir->verletbuf_tol == 0 && useOrEmulateGpuForNonbondeds)
197     {
198         gmx_fatal(FARGS, "You are using an old tpr file with a GPU, please generate a new tpr file with an up to date version of grompp");
199     }
200
201     if (ir->verletbuf_tol < 0)
202     {
203         if (MASTER(cr))
204         {
205             fprintf(stderr, "%s\n", vbd_err);
206         }
207         if (fp != nullptr)
208         {
209             fprintf(fp, "%s\n", vbd_err);
210         }
211
212         return;
213     }
214
215     GMX_RELEASE_ASSERT(supportsDynamicPairlistGenerationInterval(*ir), "In all cases that do not support dynamic nstlist, we should have returned with an appropriate message above");
216
217     if (useOrEmulateGpuForNonbondeds)
218     {
219         listfac_ok  = c_nbnxnListSizeFactorGPU;
220     }
221     else if (cpuinfo.brandString().find("Xeon Phi") != std::string::npos)
222     {
223         listfac_ok  = c_nbnxnListSizeFactorIntelXeonPhi;
224     }
225     else
226     {
227         listfac_ok  = c_nbnxnListSizeFactorCpu;
228     }
229     listfac_max     = listfac_ok + c_nbnxnListSizeFactorMargin;
230
231     nstlist_orig    = ir->nstlist;
232     if (nstlist_cmdline > 0)
233     {
234         if (fp)
235         {
236             sprintf(buf, "Getting nstlist=%d from command line option",
237                     nstlist_cmdline);
238         }
239         ir->nstlist = nstlist_cmdline;
240     }
241
242     ListSetupType      listType  = (useOrEmulateGpuForNonbondeds ? ListSetupType::Gpu : ListSetupType::CpuSimdWhenSupported);
243     VerletbufListSetup listSetup = verletbufGetSafeListSetup(listType);
244
245     /* Allow rlist to make the list a given factor larger than the list
246      * would be with the reference value for nstlist (10).
247      */
248     nstlist_prev = ir->nstlist;
249     ir->nstlist  = nbnxnReferenceNstlist;
250     const real rlistWithReferenceNstlist =
251         calcVerletBufferSize(*mtop, det(box), *ir, ir->nstlist, ir->nstlist - 1,
252                              -1, listSetup);
253     ir->nstlist  = nstlist_prev;
254
255     /* Determine the pair list size increase due to zero interactions */
256     rlist_inc = nbnxn_get_rlist_effective_inc(listSetup.cluster_size_j,
257                                               mtop->natoms/det(box));
258     rlist_ok  = (rlistWithReferenceNstlist + rlist_inc)*std::cbrt(listfac_ok) - rlist_inc;
259     rlist_max = (rlistWithReferenceNstlist + rlist_inc)*std::cbrt(listfac_max) - rlist_inc;
260     if (debug)
261     {
262         fprintf(debug, "nstlist tuning: rlist_inc %.3f rlist_ok %.3f rlist_max %.3f\n",
263                 rlist_inc, rlist_ok, rlist_max);
264     }
265
266     nstlist_prev = nstlist_orig;
267     rlist_prev   = ir->rlist;
268     do
269     {
270         if (nstlist_cmdline <= 0)
271         {
272             ir->nstlist = nstlist_try[nstlist_ind];
273         }
274
275         /* Set the pair-list buffer size in ir */
276         rlist_new =
277             calcVerletBufferSize(*mtop, det(box), *ir, ir->nstlist, ir->nstlist - 1, -1, listSetup);
278
279         /* Does rlist fit in the box? */
280         bBox = (gmx::square(rlist_new) < max_cutoff2(ir->ePBC, box));
281         bDD  = TRUE;
282         if (bBox && DOMAINDECOMP(cr))
283         {
284             /* Check if rlist fits in the domain decomposition */
285             if (inputrec2nboundeddim(ir) < DIM)
286             {
287                 gmx_incons("Changing nstlist with domain decomposition and unbounded dimensions is not implemented yet");
288             }
289             t_state state_tmp;
290             copy_mat(box, state_tmp.box);
291             bDD = change_dd_cutoff(cr, state_tmp, rlist_new);
292         }
293
294         if (debug)
295         {
296             fprintf(debug, "nstlist %d rlist %.3f bBox %s bDD %s\n",
297                     ir->nstlist, rlist_new, gmx::boolToString(bBox), gmx::boolToString(bDD));
298         }
299
300         bCont = FALSE;
301
302         if (nstlist_cmdline <= 0)
303         {
304             if (bBox && bDD && rlist_new <= rlist_max)
305             {
306                 /* Increase nstlist */
307                 nstlist_prev = ir->nstlist;
308                 rlist_prev   = rlist_new;
309                 bCont        = (nstlist_ind+1 < NNSTL && rlist_new < rlist_ok);
310             }
311             else
312             {
313                 /* Stick with the previous nstlist */
314                 ir->nstlist = nstlist_prev;
315                 rlist_new   = rlist_prev;
316                 bBox        = TRUE;
317                 bDD         = TRUE;
318             }
319         }
320
321         nstlist_ind++;
322     }
323     while (bCont);
324
325     if (!bBox || !bDD)
326     {
327         gmx_warning("%s", !bBox ? box_err : dd_err);
328         if (fp != nullptr)
329         {
330             fprintf(fp, "\n%s\n", !bBox ? box_err : dd_err);
331         }
332         ir->nstlist = nstlist_orig;
333     }
334     else if (ir->nstlist != nstlist_orig || rlist_new != ir->rlist)
335     {
336         sprintf(buf, "Changing nstlist from %d to %d, rlist from %g to %g",
337                 nstlist_orig, ir->nstlist,
338                 ir->rlist, rlist_new);
339         if (MASTER(cr))
340         {
341             fprintf(stderr, "%s\n\n", buf);
342         }
343         if (fp != nullptr)
344         {
345             fprintf(fp, "%s\n\n", buf);
346         }
347         ir->rlist     = rlist_new;
348     }
349 }
350
351 /*! \brief The interval in steps at which we perform dynamic, rolling pruning on a GPU.
352  *
353  * Ideally we should auto-tune this value.
354  * Not considering overheads, 1 would be the ideal value. But 2 seems
355  * a reasonable compromise that reduces GPU kernel launch overheads and
356  * also avoids inefficiency on large GPUs when pruning small lists.
357  * Because with domain decomposition we alternate local/non-local pruning
358  * at even/odd steps, which gives a period of 2, this value currenly needs
359  * to be 2, which is indirectly asserted when the GPU pruning is dispatched
360  * during the force evaluation.
361  */
362 static const int c_nbnxnGpuRollingListPruningInterval = 2;
363
364 /*! \brief The minimum nstlist for dynamic pair list pruning.
365  *
366  * In most cases going lower than 4 will lead to a too high pruning cost.
367  * This value should be a multiple of \p c_nbnxnGpuRollingListPruningInterval
368  */
369 static const int c_nbnxnDynamicListPruningMinLifetime = 4;
370
371 /*! \brief Set the dynamic pairlist pruning parameters in \p ic
372  *
373  * \param[in]     ir          The input parameter record
374  * \param[in]     mtop        The global topology
375  * \param[in]     box         The unit cell
376  * \param[in]     useGpuList  Tells if we are using a GPU type pairlist
377  * \param[in]     listSetup   The nbnxn pair list setup
378  * \param[in]     userSetNstlistPrune  The user set ic->nstlistPrune (using an env.var.)
379  * \param[in] ic              The nonbonded interactions constants
380  * \param[in,out] listParams  The list setup parameters
381  */
382 static void
383 setDynamicPairlistPruningParameters(const t_inputrec             *ir,
384                                     const gmx_mtop_t             *mtop,
385                                     const matrix                  box,
386                                     const bool                    useGpuList,
387                                     const VerletbufListSetup     &listSetup,
388                                     const bool                    userSetNstlistPrune,
389                                     const interaction_const_t    *ic,
390                                     NbnxnListParameters          *listParams)
391 {
392     listParams->lifetime = ir->nstlist - 1;
393
394     /* When nstlistPrune was set by the user, we need to execute one loop
395      * iteration to determine rlistInner.
396      * Otherwise we compute rlistInner and increase nstlist as long as
397      * we have a pairlist buffer of length 0 (i.e. rlistInner == cutoff).
398      */
399     const real interactionCutoff = std::max(ic->rcoulomb, ic->rvdw);
400     int        tunedNstlistPrune = listParams->nstlistPrune;
401     do
402     {
403         /* Dynamic pruning on the GPU is performed on the list for
404          * the next step on the coordinates of the current step,
405          * so the list lifetime is nstlistPrune (not the usual nstlist-1).
406          */
407         int listLifetime         = tunedNstlistPrune - (useGpuList ? 0 : 1);
408         listParams->nstlistPrune = tunedNstlistPrune;
409         listParams->rlistInner   =
410             calcVerletBufferSize(*mtop, det(box), *ir,
411                                  tunedNstlistPrune, listLifetime,
412                                  -1, listSetup);
413
414         /* On the GPU we apply the dynamic pruning in a rolling fashion
415          * every c_nbnxnGpuRollingListPruningInterval steps,
416          * so keep nstlistPrune a multiple of the interval.
417          */
418         tunedNstlistPrune += useGpuList ? c_nbnxnGpuRollingListPruningInterval : 1;
419     }
420     while (!userSetNstlistPrune &&
421            tunedNstlistPrune < ir->nstlist &&
422            listParams->rlistInner == interactionCutoff);
423
424     if (userSetNstlistPrune)
425     {
426         listParams->useDynamicPruning = true;
427     }
428     else
429     {
430         /* Determine the pair list size increase due to zero interactions */
431         real rlistInc = nbnxn_get_rlist_effective_inc(listSetup.cluster_size_j,
432                                                       mtop->natoms/det(box));
433
434         /* Dynamic pruning is only useful when the inner list is smaller than
435          * the outer. The factor 0.99 ensures at least 3% list size reduction.
436          *
437          * With dynamic pruning on the CPU we prune after updating,
438          * so nstlistPrune=nstlist-1 would add useless extra work.
439          * With the GPU there will probably be more overhead than gain
440          * with nstlistPrune=nstlist-1, so we disable dynamic pruning.
441          * Note that in such cases the first sub-condition is likely also false.
442          */
443         listParams->useDynamicPruning =
444             (listParams->rlistInner + rlistInc < 0.99*(listParams->rlistOuter + rlistInc) &&
445              listParams->nstlistPrune < listParams->lifetime);
446     }
447
448     if (!listParams->useDynamicPruning)
449     {
450         /* These parameters should not be used, but set them to useful values */
451         listParams->nstlistPrune  = -1;
452         listParams->rlistInner    = listParams->rlistOuter;
453     }
454 }
455
456 /*! \brief Returns a string describing the setup of a single pair-list
457  *
458  * \param[in] listName           Short name of the list, can be ""
459  * \param[in] nstList            The list update interval in steps
460  * \param[in] nstListForSpacing  Update interval for setting the number characters for printing \p nstList
461  * \param[in] rList              List cut-off radius
462  * \param[in] interactionCutoff  The interaction cut-off, use for printing the list buffer size
463  */
464 static std::string formatListSetup(const std::string &listName,
465                                    int                nstList,
466                                    int                nstListForSpacing,
467                                    real               rList,
468                                    real               interactionCutoff)
469 {
470     std::string listSetup = "  ";
471     if (!listName.empty())
472     {
473         listSetup += listName + " list: ";
474     }
475     listSetup += "updated every ";
476     // Make the shortest int format string that fits nstListForSpacing
477     std::string nstListFormat = "%" + gmx::formatString("%zu", gmx::formatString("%d", nstListForSpacing).size()) + "d";
478     listSetup += gmx::formatString(nstListFormat.c_str(), nstList);
479     listSetup += gmx::formatString(" steps, buffer %.3f nm, rlist %.3f nm\n",
480                                    rList - interactionCutoff, rList);
481
482     return listSetup;
483 }
484
485 void setupDynamicPairlistPruning(const gmx::MDLogger       &mdlog,
486                                  const t_inputrec          *ir,
487                                  const gmx_mtop_t          *mtop,
488                                  matrix                     box,
489                                  const interaction_const_t *ic,
490                                  NbnxnListParameters       *listParams)
491 {
492     GMX_RELEASE_ASSERT(listParams->rlistOuter > 0, "With the nbnxn setup rlist should be > 0");
493
494     /* Initialize the parameters to no dynamic list pruning */
495     listParams->useDynamicPruning = false;
496
497     const VerletbufListSetup ls   =
498     {
499         IClusterSizePerListType[listParams->pairlistType],
500         JClusterSizePerListType[listParams->pairlistType]
501     };
502
503     /* Currently emulation mode does not support dual pair-lists */
504     const bool useGpuList         = (listParams->pairlistType == PairlistType::Hierarchical8x8);
505
506     if (supportsDynamicPairlistGenerationInterval(*ir) &&
507         getenv("GMX_DISABLE_DYNAMICPRUNING") == nullptr)
508     {
509         /* Note that nstlistPrune can have any value independently of nstlist.
510          * Actually applying rolling pruning is only useful when
511          * nstlistPrune < nstlist -1
512          */
513         char *env                 = getenv("GMX_NSTLIST_DYNAMICPRUNING");
514         bool  userSetNstlistPrune = (env != nullptr);
515
516         if (userSetNstlistPrune)
517         {
518             char *end;
519             listParams->nstlistPrune = strtol(env, &end, 10);
520             if (!end || (*end != 0) ||
521                 !(listParams->nstlistPrune > 0 && listParams->nstlistPrune < ir->nstlist))
522             {
523                 gmx_fatal(FARGS, "Invalid value passed in GMX_NSTLIST_DYNAMICPRUNING=%s, should be > 0 and < nstlist", env);
524             }
525         }
526         else
527         {
528             static_assert(c_nbnxnDynamicListPruningMinLifetime % c_nbnxnGpuRollingListPruningInterval == 0,
529                           "c_nbnxnDynamicListPruningMinLifetime sets the starting value for nstlistPrune, which should be divisible by the rolling pruning interval for efficiency reasons.");
530
531             // TODO: Use auto-tuning to determine nstlistPrune
532             listParams->nstlistPrune = c_nbnxnDynamicListPruningMinLifetime;
533         }
534
535         setDynamicPairlistPruningParameters(ir, mtop, box, useGpuList, ls,
536                                             userSetNstlistPrune, ic,
537                                             listParams);
538
539         if (listParams->useDynamicPruning && useGpuList)
540         {
541             /* Note that we can round down here. This makes the effective
542              * rolling pruning interval slightly shorter than nstlistTune,
543              * thus giving correct results, but a slightly lower efficiency.
544              */
545             GMX_RELEASE_ASSERT(listParams->nstlistPrune >= c_nbnxnGpuRollingListPruningInterval,
546                                ( "With dynamic list pruning on GPUs pruning frequency must be at least as large as the rolling pruning interval (" +
547                                  std::to_string(c_nbnxnGpuRollingListPruningInterval) +
548                                  ").").c_str() );
549             listParams->numRollingPruningParts = listParams->nstlistPrune/c_nbnxnGpuRollingListPruningInterval;
550         }
551         else
552         {
553             listParams->numRollingPruningParts = 1;
554         }
555     }
556
557     std::string mesg;
558
559     const real  interactionCutoff = std::max(ic->rcoulomb, ic->rvdw);
560     if (listParams->useDynamicPruning)
561     {
562         mesg += gmx::formatString("Using a dual %dx%d pair-list setup updated with dynamic%s pruning:\n",
563                                   ls.cluster_size_i, ls.cluster_size_j,
564                                   listParams->numRollingPruningParts > 1 ? ", rolling" : "");
565         mesg += formatListSetup("outer", ir->nstlist, ir->nstlist, listParams->rlistOuter, interactionCutoff);
566         mesg += formatListSetup("inner", listParams->nstlistPrune, ir->nstlist, listParams->rlistInner, interactionCutoff);
567     }
568     else
569     {
570         mesg += gmx::formatString("Using a %dx%d pair-list setup:\n",
571                                   ls.cluster_size_i, ls.cluster_size_j);
572         mesg += formatListSetup("", ir->nstlist, ir->nstlist, listParams->rlistOuter, interactionCutoff);
573     }
574     if (supportsDynamicPairlistGenerationInterval(*ir))
575     {
576         const VerletbufListSetup listSetup1x1 = { 1, 1 };
577         const real               rlistOuter   =
578             calcVerletBufferSize(*mtop, det(box), *ir, ir->nstlist, ir->nstlist - 1,
579                                  -1, listSetup1x1);
580         real                     rlistInner   = rlistOuter;
581         if (listParams->useDynamicPruning)
582         {
583             int listLifeTime = listParams->nstlistPrune - (useGpuList ? 0 : 1);
584             rlistInner =
585                 calcVerletBufferSize(*mtop, det(box), *ir, listParams->nstlistPrune, listLifeTime,
586                                      -1, listSetup1x1);
587         }
588
589         mesg += gmx::formatString("At tolerance %g kJ/mol/ps per atom, equivalent classical 1x1 list would be:\n",
590                                   ir->verletbuf_tol);
591         if (listParams->useDynamicPruning)
592         {
593             mesg += formatListSetup("outer", ir->nstlist, ir->nstlist, rlistOuter, interactionCutoff);
594             mesg += formatListSetup("inner", listParams->nstlistPrune, ir->nstlist, rlistInner, interactionCutoff);
595         }
596         else
597         {
598             mesg += formatListSetup("", ir->nstlist, ir->nstlist, rlistOuter, interactionCutoff);
599         }
600     }
601
602     GMX_LOG(mdlog.info).asParagraph().appendText(mesg);
603 }