Version: SMASH-3.2
nucleus.cc
Go to the documentation of this file.
1 /*
2  * Copyright (c) 2014-2024
3  * SMASH Team
4  *
5  * GNU General Public License (GPLv3 or later)
6  */
7 #include "smash/nucleus.h"
8 
9 #include <fstream>
10 #include <iostream>
11 #include <limits>
12 #include <map>
13 #include <string>
14 
15 #include "smash/angles.h"
16 #include "smash/constants.h"
17 #include "smash/fourvector.h"
18 #include "smash/input_keys.h"
19 #include "smash/logging.h"
20 #include "smash/numerics.h"
21 #include "smash/particles.h"
22 #include "smash/random.h"
23 #include "smash/threevector.h"
24 
25 namespace smash {
26 static constexpr int LNucleus = LogArea::Nucleus::id;
27 
28 Nucleus::Nucleus(const std::map<PdgCode, int> &particle_list, int nTest) {
29  fill_from_list(particle_list, nTest);
32 }
33 
34 Nucleus::Nucleus(Configuration &config, int nTest) {
35  assert(has_projectile_or_target(config));
36  const bool is_projectile = is_about_projectile(config);
37  const auto &[particles_key, diffusiveness_key, radius_key,
38  saturation_key] = [&is_projectile]() {
39  return is_projectile
40  ? std::make_tuple(
45  : std::make_tuple(
50  }();
51  // Fill nuclei with particles.
52  std::map<PdgCode, int> part = config.take(particles_key);
53  fill_from_list(part, nTest);
54  // Look for user-defined values or take the default parameters.
55  const bool is_diffusiveness_given = config.has_value(diffusiveness_key),
56  is_radius_given = config.has_value(radius_key),
57  is_saturation_given = config.has_value(saturation_key);
58  if (is_diffusiveness_given && is_radius_given && is_saturation_given) {
59  diffusiveness_ = config.take(diffusiveness_key);
60  nuclear_radius_ = config.take(radius_key);
61  saturation_density_ = config.take(saturation_key);
62  } else if (!is_diffusiveness_given && !is_radius_given &&
63  !is_saturation_given) {
66  } else {
67  throw std::invalid_argument(
68  "Diffusiveness, Radius and Saturation_Density required to manually "
69  "configure the Woods-Saxon distribution. Only one or two were provided."
70  "\nProviding none of the above mentioned parameters automatically "
71  "configures the distribution based on the atomic number.");
72  }
73 }
74 
75 double Nucleus::mass() const {
76  double total_mass = 0.;
77  for (auto i = cbegin(); i != cend(); i++) {
78  total_mass += i->momentum().abs();
79  }
80  return total_mass / (testparticles_ + 0.0);
81 }
82 
236  // Get the solid angle of the nucleon.
237  Angles dir;
239  // diffusiveness_ zero or negative? Use hard sphere.
240  if (almost_equal(diffusiveness_, 0.)) {
241  return dir.threevec() * nuclear_radius_ * std::cbrt(random::canonical());
242  }
243  if (almost_equal(nuclear_radius_, 0.)) {
244  return smash::ThreeVector();
245  }
246  double radius_scaled = nuclear_radius_ / diffusiveness_;
247  double prob_range1 = 1.0;
248  double prob_range2 = 3. / radius_scaled;
249  double prob_range3 = 2. * prob_range2 / radius_scaled;
250  double prob_range4 = 1. * prob_range3 / radius_scaled;
251  double ranges234 = prob_range2 + prob_range3 + prob_range4;
252  double t;
254  do {
255  double which_range = random::uniform(-prob_range1, ranges234);
256  if (which_range < 0.0) {
257  t = radius_scaled * (std::cbrt(random::canonical()) - 1.);
258  } else {
259  t = -std::log(random::canonical());
260  if (which_range >= prob_range2) {
261  t -= std::log(random::canonical());
262  if (which_range >= prob_range2 + prob_range3) {
263  t -= std::log(random::canonical());
264  }
265  }
266  }
274  } while (random::canonical() > 1. / (1. + std::exp(-std::abs(t))));
276  double position_scaled = t + radius_scaled;
277  double position = position_scaled * diffusiveness_;
278  return dir.threevec() * position;
279 }
280 
281 double Nucleus::woods_saxon(double r) {
282  return r * r / (std::exp((r - nuclear_radius_) / diffusiveness_) + 1);
283 }
284 
286  for (auto i = begin(); i != end(); i++) {
287  // Initialize momentum
288  i->set_4momentum(i->pole_mass(), 0.0, 0.0, 0.0);
289  /* Sampling the Woods-Saxon, get the radial
290  * position and solid angle for the nucleon. */
292 
293  // Set the position of the nucleon.
294  i->set_4position(FourVector(0.0, pos));
295  }
296 
297  // Recenter and rotate
298  align_center();
299  rotate();
300 }
301 
304  int Z = Nucleus::number_of_protons();
305  if (A == 1) { // single particle
306  /* In case of testparticles, an infinite reaction loop will be
307  * avoided by a small finite spread according to a single particles
308  * 'nucleus'. The proper solution will be to introduce parallel
309  * ensembles. */
311  testparticles_ == 1 ? 0. : 1. - std::exp(-(testparticles_ - 1.) * 0.1));
312  set_diffusiveness(testparticles_ == 1 ? -1. : 0.02);
313  } else if ((A == 238) && (Z == 92)) { // Uranium
314  // Default values.
315  set_diffusiveness(0.556);
316  set_nuclear_radius(6.86);
317  } else if ((A == 208) && (Z == 82)) { // Lead
318  // Default values.
319  set_diffusiveness(0.54);
320  set_nuclear_radius(6.67);
321  } else if ((A == 197) && (Z == 79)) { // Gold
322  // Default values from \iref{Schopper:2004qco}
323  set_diffusiveness(0.523);
324  set_nuclear_radius(6.55);
325  } else if ((A == 129) && (Z == 54)) { // Xenon
326  // Default values.
327  set_diffusiveness(0.59);
328  set_nuclear_radius(5.36);
329  } else if ((A == 63) && (Z == 29)) { // Copper
330  // Default values.
331  set_diffusiveness(0.5977);
332  set_nuclear_radius(4.20641);
333  } else if (A == 96) {
334  if (Z == 40) { // Zirconium
335  // Default values.
336  set_diffusiveness(0.46);
337  set_nuclear_radius(5.02);
338  } else if (Z == 44) { // Ruthenium
339  // Default values.
340  set_diffusiveness(0.46);
341  set_nuclear_radius(5.085);
342  } else {
343  // radius and diffusiveness taken from \iref{Rybczynski:2013yba}
344  set_diffusiveness(0.54);
345  set_nuclear_radius(1.12 * std::pow(A, 1.0 / 3.0) -
346  0.86 * std::pow(A, -1.0 / 3.0));
347  }
348  } else {
349  // saturation density already has reasonable default
351  if (A <= 16) {
352  set_diffusiveness(0.545);
353  } else {
354  // diffusiveness taken from \iref{Rybczynski:2013yba}
355  set_diffusiveness(0.54);
356  }
357  }
358 }
359 
361  const bool is_projectile =
362  has_projectile_or_target(config) ? is_about_projectile(config) : true;
363  const auto &[rotation_key, theta_key, phi_key, psi_key] = [&is_projectile]() {
364  return is_projectile
365  ? std::make_tuple(
370  : std::make_tuple(
375  }();
376  const bool was_any_angle_provided = config.has_value(theta_key) ||
377  config.has_value(phi_key) ||
378  config.has_value(psi_key);
379  random_rotation_ = config.take(rotation_key);
380  if (random_rotation_ && was_any_angle_provided) {
381  throw std::domain_error(
382  "The random rotation of nuclei has been requested, but some specific "
383  "rotation angle is provided, too. Please specify only either of them.");
384  } else {
385  euler_theta_ = config.take(theta_key);
386  euler_phi_ = config.take(phi_key);
387  euler_psi_ = config.take(psi_key);
388  }
389 }
390 
392  if (random_rotation_) {
393  // Randomly generate euler angles for theta and phi. Psi needs not be
394  // assigned, as the nucleus objects are symmetric with respect to psi.
396  }
397  if (euler_phi_ != 0.0 || euler_theta_ != 0.0 || euler_psi_ != 0.0) {
398  for (auto &particle : *this) {
399  /* Rotate every vector by the euler angles phi, theta and psi.
400  * This means applying the matrix for a rotation of phi around the z-axis,
401  * followed by the matrix for a rotation of theta around the rotated
402  * x-axis and the matrix for a rotation of psi around the rotated z-axis.
403  */
404  ThreeVector three_pos = particle.position().threevec();
406  particle.set_3position(three_pos);
407  }
408  }
409 }
410 
412  const int N_n = std::count_if(begin(), end(), [](const ParticleData i) {
413  return i.pdgcode() == pdg::n;
414  });
415  const int N_p = std::count_if(begin(), end(), [](const ParticleData i) {
416  return i.pdgcode() == pdg::p;
417  });
418  const FourVector nucleus_center = center();
419  const int A = N_n + N_p;
420  constexpr double pi2_3 = 3.0 * M_PI * M_PI;
421  logg[LNucleus].debug() << N_n << " neutrons, " << N_p << " protons.";
422 
423  ThreeVector ptot = ThreeVector(0.0, 0.0, 0.0);
424  for (auto i = begin(); i != end(); i++) {
425  // Only protons and neutrons get Fermi momenta
426  if (i->pdgcode() != pdg::p && i->pdgcode() != pdg::n) {
427  if (i->is_baryon()) {
428  logg[LNucleus].warn() << "No rule to calculate Fermi momentum "
429  << "for particle " << i->pdgcode();
430  }
431  continue;
432  }
433  const double r = (i->position() - nucleus_center).abs3();
434  const double theta = (i->position().threevec().get_theta());
435  const double phi = (i->position().threevec().get_phi());
436  double rho = nucleon_density(r, std::cos(theta), phi);
437 
438  if (i->pdgcode() == pdg::p) {
439  rho = rho * N_p / A;
440  }
441  if (i->pdgcode() == pdg::n) {
442  rho = rho * N_n / A;
443  }
444  const double p =
445  hbarc * std::pow(pi2_3 * rho * random::uniform(0.0, 1.0), 1.0 / 3.0);
446  Angles phitheta;
447  phitheta.distribute_isotropically();
448  const ThreeVector ith_3momentum = phitheta.threevec() * p;
449  ptot += ith_3momentum;
450  i->set_3momentum(ith_3momentum);
451  logg[LNucleus].debug() << "Particle: " << *i << ", pF[GeV]: "
452  << hbarc * std::pow(pi2_3 * rho, 1.0 / 3.0)
453  << " r[fm]: " << r
454  << " Nuclear radius[fm]: " << nuclear_radius_;
455  }
456  if (A == 0) {
457  // No Fermi momenta should be assigned
458  assert(ptot.x1() == 0.0 && ptot.x2() == 0.0 && ptot.x3() == 0.0);
459  } else {
460  /* Ensure zero total momentum of nucleus - redistribute ptot equally
461  * among protons and neutrons */
462  const ThreeVector centralizer = ptot / A;
463  for (auto i = begin(); i != end(); i++) {
464  if (i->pdgcode() == pdg::p || i->pdgcode() == pdg::n) {
465  i->set_4momentum(i->pole_mass(),
466  i->momentum().threevec() - centralizer);
467  }
468  }
469  }
470 }
471 
472 void Nucleus::boost(double beta_scalar) {
473  double beta_squared = beta_scalar * beta_scalar;
474  double one_over_gamma = std::sqrt(1.0 - beta_squared);
475  double gamma = 1.0 / one_over_gamma;
476  /* We are talking about a /passive/ lorentz transformation here, as
477  * far as I can see, so we need to boost in the direction opposite to
478  * where we want to go
479  * ( The vector we transform - p - stays unchanged, but we go into
480  * a system that moves with -beta. Now in this frame, it seems
481  * like p has been accelerated with +beta.
482  * ) */
483  for (auto i = begin(); i != end(); i++) {
484  /* a real Lorentz Transformation would leave the particles at
485  * different times here, which we would then have to propagate back
486  * to equal times. Since we know the result, we can simply multiply
487  * the z-value with 1/gamma. */
488  FourVector this_position = i->position();
489  this_position.set_x3(this_position.x3() * one_over_gamma);
490  i->set_4position(this_position);
491  /* The simple Lorentz transformation of momenta does not take into account
492  * that nucleus has binding energy. Here we apply the method used
493  * in the JAM code \iref{Nara:1999dz}: p' = p_beam + gamma*p_F.
494  * This formula is derived under assumption that all nucleons have
495  * the same binding energy. */
496  FourVector mom_i = i->momentum();
497  i->set_4momentum(i->pole_mass(), mom_i.x1(), mom_i.x2(),
498  gamma * (beta_scalar * mom_i.x0() + mom_i.x3()));
499  }
500 }
501 
502 void Nucleus::fill_from_list(const std::map<PdgCode, int> &particle_list,
503  int testparticles) {
504  testparticles_ = testparticles;
505  for (auto n = particle_list.cbegin(); n != particle_list.cend(); ++n) {
506  const ParticleType &current_type = ParticleType::find(n->first);
507  double current_mass = current_type.mass();
508  for (unsigned int i = 0; i < n->second * testparticles_; i++) {
509  // append particle to list and set its PDG code.
510  particles_.emplace_back(current_type);
511  particles_.back().set_4momentum(current_mass, 0.0, 0.0, 0.0);
512  }
513  }
514 }
515 
516 void Nucleus::shift(double z_offset, double x_offset, double simulation_time) {
517  // Move the nucleus in z and x directions, and set the time.
518  for (auto i = begin(); i != end(); i++) {
519  FourVector this_position = i->position();
520  this_position.set_x3(this_position.x3() + z_offset);
521  this_position.set_x1(this_position.x1() + x_offset);
522  this_position.set_x0(simulation_time);
523  i->set_4position(this_position);
524  i->set_formation_time(simulation_time);
525  }
526 }
527 
528 void Nucleus::copy_particles(Particles *external_particles) {
529  for (auto p = begin(); p != end(); p++) {
530  external_particles->insert(*p);
531  }
532 }
533 
535  FourVector centerpoint(0.0, 0.0, 0.0, 0.0);
536  for (auto p = cbegin(); p != cend(); p++) {
537  centerpoint += p->position();
538  }
539  centerpoint /= size();
540  return centerpoint;
541 }
542 
544  // Sample euler_theta_ such that cos(theta) is uniform
545  euler_phi_ = twopi * random::uniform(0., 1.);
546  euler_theta_ = std::acos(2 * random::uniform(0., 1.) - 1);
547  euler_psi_ = twopi * random::uniform(0., 1.);
548 }
549 
550 double Nucleus::nucleon_density(double r, double, double) const {
551  return get_saturation_density() /
552  (std::exp((r - nuclear_radius_) / diffusiveness_) + 1.);
553 }
554 
555 double Nucleus::nucleon_density_unnormalized(double r, double, double) const {
556  return 1.0 / (std::exp((r - nuclear_radius_) / diffusiveness_) + 1.);
557 }
558 
561  // Transform integral from (0, oo) to (0, 1) via r = (1 - t) / t.
562  // To prevent overflow, the integration is only performed to t = 0.01 which
563  // corresponds to r = 99fm. Additionally the precision settings in the
564  // Integrator2d scheme are equally important. However both these point affect
565  // the result only after the seventh digit which should not be relevant here.
566  const auto result = integrate(0.01, 1, -1, 1, [&](double t, double cosx) {
567  const double r = (1 - t) / t;
568  return twopi * std::pow(r, 2.0) *
569  nucleon_density_unnormalized(r, cosx, 0.0) / std::pow(t, 2.0);
570  });
571  const auto rho0 = number_of_particles() / result.value();
572  return rho0;
573 }
574 
575 std::ostream &operator<<(std::ostream &out, const Nucleus &n) {
576  return out << " #particles #testparticles mass [GeV] "
577  "radius [fm] diffusiveness [fm]\n"
578  << format(n.number_of_particles(), nullptr, 12)
579  << format(n.size(), nullptr, 17) << format(n.mass(), nullptr, 13)
580  << format(n.get_nuclear_radius(), nullptr, 14)
581  << format(n.get_diffusiveness(), nullptr, 20);
582 }
583 
585  const bool is_projectile = config.has_section(InputSections::m_c_projectile);
586  const bool is_target = config.has_section(InputSections::m_c_target);
587  return is_projectile || is_target;
588 }
589 
590 bool is_about_projectile(const Configuration &config) {
591  const bool is_projectile = config.has_section(InputSections::m_c_projectile);
592  const bool is_target = config.has_section(InputSections::m_c_target);
593  if (is_projectile == is_target) {
594  throw std::logic_error(
595  "Error parsing configuration of EITHER projectile OR target.\n"
596  "Configuration tested for it contains the following:\n------------\n" +
597  config.to_string() + "\n------------\n");
598  }
599  return is_projectile;
600 }
601 
602 } // namespace smash
Angles provides a common interface for generating directions: i.e., two angles that should be interpr...
Definition: angles.h:59
ThreeVector threevec() const
Definition: angles.h:288
void distribute_isotropically()
Populate the object with a new direction.
Definition: angles.h:199
Interface to the SMASH configuration files.
std::string to_string() const
Return a string of the current YAML tree.
bool has_value(const Key< T > &key) const
Return whether there is a non-empty value behind the requested key (which is supposed not to refer to...
bool has_section(const KeyLabels &labels) const
Return whether there is a (possibly empty) section with the given labels.
T take(const Key< T > &key)
The default interface for SMASH to read configuration values.
The FourVector class holds relevant values in Minkowski spacetime with (+, −, −, −) metric signature.
Definition: fourvector.h:33
double x3() const
Definition: fourvector.h:325
double x2() const
Definition: fourvector.h:321
ThreeVector threevec() const
Definition: fourvector.h:329
double x0() const
Definition: fourvector.h:313
void set_x3(double z)
Definition: fourvector.h:327
void set_x1(double x)
Definition: fourvector.h:319
double x1() const
Definition: fourvector.h:317
void set_x0(double t)
Definition: fourvector.h:315
A C++ interface for numerical integration in two dimensions with the Cuba Cuhre integration function.
Definition: integrate.h:219
A nucleus is a collection of particles that are initialized, before the beginning of the simulation a...
Definition: nucleus.h:27
Nucleus()=default
default constructor
double euler_theta_
Euler angle theta.
Definition: nucleus.h:298
std::vector< ParticleData >::const_iterator cbegin() const
For const iterators over the particle list:
Definition: nucleus.h:312
virtual double nucleon_density_unnormalized(double r, double, double) const
Return the unnormalized Woods-Saxon distribution for the given position without deformation.
Definition: nucleus.cc:555
void shift(double z_offset, double x_offset, double simulation_time)
Shifts the nucleus to correct impact parameter and z displacement.
Definition: nucleus.cc:516
double get_saturation_density() const
Definition: nucleus.h:333
double woods_saxon(double x)
Woods-Saxon distribution.
Definition: nucleus.cc:281
void random_euler_angles()
Randomly generate Euler angles.
Definition: nucleus.cc:543
virtual void arrange_nucleons()
Sets the positions of the nucleons inside a nucleus.
Definition: nucleus.cc:285
virtual double calculate_saturation_density() const
Definition: nucleus.cc:559
double default_nuclear_radius()
Default nuclear radius calculated as:
Definition: nucleus.h:341
double diffusiveness_
Diffusiveness of Woods-Saxon distribution of this nucleus in fm (for diffusiveness_ == 0,...
Definition: nucleus.h:266
double saturation_density_
Saturation density of this nucleus.
Definition: nucleus.h:283
FourVector center() const
Calculate geometrical center of the nucleus.
Definition: nucleus.cc:534
virtual void generate_fermi_momenta()
Generates momenta according to Fermi motion for the nucleons.
Definition: nucleus.cc:411
virtual void set_parameters_automatic()
Sets the deformation parameters of the Woods-Saxon distribution according to the current mass number.
Definition: nucleus.cc:302
std::vector< ParticleData >::const_iterator cend() const
For const iterators over the particle list:
Definition: nucleus.h:316
size_t size() const
Number of numerical (=test-)particles in the nucleus:
Definition: nucleus.h:148
size_t testparticles_
Number of testparticles per physical particle.
Definition: nucleus.h:275
virtual double nucleon_density(double r, double, double) const
Return the Woods-Saxon probability density for the given position.
Definition: nucleus.cc:550
double euler_phi_
The Euler angle phi of the three Euler angles used to apply rotations to the nucleus.
Definition: nucleus.h:296
double nuclear_radius_
Nuclear radius of this nucleus.
Definition: nucleus.h:268
void fill_from_list(const std::map< PdgCode, int > &particle_list, int testparticles)
Adds particles from a map PDG code => Number_of_particles_with_that_PDG_code to the nucleus.
Definition: nucleus.cc:502
std::vector< ParticleData > particles_
Particles associated with this nucleus.
Definition: nucleus.h:279
double euler_psi_
Euler angle psi.
Definition: nucleus.h:300
double mass() const
Definition: nucleus.cc:75
void align_center()
Shifts the nucleus so that its center is at (0,0,0)
Definition: nucleus.h:214
void copy_particles(Particles *particles)
Copies the particles from this nucleus into the particle list.
Definition: nucleus.cc:528
virtual void set_saturation_density(double density)
Sets the saturation density of the nucleus.
Definition: nucleus.h:252
void set_nuclear_radius(double rad)
Sets the nuclear radius.
Definition: nucleus.h:356
bool random_rotation_
Whether the nucleus should be rotated randomly.
Definition: nucleus.h:302
void set_diffusiveness(double diffuse)
Sets the diffusiveness of the nucleus.
Definition: nucleus.h:323
virtual void rotate()
Rotates the nucleus using the three euler angles phi, theta and psi.
Definition: nucleus.cc:391
std::vector< ParticleData >::iterator begin()
For iterators over the particle list:
Definition: nucleus.h:306
size_t number_of_protons() const
Number of physical protons in the nucleus:
Definition: nucleus.h:175
void boost(double beta_scalar)
Boosts the nuclei into the computational frame, such that the nucleons have the appropriate momentum ...
Definition: nucleus.cc:472
virtual ThreeVector distribute_nucleon()
The distribution of return values from this function is according to a spherically symmetric Woods-Sa...
Definition: nucleus.cc:235
size_t number_of_particles() const
Number of physical particles in the nucleus:
Definition: nucleus.h:156
void set_orientation_from_config(Configuration &orientation_config)
Set angles for rotation of the nucleus from config file.
Definition: nucleus.cc:360
std::vector< ParticleData >::iterator end()
For iterators over the particle list:
Definition: nucleus.h:310
ParticleData contains the dynamic information of a certain particle.
Definition: particledata.h:58
PdgCode pdgcode() const
Get the pdgcode of the particle.
Definition: particledata.h:87
void set_4momentum(const FourVector &momentum_vector)
Set the particle's 4-momentum directly.
Definition: particledata.h:164
const FourVector & momentum() const
Get the particle's 4-momentum.
Definition: particledata.h:158
bool is_baryon() const
Definition: particledata.h:94
double pole_mass() const
Get the particle's pole mass ("on-shell").
Definition: particledata.h:115
void set_3momentum(const ThreeVector &mom)
Set the momentum of the particle without modifying the energy.
Definition: particledata.h:196
const FourVector & position() const
Get the particle's position in Minkowski space.
Definition: particledata.h:204
Particle type contains the static properties of a particle species.
Definition: particletype.h:98
static const ParticleType & find(PdgCode pdgcode)
Returns the ParticleType object for the given pdgcode.
Definition: particletype.cc:99
double mass() const
Definition: particletype.h:145
The Particles class abstracts the storage and manipulation of particles.
Definition: particles.h:33
const ParticleData & insert(const ParticleData &p)
Inserts the particle into the list of particles.
Definition: particles.cc:50
The ThreeVector class represents a physical three-vector with the components .
Definition: threevector.h:31
double get_phi() const
Definition: threevector.h:270
double x3() const
Definition: threevector.h:185
void rotate(double phi, double theta, double psi)
Rotate vector by the given Euler angles phi, theta, psi.
Definition: threevector.h:283
double x2() const
Definition: threevector.h:181
double get_theta() const
Definition: threevector.h:278
double x1() const
Definition: threevector.h:177
Collection of useful constants that are known at compile time.
std::ostream & operator<<(std::ostream &out, const ActionPtr &action)
Convenience: dereferences the ActionPtr to Action.
Definition: action.h:546
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
Definition: logging.cc:40
FormattingHelper< T > format(const T &value, const char *unit, int width=-1, int precision=-1)
Acts as a stream modifier for std::ostream to output an object with an optional suffix string and wit...
Definition: logging.h:217
constexpr int p
Proton.
constexpr int n
Neutron.
T uniform(T min, T max)
Definition: random.h:88
T canonical()
Definition: random.h:113
Definition: action.h:24
static Integrator integrate
Definition: decaytype.cc:143
constexpr double twopi
.
Definition: constants.h:45
bool has_projectile_or_target(const Configuration &config)
Find out whether a configuration has a projectile or a target sub-section.
Definition: nucleus.cc:584
constexpr double hbarc
GeV <-> fm conversion factor.
Definition: constants.h:25
bool is_about_projectile(const Configuration &config)
Find out whether a configuration is about projectile or target.
Definition: nucleus.cc:590
static constexpr int LNucleus
Definition: nucleus.cc:26
bool almost_equal(const N x, const N y)
Checks two numbers for relative approximate equality.
Definition: numerics.h:44
Generic numerical functions.
static const Key< double > modi_collider_projectile_saturationDensity
See user guide description for more information.
Definition: input_keys.h:3293
static const Key< double > modi_collider_projectile_radius
See user guide description for more information.
Definition: input_keys.h:3270
static const Key< double > modi_collider_target_orientation_theta
See user guide description for more information.
Definition: input_keys.h:3644
static const Key< double > modi_collider_projectile_diffusiveness
See user guide description for more information.
Definition: input_keys.h:3216
static const Key< double > modi_collider_target_saturationDensity
See user guide description for more information.
Definition: input_keys.h:3300
static const Key< bool > modi_collider_target_orientation_randRot
See user guide description for more information.
Definition: input_keys.h:3681
static const Key< double > modi_collider_projectile_orientation_theta
See user guide description for more information.
Definition: input_keys.h:3639
static const Key< double > modi_collider_target_radius
See user guide description for more information.
Definition: input_keys.h:3277
static const Key< std::map< PdgCode, int > > modi_collider_target_particles
See user guide description for more information.
Definition: input_keys.h:3250
static const Key< double > modi_collider_target_diffusiveness
See user guide description for more information.
Definition: input_keys.h:3223
static const Key< std::map< PdgCode, int > > modi_collider_projectile_particles
See user guide description for more information.
Definition: input_keys.h:3244
static const Key< double > modi_collider_target_orientation_phi
See user guide description for more information.
Definition: input_keys.h:3626
static const Key< double > modi_collider_projectile_orientation_psi
See user guide description for more information.
Definition: input_keys.h:3657
static const Key< double > modi_collider_target_orientation_psi
See user guide description for more information.
Definition: input_keys.h:3662
static const Key< double > modi_collider_projectile_orientation_phi
See user guide description for more information.
Definition: input_keys.h:3621
static const Key< bool > modi_collider_projectile_orientation_randRot
See user guide description for more information.
Definition: input_keys.h:3676
static const Section m_c_projectile
Subsection for the projectile in collider modus.
Definition: input_keys.h:102
static const Section m_c_target
Subsection for the target in collider modus.
Definition: input_keys.h:117