ESPResSo
Extensible Simulation Package for Research on Soft Matter Systems
Loading...
Searching...
No Matches
statistics.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/** \file
22 * Statistical tools to analyze simulations.
23 *
24 * The corresponding header file is statistics.hpp.
25 */
26
28
29#include "BoxGeometry.hpp"
30#include "Particle.hpp"
32#include "communication.hpp"
33#include "errorhandling.hpp"
34#include "npt.hpp"
36#include "system/System.hpp"
37
38#include <utils/Vector.hpp>
39#include <utils/contains.hpp>
40#include <utils/math/sqr.hpp>
42
43#include <boost/mpi/collectives/broadcast.hpp>
44#include <boost/mpi/collectives/reduce.hpp>
45
46#include <cassert>
47#include <cmath>
48#include <cstdlib>
49#include <functional>
50#include <limits>
51#include <numbers>
52#include <stdexcept>
53#include <tuple>
54#include <utility>
55#include <vector>
56
58/** @brief Serialize @c std::tuple. */
59template <typename Archive, typename... T>
60void serialize(Archive &ar, std::tuple<T...> &pack, unsigned int const) {
61 std::apply([&](auto &...item) { ((ar & item), ...); }, pack);
62}
63} // namespace boost::serialization
64
65/** @brief Decay a tuple of only 1 type to that type. */
66template <typename... F> struct DecayTupleResult {
67 using type = std::tuple<std::invoke_result_t<F, Particle const &>...>;
68};
69
70template <typename F> struct DecayTupleResult<F> {
71 using type = std::invoke_result_t<F, Particle const &>;
72};
73
74/**
75 * @brief Gather particle traits to MPI rank 0.
76 * When only one trait is requested, return a vector of type T.
77 * When multiple traits are requested, return a vector of tuples.
78 */
79template <class... Trait>
80static auto gather_traits_for_types(System::System const &system,
81 std::vector<int> const &p_types,
82 Trait &&...trait) {
83 std::vector<typename DecayTupleResult<Trait...>::type> buffer{};
84
85 for (auto const &p : system.cell_structure->local_particles()) {
86 if (Utils::contains(p_types, p.type())) {
87 buffer.emplace_back(trait(p)...);
88 }
89 }
90
92 if (::comm_cart.rank() != 0) {
93 buffer.clear();
94 }
95 return buffer;
96}
97
98double mindist(System::System const &system, std::vector<int> const &set1,
99 std::vector<int> const &set2) {
100 using Utils::contains;
101
102 std::vector<int> buf_type{};
103 std::vector<Utils::Vector3d> buf_pos{};
104
105 auto const &box_geo = *system.box_geo;
106 auto const accept_all = set1.empty() or set2.empty();
107 for (auto const &p : system.cell_structure->local_particles()) {
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()));
111 }
112 }
113
116 if (::comm_cart.rank() != 0) {
117 buf_type.clear();
118 buf_pos.clear();
119 }
120
121 auto mindist_sq = std::numeric_limits<double>::infinity();
122 for (std::size_t j = 0ul; j < buf_type.size(); ++j) {
123 /* check which sets particle j belongs to (bit 0: set1, bit1: set2) */
124 auto in_set = 0;
125 if (set1.empty() || contains(set1, buf_type[j]))
126 in_set = 1;
127 if (set2.empty() || contains(set2, buf_type[j]))
128 in_set |= 2;
129 assert(in_set != 0);
130
131 for (auto i = j + 1ul; i != buf_type.size(); ++i) {
132 /* accept a pair if particle j is in set1 and particle i in set2 or vice
133 * versa. */
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());
138 }
139 }
140 }
141
142 return std::sqrt(mindist_sq);
143}
144
146 bool include_particles,
147 bool include_lbfluid) {
148 Utils::Vector3d momentum{};
149 if (include_particles) {
150 momentum = reduce_over_local_particles<Utils::Vector3d>(
151 *(system.cell_structure),
152 [](Utils::Vector3d &acc, Particle const &p) {
153 acc += p.mass() * p.v();
154 },
155 [](Utils::Vector3d &acc, Utils::Vector3d const &v) { acc = acc + v; });
156 }
157 if (include_lbfluid and system.lb.is_solver_set()) {
158 momentum += system.lb.get_momentum() * system.lb.get_lattice_speed();
159 }
160 return momentum;
161}
162
164 auto const &box_geo = *system.box_geo;
165 auto const &cell_structure = *system.cell_structure;
166 Utils::Vector3d local_com{};
167 double local_mass = 0.;
168
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();
173 }
174 }
175 Utils::Vector3d com{};
176 double mass = 1.; // placeholder value to avoid division by zero
177 boost::mpi::reduce(::comm_cart, local_com, com, std::plus<>(), 0);
178 boost::mpi::reduce(::comm_cart, local_mass, mass, std::plus<>(), 0);
179 return com / mass;
180}
181
183 auto const &box_geo = *system.box_geo;
184 auto const &cell_structure = *system.cell_structure;
185 Utils::Vector3d am{};
186
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());
190 am += p.mass() * vector_product(pos, p.v());
191 }
192 }
193 return am;
194}
195
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());
201 };
202 auto const buf_pos = gather_traits_for_types(system, p_types, trait_pos);
203
204 Utils::Vector9d mat{};
205 if (::comm_cart.rank() == 0) {
206 auto const center =
207 std::accumulate(buf_pos.begin(), buf_pos.end(), Utils::Vector3d{}) /
208 static_cast<double>(buf_pos.size());
209 // compute covariance matrix
210 for (unsigned int i = 0u; i < 3u; ++i) {
211 for (unsigned int j = 0u; j < 3u; ++j) {
212 if (i > j) {
213 mat[i * 3u + j] = mat[j * 3u + i];
214 } else {
215 mat[i * 3u + j] = std::accumulate(
216 buf_pos.begin(), buf_pos.end(), 0.,
217 [i, j, &center](double acc, Utils::Vector3d const &pos) {
218 return acc + (pos[i] - center[i]) * (pos[j] - center[j]);
219 });
220 }
221 }
222 }
223 mat /= static_cast<double>(buf_pos.size());
224 }
225 return mat;
226}
227
229 int p_type) {
230 auto const &box_geo = *system.box_geo;
231 auto const &cell_structure = *system.cell_structure;
232 Utils::Vector9d mat{};
233 auto com = center_of_mass(system, p_type);
234 boost::mpi::broadcast(::comm_cart, com, 0);
235
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]);
246 }
247 }
248 /* use symmetry */
249 mat[3] = mat[1];
250 mat[6] = mat[2];
251 mat[7] = mat[5];
252 return mat;
253}
254
255std::vector<int> nbhood(System::System const &system,
256 Utils::Vector3d const &pos, double dist) {
257 std::vector<int> buf_pid{};
258 auto const dist_sq = dist * dist;
259 auto const &box_geo = *system.box_geo;
260
261 for (auto const &p : system.cell_structure->local_particles()) {
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());
265 }
266 }
267
269 if (::comm_cart.rank() != 0) {
270 buf_pid.clear();
271 }
272
273 return buf_pid;
274}
275
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) {
281
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());
286 };
287 auto const buf1 =
288 gather_traits_for_types(system, p1_types, trait_id, trait_pos);
289 auto const buf2 =
290 gather_traits_for_types(system, p2_types, trait_id, trait_pos);
291 auto const r_max2 = Utils::sqr(r_max);
292 auto const r_min2 = Utils::sqr(r_min);
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);
297
298 long cnt = 0;
299 double low = 0.0;
300 std::vector<double> distribution(r_bins);
301
302 for (auto const &[pid1, pos1] : buf1) {
303 auto min_dist2 = start_dist2;
304 /* particle loop: p2_types */
305 for (auto const &[pid2, pos2] : buf2) {
306 if (pid1 != pid2) {
307 auto const act_dist2 = box_geo.get_mi_vector(pos1, pos2).norm2();
308 if (act_dist2 < min_dist2) {
309 min_dist2 = act_dist2;
310 }
311 }
312 }
313 if (min_dist2 <= r_max2) {
314 if (min_dist2 >= r_min2) {
315 auto const min_dist = std::sqrt(min_dist2);
316 /* calculate bin index */
317 auto const ind = static_cast<int>(
318 ((log_flag) ? std::log(min_dist / r_min) : (min_dist - r_min)) *
319 inv_bin_width);
320 if (ind >= 0 and ind < r_bins) {
321 distribution[ind] += 1.0;
322 }
323 } else {
324 low += 1.0;
325 }
326 }
327 cnt++;
328 }
329
330 if (cnt != 0) {
331 // normalization
332 low /= static_cast<double>(cnt);
333 for (int i = 0; i < r_bins; i++) {
334 distribution[i] /= static_cast<double>(cnt);
335 }
336
337 // integration
338 if (int_flag) {
339 distribution[0] += low;
340 for (int i = 0; i < r_bins - 1; i++)
341 distribution[i + 1] += distribution[i];
342 }
343 }
344
345 std::vector<double> radii(r_bins);
346 if (log_flag) {
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;
351 }
352 } else {
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;
356 }
357 }
358
359 return {radii, distribution};
360}
361
362std::vector<std::vector<double>>
363structure_factor(System::System const &system, std::vector<int> const &p_types,
364 int order) {
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());
368 };
369 auto const buf_pos = gather_traits_for_types(system, p_types, trait_pos);
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;
375
376 if (::comm_cart.rank() == 0) {
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) {
384 auto const qr = twoPI_L * (Utils::Vector3i{{i, j, k}} * pos);
385 C_sum += cos(qr);
386 S_sum += sin(qr);
387 }
388 ff[2 * n - 2] += C_sum * C_sum + S_sum * S_sum;
389 ff[2 * n - 1]++;
390 }
391 }
392 }
393 }
394
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];
399 ++length;
400 }
401 }
402
403 wavevectors.resize(length);
404 intensities.resize(length);
405
406 int cnt = 0;
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];
411 cnt++;
412 }
413 }
414 }
415
416 return {std::move(wavevectors), std::move(intensities)};
417}
Vector implementation and trait types for boost qvm interoperability.
Main system class.
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.
Definition sqr.hpp:28
bool contains(Range &&rng, T const &value)
Check whether a range contains a value.
Definition contains.hpp:36
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.
Definition lb/Solver.cpp:65
auto get_lattice_speed() const
Get the lattice speed (agrid/tau).
Utils::Vector3d get_momentum() const
Struct holding all information for one particle.
Definition Particle.hpp:450