26#include "communication.hpp"
29#include "system/System.hpp"
36#include <boost/container/flat_set.hpp>
37#include <boost/mpi/collectives.hpp>
38#include <boost/mpi/communicator.hpp>
39#include <boost/range/algorithm/reverse.hpp>
40#include <boost/range/numeric.hpp>
47#include <initializer_list>
52int RegularDecomposition::position_to_cell_index(
56 for (
auto i = 0
u; i < 3u; i++) {
83void RegularDecomposition::move_if_local(
86 for (
auto &part :
src) {
93 rest.
insert(std::move(part));
110 for (
auto it =
src.begin();
it !=
src.end();) {
111 auto const pos =
it->pos()[dir];
116 left.insert(std::move(*
it));
124void RegularDecomposition::exchange_neighbors(
129 for (
int dir = 0; dir < 3; dir++) {
131 if (Utils::Mpi::cart_get<3>(
m_comm).dims[dir] == 1) {
136 if (Utils::Mpi::cart_get<3>(
m_comm).dims[dir] == 2) {
144 using boost::mpi::request;
155 boost::mpi::wait_all(
reqs.begin(),
reqs.end());
176 std::vector<ParticleChange> &
diff) {
180 for (
auto it = c->particles().begin();
it != c->particles().end();) {
191 auto p = std::move(*
it);
192 it = c->particles().erase(
it);
209 auto const grid = Utils::Mpi::cart_get<3>(
m_comm).dims;
218 std::plus<std::size_t>());
233 <<
"than one local box length in one timestep";
234 sort_cell->particles().insert(std::move(part));
241void RegularDecomposition::mark_cells() {
257void RegularDecomposition::fill_comm_cell_lists(
ParticleList **part_lists,
260 for (
int o =
lc[0];
o <=
hc[0];
o++)
261 for (
int n =
lc[1]; n <=
hc[1]; n++)
262 for (
int m =
lc[2]; m <=
hc[2]; m++) {
265 *part_lists++ = &(
cells.at(i).particles());
278int RegularDecomposition::calc_processor_min_num_cells()
const {
284 return boost::accumulate(Utils::Mpi::cart_get<3>(
m_comm).dims, 1,
290void RegularDecomposition::create_cell_grid(
double range) {
308 auto const scale = std::cbrt(RegularDecomposition::max_num_cells / volume);
310 for (
auto i = 0
u; i < 3u; i++) {
315 if (cell_range[i] <
range) {
320 <<
"interaction range " <<
range <<
" in direction " << i
321 <<
" is larger than the local box size " <<
local_box_l[i];
343 for (
auto i = 1u; i < 3u; ++i) {
358 <<
": either interaction range is too large for "
359 <<
"the current skin (range=" <<
range <<
", "
360 <<
"half_local_box_l=[" <<
local_box_l / 2. <<
"]) "
361 <<
"or min_num_cells too large";
373 for (
auto i = 0
u; i < 3u; i++) {
389 return boost::container::flat_set<K, std::remove_reference_t<Comparator>>(
390 std::forward<Comparator>(
comp));
393void RegularDecomposition::init_cell_interactions() {
424 return std::abs((a - b)[
fc_dir]) > 1;
454 throw std::domain_error(
"fully_connected_boundary normal and connection "
455 "coordinates need to differ.");
457 if (node_grid[
fc_dir] != 1) {
458 throw std::runtime_error(
459 "The MPI nodegrid must be 1 in the fully connected direction.");
471 for (
int o = start[2];
o < end[2];
o++)
472 for (
int n = start[1]; n < end[1]; n++)
473 for (
int m = start[0]; m < end[0]; m++) {
493 for (
auto i = 0
u; i < 3u; i++) {
532 for (
auto coord : {0
u, 1u, 2u}) {
545 auto cell = &
cells.at(
578 boost::reverse(c.part_lists);
589 auto next = std::next(
it);
615 for (dir = 0; dir < 3; dir++) {
616 for (
lr = 0;
lr < 2;
lr++) {
635 for (dir = 0; dir < 3; dir++) {
636 lc[(dir + 1) % 3] = 1 -
done[(dir + 1) % 3];
637 lc[(dir + 2) % 3] = 1 -
done[(dir + 2) % 3];
644 for (
lr = 0;
lr < 2;
lr++) {
656 fill_comm_cell_lists(
ghost_comm.communications[
cnt].part_lists.data(),
663 fill_comm_cell_lists(
670 for (i = 0; i < 2; i++) {
671 if ((
comm_info.coords[dir] + i) % 2 == 0) {
679 fill_comm_cell_lists(
683 if ((
comm_info.coords[dir] + (1 - i)) % 2 == 0) {
691 fill_comm_cell_lists(
708 : m_comm(
std::
move(comm)), m_box(box_geo), m_local_box(local_geo),
712 create_cell_grid(
range);
715 init_cell_interactions();
static int coord(std::string const &s)
auto make_flat_set(Comparator &&comp)
static void fold_and_reset(Particle &p, BoxGeometry const &box_geo)
Fold coordinates to box and reset the old position.
Vector implementation and trait types for boost qvm interoperability.
T get_mi_coord(T a, T b, unsigned coord) const
Get the minimum-image distance between two coordinates.
Utils::Vector3d const & length() const
Box length.
constexpr bool periodic(unsigned coord) const
Check periodicity in direction.
void fold_position(Utils::Vector3d &pos, Utils::Vector3i &image_box) const
Fold coordinates to primary simulation box in-place.
auto const & my_right() const
Right (top, back) corner of this nodes local box.
auto const & boundary() const
Boundary information for the local box.
auto const & my_left() const
Left (bottom, front) corner of this nodes local box.
auto const & length() const
Dimensions of the box a single node is responsible for.
T & insert(T const &v)
Insert an element into the container.
DEVICE_QUALIFIER constexpr size_type size() const noexcept
static DEVICE_QUALIFIER constexpr Vector< T, N > broadcast(typename Base::value_type const &value) noexcept
Create a vector that has all entries set to the same value.
cudaStream_t stream[1]
CUDA streams for parallel computing on CPU and GPU.
Communicator communicator
This file contains the errorhandling code for severe errors, like a broken bond or illegal parameter ...
#define runtimeErrorMsg()
#define GHOST_RECV
recv from a single node
#define GHOST_PSTSTORE
additional flag for poststoring
#define GHOST_LOCL
transfer data from cell to cell on this node
#define GHOST_SEND
send to a single node
#define GHOST_PREFETCH
additional flag for prefetching
std::array< mpi::request, 2 > isendrecv(mpi::communicator const &comm, int dest, int stag, const T &sval, int src, int rtag, T &rval)
mpi::status sendrecv(mpi::communicator const &comm, int dest, int stag, const T &sval, int src, int rtag, T &rval)
T product(Vector< T, N > const &v)
int get_linear_index(int a, int b, int c, const Vector3i &adim)
auto hadamard_product(Vector< T, N > const &a, Vector< U, N > const &b)
void assign_prefetches(GhostCommunicator &comm)
Of every two communication rounds, set the first receivers to prefetch and poststore.
void revert_comm_order(GhostCommunicator &comm)
Revert the order of a communicator: After calling this the communicator is working in reverted order ...
Utils::Vector3i node_grid
Properties for a ghost communication.
std::vector< GhostCommunication > communications
List of ghost communications.
Struct holding all information for one particle.
auto & pos_at_last_verlet_update()
auto const & image_box() const
GhostCommunicator m_exchange_ghosts_comm
Utils::Vector3i ghost_cell_grid
linked cell grid with ghost frame.
Utils::Vector3d max_cutoff() const override
Utils::Vector3d inv_cell_size
inverse cell_size.
std::vector< Cell * > m_ghost_cells
BoxGeometry const & m_box
Cell * particle_to_cell(Particle const &p) override
auto fully_connected_boundary() const
void resort(bool global, std::vector< ParticleChange > &diff) override
std::vector< Cell > cells
RegularDecomposition(boost::mpi::communicator comm, double range, BoxGeometry const &box_geo, LocalBox const &local_geo, std::optional< std::pair< int, int > > fully_connected)
Utils::Vector3d cell_size
Cell size.
std::span< Cell *const > local_cells() const override
std::vector< Cell * > m_local_cells
Utils::Vector3d max_range() const override
GhostCommunicator m_collect_ghost_force_comm
Utils::Vector3i cell_grid
Grid dimensions per node.
Utils::Vector3i cell_offset
Offset in global grid.
boost::mpi::communicator m_comm