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 = 0u; i < 3u; i++) {
57 cpos[i] =
static_cast<int>(std::floor(pos[i] *
inv_cell_size[i])) + 1 -
83void RegularDecomposition::move_if_local(
85 std::vector<ParticleChange> &modified_cells) {
86 for (
auto &part : src) {
87 auto target_cell = position_to_cell(part.pos());
90 target_cell->particles().insert(std::move(part));
91 modified_cells.emplace_back(
ModifiedList{target_cell->particles()});
93 rest.
insert(std::move(part));
100void RegularDecomposition::move_left_or_right(
ParticleList &src,
106 auto const can_move_left =
m_box.
periodic(dir) or not is_open_boundary_left;
107 auto const can_move_right =
m_box.
periodic(dir) or not is_open_boundary_right;
110 for (
auto it = src.
begin(); it != src.
end();) {
111 auto const pos = it->pos()[dir];
113 right.
insert(std::move(*it));
116 left.
insert(std::move(*it));
124void RegularDecomposition::exchange_neighbors(
125 ParticleList &pl, std::vector<ParticleChange> &modified_cells) {
126 auto const node_neighbors = Utils::Mpi::cart_neighbors<3>(
m_comm);
127 static ParticleList send_buf_l, send_buf_r, recv_buf_l, recv_buf_r;
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) {
137 move_left_or_right(pl, send_buf_l, send_buf_l, dir);
140 node_neighbors[2 * dir], 0, recv_buf_l);
144 using boost::mpi::request;
147 move_left_or_right(pl, send_buf_l, send_buf_r, dir);
150 node_neighbors[2 * dir], 0, recv_buf_l);
151 auto req_r =
isendrecv(
m_comm, node_neighbors[2 * dir + 1], 0, send_buf_r,
152 node_neighbors[2 * dir + 1], 0, recv_buf_r);
154 std::array<request, 4> reqs{{req_l[0], req_l[1], req_r[0], req_r[1]}};
155 boost::mpi::wait_all(reqs.begin(), reqs.end());
161 move_if_local(recv_buf_l, pl, modified_cells);
162 move_if_local(recv_buf_r, pl, modified_cells);
176 std::vector<ParticleChange> &diff) {
180 for (
auto it = c->particles().begin(); it != c->particles().end();) {
186 if (target_cell == c) {
191 auto p = std::move(*it);
192 it = c->particles().erase(it);
196 if (target_cell ==
nullptr) {
198 displaced_parts.
insert(std::move(p));
201 else if (target_cell != c) {
202 target_cell->particles().insert(std::move(p));
203 diff.emplace_back(
ModifiedList{target_cell->particles()});
209 auto const grid = Utils::Mpi::cart_get<3>(
m_comm).dims;
213 int rounds_left = grid[0] + grid[1] + grid[2] - 3;
214 for (; rounds_left > 0; rounds_left--) {
215 exchange_neighbors(displaced_parts, diff);
217 auto left_over = boost::mpi::all_reduce(
m_comm, displaced_parts.
size(),
218 std::plus<std::size_t>());
220 if (left_over == 0) {
225 exchange_neighbors(displaced_parts, diff);
228 if (not displaced_parts.
empty()) {
231 for (
auto &part : displaced_parts) {
233 <<
"than one local box length in one timestep";
234 sort_cell->particles().insert(std::move(part));
236 diff.emplace_back(
ModifiedList{sort_cell->particles()});
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());
270 auto dir_max_range = [
this](
unsigned int i) {
274 return {dir_max_range(0u), dir_max_range(1u), dir_max_range(2u)};
278int RegularDecomposition::calc_processor_min_num_cells()
const {
284 return boost::accumulate(Utils::Mpi::cart_get<3>(
m_comm).dims, 1,
285 [](
int n_cells,
int grid) {
286 return (grid == 1) ? 2 * n_cells : n_cells;
290void RegularDecomposition::create_cell_grid(
double range) {
291 auto const cart_info = Utils::Mpi::cart_get<3>(
m_comm);
295 auto const min_num_cells = calc_processor_min_num_cells();
299 auto const cells_per_dir =
300 static_cast<int>(std::ceil(std::cbrt(min_num_cells)));
308 auto const scale = std::cbrt(RegularDecomposition::max_num_cells / volume);
310 for (
auto i = 0u; i < 3u; i++) {
312 cell_grid[i] =
static_cast<int>(std::ceil(local_box_l[i] * scale));
313 cell_range[i] = local_box_l[i] /
static_cast<double>(
cell_grid[i]);
315 if (cell_range[i] < range) {
317 cell_grid[i] =
static_cast<int>(std::floor(local_box_l[i] / range));
320 <<
"interaction range " << range <<
" in direction " << i
321 <<
" is larger than the local box size " << local_box_l[i];
324 cell_range[i] = local_box_l[i] /
static_cast<double>(
cell_grid[i]);
336 if (n_local_cells <= RegularDecomposition::max_num_cells)
341 auto min_size = cell_range[0];
343 for (
auto i = 1u; i < 3u; ++i) {
344 if (
cell_grid[i] > 1 and cell_range[i] < min_size) {
346 min_size = cell_range[i];
355 if (n_local_cells < min_num_cells) {
357 <<
" is smaller than minimum " << min_num_cells
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";
365 if (n_local_cells > RegularDecomposition::max_num_cells) {
369 auto const node_pos = cart_info.coords;
373 for (
auto i = 0u; i < 3u; i++) {
383 cells.resize(
static_cast<unsigned int>(new_cells));
389 return boost::container::flat_set<K, std::remove_reference_t<Comparator>>(
390 std::forward<Comparator>(comp));
393void RegularDecomposition::init_cell_interactions() {
398 auto const cart_info = Utils::Mpi::cart_get<3>(
m_comm);
400 auto const &node_pos = cart_info.coords;
409 return (cell_idx[
coord] == 0 or cell_idx[
coord] == global_size[
coord]);
415 auto const fcb_is_inner_connection = [&global_size,
this](
Utils::Vector3i a,
419 auto const involves_ghost_cell =
420 (a[fc_normal] == -1 or a[fc_normal] == global_size[fc_normal] or
421 b[fc_normal] == -1 or b[fc_normal] == global_size[fc_normal]);
422 if (not involves_ghost_cell) {
424 return std::abs((a - b)[fc_dir]) > 1;
434 return (global_halo_offset + local_index);
439 auto const folded_index = (global_index + global_size) % global_size;
447 return (global_index - global_halo_offset);
453 if (fc_normal == fc_dir) {
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++) {
485 if (at_boundary(fc_boundary, {m, n, o})) {
486 lower_index[fc_direction] = -1;
487 upper_index[fc_direction] = global_size[fc_boundary];
493 for (
auto i = 0u; i < 3u; i++) {
495 lower_index[i] = std::max(0, lower_index[i]);
496 upper_index[i] = std::min(global_size[i] - 1, upper_index[i]);
502 auto neighbors = make_flat_set<Utils::Vector3i>(
504 return folded_linear_index(a) < folded_linear_index(b);
508 for (
int p = lower_index[2]; p <= upper_index[2]; p++)
509 for (
int q = lower_index[1]; q <= upper_index[1]; q++)
510 for (
int r = lower_index[0]; r <= upper_index[0]; r++) {
514 if (fcb_is_inner_connection({m, n, o}, {r, q, p}))
521 auto const ind1 = folded_linear_index({m, n, o});
523 std::vector<Cell *> red_neighbors;
524 std::vector<Cell *> black_neighbors;
530 for (
auto &neighbor : neighbors) {
532 for (
auto coord : {0u, 1u, 2u}) {
533 if (neighbor[
coord] == -1) {
540 auto const ind2 = folded_linear_index(neighbor);
545 auto cell = &
cells.at(
550 red_neighbors.push_back(cell);
552 black_neighbors.push_back(cell);
578 boost::reverse(c.part_lists);
589 auto next = std::next(it);
607 int dir, lr, i, cnt, n_comm_cells[3];
610 auto const comm_info = Utils::Mpi::cart_get<3>(
m_comm);
611 auto const node_neighbors = Utils::Mpi::cart_neighbors<3>(
m_comm);
615 for (dir = 0; dir < 3; dir++) {
616 for (lr = 0; lr < 2; lr++) {
618 if (comm_info.dims[dir] == 1)
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];
638 hc[(dir + 1) % 3] =
cell_grid[(dir + 1) % 3] + done[(dir + 1) % 3];
639 hc[(dir + 2) % 3] =
cell_grid[(dir + 2) % 3] + done[(dir + 2) % 3];
644 for (lr = 0; lr < 2; lr++) {
645 if (comm_info.dims[dir] == 1) {
647 ghost_comm.communications[cnt].type =
GHOST_LOCL;
648 ghost_comm.communications[cnt].node =
m_comm.rank();
651 ghost_comm.communications[cnt].part_lists.resize(2 * n_comm_cells[dir]);
654 lc[dir] = hc[dir] = 1 + lr * (
cell_grid[dir] - 1);
656 fill_comm_cell_lists(ghost_comm.communications[cnt].part_lists.data(),
660 lc[dir] = hc[dir] = 0 + (1 - lr) * (
cell_grid[dir] + 1);
663 fill_comm_cell_lists(
664 &ghost_comm.communications[cnt].part_lists[n_comm_cells[dir]], lc,
670 for (i = 0; i < 2; i++) {
671 if ((comm_info.coords[dir] + i) % 2 == 0) {
672 ghost_comm.communications[cnt].type =
GHOST_SEND;
673 ghost_comm.communications[cnt].node = node_neighbors[2 * dir + lr];
674 ghost_comm.communications[cnt].part_lists.resize(n_comm_cells[dir]);
677 lc[dir] = hc[dir] = 1 + lr * (
cell_grid[dir] - 1);
679 fill_comm_cell_lists(
680 ghost_comm.communications[cnt].part_lists.data(), lc, hc);
683 if ((comm_info.coords[dir] + (1 - i)) % 2 == 0) {
684 ghost_comm.communications[cnt].type =
GHOST_RECV;
685 ghost_comm.communications[cnt].node =
686 node_neighbors[2 * dir + (1 - lr)];
687 ghost_comm.communications[cnt].part_lists.resize(n_comm_cells[dir]);
689 lc[dir] = hc[dir] = (1 - lr) * (
cell_grid[dir] + 1);
691 fill_comm_cell_lists(
692 ghost_comm.communications[cnt].part_lists.data(), lc, hc);
705 boost::mpi::communicator comm,
double range,
BoxGeometry const &box_geo,
707 std::optional<std::pair<int, int>> fully_connected)
708 : m_comm(
std::move(comm)), m_box(box_geo), m_local_box(local_geo),
709 m_fully_connected_boundary(
std::move(fully_connected)) {
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.
void clear()
Remove all elements form container.
bool empty() const
Is the container empty?
T & insert(T const &v)
Insert an element into the container.
iterator erase(iterator it)
Remove element from the list.
std::size_t size() const
Number of elements in 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.
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