29#include "ParticleList.hpp"
37#include "system/Leaf.hpp"
41#include <boost/container/static_vector.hpp>
42#include <boost/iterator/indirect_iterator.hpp>
43#include <boost/range/algorithm/transform.hpp>
55#include <unordered_set>
59#ifdef ESPRESSO_CALIPER
60#include <caliper/cali.h>
64#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
66template <
class DataType,
class... Properties>
class View;
76template <
class DataType,
class MemorySpace,
int,
class MemoryTraits>
80template <
class MemorySpace,
class ListAlgorithm,
class Layout,
class BuildTag>
84template <
typename Callable>
86 { c(p) } -> std::same_as<void>;
107#ifdef ESPRESSO_BOND_CONSTRAINT
126 auto first_non_empty = std::ranges::find_if(
127 cells, [](
const Cell *c) {
return not c->
particles().empty(); });
147struct MinimalImageDistance {
155struct EuclidianDistance {
170#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
180 Cabana::TeamVectorOpTag>;
185 std::vector<Particle *> m_particle_index;
187 std::unique_ptr<ParticleDecomposition> m_decomposition;
193 bool m_verlet_skin_set =
false;
194 bool m_rebuild_verlet_list =
true;
195 bool m_rebuild_verlet_list_cabana =
true;
196 std::vector<std::pair<Particle *, Particle *>> m_verlet_list;
197 double m_le_pos_offset_at_last_resort = 0.;
199 double m_verlet_skin = 0.;
200 double m_verlet_reuse = 0.;
201#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
202 int m_cached_max_local_particle_id = 0;
204 std::unique_ptr<Kokkos::View<int *>> m_id_to_index;
205 std::unique_ptr<ForceType> m_local_force;
206#ifdef ESPRESSO_ROTATION
207 std::unique_ptr<ForceType> m_local_torque;
210 std::unique_ptr<VirialType> m_local_virial;
212 std::unique_ptr<ListType> m_verlet_list_cabana;
214 std::unique_ptr<AoSoA_pack> m_aosoa;
216 std::vector<Particle *> m_unique_particles;
217 std::shared_ptr<KokkosHandle> m_kokkos_handle;
238 assert(not p or p->
id() ==
id);
240 if (
static_cast<unsigned int>(
id) >= m_particle_index.size())
241 m_particle_index.resize(
static_cast<unsigned int>(
id + 1));
243 m_particle_index[
static_cast<unsigned int>(id)] = p;
286 auto &new_part = pl.
insert(std::move(p));
308 if (
static_cast<unsigned int>(
id) >= m_particle_index.size())
311 return m_particle_index[
static_cast<unsigned int>(id)];
318 if (
static_cast<unsigned int>(
id) >= m_particle_index.size())
321 return m_particle_index[
static_cast<unsigned int>(id)];
324 template <
class InputRange,
class OutputIterator>
326 std::ranges::transform(ids, out,
347 std::size_t count = 0;
348 for (
auto const &cell : m_decomposition->local_cells()) {
349 count += cell->particles().size();
356#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
368 bool parallel =
true)
const {
369#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
371 parallel_for_each_particle_impl(
decomposition().local_cells(), f);
404#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
405 void parallel_for_each_particle_impl(std::span<Cell *const> cells,
457#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
459 return m_cached_max_local_particle_id;
480 return assert(m_decomposition), *m_decomposition;
485 return assert(m_decomposition), *m_decomposition;
493 m_resort_particles |= level;
494 assert(m_resort_particles >= level);
519 return m_le_pos_offset_at_last_resort;
553#ifdef ESPRESSO_BOND_CONSTRAINT
578 if (n_verlet_updates > 0) {
579 m_verlet_reuse = n_steps /
static_cast<double>(n_verlet_updates);
598 boost::container::static_vector<Particle *, 4> partners;
602 if (std::ranges::find(partners,
nullptr) != partners.end()) {
621 template <
class Handler>
622 void execute_bond_handler(
Particle &p, Handler handler) {
623 for (
const BondView bond : p.bonds()) {
624 auto const partner_ids = bond.partner_ids();
628 auto const partners_span = std::span(partners.data(), partners.size());
629 auto const bond_broken = handler(p, bond.bond_id(), partners_span);
643 void invalidate_ghosts() {
652 void set_particle_decomposition(
679 std::optional<std::pair<int, int>> fully_connected_boundary);
688 std::set<int> n_square_types);
697 template <
class Kernel>
void link_cell(Kernel kernel) {
700 auto const first = boost::make_indirect_iterator(local_cells_span.begin());
701 auto const last = boost::make_indirect_iterator(local_cells_span.end());
710 throw std::runtime_error(
"Non-cuboid box type is not compatible with a "
711 "particle decomposition that relies on "
712 "EuclideanDistance for distance calculation.");
716 [&kernel, df = detail::EuclidianDistance{}](
721#ifdef ESPRESSO_SHARED_MEMORY_PARALLELISM
732#ifdef ESPRESSO_ROTATION
744 return m_rebuild_verlet_list_cabana;
768 if (rebuild_verlet_list) {
769 kernel(m_decomposition->local_cells(), m_decomposition->box(),
770 *m_verlet_list_cabana);
772 m_rebuild_verlet_list_cabana =
false;
778 kernel(m_decomposition->local_cells(), m_decomposition->box());
788 template <
class PairKernel,
class VerletCriterion>
789 void verlet_list_loop(PairKernel pair_kernel,
794 if (m_rebuild_verlet_list) {
795 m_verlet_list.clear();
798 if (verlet_criterion(p1, p2, d)) {
799 m_verlet_list.emplace_back(&p1, &p2);
800 pair_kernel(p1, p2, d);
804 m_rebuild_verlet_list =
false;
805 m_rebuild_verlet_list_cabana =
true;
810 auto const distance_function =
812 for (
auto const &[p1, p2] : m_verlet_list) {
813 pair_kernel(*p1, *p2, distance_function(*p1, *p2));
816 auto const distance_function = detail::EuclidianDistance{};
817 for (
auto const &[p1, p2] : m_verlet_list) {
818 pair_kernel(*p1, *p2, distance_function(*p1, *p2));
828 template <
class BondKernel>
void bond_loop(BondKernel
const &bond_kernel) {
830 execute_bond_handler(p, bond_kernel);
838 link_cell(pair_kernel);
846 template <
class PairKernel,
class VerletCriterion>
850 verlet_list_loop(pair_kernel, verlet_criterion);
853 link_cell(pair_kernel);
893 return particle_to_cell(p);
904 template <
class Kernel>
909 if (cell ==
nullptr) {
916 auto const distance_function =
918 short_range_neighbor_loop(p, cell, kernel, distance_function);
920 auto const distance_function = detail::EuclidianDistance{};
921 short_range_neighbor_loop(p, cell, kernel, distance_function);
927 template <
class Kernel,
class DistanceFunc>
928 void short_range_neighbor_loop(
Particle const &p1,
Cell *
const cell,
929 Kernel &kernel, DistanceFunc
const &df) {
931 for (
auto const &p2 : cell->particles()) {
932 if (p1.
id() != p2.
id()) {
933 auto const vec = df(p1, p2).vec21;
938 for (
auto const neighbor : cell->neighbors().all()) {
940 if (neighbor != cell) {
941 for (
auto const &p2 : neighbor->
particles()) {
942 auto const vec = df(p1, p2).vec21;
ParticleIterator< std::span< Cell *const >::iterator > CellParticleIterator
CellStructureType
Cell structure topology.
@ NSQUARE
Atom decomposition (N-square).
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.
void bond_broken_error(int id, std::span< const int > partner_ids)
Immutable view on a bond.
ESPRESSO_ATTR_ALWAYS_INLINE Utils::Vector< T, 3 > get_mi_vector(const Utils::Vector< T, 3 > &a, const Utils::Vector< T, 3 > &b) const
Get the minimum-image vector between two coordinates.
Describes a cell structure / cell system.
ParticleRange ghost_particles() const
Particle * get_local_particle(int id)
Get a local particle by id.
void set_kokkos_handle(std::shared_ptr< KokkosHandle > handle)
void update_particle_index(ParticleList &pl)
Update local particle index.
void check_particle_sorting() const
Check that particles are in the correct cell.
void rebuild_verlet_list_cabana(auto &&kernel, bool rebuild_verlet_list)
std::size_t count_local_particles() const
void clear_resort_particles()
Set the resort level to sorted.
Cell * find_current_cell(const Particle &p)
Find cell a particle is stored in.
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 clear_particle_index()
Clear the particles index.
auto prepare_verlet_list_cabana(double cutoff)
Reset local properties of the Verlet list.
static constexpr auto vector_length
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.
auto get_le_pos_offset_at_last_resort() const
Kokkos::HostSpace memory_space
int get_cached_max_local_particle_id() const
void get_local_particles(InputRange ids, OutputIterator out)
void update_verlet_stats(int n_steps, int n_verlet_updates)
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
unsigned get_resort_particles() const
Get the currently scheduled resort level.
auto get_verlet_reuse() const
Average number of integration steps the Verlet list was re-used.
void rebuild_local_properties(double pair_cutoff)
void for_each_local_particle(ParticleUnaryOp &&f, bool parallel=true) const
Run a kernel on all local particles.
void non_bonded_loop(PairKernel pair_kernel)
Non-bonded pair loop.
void for_each_ghost_particle(ParticleUnaryOp &&f) const
Run a kernel on all ghost particles.
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,...
const Particle * get_local_particle(int id) const
This is an overloaded member function, provided for convenience. It differs from the above function o...
auto resolve_bond_partners(std::span< const int > partner_ids)
Resolve ids to particles.
void bond_loop(BondKernel const &bond_kernel)
Bonded pair loop.
void ghosts_count()
Synchronize number of ghosts.
void set_resort_particles(Cells::Resort level)
Increase the local resort level at least to level.
void cell_list_loop(auto &&kernel)
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.
Cabana::HalfNeighborTag ListAlgorithm
auto get_verlet_skin() const
Get the Verlet skin.
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.
auto const & get_verlet_list_cabana() const
bool run_on_particle_short_range_neighbors(Particle const &p, Kernel &kernel)
Run kernel on all particles inside local cell and its neighbors.
bool use_parallel_for_each_local_particle() const
whether to use parallel version of for_each_local_particle
void remove_all_particles()
Remove all particles from the cell system.
ParticleRange local_particles() const
void update_particle_index(Particle &p)
Update local particle index.
void ghosts_reduce_rattle_correction()
Add rattle corrections from ghost particles to real particles.
CellStructureType decomposition_type() const
auto is_verlet_list_cabana_rebuild_needed() const
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 non_bonded_loop(PairKernel pair_kernel, const VerletCriterion &verlet_criterion)
Non-bonded pair loop with potential use of verlet lists.
void reset_local_properties()
auto & particles()
Particles.
A distributed particle decomposition.
virtual Utils::Vector3d max_cutoff() const =0
Maximum supported cutoff.
virtual std::span< Cell *const > local_cells() const =0
Get pointer to local cells.
virtual Cell * particle_to_cell(Particle const &p)=0
Determine which cell a particle id belongs to.
virtual Utils::Vector3d max_range() const =0
Range in which calculations are performed.
virtual std::optional< BoxGeometry > minimum_image_distance() const =0
Return the box geometry needed for distance calculation if minimum image convention should be used ne...
virtual BoxGeometry const & box() const =0
Abstract class that represents a component of the system.
std::size_t capacity() const
Capacity of the container.
T & insert(T const &v)
Insert an element into the container.
std::size_t size() const
Number of elements in the container.
Returns true if the particles are to be considered for short range interactions.
Ghost particles and particle exchange.
void link_cell(CellIterator first, CellIterator last, PairKernel &&pair_kernel)
Iterates over all particles in the cell range, and over all pairs within the cells and with their nei...
DataPart
Flags to select particle parts for communication.
@ DATA_PART_MOMENTUM
Particle::m.
@ DATA_PART_FORCE
Particle::f.
@ DATA_PART_PROPERTIES
Particle::p.
@ DATA_PART_BONDS
Particle::bonds.
@ DATA_PART_RATTLE
Particle::rattle.
@ DATA_PART_POSITION
Particle::r.
ParticleRange particles(std::span< Cell *const > cells)
Exception indicating that a particle id could not be resolved.
Distance vector and length handed to pair kernels.
Distance(Utils::Vector3d const &vec21)
Struct holding all information for one particle.