ESPResSo
Extensible Simulation Package for Research on Soft Matter Systems
Loading...
Searching...
No Matches
CellStructure.cpp
Go to the documentation of this file.
1/*
2 * Copyright (C) 2010-2022 The ESPResSo project
3 * Copyright (C) 2002,2003,2004,2005,2006,2007,2008,2009,2010
4 * Max-Planck-Institute for Polymer Research, Theory Group
5 *
6 * This file is part of ESPResSo.
7 *
8 * ESPResSo is free software: you can redistribute it and/or modify
9 * it under the terms of the GNU General Public License as published by
10 * the Free Software Foundation, either version 3 of the License, or
11 * (at your option) any later version.
12 *
13 * ESPResSo is distributed in the hope that it will be useful,
14 * but WITHOUT ANY WARRANTY; without even the implied warranty of
15 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
16 * GNU General Public License for more details.
17 *
18 * You should have received a copy of the GNU General Public License
19 * along with this program. If not, see <http://www.gnu.org/licenses/>.
20 */
21
23
28
29#include "BoxGeometry.hpp"
30#include "LocalBox.hpp"
31#include "Particle.hpp"
32#include "aosoa_pack.hpp"
34#include "communication.hpp"
40#include "system/System.hpp"
41
42#include <utils/Vector.hpp>
43#include <utils/contains.hpp>
45#include <utils/math/sqr.hpp>
46
47#ifdef ESPRESSO_CALIPER
48#include <caliper/cali.h>
49#endif
50
51#include <boost/mpi/collectives/all_reduce.hpp>
52
53#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
54#include <Cabana_Core.hpp>
55#include <Cabana_NeighborList.hpp>
56#include <Kokkos_Core.hpp>
57#include <omp.h>
58#endif
59
60#include <algorithm>
61#include <cassert>
62#include <cstddef>
63#include <cstdint>
64#include <iterator>
65#include <memory>
66#include <optional>
67#include <ranges>
68#include <set>
69#include <stdexcept>
70#include <string>
71#include <utility>
72#include <variant>
73#include <vector>
74
76#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
78 // Kokkos handle can only be freed after all Cabana containers have been freed
79 m_kokkos_handle.reset();
80#endif
81}
82
83#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
85 m_local_force.reset();
86#ifdef ESPRESSO_ROTATION
87 m_local_torque.reset();
88#endif
89#ifdef ESPRESSO_NPT
90 m_local_virial.reset();
91#endif
92 m_id_to_index.reset();
93 m_aosoa.reset();
94 m_verlet_list_cabana.reset();
95 m_rebuild_verlet_list_cabana = true;
96}
97
98void CellStructure::set_kokkos_handle(std::shared_ptr<KokkosHandle> handle) {
99 m_kokkos_handle = std::move(handle);
100}
101
102static auto estimate_max_counts(double pair_cutoff,
103 std::size_t number_of_unique_particles) {
104 if (std::isinf(pair_cutoff)) {
105 return number_of_unique_particles;
106 }
107 if (pair_cutoff < 0.) {
108 pair_cutoff = 0.;
109 }
110 auto const volume = Utils::int_pow<3>(pair_cutoff);
111 auto max_counts = static_cast<std::size_t>(std::ceil(8. * volume));
112 std::size_t constexpr threshold_num = 16;
113 if (max_counts < threshold_num) {
114 max_counts = std::min(threshold_num, number_of_unique_particles);
115 }
116 return max_counts;
117}
118
119void CellStructure::rebuild_local_properties(double const pair_cutoff) {
120#ifdef ESPRESSO_CALIPER
121 CALI_CXX_MARK_FUNCTION;
122#endif
123 assert(m_kokkos_handle);
124 using execution_space = Kokkos::DefaultExecutionSpace;
125 auto const num_threads = execution_space().concurrency();
126 auto const num_part = get_unique_particles().size();
127 auto max_counts = estimate_max_counts(pair_cutoff, num_part);
128#ifdef ESPRESSO_COLLISION_DETECTION
129 auto const &system = get_system();
130 if (system.has_collision_detection_enabled()) {
131 // TODO: use other types of Verlet list data structures
132 max_counts = num_part * 2ul;
133 }
134#endif
135 if (m_local_force) { // local properties are reallocated
136 Kokkos::realloc(get_local_force(), num_part, num_threads);
137#ifdef ESPRESSO_ROTATION
138 Kokkos::realloc(get_local_torque(), num_part, num_threads);
139#endif
140 Kokkos::realloc(get_id_to_index(), get_cached_max_local_particle_id() + 1);
141 Kokkos::deep_copy(get_id_to_index(), -1);
142 // Resize particle views using AoSoA_pack's resize method
143 m_aosoa->resize(num_part);
144 Kokkos::deep_copy(m_aosoa->flags, uint8_t{0});
145 m_verlet_list_cabana->reallocData(num_part, max_counts);
146 } else { // local properties are initialized
147 m_local_force =
148 std::make_unique<ForceType>("local_force", num_part, num_threads);
149#ifdef ESPRESSO_ROTATION
150 m_local_torque =
151 std::make_unique<ForceType>("local_torque", num_part, num_threads);
152#endif
153 m_id_to_index = std::make_unique<Kokkos::View<int *>>(
154 Kokkos::ViewAllocateWithoutInitializing("id_to_index"),
156 Kokkos::deep_copy(get_id_to_index(), -1);
157 // Create AoSoA_pack and initialize with resize
158 m_aosoa = std::make_unique<AoSoA_pack>();
159 m_aosoa->resize(num_part);
160 Kokkos::deep_copy(m_aosoa->flags, uint8_t{0});
161
162 m_verlet_list_cabana =
163 std::make_unique<ListType>(0ul, num_part, max_counts);
164 }
165#ifdef ESPRESSO_NPT
166 m_local_virial = std::make_unique<VirialType>("local_virial", num_threads);
167#endif
168}
169
171#ifdef ESPRESSO_CALIPER
172 CALI_CXX_MARK_FUNCTION;
173#endif
174 Kokkos::deep_copy(get_local_force(), 0.);
175}
176
178 Kokkos::deep_copy(get_local_force(), 0.);
179#ifdef ESPRESSO_ROTATION
180 Kokkos::deep_copy(get_local_torque(), 0.);
181#endif
182#ifdef ESPRESSO_NPT
183 Kokkos::deep_copy(get_local_virial(), 0.);
184#endif
185 Kokkos::deep_copy(get_aosoa().flags, uint8_t{0});
186}
187
189#ifdef ESPRESSO_CALIPER
190 CALI_CXX_MARK_FUNCTION;
191#endif
192 auto &unique_particles = m_unique_particles;
193 unique_particles.clear();
194 unique_particles.resize(count_local_particles());
195 std::unordered_set<int> registered_index{};
196 using execution_space = Kokkos::DefaultExecutionSpace;
197 int n_threads = execution_space().concurrency();
198 std::vector<int> max_ids(n_threads);
200 *this, [&unique_particles, &max_ids](std::size_t index, Particle &p) {
201 unique_particles[index] = &p;
202 const int thread_num = omp_get_thread_num();
203 max_ids[thread_num] = std::max(p.id(), max_ids[thread_num]);
204 });
205 int max_id = *(std::max_element(max_ids.begin(), max_ids.end()));
206 for (auto &p : ghost_particles()) {
207 auto const *local_particle = get_local_particle(p.id());
208 if (not local_particle) {
209 continue;
210 }
211 if (not local_particle->is_ghost()) {
212 continue;
213 }
214 if (registered_index.contains(p.id())) {
215 continue;
216 }
217 registered_index.insert(p.id());
218 unique_particles.emplace_back(&p);
219 max_id = std::max(p.id(), max_id);
220 }
221 registered_index.clear();
222 m_cached_max_local_particle_id = max_id;
223}
224
225#endif // ESPRESSO_SHARED_MEMORY_PARALLELISM
226
228 : m_decomposition{std::make_unique<AtomDecomposition>(box)} {}
229
231 auto const max_id = get_max_local_particle_id();
232
233 for (auto const &p : local_particles()) {
234 auto const id = p.id();
235
236 if (id < 0 || id > max_id) {
237 throw std::runtime_error("Particle id out of bounds.");
238 }
239
240 if (get_local_particle(id) != &p) {
241 throw std::runtime_error("Invalid local particle index entry.");
242 }
243 }
244
245 /* checks: local particle id */
246 std::size_t local_part_cnt = 0u;
247 for (int n = 0; n < get_max_local_particle_id() + 1; n++) {
248 if (get_local_particle(n) != nullptr) {
249 local_part_cnt++;
250 if (get_local_particle(n)->id() != n) {
251 throw std::runtime_error("local_particles part has corrupted id.");
252 }
253 }
254 }
255
256 if (local_part_cnt != local_particles().size()) {
257 throw std::runtime_error(
258 std::to_string(local_particles().size()) + " parts in cells but " +
259 std::to_string(local_part_cnt) + " parts in local_particles");
260 }
261}
262
264 for (auto cell : decomposition().local_cells()) {
265 for (auto const &p : cell->particles()) {
266 if (particle_to_cell(p) != cell) {
267 throw std::runtime_error("misplaced particle with id " +
268 std::to_string(p.id()));
269 }
270 }
271 }
272}
273
275 auto remove_all_bonds_to = [id](BondList &bl) {
276 for (auto it = bl.begin(); it != bl.end();) {
277 if (Utils::contains(it->partner_ids(), id)) {
278 it = bl.erase(it);
279 } else {
280 std::advance(it, 1);
281 }
282 }
283 };
284
285 for (auto cell : decomposition().local_cells()) {
286 auto &parts = cell->particles();
287 for (auto it = parts.begin(); it != parts.end();) {
288 if (it->id() == id) {
289 it = parts.erase(it);
290 update_particle_index(id, nullptr);
292 } else {
293 remove_all_bonds_to(it->bonds());
294 it++;
295 }
296 }
297 }
298}
299
301 auto const sort_cell = particle_to_cell(p);
302 if (sort_cell) {
303 return std::addressof(
304 append_indexed_particle(sort_cell->particles(), std::move(p)));
305 }
306
307 return {};
308}
309
311 auto const sort_cell = particle_to_cell(p);
312 /* There is always at least one cell, so if the particle
313 * does not belong to a cell on this node we can put it there. */
314 auto cell = sort_cell ? sort_cell : decomposition().local_cells()[0];
315
316 /* If the particle isn't local a global resort may be
317 * needed, otherwise a local resort if sufficient. */
319
320 return std::addressof(
321 append_indexed_particle(cell->particles(), std::move(p)));
322}
323
325 auto it = std::ranges::find_if(std::ranges::views::reverse(m_particle_index),
326 [](auto const *p) { return p != nullptr; });
327
328 return (it != m_particle_index.rend()) ? (*it)->id() : -1;
329}
330
332 for (auto cell : decomposition().local_cells()) {
333 cell->particles().clear();
334 }
335
336 m_particle_index.clear();
337}
338
339/* Map the data parts flags from cells to those used internally
340 * by the ghost communication */
341unsigned map_data_parts(unsigned data_parts) {
342 using namespace Cells;
343
344 /* clang-format off */
345 return GHOSTTRANS_NONE
346 | ((data_parts & DATA_PART_PROPERTIES) ? GHOSTTRANS_PROPRTS : 0u)
347 | ((data_parts & DATA_PART_POSITION) ? GHOSTTRANS_POSITION : 0u)
348 | ((data_parts & DATA_PART_MOMENTUM) ? GHOSTTRANS_MOMENTUM : 0u)
349 | ((data_parts & DATA_PART_FORCE) ? GHOSTTRANS_FORCE : 0u)
350#ifdef ESPRESSO_BOND_CONSTRAINT
351 | ((data_parts & DATA_PART_RATTLE) ? GHOSTTRANS_RATTLE : 0u)
352#endif
353 | ((data_parts & DATA_PART_BONDS) ? GHOSTTRANS_BONDS : 0u);
354 /* clang-format on */
355}
356
358 ghost_communicator(decomposition().exchange_ghosts_comm(),
359 *get_system().box_geo, GHOSTTRANS_PARTNUM);
360}
361void CellStructure::ghosts_update(unsigned data_parts) {
362 ghost_communicator(decomposition().exchange_ghosts_comm(),
363 *get_system().box_geo, map_data_parts(data_parts));
364}
366 ghost_communicator(decomposition().collect_ghost_force_comm(),
367 *get_system().box_geo, GHOSTTRANS_FORCE);
368}
369#ifdef ESPRESSO_BOND_CONSTRAINT
374#endif
375
376namespace {
377/**
378 * @brief Apply a @ref ParticleChange to a particle index.
379 */
382
384 cs->update_particle_index(rp.id, nullptr);
385 }
387};
388} // namespace
389
390void CellStructure::resort_particles(bool global_flag) {
391 invalidate_ghosts();
392
393 static std::vector<ParticleChange> diff;
394 diff.clear();
395
396 m_decomposition->resort(global_flag, diff);
397
398 for (auto d : diff) {
399 std::visit(UpdateParticleIndexVisitor{this}, d);
400 }
401
402 auto const &lebc = get_system().box_geo->lees_edwards_bc();
403 m_rebuild_verlet_list = true;
404 m_rebuild_verlet_list_cabana = true;
405 m_le_pos_offset_at_last_resort = lebc.pos_offset;
406
407#ifdef ESPRESSO_ADDITIONAL_CHECKS
410#endif
411}
412
414 auto &system = get_system();
415 auto &local_geo = *system.local_geo;
416 auto const &box_geo = *system.box_geo;
417 set_particle_decomposition(
418 std::make_unique<AtomDecomposition>(::comm_cart, box_geo));
420 local_geo.set_cell_structure_type(m_type);
421 system.on_cell_structure_change();
422}
423
425 double range, std::optional<std::pair<int, int>> fully_connected_boundary) {
426 auto &system = get_system();
427 auto &local_geo = *system.local_geo;
428 auto const &box_geo = *system.box_geo;
429 set_particle_decomposition(std::make_unique<RegularDecomposition>(
430 ::comm_cart, range, box_geo, local_geo, fully_connected_boundary));
432 local_geo.set_cell_structure_type(m_type);
433 system.on_cell_structure_change();
434}
435
437 std::set<int> n_square_types) {
438 auto &system = get_system();
439 auto &local_geo = *system.local_geo;
440 auto const &box_geo = *system.box_geo;
441 set_particle_decomposition(std::make_unique<HybridDecomposition>(
442 ::comm_cart, cutoff_regular, m_verlet_skin,
443 [&system]() { return system.get_global_ghost_flags(); }, box_geo,
444 local_geo, n_square_types));
446 local_geo.set_cell_structure_type(m_type);
447 system.on_cell_structure_change();
448}
449
451 assert(value >= 0.);
452 m_verlet_skin = value;
453 m_verlet_skin_set = true;
454 m_rebuild_verlet_list_cabana = true;
455 get_system().on_verlet_skin_change();
456}
457
459 assert(not is_verlet_skin_set());
460 auto const max_cut = get_system().maximal_cutoff();
461 if (max_cut <= 0.) {
462 throw std::runtime_error(
463 "cannot automatically determine skin, please set it manually");
464 }
465 /* maximal skin that can be used without resorting is the maximal
466 * range of the cell system minus what is needed for interactions. */
467 auto const max_range = std::ranges::min(max_cutoff());
468 auto const new_skin = std::min(0.4 * max_cut, max_range - max_cut);
469 set_verlet_skin(new_skin);
470}
471
473 /* data parts that are only updated on resort */
474 auto constexpr resort_only_parts =
476
477 auto const global_resort = boost::mpi::all_reduce(
478 ::comm_cart, m_resort_particles, std::bit_or<unsigned>());
479
480 if (global_resort != Cells::RESORT_NONE) {
481 auto const do_global_resort = (global_resort & Cells::RESORT_GLOBAL) != 0;
482
483 /* Resort cell system */
484 resort_particles(do_global_resort);
485 ghosts_count();
486 ghosts_update(data_parts);
487
488 /* Add the ghost particles to the index if we don't already
489 * have them. */
490 for (auto &p : ghost_particles()) {
491 if (get_local_particle(p.id()) == nullptr) {
492 update_particle_index(p.id(), &p);
493 }
494 }
495
496 /* Particles are now sorted */
498 } else {
499 /* Communication step: ghost information */
500 ghosts_update(data_parts & ~resort_only_parts);
501 }
502}
503
504#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
505void CellStructure::parallel_for_each_particle_impl(
506 std::span<Cell *const> cells, ParticleUnaryOp &f) const {
507 if (cells.size() > 1) {
508 Kokkos::parallel_for( // loop over cells
509 "for_each_local_particle", cells.size(), [&](auto cell_idx) {
510 for (auto &p : cells[cell_idx]->particles())
511 f(p);
512 });
513 } else if (cells.size() == 1) {
514 auto &particles = cells.front()->particles();
515 Kokkos::parallel_for( // loop over particles
516 "for_each_local_particle", particles.size(),
517 [&](auto part_idx) { f(*(particles.begin() + part_idx)); });
518 }
519}
520#endif // ESPRESSO_SHARED_MEMORY_PARALLELISM
521
523 Utils::Vector3d const &additional_offset) const {
524 auto const lim = Utils::sqr(m_verlet_skin / 2.) - additional_offset.norm2();
525
527 [lim](bool &result, Particle const &p) {
528 if ((p.pos() - p.pos_at_last_verlet_update()).norm2() > lim) {
529 result = true;
530 }
531 };
532
533 Reduction::ReductionOp<bool> reduce_op = [](bool &acc, bool const &val) {
534 acc |= val;
535 };
536
537 return reduce_over_local_particles(*this, add_partial, reduce_op);
538}
@ NSQUARE
Atom decomposition (N-square).
@ HYBRID
Hybrid decomposition.
@ REGULAR
Regular decomposition.
static auto estimate_max_counts(double pair_cutoff, std::size_t number_of_unique_particles)
unsigned map_data_parts(unsigned data_parts)
Map the data parts flags from cells to those used internally by the ghost communication.
unsigned map_data_parts(unsigned data_parts)
Map the data parts flags from cells to those used internally by the ghost communication.
std::function< void(Particle &)> ParticleUnaryOp
Vector implementation and trait types for boost qvm interoperability.
Atom decomposition cell system.
Bond storage.
Definition BondList.hpp:84
Describes a cell structure / cell system.
ParticleRange ghost_particles() const
auto & get_local_force()
Particle * get_local_particle(int id)
Get a local particle by id.
void set_kokkos_handle(std::shared_ptr< KokkosHandle > handle)
void check_particle_sorting() const
Check that particles are in the correct cell.
auto & get_id_to_index()
std::size_t count_local_particles() const
virtual ~CellStructure()
void clear_resort_particles()
Set the resort level to sorted.
auto is_verlet_skin_set() const
Whether the Verlet skin is set.
void clear_local_properties()
ParticleDecomposition const & decomposition() const
Get the underlying particle decomposition.
void update_ghosts_and_resort_particle(unsigned data_parts)
Update ghost particles, with particle resort if needed.
Particle * add_local_particle(Particle &&p)
Add a particle.
void set_verlet_skin_heuristic()
Set the Verlet skin using a heuristic.
void set_verlet_skin(double value)
Set the Verlet skin.
void ghosts_update(unsigned data_parts)
Update ghost particles.
int get_cached_max_local_particle_id() const
CellStructure(BoxGeometry const &box)
auto & get_local_torque()
auto & get_local_virial()
void update_particle_index(int id, Particle *p)
Update local particle index.
void ghosts_reduce_forces()
Add forces from ghost particles to real particles.
auto const & get_unique_particles() const
void rebuild_local_properties(double pair_cutoff)
Utils::Vector3d max_range() const
Maximal pair range supported by current cell system.
bool check_resort_required(Utils::Vector3d const &additional_offset={}) const
Check whether a particle has moved further than half the skin since the last Verlet list update,...
void ghosts_count()
Synchronize number of ghosts.
void set_resort_particles(Cells::Resort level)
Increase the local resort level at least to level.
void remove_particle(int id)
Remove a particle.
Particle * add_particle(Particle &&p)
Add a particle.
void resort_particles(bool global_flag)
Resort particles.
void check_particle_index() const
Check that particle index is commensurate with particles.
void set_regular_decomposition(double range, std::optional< std::pair< int, int > > fully_connected_boundary)
Set the particle decomposition to RegularDecomposition.
void set_atom_decomposition()
Set the particle decomposition to AtomDecomposition.
void remove_all_particles()
Remove all particles from the cell system.
ParticleRange local_particles() const
void ghosts_reduce_rattle_correction()
Add rattle corrections from ghost particles to real particles.
void set_hybrid_decomposition(double cutoff_regular, std::set< int > n_square_types)
Set the particle decomposition to HybridDecomposition.
int get_max_local_particle_id() const
Get the maximal particle id on this node.
Utils::Vector3d max_cutoff() const
Maximal cutoff supported by current cell system.
void reset_local_properties()
virtual std::span< Cell *const > local_cells() const =0
Get pointer to local cells.
base_type::size_type size() const
constexpr T norm2() const
Definition Vector.hpp:159
boost::mpi::communicator comm_cart
The communicator.
void ghost_communicator(GhostCommunicator const &gcr, BoxGeometry const &box_geo, unsigned int data_parts)
Do a ghost communication with the specified data parts.
Definition ghosts.cpp:442
@ GHOSTTRANS_MOMENTUM
transfer ParticleMomentum
Definition ghosts.hpp:132
@ GHOSTTRANS_RATTLE
transfer ParticleRattle
Definition ghosts.hpp:137
@ GHOSTTRANS_PARTNUM
resize the receiver particle arrays to the size of the senders
Definition ghosts.hpp:140
@ GHOSTTRANS_POSITION
transfer ParticlePosition
Definition ghosts.hpp:130
@ GHOSTTRANS_PROPRTS
transfer ParticleProperties
Definition ghosts.hpp:128
@ GHOSTTRANS_FORCE
transfer ParticleForce
Definition ghosts.hpp:134
@ GHOSTTRANS_NONE
Definition ghosts.hpp:126
@ GHOSTTRANS_BONDS
Definition ghosts.hpp:141
@ DATA_PART_PROPERTIES
Particle::p.
@ DATA_PART_BONDS
Particle::bonds.
ParticleRange particles(std::span< Cell *const > cells)
std::function< void(ResultType &, ResultType const &)> ReductionOp
Join two partial reduction results.
std::function< void(ResultType &, Particle const &)> AddPartialResultKernel
Kernel that adds the result from a single particle to a reduction.
DEVICE_QUALIFIER constexpr T sqr(T x)
Calculates the SQuaRe of x.
Definition sqr.hpp:28
bool contains(Range &&rng, T const &value)
Check whether a range contains a value.
Definition contains.hpp:36
STL namespace.
void enumerate_local_particles(CellStructure const &cs, Kernel &&kernel)
Run a kernel on all local particles with enumeration.
ResultType reduce_over_local_particles(CellStructure const &cs, Reduction::AddPartialResultKernel< ResultType > add_partial, Reduction::ReductionOp< ResultType > reduce_op)
performs a reduction over all particles
Struct holding all information for one particle.
Definition Particle.hpp:450
auto const & id() const
Definition Particle.hpp:469