2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2006,2007,2008,2009,2010,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.
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.
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.
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.
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.
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.
38 * \brief This file implements functions for domdec to use
39 * while managing inter-atomic constraints.
41 * \author Berk Hess <hess@kth.se>
42 * \ingroup module_domdec
47 #include "domdec_constraints.h"
54 #include "gromacs/domdec/dlbtiming.h"
55 #include "gromacs/domdec/domdec.h"
56 #include "gromacs/domdec/domdec_struct.h"
57 #include "gromacs/domdec/ga2la.h"
58 #include "gromacs/domdec/hashedmap.h"
59 #include "gromacs/math/vec.h"
60 #include "gromacs/mdlib/constr.h"
61 #include "gromacs/mdlib/gmx_omp_nthreads.h"
62 #include "gromacs/mdtypes/commrec.h"
63 #include "gromacs/mdtypes/forcerec.h" // only for GET_CGINFO_*
64 #include "gromacs/pbcutil/ishift.h"
65 #include "gromacs/topology/ifunc.h"
66 #include "gromacs/topology/mtop_lookup.h"
67 #include "gromacs/utility/exceptions.h"
68 #include "gromacs/utility/fatalerror.h"
69 #include "gromacs/utility/gmxassert.h"
70 #include "gromacs/utility/smalloc.h"
72 #include "domdec_specatomcomm.h"
74 /*! \brief Struct used during constraint setup with domain decomposition */
75 struct gmx_domdec_constraints_t
77 //! @cond Doxygen_Suppress
78 std::vector
<int> molb_con_offset
; /**< Offset in the constraint array for each molblock */
79 std::vector
<int> molb_ncon_mol
; /**< The number of constraints per molecule for each molblock */
81 int ncon
; /**< The fully local and conneced constraints */
82 /* The global constraint number, only required for clearing gc_req */
83 std::vector
<int> con_gl
; /**< Global constraint indices for local constraints */
84 std::vector
<int> con_nlocat
; /**< Number of local atoms (2/1/0) for each constraint */
86 std::vector
<bool> gc_req
; /**< Boolean that tells if a global constraint index has been requested; note: size global #constraints */
88 /* Hash table for keeping track of requests */
89 std::unique_ptr
< gmx::HashedMap
< int>> ga2la
; /**< Global to local communicated constraint atom only index */
91 /* Multi-threading stuff */
92 int nthread
; /**< Number of threads used for DD constraint setup */
93 std::vector
<t_ilist
> ils
; /**< Constraint ilist working arrays, size \p nthread */
95 /* Buffers for requesting atoms */
96 std::vector
< std::vector
< int>> requestedGlobalAtomIndices
; /**< Buffers for requesting global atom indices, one per thread */
101 void dd_move_x_constraints(gmx_domdec_t
*dd
, matrix box
,
102 rvec
*x0
, rvec
*x1
, gmx_bool bX1IsCoord
)
104 if (dd
->constraint_comm
)
106 dd_move_x_specat(dd
, dd
->constraint_comm
, box
, x0
, x1
, bX1IsCoord
);
108 ddReopenBalanceRegionCpu(dd
);
112 gmx::ArrayRef
<const int> dd_constraints_nlocalatoms(const gmx_domdec_t
*dd
)
114 if (dd
&& dd
->constraints
)
116 return dd
->constraints
->con_nlocat
;
124 void dd_clear_local_constraint_indices(gmx_domdec_t
*dd
)
126 gmx_domdec_constraints_t
*dc
= dd
->constraints
;
128 std::fill(dc
->gc_req
.begin(), dc
->gc_req
.end(), false);
130 if (dd
->constraint_comm
)
136 /*! \brief Walks over the constraints out from the local atoms into the non-local atoms and adds them to a list */
137 static void walk_out(int con
, int con_offset
, int a
, int offset
, int nrec
,
138 gmx::ArrayRef
<const int> ia1
,
139 gmx::ArrayRef
<const int> ia2
,
140 const t_blocka
*at2con
,
141 const gmx_ga2la_t
&ga2la
, gmx_bool bHomeConnect
,
142 gmx_domdec_constraints_t
*dc
,
143 gmx_domdec_specat_comm_t
*dcc
,
145 std::vector
<int> *ireq
)
147 int a1_gl
, a2_gl
, i
, coni
, b
;
150 if (!dc
->gc_req
[con_offset
+ con
])
152 /* Add this non-home constraint to the list */
153 dc
->con_gl
.push_back(con_offset
+ con
);
154 dc
->con_nlocat
.push_back(bHomeConnect
? 1 : 0);
155 dc
->gc_req
[con_offset
+ con
] = true;
156 if (il_local
->nr
+ 3 > il_local
->nalloc
)
158 il_local
->nalloc
= over_alloc_dd(il_local
->nr
+3);
159 srenew(il_local
->iatoms
, il_local
->nalloc
);
161 iap
= constr_iatomptr(ia1
, ia2
, con
);
162 il_local
->iatoms
[il_local
->nr
++] = iap
[0];
163 a1_gl
= offset
+ iap
[1];
164 a2_gl
= offset
+ iap
[2];
165 /* The following indexing code can probably be optizimed */
166 if (const int *a_loc
= ga2la
.findHome(a1_gl
))
168 il_local
->iatoms
[il_local
->nr
++] = *a_loc
;
172 /* We set this index later */
173 il_local
->iatoms
[il_local
->nr
++] = -a1_gl
- 1;
175 if (const int *a_loc
= ga2la
.findHome(a2_gl
))
177 il_local
->iatoms
[il_local
->nr
++] = *a_loc
;
181 /* We set this index later */
182 il_local
->iatoms
[il_local
->nr
++] = -a2_gl
- 1;
186 /* Check to not ask for the same atom more than once */
187 if (!dc
->ga2la
->find(offset
+ a
))
190 /* Add this non-home atom to the list */
191 ireq
->push_back(offset
+ a
);
192 /* Temporarily mark with -2, we get the index later */
193 dc
->ga2la
->insert(offset
+ a
, -2);
198 for (i
= at2con
->index
[a
]; i
< at2con
->index
[a
+1]; i
++)
204 iap
= constr_iatomptr(ia1
, ia2
, coni
);
213 if (!ga2la
.findHome(offset
+ b
))
215 walk_out(coni
, con_offset
, b
, offset
, nrec
-1,
217 ga2la
, FALSE
, dc
, dcc
, il_local
, ireq
);
224 /*! \brief Looks up SETTLE constraints for a range of charge-groups */
225 static void atoms_to_settles(gmx_domdec_t
*dd
,
226 const gmx_mtop_t
*mtop
,
228 gmx::ArrayRef
< const std::vector
< int>> at2settle_mt
,
229 int cg_start
, int cg_end
,
231 std::vector
<int> *ireq
)
233 const gmx_ga2la_t
&ga2la
= *dd
->ga2la
;
234 int nral
= NRAL(F_SETTLE
);
237 for (int a
= cg_start
; a
< cg_end
; a
++)
239 if (GET_CGINFO_SETTLE(cginfo
[a
]))
241 int a_gl
= dd
->globalAtomIndices
[a
];
243 mtopGetMolblockIndex(mtop
, a_gl
, &mb
, nullptr, &a_mol
);
245 const gmx_molblock_t
*molb
= &mtop
->molblock
[mb
];
246 int settle
= at2settle_mt
[molb
->type
][a_mol
];
250 int offset
= a_gl
- a_mol
;
252 const int *ia1
= mtop
->moltype
[molb
->type
].ilist
[F_SETTLE
].iatoms
.data();
255 gmx_bool bAssign
= FALSE
;
257 for (int sa
= 0; sa
< nral
; sa
++)
259 int a_glsa
= offset
+ ia1
[settle
*(1+nral
)+1+sa
];
261 if (ga2la
.findHome(a_glsa
))
263 if (nlocal
== 0 && a_gl
== a_glsa
)
273 if (ils_local
->nr
+1+nral
> ils_local
->nalloc
)
275 ils_local
->nalloc
= over_alloc_dd(ils_local
->nr
+1+nral
);
276 srenew(ils_local
->iatoms
, ils_local
->nalloc
);
279 ils_local
->iatoms
[ils_local
->nr
++] = ia1
[settle
*4];
281 for (int sa
= 0; sa
< nral
; sa
++)
283 if (const int *a_loc
= ga2la
.findHome(a_gls
[sa
]))
285 ils_local
->iatoms
[ils_local
->nr
++] = *a_loc
;
289 ils_local
->iatoms
[ils_local
->nr
++] = -a_gls
[sa
] - 1;
290 /* Add this non-home atom to the list */
291 ireq
->push_back(a_gls
[sa
]);
292 /* A check on double atom requests is
293 * not required for settle.
303 /*! \brief Looks up constraint for the local atoms */
304 static void atoms_to_constraints(gmx_domdec_t
*dd
,
305 const gmx_mtop_t
*mtop
,
307 gmx::ArrayRef
<const t_blocka
> at2con_mt
, int nrec
,
309 std::vector
<int> *ireq
)
311 const t_blocka
*at2con
;
312 int b_lo
, offset
, b_mol
, i
, con
, con_offset
;
314 gmx_domdec_constraints_t
*dc
= dd
->constraints
;
315 gmx_domdec_specat_comm_t
*dcc
= dd
->constraint_comm
;
317 const gmx_ga2la_t
&ga2la
= *dd
->ga2la
;
320 dc
->con_nlocat
.clear();
324 for (int a
= 0; a
< dd
->ncg_home
; a
++)
326 if (GET_CGINFO_CONSTR(cginfo
[a
]))
328 int a_gl
= dd
->globalAtomIndices
[a
];
330 mtopGetMolblockIndex(mtop
, a_gl
, &mb
, &molnr
, &a_mol
);
332 const gmx_molblock_t
&molb
= mtop
->molblock
[mb
];
334 gmx::ArrayRef
<const int> ia1
= mtop
->moltype
[molb
.type
].ilist
[F_CONSTR
].iatoms
;
335 gmx::ArrayRef
<const int> ia2
= mtop
->moltype
[molb
.type
].ilist
[F_CONSTRNC
].iatoms
;
337 /* Calculate the global constraint number offset for the molecule.
338 * This is only required for the global index to make sure
339 * that we use each constraint only once.
342 dc
->molb_con_offset
[mb
] + molnr
*dc
->molb_ncon_mol
[mb
];
344 /* The global atom number offset for this molecule */
345 offset
= a_gl
- a_mol
;
346 at2con
= &at2con_mt
[molb
.type
];
347 for (i
= at2con
->index
[a_mol
]; i
< at2con
->index
[a_mol
+1]; i
++)
350 const int *iap
= constr_iatomptr(ia1
, ia2
, con
);
359 if (const int *a_loc
= ga2la
.findHome(offset
+ b_mol
))
361 /* Add this fully home constraint at the first atom */
364 dc
->con_gl
.push_back(con_offset
+ con
);
365 dc
->con_nlocat
.push_back(2);
366 if (ilc_local
->nr
+ 3 > ilc_local
->nalloc
)
368 ilc_local
->nalloc
= over_alloc_dd(ilc_local
->nr
+ 3);
369 srenew(ilc_local
->iatoms
, ilc_local
->nalloc
);
372 ilc_local
->iatoms
[ilc_local
->nr
++] = iap
[0];
373 ilc_local
->iatoms
[ilc_local
->nr
++] = (a_gl
== iap
[1] ? a
: b_lo
);
374 ilc_local
->iatoms
[ilc_local
->nr
++] = (a_gl
== iap
[1] ? b_lo
: a
);
381 /* We need the nrec constraints coupled to this constraint,
382 * so we need to walk out of the home cell by nrec+1 atoms,
383 * since already atom bg is not locally present.
384 * Therefore we call walk_out with nrec recursions to go
385 * after this first call.
387 walk_out(con
, con_offset
, b_mol
, offset
, nrec
,
389 ga2la
, TRUE
, dc
, dcc
, ilc_local
, ireq
);
395 GMX_ASSERT(dc
->con_gl
.size() == static_cast<size_t>(dc
->ncon
), "con_gl size should match the number of constraints");
396 GMX_ASSERT(dc
->con_nlocat
.size() == static_cast<size_t>(dc
->ncon
), "con_nlocat size should match the number of constraints");
401 "Constraints: home %3d border %3d atoms: %3zu\n",
402 nhome
, dc
->ncon
-nhome
,
403 dd
->constraint_comm
? ireq
->size() : 0);
407 int dd_make_local_constraints(gmx_domdec_t
*dd
, int at_start
,
408 const struct gmx_mtop_t
*mtop
,
410 gmx::Constraints
*constr
, int nrec
,
413 gmx_domdec_constraints_t
*dc
;
414 t_ilist
*ilc_local
, *ils_local
;
415 std::vector
<int> *ireq
;
416 gmx::ArrayRef
<const t_blocka
> at2con_mt
;
417 gmx::HashedMap
<int> *ga2la_specat
;
421 // This code should not be called unless this condition is true,
422 // because that's the only time init_domdec_constraints is
424 GMX_RELEASE_ASSERT(dd
->splitConstraints
|| dd
->splitSettles
, "dd_make_local_constraints called when there are no local constraints");
425 // ... and init_domdec_constraints always sets
426 // dd->constraint_comm...
427 GMX_RELEASE_ASSERT(dd
->constraint_comm
, "Invalid use of dd_make_local_constraints before construction of constraint_comm");
428 // ... which static analysis needs to be reassured about, because
429 // otherwise, when dd->splitSettles is
430 // true. dd->constraint_comm is unilaterally dereferenced before
431 // the call to atoms_to_settles.
433 dc
= dd
->constraints
;
435 ilc_local
= &il_local
[F_CONSTR
];
436 ils_local
= &il_local
[F_SETTLE
];
440 if (dd
->constraint_comm
)
442 // TODO Perhaps gmx_domdec_constraints_t should keep a valid constr?
443 GMX_RELEASE_ASSERT(constr
!= nullptr, "Must have valid constraints object");
444 at2con_mt
= constr
->atom2constraints_moltype();
445 ireq
= &dc
->requestedGlobalAtomIndices
[0];
450 // Currently unreachable
455 gmx::ArrayRef
< const std::vector
< int>> at2settle_mt
;
456 /* When settle works inside charge groups, we assigned them already */
457 if (dd
->splitSettles
)
459 // TODO Perhaps gmx_domdec_constraints_t should keep a valid constr?
460 GMX_RELEASE_ASSERT(constr
!= nullptr, "Must have valid constraints object");
461 at2settle_mt
= constr
->atom2settle_moltype();
465 if (at2settle_mt
.empty())
467 atoms_to_constraints(dd
, mtop
, cginfo
, at2con_mt
, nrec
,
475 /* Do the constraints, if present, on the first thread.
476 * Do the settles on all other threads.
478 t0_set
= ((!at2con_mt
.empty() && dc
->nthread
> 1) ? 1 : 0);
480 #pragma omp parallel for num_threads(dc->nthread) schedule(static)
481 for (thread
= 0; thread
< dc
->nthread
; thread
++)
485 if (!at2con_mt
.empty() && thread
== 0)
487 atoms_to_constraints(dd
, mtop
, cginfo
, at2con_mt
, nrec
,
491 if (thread
>= t0_set
)
496 /* Distribute the settle check+assignments over
497 * dc->nthread or dc->nthread-1 threads.
499 cg0
= (dd
->ncg_home
*(thread
-t0_set
))/(dc
->nthread
-t0_set
);
500 cg1
= (dd
->ncg_home
*(thread
-t0_set
+1))/(dc
->nthread
-t0_set
);
502 if (thread
== t0_set
)
508 ilst
= &dc
->ils
[thread
];
512 std::vector
<int> &ireqt
= dc
->requestedGlobalAtomIndices
[thread
];
518 atoms_to_settles(dd
, mtop
, cginfo
, at2settle_mt
,
523 GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR
;
526 /* Combine the generate settles and requested indices */
527 for (thread
= 1; thread
< dc
->nthread
; thread
++)
534 ilst
= &dc
->ils
[thread
];
535 if (ils_local
->nr
+ ilst
->nr
> ils_local
->nalloc
)
537 ils_local
->nalloc
= over_alloc_large(ils_local
->nr
+ ilst
->nr
);
538 srenew(ils_local
->iatoms
, ils_local
->nalloc
);
540 for (ia
= 0; ia
< ilst
->nr
; ia
++)
542 ils_local
->iatoms
[ils_local
->nr
+ia
] = ilst
->iatoms
[ia
];
544 ils_local
->nr
+= ilst
->nr
;
547 const std::vector
<int> &ireqt
= dc
->requestedGlobalAtomIndices
[thread
];
548 ireq
->insert(ireq
->end(), ireqt
.begin(), ireqt
.end());
553 fprintf(debug
, "Settles: total %3d\n", ils_local
->nr
/4);
557 if (dd
->constraint_comm
)
562 setup_specat_communication(dd
, ireq
, dd
->constraint_comm
,
563 dd
->constraints
->ga2la
.get(),
565 "constraint", " or lincs-order");
567 /* Fill in the missing indices */
568 ga2la_specat
= dd
->constraints
->ga2la
.get();
570 nral1
= 1 + NRAL(F_CONSTR
);
571 for (i
= 0; i
< ilc_local
->nr
; i
+= nral1
)
573 iap
= ilc_local
->iatoms
+ i
;
574 for (j
= 1; j
< nral1
; j
++)
578 const int *a
= ga2la_specat
->find(-iap
[j
] - 1);
579 GMX_ASSERT(a
, "We have checked before that this atom index has been set");
585 nral1
= 1 + NRAL(F_SETTLE
);
586 for (i
= 0; i
< ils_local
->nr
; i
+= nral1
)
588 iap
= ils_local
->iatoms
+ i
;
589 for (j
= 1; j
< nral1
; j
++)
593 const int *a
= ga2la_specat
->find(-iap
[j
] - 1);
594 GMX_ASSERT(a
, "We have checked before that this atom index has been set");
602 // Currently unreachable
609 void init_domdec_constraints(gmx_domdec_t
*dd
,
610 const gmx_mtop_t
*mtop
)
612 gmx_domdec_constraints_t
*dc
;
613 const gmx_molblock_t
*molb
;
617 fprintf(debug
, "Begin init_domdec_constraints\n");
620 dd
->constraints
= new gmx_domdec_constraints_t
;
621 dc
= dd
->constraints
;
623 dc
->molb_con_offset
.resize(mtop
->molblock
.size());
624 dc
->molb_ncon_mol
.resize(mtop
->molblock
.size());
627 for (size_t mb
= 0; mb
< mtop
->molblock
.size(); mb
++)
629 molb
= &mtop
->molblock
[mb
];
630 dc
->molb_con_offset
[mb
] = ncon
;
631 dc
->molb_ncon_mol
[mb
] =
632 mtop
->moltype
[molb
->type
].ilist
[F_CONSTR
].size()/3 +
633 mtop
->moltype
[molb
->type
].ilist
[F_CONSTRNC
].size()/3;
634 ncon
+= molb
->nmol
*dc
->molb_ncon_mol
[mb
];
639 dc
->gc_req
.resize(ncon
);
642 /* Use a hash table for the global to local index.
643 * The number of keys is a rough estimate, it will be optimized later.
645 int numKeysEstimate
= std::min(mtop
->natoms
/20,
646 mtop
->natoms
/(2*dd
->nnodes
));
647 dc
->ga2la
= std::make_unique
< gmx::HashedMap
< int>>(numKeysEstimate
);
649 dc
->nthread
= gmx_omp_nthreads_get(emntDomdec
);
650 dc
->ils
.resize(dc
->nthread
);
652 dd
->constraint_comm
= new gmx_domdec_specat_comm_t
;
654 dc
->requestedGlobalAtomIndices
.resize(dc
->nthread
);