32#include "communication.hpp"
36#include "system/System.hpp"
43#include <boost/mpi/collectives/broadcast.hpp>
44#include <boost/mpi/collectives/reduce.hpp>
59template <
typename Archive,
typename... T>
60void serialize(Archive &ar, std::tuple<T...> &pack,
unsigned int const) {
61 std::apply([&](
auto &...item) { ((ar & item), ...); }, pack);
67 using type = std::tuple<std::invoke_result_t<F, Particle const &>...>;
71 using type = std::invoke_result_t<F, Particle const &>;
79template <
class... Trait>
81 std::vector<int>
const &p_types,
87 buffer.emplace_back(trait(p)...);
99 std::vector<int>
const &set2) {
102 std::vector<int> buf_type{};
103 std::vector<Utils::Vector3d> buf_pos{};
105 auto const &box_geo = *system.
box_geo;
106 auto const accept_all = set1.empty() or set2.empty();
108 if (accept_all or contains(set1, p.type()) or contains(set2, p.type())) {
109 buf_type.emplace_back(p.type());
110 buf_pos.emplace_back(box_geo.unfolded_position(p.pos(), p.image_box()));
121 auto mindist_sq = std::numeric_limits<double>::infinity();
122 for (std::size_t j = 0ul; j < buf_type.size(); ++j) {
125 if (set1.empty() || contains(set1, buf_type[j]))
127 if (set2.empty() || contains(set2, buf_type[j]))
131 for (
auto i = j + 1ul; i != buf_type.size(); ++i) {
134 if (((in_set & 1) and (set2.empty() or contains(set2, buf_type[i]))) or
135 ((in_set & 2) and (set1.empty() or contains(set1, buf_type[i])))) {
136 mindist_sq = std::min(
137 mindist_sq, box_geo.get_mi_vector(buf_pos[j], buf_pos[i]).norm2());
142 return std::sqrt(mindist_sq);
146 bool include_particles,
147 bool include_lbfluid) {
149 if (include_particles) {
150 momentum = reduce_over_local_particles<Utils::Vector3d>(
153 acc += p.mass() * p.v();
164 auto const &box_geo = *system.
box_geo;
167 double local_mass = 0.;
169 for (
auto const &p : cell_structure.local_particles()) {
170 if ((p.type() == p_type or p_type == -1) and not p.is_virtual()) {
171 local_com += box_geo.unfolded_position(p.pos(), p.image_box()) * p.mass();
172 local_mass += p.mass();
177 boost::mpi::reduce(
::comm_cart, local_com, com, std::plus<>(), 0);
178 boost::mpi::reduce(
::comm_cart, local_mass, mass, std::plus<>(), 0);
183 auto const &box_geo = *system.
box_geo;
187 for (
auto const &p : cell_structure.local_particles()) {
188 if ((p.type() == p_type or p_type == -1) and not p.is_virtual()) {
189 auto const pos = box_geo.unfolded_position(p.pos(), p.image_box());
197 std::vector<int>
const &p_types) {
198 auto const &box_geo = *system.
box_geo;
199 auto const trait_pos = [&box_geo](
Particle const &p) {
200 return box_geo.unfolded_position(p.pos(), p.image_box());
208 static_cast<double>(buf_pos.size());
210 for (
unsigned int i = 0u; i < 3u; ++i) {
211 for (
unsigned int j = 0u; j < 3u; ++j) {
213 mat[i * 3u + j] = mat[j * 3u + i];
215 mat[i * 3u + j] = std::accumulate(
216 buf_pos.begin(), buf_pos.end(), 0.,
218 return acc + (pos[i] - center[i]) * (pos[j] - center[j]);
223 mat /=
static_cast<double>(buf_pos.size());
230 auto const &box_geo = *system.
box_geo;
236 for (
auto const &p : cell_structure.local_particles()) {
237 if (p.type() == p_type and not p.is_virtual()) {
238 auto const pos = box_geo.unfolded_position(p.pos(), p.image_box()) - com;
239 auto const mass = p.mass();
240 mat[0] += mass * (pos[1] * pos[1] + pos[2] * pos[2]);
241 mat[4] += mass * (pos[0] * pos[0] + pos[2] * pos[2]);
242 mat[8] += mass * (pos[0] * pos[0] + pos[1] * pos[1]);
243 mat[1] -= mass * (pos[0] * pos[1]);
244 mat[2] -= mass * (pos[0] * pos[2]);
245 mat[5] -= mass * (pos[1] * pos[2]);
257 std::vector<int> buf_pid{};
258 auto const dist_sq = dist * dist;
259 auto const &box_geo = *system.
box_geo;
262 auto const r_sq = box_geo.get_mi_vector(pos, p.pos()).norm2();
263 if (r_sq < dist_sq) {
264 buf_pid.push_back(p.id());
276std::vector<std::vector<double>>
278 std::vector<int>
const &p1_types,
279 std::vector<int>
const &p2_types,
double r_min,
280 double r_max,
int r_bins,
bool log_flag,
bool int_flag) {
282 auto const &box_geo = *system.
box_geo;
283 auto const trait_id = [](
Particle const &p) {
return p.id(); };
284 auto const trait_pos = [&box_geo](
Particle const &p) {
285 return box_geo.unfolded_position(p.pos(), p.image_box());
293 auto const start_dist2 =
Utils::sqr(r_max + 1.);
294 auto const inv_bin_width =
295 (log_flag) ?
static_cast<double>(r_bins) / std::log(r_max / r_min)
296 :
static_cast<double>(r_bins) / (r_max - r_min);
300 std::vector<double> distribution(r_bins);
302 for (
auto const &[pid1, pos1] : buf1) {
303 auto min_dist2 = start_dist2;
305 for (
auto const &[pid2, pos2] : buf2) {
307 auto const act_dist2 = box_geo.get_mi_vector(pos1, pos2).norm2();
308 if (act_dist2 < min_dist2) {
309 min_dist2 = act_dist2;
313 if (min_dist2 <= r_max2) {
314 if (min_dist2 >= r_min2) {
315 auto const min_dist = std::sqrt(min_dist2);
317 auto const ind =
static_cast<int>(
318 ((log_flag) ? std::log(min_dist / r_min) : (min_dist - r_min)) *
320 if (ind >= 0 and ind < r_bins) {
321 distribution[ind] += 1.0;
332 low /=
static_cast<double>(cnt);
333 for (
int i = 0; i < r_bins; i++) {
334 distribution[i] /=
static_cast<double>(cnt);
339 distribution[0] += low;
340 for (
int i = 0; i < r_bins - 1; i++)
341 distribution[i + 1] += distribution[i];
345 std::vector<double> radii(r_bins);
347 auto const log_fac = std::pow(r_max / r_min, 1. / r_bins);
348 radii[0] = r_min * std::sqrt(log_fac);
349 for (
int i = 1; i < r_bins; ++i) {
350 radii[i] = radii[i - 1] * log_fac;
353 auto const bin_width = (r_max - r_min) /
static_cast<double>(r_bins);
354 for (
int i = 0; i < r_bins; ++i) {
355 radii[i] = r_min + bin_width / 2. +
static_cast<double>(i) * bin_width;
359 return {radii, distribution};
362std::vector<std::vector<double>>
365 auto const &box_geo = *system.
box_geo;
366 auto const trait_pos = [&box_geo](
Particle const &p) {
367 return box_geo.unfolded_position(p.pos(), p.image_box());
370 auto const order_sq =
Utils::sqr(
static_cast<std::size_t
>(order));
371 auto const twoPI_L = 2. * std::numbers::pi * system.
box_geo->length_inv()[0];
372 std::vector<double> ff(2ul * order_sq + 1ul);
373 std::vector<double> wavevectors;
374 std::vector<double> intensities;
377 for (
int i = 0; i <= order; i++) {
378 for (
int j = -order; j <= order; j++) {
379 for (
int k = -order; k <= order; k++) {
380 auto const n = i * i + j * j + k * k;
381 if ((
static_cast<std::size_t
>(n) <= order_sq) && (n >= 1)) {
382 double C_sum = 0.0, S_sum = 0.0;
383 for (
auto const &pos : buf_pos) {
388 ff[2 * n - 2] += C_sum * C_sum + S_sum * S_sum;
395 std::size_t length = 0;
396 for (std::size_t qi = 0; qi < order_sq; qi++) {
397 if (ff[2 * qi + 1] != 0) {
398 ff[2 * qi] /=
static_cast<double>(buf_pos.size()) * ff[2 * qi + 1];
403 wavevectors.resize(length);
404 intensities.resize(length);
407 for (std::size_t i = 0; i < order_sq; i++) {
408 if (ff[2 * i + 1] != 0) {
409 wavevectors[cnt] = twoPI_L * std::sqrt(
static_cast<double>(i + 1));
410 intensities[cnt] = ff[2 * i];
416 return {std::move(wavevectors), std::move(intensities)};
Vector implementation and trait types for boost qvm interoperability.
std::shared_ptr< CellStructure > cell_structure
std::shared_ptr< BoxGeometry > box_geo
boost::mpi::communicator comm_cart
The communicator.
__device__ void vector_product(float const *a, float const *b, float *out)
This file contains the errorhandling code for severe errors, like a broken bond or illegal parameter ...
void gather_buffer(std::vector< T, Allocator > &buffer, boost::mpi::communicator const &comm, int root=0)
Gather buffer with different size on each node.
DEVICE_QUALIFIER constexpr T sqr(T x)
Calculates the SQuaRe of x.
bool contains(Range &&rng, T const &value)
Check whether a range contains a value.
void serialize(Archive &ar, std::tuple< T... > &pack, unsigned int const)
Serialize std::tuple.
Exports for the NpT code.
Utils::Vector3d center_of_mass(System::System const &system, int p_type)
Calculate the center of mass of particles of a certain type.
Utils::Vector3d angular_momentum(System::System const &system, int p_type)
Calculate the angular momentum of particles of a certain type.
std::vector< int > nbhood(System::System const &system, Utils::Vector3d const &pos, double dist)
Find all particles within a given radius dist around a position pos.
Utils::Vector9d moment_of_inertia_matrix(System::System const &system, int p_type)
Calculate the moment of inertia of particles of a certain type.
Utils::Vector9d gyration_tensor(System::System const &system, std::vector< int > const &p_types)
Calculate the gyration tensor of particles of certain types.
Utils::Vector3d calc_linear_momentum(System::System const &system, bool include_particles, bool include_lbfluid)
Calculate total momentum of the system (particles & LB fluid).
std::vector< std::vector< double > > structure_factor(System::System const &system, std::vector< int > const &p_types, int order)
Calculate the spherically averaged structure factor.
double mindist(System::System const &system, std::vector< int > const &set1, std::vector< int > const &set2)
Calculate the minimal distance of two particles with types in set1 and set2, respectively.
static auto gather_traits_for_types(System::System const &system, std::vector< int > const &p_types, Trait &&...trait)
Gather particle traits to MPI rank 0.
std::vector< std::vector< double > > calc_part_distribution(System::System const &system, std::vector< int > const &p1_types, std::vector< int > const &p2_types, double r_min, double r_max, int r_bins, bool log_flag, bool int_flag)
Calculate the distribution of particles around others.
Statistical tools to analyze simulations.
std::invoke_result_t< F, Particle const & > type
Decay a tuple of only 1 type to that type.
std::tuple< std::invoke_result_t< F, Particle const & >... > type
bool is_solver_set() const
Return true if a LB solver is active.
auto get_lattice_speed() const
Get the lattice speed (agrid/tau).
Utils::Vector3d get_momentum() const
Struct holding all information for one particle.