Version: SMASH-3.2
collidermodus.cc
Go to the documentation of this file.
1 /*
2  * Copyright (c) 2012-2024
3  * SMASH Team
4  *
5  * GNU General Public License (GPLv3 or later)
6  */
7 
8 #include "smash/collidermodus.h"
9 
10 #include <algorithm>
11 #include <cmath>
12 #include <cstdlib>
13 #include <cstring>
14 #include <memory>
15 #include <stdexcept>
16 #include <string>
17 #include <tuple>
18 #include <utility>
19 #include <vector>
20 
21 #include "smash/configuration.h"
22 #include "smash/customnucleus.h"
24 #include "smash/fourvector.h"
25 #include "smash/icparameters.h"
26 #include "smash/input_keys.h"
27 #include "smash/logging.h"
28 #include "smash/nucleus.h"
29 #include "smash/random.h"
30 
31 namespace smash {
32 static constexpr int LCollider = LogArea::Collider::id;
33 
35  const ExperimentParameters &params) {
36  Configuration modus_cfg = modus_config.extract_complete_sub_configuration(
38  // Get the reference frame for the collision calculation.
40 
43  Configuration targ_cfg =
45  /* Needed to check if projectile and target in customnucleus are read from
46  * the same input file.*/
47  bool same_file = false;
48  // Set up the projectile nucleus
50  projectile_ =
51  create_deformed_nucleus(proj_cfg, params.testparticles, "projectile");
52  } else if (proj_cfg.has_section(InputSections::m_c_p_custom)) {
53  same_file = same_inputfile(proj_cfg, targ_cfg);
54  projectile_ = std::make_unique<CustomNucleus>(
55  proj_cfg, params.testparticles, same_file);
56  } else if (proj_cfg.has_section(InputSections::m_c_p_alphaClustered)) {
57  logg[LCollider].info() << "Projectile is alpha-clustered with woods-saxon "
58  "parameters for the He-clusters listed below.";
60  "projectile");
61  } else {
62  projectile_ = std::make_unique<Nucleus>(proj_cfg, params.testparticles);
63  }
64  if (projectile_->size() < 1) {
65  throw ColliderEmpty("Input Error: Projectile nucleus is empty.");
66  }
68 
69  // Set up the target nucleus
71  target_ = create_deformed_nucleus(targ_cfg, params.testparticles, "target");
72  } else if (targ_cfg.has_section(InputSections::m_c_t_custom)) {
73  target_ = std::make_unique<CustomNucleus>(targ_cfg, params.testparticles,
74  same_file);
75  } else if (targ_cfg.has_section(InputSections::m_c_t_alphaClustered)) {
76  logg[LCollider].info() << "Target is alpha-clustered with woods-saxon "
77  "parameters for the He-clusters listed below.";
78  target_ =
79  create_alphaclustered_nucleus(targ_cfg, params.testparticles, "target");
80  } else {
81  target_ = std::make_unique<Nucleus>(targ_cfg, params.testparticles);
82  }
83  if (target_->size() < 1) {
84  throw ColliderEmpty("Input Error: Target nucleus is empty.");
85  }
86  target_->set_label(BelongsTo::Target);
87 
88  // Get the Fermi-Motion input (off, on, frozen)
91  logg[LCollider].info() << "Fermi motion is ON.";
92  } else if (fermi_motion_ == FermiMotion::Frozen) {
93  logg[LCollider].info() << "FROZEN Fermi motion is on.";
94  } else if (fermi_motion_ == FermiMotion::Off) {
95  logg[LCollider].info() << "Fermi motion is OFF.";
96  }
97 
98  // Get the total nucleus-nucleus collision energy. Since there is
99  // no meaningful choice for a default energy, we require the user to
100  // give one (and only one) energy input from the available options.
101  int energy_input = 0;
102  const double mass_projec = projectile_->mass();
103  const double mass_target = target_->mass();
104  // average mass of a particle in that nucleus
105  const double mass_a =
106  projectile_->mass() / projectile_->number_of_particles();
107  const double mass_b = target_->mass() / target_->number_of_particles();
108  // Option 1: Center of mass energy.
111  // Check that input satisfies the lower bound (everything at rest).
112  if (sqrt_s_NN_ <= mass_a + mass_b) {
114  "Input Error: sqrt(s_NN) is not larger than masses:\n" +
115  std::to_string(sqrt_s_NN_) + " GeV <= " + std::to_string(mass_a) +
116  " GeV + " + std::to_string(mass_b) + " GeV.");
117  }
118  // Set the total nucleus-nucleus collision energy.
119  total_s_ = (sqrt_s_NN_ * sqrt_s_NN_ - mass_a * mass_a - mass_b * mass_b) *
120  mass_projec * mass_target / (mass_a * mass_b) +
121  mass_projec * mass_projec + mass_target * mass_target;
122  energy_input++;
123  }
124  /* Option 2: Total energy per nucleon of the projectile nucleus
125  * (target at rest). */
126  if (modus_cfg.has_value(InputKeys::modi_collider_eTot)) {
127  const double e_tot = modus_cfg.take(InputKeys::modi_collider_eTot);
128  if (e_tot < 0) {
130  "Input Error: "
131  "E_Tot must be nonnegative.");
132  }
133  // Set the total nucleus-nucleus collision energy.
134  total_s_ = s_from_Etot(e_tot * projectile_->number_of_particles(),
135  mass_projec, mass_target);
136  sqrt_s_NN_ = std::sqrt(s_from_Etot(e_tot, mass_a, mass_b));
137  energy_input++;
138  }
139  /* Option 3: Kinetic energy per nucleon of the projectile nucleus
140  * (target at rest). */
141  if (modus_cfg.has_value(InputKeys::modi_collider_eKin)) {
142  const double e_kin = modus_cfg.take(InputKeys::modi_collider_eKin);
143  if (e_kin < 0) {
145  "Input Error: "
146  "E_Kin must be nonnegative.");
147  }
148  // Set the total nucleus-nucleus collision energy.
149  total_s_ = s_from_Ekin(e_kin * projectile_->number_of_particles(),
150  mass_projec, mass_target);
151  sqrt_s_NN_ = std::sqrt(s_from_Ekin(e_kin, mass_a, mass_b));
152  energy_input++;
153  }
154  // Option 4: Momentum of the projectile nucleus (target at rest).
155  if (modus_cfg.has_value(InputKeys::modi_collider_pLab)) {
156  const double p_lab = modus_cfg.take(InputKeys::modi_collider_pLab);
157  if (p_lab < 0) {
159  "Input Error: "
160  "P_Lab must be nonnegative.");
161  }
162  // Set the total nucleus-nucleus collision energy.
163  total_s_ = s_from_plab(p_lab * projectile_->number_of_particles(),
164  mass_projec, mass_target);
165  sqrt_s_NN_ = std::sqrt(s_from_plab(p_lab, mass_a, mass_b));
166  energy_input++;
167  }
168  // Option 5: Total energy per nucleon of _each_ beam
171  const double e_tot_p =
173  const double e_tot_t = targ_cfg.take(InputKeys::modi_collider_target_eTot);
174  if (e_tot_p < 0 || e_tot_t < 0) {
176  "Input Error: "
177  "E_Tot must be nonnegative.");
178  }
179  total_s_ = s_from_Etot(e_tot_p * projectile_->number_of_particles(),
180  e_tot_t * target_->number_of_particles(),
181  mass_projec, mass_target);
182  sqrt_s_NN_ = std::sqrt(s_from_Ekin(e_tot_p, e_tot_t, mass_a, mass_b));
183  energy_input++;
184  }
185  // Option 6: Kinetic energy per nucleon of _each_ beam
188  const double e_kin_p =
190  const double e_kin_t = targ_cfg.take(InputKeys::modi_collider_target_eKin);
191  if (e_kin_p < 0 || e_kin_t < 0) {
193  "Input Error: "
194  "E_Kin must be nonnegative.");
195  }
196  total_s_ = s_from_Ekin(e_kin_p * projectile_->number_of_particles(),
197  e_kin_t * target_->number_of_particles(),
198  mass_projec, mass_target);
199  sqrt_s_NN_ = std::sqrt(s_from_Ekin(e_kin_p, e_kin_t, mass_a, mass_b));
200  energy_input++;
201  }
202  // Option 7: Momentum per nucleon of _each_ beam
205  const double p_lab_p =
207  const double p_lab_t = targ_cfg.take(InputKeys::modi_collider_target_pLab);
208  if (p_lab_p < 0 || p_lab_t < 0) {
210  "Input Error: "
211  "P_Lab must be nonnegative.");
212  }
213  total_s_ = s_from_plab(p_lab_p * projectile_->number_of_particles(),
214  p_lab_t * target_->number_of_particles(),
215  mass_projec, mass_target);
216  sqrt_s_NN_ = std::sqrt(s_from_plab(p_lab_p, p_lab_t, mass_a, mass_b));
217  energy_input++;
218  }
219  if (energy_input == 0) {
220  throw std::domain_error(
221  "Input Error: Non-existent collision energy. "
222  "Please provide one of Sqrtsnn/E_Kin/P_Lab.");
223  }
224  if (energy_input > 1) {
225  throw std::invalid_argument(
226  "Input Error: Redundant collision energy. "
227  "Please provide only one of Sqrtsnn/E_Kin/P_Lab.");
228  }
229 
230  /* Impact parameter setting: Either "Value", "Range", "Max" or "Sample".
231  * Unspecified means 0 impact parameter.*/
234  imp_min_ = impact_;
235  imp_max_ = impact_;
236  } else {
237  // If impact is not supplied by value, inspect sampling parameters:
240  if (sampling_ == Sampling::Custom) {
243  throw std::invalid_argument(
244  "Input Error: Need impact parameter spectrum for custom sampling."
245  " Please provide Values and Yields.");
246  }
247  const std::vector<double> impacts =
249  const std::vector<double> yields =
251  if (impacts.size() != yields.size()) {
252  throw std::invalid_argument(
253  "Input Error: Need as many impact parameter values as yields. "
254  "Please make sure that Values and Yields have the same length.");
255  }
256  impact_interpolation_ = std::make_unique<InterpolateDataLinear<double>>(
257  InterpolateDataLinear<double>(impacts, yields));
258 
259  const auto imp_minmax =
260  std::minmax_element(impacts.begin(), impacts.end());
261  imp_min_ = *imp_minmax.first;
262  imp_max_ = *imp_minmax.second;
263  yield_max_ = *std::max_element(yields.begin(), yields.end());
264  }
265  }
267  const std::array<double, 2> range =
269  imp_min_ = range[0];
270  imp_max_ = range[1];
271  }
273  imp_min_ = 0.0;
275  }
276  }
278  // whether the direction of separation should be randomly sampled
281  // Look for user-defined initial separation between nuclei.
282  // The displacement is half the distance (both nuclei are shifted
283  // initial_z_displacement_ away from origin)
287  IC_for_hybrid_ = true;
288  IC_parameters_ = std::make_unique<InitialConditionParameters>();
289  IC_parameters_->type =
291 
293  if (modus_cfg.has_value(
295  IC_parameters_->proper_time = modus_cfg.take(
297  }
298  if (modus_cfg.has_value(
300  IC_parameters_->lower_bound = modus_cfg.take(
302  }
303  if (modus_cfg.has_value(
305  IC_parameters_->rapidity_cut = modus_cfg.take(
307  }
308  if (modus_cfg.has_value(
310  IC_parameters_->pT_cut =
312  }
313  } else if (IC_parameters_->type == FluidizationType::Dynamic) {
314  double threshold = modus_cfg.take(
316  double min_time =
318  double max_time =
320  int cells =
322  double form_time_fraction = modus_cfg.take(
324  if (threshold <= 0 || max_time < min_time || min_time < 0 || cells < 2 ||
325  form_time_fraction < 0) {
326  logg[LCollider].fatal()
327  << "Bad parameters chosen for dynamic initial conditions. At least "
328  "one of the following inequalities is violated:\n"
329  << " Energy_Density_Threshold = " << threshold << " > 0\n"
330  << " Maximum_Time = " << max_time << " > " << min_time
331  << " = Minimum_Time > 0\n Fluidization_Cells = " << cells
332  << " > 2\n"
333  << " Formation_Time_Fraction < 0";
334  throw std::invalid_argument("Please adjust the configuration file.");
335  }
336 
337  IC_parameters_->fluidizable_processes = modus_cfg.take(
339 
340  double min_size = std::max(min_time, 10.);
341  std::array<double, 3> length{2 * min_size, 2 * min_size, 2 * min_size};
342  std::array<double, 3> origin{-min_size, -min_size, -min_size};
343  std::array<int, 3> cell_array{cells, cells, cells};
344 
346  std::make_unique<RectangularLattice<EnergyMomentumTensor>>(
347  length, cell_array, origin, false, LatticeUpdate::EveryTimestep);
348  fluid_background_ = std::make_unique<std::map<int32_t, double>>();
349 
350  IC_parameters_->energy_density_threshold = threshold;
351  IC_parameters_->min_time = min_time;
352  IC_parameters_->max_time = max_time;
353  IC_parameters_->num_fluid_cells = cells;
354  logg[LCollider].info()
355  << "Dynamic Initial Conditions with threshold " << threshold
356  << " GeV/fm³ in energy density, between " << min_time << " and "
357  << max_time << " fm.";
358  IC_parameters_->formation_time_fraction = form_time_fraction;
359  }
360  }
361 }
362 
363 std::ostream &operator<<(std::ostream &out, const ColliderModus &m) {
364  return out << "-- Collider Modus:\n"
365  << "sqrt(S) (nucleus-nucleus) = "
366  << format(std::sqrt(m.total_s_), "GeV\n")
367  << "sqrt(S) (nucleon-nucleon) = " << format(m.sqrt_s_NN_, "GeV\n")
368  << "Projectile:\n"
369  << *m.projectile_ << "\nTarget:\n"
370  << *m.target_;
371 }
372 
373 std::unique_ptr<DeformedNucleus> ColliderModus::create_deformed_nucleus(
374  Configuration &nucleus_cfg, int ntest, const std::string &nucleus_type) {
375  assert(has_projectile_or_target(nucleus_cfg));
376  const bool is_projectile = is_about_projectile(nucleus_cfg);
377  const auto &[automatic_key, beta2_key, beta3_key, beta4_key,
378  gamma_key] = [&is_projectile]() {
379  return is_projectile
380  ? std::make_tuple(
386  : std::make_tuple(
392  }();
393 
394  bool automatic_deformation = nucleus_cfg.take(automatic_key);
395  bool was_any_beta_given = nucleus_cfg.has_value(beta2_key) ||
396  nucleus_cfg.has_value(beta3_key) ||
397  nucleus_cfg.has_value(beta4_key);
398  bool was_any_deformation_parameter_given =
399  was_any_beta_given || nucleus_cfg.has_value(gamma_key);
400  bool was_gamma_given_without_beta_2 =
401  nucleus_cfg.has_value(gamma_key) && !nucleus_cfg.has_value(beta2_key);
402 
403  if (automatic_deformation && was_any_deformation_parameter_given) {
404  throw std::invalid_argument(
405  "Automatic deformation of " + nucleus_type +
406  " nucleus requested, but deformation parameter(s) were provided as"
407  " well. Please, check the 'Deformed' section in your input file.");
408  } else if (!automatic_deformation && !was_any_beta_given) {
409  throw std::invalid_argument(
410  "Manual deformation of " + nucleus_type +
411  " nucleus requested, but no deformation beta parameter was provided."
412  " Please, check the 'Deformed' section in your input file.");
413  } else if (!automatic_deformation && was_gamma_given_without_beta_2) {
414  throw std::invalid_argument(
415  "Manual deformation of " + nucleus_type +
416  " nucleus requested, but 'Gamma' parameter was provided without "
417  "providing a value of 'Beta_2' having hence no deformation effect. "
418  "Please, check the 'Deformed' section in your input file.");
419  } else {
420  return std::make_unique<DeformedNucleus>(nucleus_cfg, ntest,
421  automatic_deformation);
422  }
423 }
424 
425 std::unique_ptr<AlphaClusteredNucleus>
427  int ntest,
428  const std::string &nucleus_type) {
429  const bool is_projectile = is_about_projectile(nucleus_cfg);
430  const auto &[automatic_key, side_length_key] = [&is_projectile]() {
431  return is_projectile
432  ? std::make_tuple(
433  InputKeys::
434  modi_collider_projectile_alphaClustered_automatic,
435  InputKeys::
436  modi_collider_projectile_alphaClustered_sideLength)
437  : std::make_tuple(
440  }();
441 
442  bool automatic_alphaclustering = nucleus_cfg.take(automatic_key);
443  bool was_sidelength_given = nucleus_cfg.has_value(side_length_key);
444 
445  if (automatic_alphaclustering && was_sidelength_given) {
446  throw std::invalid_argument(
447  "Automatic alpha-clustering of " + nucleus_type +
448  " nucleus requested, but a sidelength was provided as"
449  " well. Please, check the 'Alpha_Clustered' section in your input "
450  "file.");
451  } else if (!automatic_alphaclustering && !was_sidelength_given) {
452  throw std::invalid_argument(
453  "Manual alpha-clustering of " + nucleus_type +
454  " nucleus requested, but no sidelength was provided."
455  " Please, check the 'Alpha_Clustered' section in your input file.");
456  } else {
457  return std::make_unique<AlphaClusteredNucleus>(nucleus_cfg, ntest,
458  automatic_alphaclustering);
459  }
460 }
461 
463  const ExperimentParameters &) {
464  // Populate the nuclei with appropriately distributed nucleons.
465  // If deformed, this includes rotating the nucleus.
466  projectile_->arrange_nucleons();
467  target_->arrange_nucleons();
468 
469  // Use the total mandelstam variable to get the frame-dependent velocity for
470  // each nucleus. Position a is projectile, position b is target.
471  double v_a, v_b;
472  std::tie(v_a, v_b) =
473  get_velocities(total_s_, projectile_->mass(), target_->mass());
474 
475  // If velocities are larger or equal to 1, throw an exception.
476  if (v_a >= 1.0 || v_b >= 1.0) {
477  throw std::domain_error(
478  "Found velocity equal to or larger than 1 in "
479  "ColliderModus::initial_conditions.\nConsider using "
480  "the center of velocity reference frame.");
481  }
482 
483  // Calculate the beam velocity of the projectile and the target, which will
484  // be used to calculate the beam momenta in experiment.cc
486  velocity_projectile_ = v_a;
487  velocity_target_ = v_b;
488  }
489 
490  // Generate Fermi momenta if necessary
493  // Frozen: Fermi momenta will be ignored during the propagation to
494  // avoid that the nuclei will fly apart.
495  projectile_->generate_fermi_momenta();
496  target_->generate_fermi_momenta();
497  } else if (fermi_motion_ == FermiMotion::Off) {
498  } else {
499  throw std::invalid_argument("Invalid Fermi_Motion input.");
500  }
501 
502  // Boost the nuclei to the appropriate velocity.
503  projectile_->boost(v_a);
504  target_->boost(v_b);
505 
506  // Shift the nuclei into starting positions. Contracted spheres with
507  // nuclear radii should touch exactly at t=0. Modus starts at negative
508  // time corresponding to additional initial displacement.
509  const double d_a = std::max(0., projectile_->get_diffusiveness());
510  const double d_b = std::max(0., target_->get_diffusiveness());
511  const double r_a = projectile_->get_nuclear_radius();
512  const double r_b = target_->get_nuclear_radius();
513  const double dz = initial_z_displacement_;
514 
515  const double simulation_time = -dz / std::abs(v_a);
516  const double proj_z = -dz - std::sqrt(1.0 - v_a * v_a) * (r_a + d_a);
517  const double targ_z =
518  +dz * std::abs(v_b / v_a) + std::sqrt(1.0 - v_b * v_b) * (r_b + d_b);
519  // rotation angle in the transverse plane
520  const double phi =
521  random_reaction_plane_ ? random::uniform(0.0, 2.0 * M_PI) : 0.0;
522 
523  projectile_->shift(proj_z, +impact_ / 2.0, simulation_time);
524  target_->shift(targ_z, -impact_ / 2.0, simulation_time);
525 
526  // Put the particles in the nuclei into code particles.
527  projectile_->copy_particles(particles);
528  target_->copy_particles(particles);
529  rotate_reaction_plane(phi, particles);
530  return simulation_time;
531 }
532 
533 void ColliderModus::rotate_reaction_plane(double phi, Particles *particles) {
534  for (ParticleData &p : *particles) {
535  ThreeVector pos = p.position().threevec();
536  ThreeVector mom = p.momentum().threevec();
537  pos.rotate_around_z(phi);
538  mom.rotate_around_z(phi);
539  p.set_3position(pos);
540  p.set_3momentum(mom);
541  }
542 }
543 
545  switch (sampling_) {
546  case Sampling::Quadratic: {
547  // quadratic sampling: Note that for bmin > bmax, this still yields
548  // the correct distribution (however canonical() = 0 is then the
549  // upper end, not the lower).
550  impact_ = std::sqrt(imp_min_ * imp_min_ +
553  } break;
554  case Sampling::Custom: {
555  // rejection sampling based on given distribution
556  assert(impact_interpolation_ != nullptr);
557  double probability_random = 1;
558  double probability = 0;
559  double b;
560  while (probability_random > probability) {
562  probability = (*impact_interpolation_)(b) / yield_max_;
563  assert(probability < 1.);
564  probability_random = random::uniform(0., 1.);
565  }
566  impact_ = b;
567  } break;
568  case Sampling::Uniform: {
569  // linear sampling. Still, min > max works fine.
571  }
572  }
573 }
574 
575 std::pair<double, double> ColliderModus::get_velocities(double s, double m_a,
576  double m_b) {
577  double v_a = 0.0;
578  double v_b = 0.0;
579  // Frame dependent calculations of velocities. Assume v_a >= 0, v_b <= 0.
580  switch (frame_) {
582  v_a = center_of_velocity_v(s, m_a, m_b);
583  v_b = -v_a;
584  break;
586  // Compute center of mass momentum.
587  double pCM = pCM_from_s(s, m_a, m_b);
588  v_a = pCM / std::sqrt(m_a * m_a + pCM * pCM);
589  v_b = -pCM / std::sqrt(m_b * m_b + pCM * pCM);
590  } break;
592  v_a = fixed_target_projectile_v(s, m_a, m_b);
593  break;
594  default:
595  throw std::invalid_argument(
596  "Invalid reference frame in "
597  "ColliderModus::get_velocities.");
598  }
599  return std::make_pair(v_a, v_b);
600 }
601 
602 std::string ColliderModus::custom_file_path(const std::string &file_directory,
603  const std::string &file_name) {
604  // make sure that path is correct even if the / at the end is missing
605  if (file_directory.back() == '/') {
606  return file_directory + file_name;
607  } else {
608  return file_directory + '/' + file_name;
609  }
610 }
611 
613  Configuration &targ_config) {
614  /* Check if both nuclei are custom
615  * Only check target as function is called after if statement for
616  * projectile.
617  */
618  if (!targ_config.has_section(InputSections::m_c_t_custom)) {
619  return false;
620  }
621  std::string projectile_file_directory = proj_config.read(
623  std::string target_file_directory =
625  std::string projectile_file_name =
627  std::string target_file_name =
629  // Check if files are the same for projectile and target
630  std::string proj_path =
631  custom_file_path(projectile_file_directory, projectile_file_name);
632  std::string targ_path =
633  custom_file_path(target_file_directory, target_file_name);
634  if (proj_path == targ_path) {
635  return true;
636  } else {
637  return false;
638  }
639 }
640 
642  const double t, const std::vector<Particles> &ensembles,
643  const DensityParameters &dens_par) {
644  if (fluid_lattice_ == nullptr) {
645  throw std::logic_error(
646  "Trying to build fluidization lattice with unset pointer in "
647  "ColliderModus.");
648  }
649  if (t < IC_parameters_->min_time.value() ||
650  t > IC_parameters_->max_time.value()) {
651  return;
652  }
653  const double resizing_rate = 5;
654  double side = fluid_lattice_->lattice_sizes()[0] / 2.;
655  if (t > side) {
656  side += resizing_rate;
657  std::array<double, 3> new_length{2 * side, 2 * side, 2 * side};
658  std::array<double, 3> new_origin{-side, -side, -side};
659  fluid_lattice_->reset_and_resize(new_length, new_origin, std::nullopt);
660  logg[LCollider].debug() << "Fluidization lattice resizing at " << t
661  << " fm to " << 2 * side << " fm";
662  }
663 
666  dens_par, ensembles, false);
667 }
668 
669 } // namespace smash
ColliderModus: Provides a modus for colliding nuclei.
Definition: collidermodus.h:48
CalculationFrame frame_
Reference frame for the system, as specified from config.
double imp_min_
Minimum value of impact parameter.
double initial_z_displacement_
Initial z-displacement of nuclei.
bool IC_for_hybrid_
Whether the particles will serve as initial conditions for hydrodynamics.
double yield_max_
Maximum value of yield. Needed for custom impact parameter sampling.
bool random_reaction_plane_
Whether the reaction plane should be randomized.
void rotate_reaction_plane(double phi, Particles *particles)
Rotate the reaction plane about the angle phi.
std::pair< double, double > get_velocities(double mandelstam_s, double m_a, double m_b)
Get the frame dependent velocity for each nucleus, using the current reference frame.
void sample_impact()
Sample impact parameter.
std::unique_ptr< Nucleus > projectile_
Projectile.
std::unique_ptr< InterpolateDataLinear< double > > impact_interpolation_
Pointer to the impact parameter interpolation.
FermiMotion fermi_motion_
An option to include Fermi motion ("off", "on", "frozen")
static std::unique_ptr< AlphaClusteredNucleus > create_alphaclustered_nucleus(Configuration &nucleus_cfg, const int ntest, const std::string &nucleus_type)
Configure Alpha-Clustered Nucleus.
double velocity_projectile_
Beam velocity of the projectile.
Sampling sampling_
Method used for sampling of impact parameter.
std::unique_ptr< RectangularLattice< EnergyMomentumTensor > > fluid_lattice_
Energy-momentum tensor lattice for dynamic fluidization.
std::string custom_file_path(const std::string &file_directory, const std::string &file_name)
Creates full path string consisting of file_directory and file_name Needed to initialize a customnucl...
double total_s_
Center-of-mass energy squared of the nucleus-nucleus collision.
std::unique_ptr< Nucleus > target_
Target.
ColliderModus(Configuration modus_config, const ExperimentParameters &parameters)
Constructor.
double impact_
Impact parameter.
double sqrt_s_NN_
Center-of-mass energy of a nucleon-nucleon collision.
double initial_conditions(Particles *particles, const ExperimentParameters &parameters)
Generates initial state of the particles in the system.
void build_fluidization_lattice(double t, const std::vector< Particles > &ensembles, const DensityParameters &dens_par)
Build lattice of energy momentum tensor.
bool same_inputfile(Configuration &proj_config, Configuration &targ_config)
Checks if target and projectile are read from the same external file if they are both initialized as ...
std::unique_ptr< std::map< int32_t, double > > fluid_background_
Energy density background from hydrodynamic evolution, with particle indices as keys.
static std::unique_ptr< DeformedNucleus > create_deformed_nucleus(Configuration &nucleus_cfg, const int ntest, const std::string &nucleus_type)
Configure Deformed Nucleus.
double velocity_target_
Beam velocity of the target.
std::unique_ptr< InitialConditionParameters > IC_parameters_
Plain Old Data type to hold parameters for initial conditions.
double imp_max_
Maximum value of impact parameter.
Interface to the SMASH configuration files.
T read(const Key< T > &key) const
Additional interface for SMASH to read configuration values without removing them.
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.
Configuration extract_complete_sub_configuration(KeyLabels section, Configuration::GetEmpty empty_if_not_existing=Configuration::GetEmpty::No)
Alternative method to extract a sub-configuration, which retains the labels from the top-level in the...
T take(const Key< T > &key)
The default interface for SMASH to read configuration values.
A class to pre-calculate and store parameters relevant for density calculation.
Definition: density.h:92
Represent a piecewise linear interpolation.
Definition: interpolation.h:62
double length() const
Definition: modusdefault.h:93
ParticleData contains the dynamic information of a certain particle.
Definition: particledata.h:58
The Particles class abstracts the storage and manipulation of particles.
Definition: particles.h:33
The ThreeVector class represents a physical three-vector with the components .
Definition: threevector.h:31
void rotate_around_z(double theta)
Rotate the vector around the z axis by the given angle theta.
Definition: threevector.h:315
@ On
Use fermi motion in combination with potentials.
@ Frozen
Use fermi motion without potentials.
@ Off
Don't use fermi motion.
@ ConstantTau
Hypersurface crossed at a fixed proper time.
@ Dynamic
Dynamic fluidization based on local densities.
@ Quadratic
Sample from areal / quadratic distribution.
@ Custom
Sample from custom, user-defined distribution.
@ Uniform
Sample from uniform distribution.
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.
T uniform(T min, T max)
Definition: random.h:88
T canonical()
Definition: random.h:113
Definition: action.h:24
T pCM(const T sqrts, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:79
double fixed_target_projectile_v(double s, double ma, double mb)
Definition: kinematics.h:39
double s_from_Ekin(double e_kin, double m_P, double m_T)
Convert E_kin to Mandelstam-s for a fixed-target setup, with a projectile of mass m_P and a kinetic e...
Definition: kinematics.h:239
void update_lattice_accumulating_ensembles(RectangularLattice< T > *lat, const LatticeUpdate update, const DensityType dens_type, const DensityParameters &par, const std::vector< Particles > &ensembles, const bool compute_gradient)
Updates the contents on the lattice when ensembles are used.
Definition: density.h:644
double center_of_velocity_v(double s, double ma, double mb)
Definition: kinematics.h:26
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
bool is_about_projectile(const Configuration &config)
Find out whether a configuration is about projectile or target.
Definition: nucleus.cc:590
T pCM_from_s(const T s, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:66
static constexpr int LCollider
double s_from_Etot(double e_tot, double m_P, double m_T)
Convert E_tot to Mandelstam-s for a fixed-target setup, with a projectile of mass m_P and a total ene...
Definition: kinematics.h:211
double s_from_plab(double plab, double m_P, double m_T)
Convert p_lab to Mandelstam-s for a fixed-target setup, with a projectile of mass m_P and momentum pl...
Definition: kinematics.h:265
Thrown when either projectile_ or target_ nuclei are empty.
Helper structure for Experiment.
int testparticles
Number of test-particles.
A container to keep track of all ever existed input keys.
Definition: input_keys.h:1067
static const Key< double > modi_collider_projectile_eKin
See user guide description for more information.
Definition: input_keys.h:3319
static const Key< double > modi_collider_target_pLab
See user guide description for more information.
Definition: input_keys.h:3370
static const Key< double > modi_collider_target_eTot
See user guide description for more information.
Definition: input_keys.h:3343
static const Key< double > modi_collider_initialDistance
See user guide description for more information.
Definition: input_keys.h:3195
static const Key< bool > modi_collider_projectile_deformed_automatic
See user guide description for more information.
Definition: input_keys.h:3449
static const Key< double > modi_collider_projectile_deformed_beta3
See user guide description for more information.
Definition: input_keys.h:3487
static const Key< std::string > modi_collider_projectile_custom_fileDirectory
See user guide description for more information.
Definition: input_keys.h:3390
static const Key< double > modi_collider_eKin
See user guide description for more information.
Definition: input_keys.h:3075
static const Key< double > modi_collider_pLab
See user guide description for more information.
Definition: input_keys.h:3108
static const Key< FluidizationType > modi_collider_initialConditions_type
See user guide description for more information.
Definition: input_keys.h:3806
static const Key< double > modi_collider_sqrtSNN
See user guide description for more information.
Definition: input_keys.h:3123
static const Key< int > modi_collider_initialConditions_fluidCells
See user guide description for more information.
Definition: input_keys.h:3943
static const Key< std::vector< double > > modi_collider_impact_values
See user guide description for more information.
Definition: input_keys.h:3772
static const Key< double > modi_collider_impact_value
See user guide description for more information.
Definition: input_keys.h:3756
static const Key< double > modi_collider_projectile_deformed_beta4
See user guide description for more information.
Definition: input_keys.h:3507
static const Key< bool > modi_collider_impact_randomReactionPlane
See user guide description for more information.
Definition: input_keys.h:3709
static const Key< std::array< double, 2 > > modi_collider_impact_range
See user guide description for more information.
Definition: input_keys.h:3722
static const Key< double > modi_collider_initialConditions_maxTime
See user guide description for more information.
Definition: input_keys.h:3930
static const Key< double > modi_collider_initialConditions_minTime
See user guide description for more information.
Definition: input_keys.h:3916
static const Key< FluidizableProcessesBitSet > modi_collider_initialConditions_fluidProcesses
See user guide description for more information.
Definition: input_keys.h:3970
static const Key< bool > modi_collider_target_deformed_automatic
See user guide description for more information.
Definition: input_keys.h:3454
static const Key< double > modi_collider_initialConditions_eDenThreshold
See user guide description for more information.
Definition: input_keys.h:3900
static const Key< double > modi_collider_target_eKin
See user guide description for more information.
Definition: input_keys.h:3324
static const Key< CalculationFrame > modi_collider_calculationFrame
See user guide description for more information.
Definition: input_keys.h:3147
static const Key< double > modi_collider_impact_max
See user guide description for more information.
Definition: input_keys.h:3696
static const Key< std::vector< double > > modi_collider_impact_yields
See user guide description for more information.
Definition: input_keys.h:3786
static const Key< double > modi_collider_initialConditions_formTimeFraction
See user guide description for more information.
Definition: input_keys.h:3988
static const Key< double > modi_collider_target_deformed_beta2
See user guide description for more information.
Definition: input_keys.h:3472
static const Key< double > modi_collider_target_alphaClustered_sideLength
See user guide description for more information.
Definition: input_keys.h:3595
static const Key< double > modi_collider_target_deformed_beta4
See user guide description for more information.
Definition: input_keys.h:3512
static const Key< double > modi_collider_initialConditions_lowerBound
See user guide description for more information.
Definition: input_keys.h:3821
static const Key< double > modi_collider_eTot
See user guide description for more information.
Definition: input_keys.h:3091
static const Key< std::string > modi_collider_target_custom_fileName
See user guide description for more information.
Definition: input_keys.h:3413
static const Key< double > modi_collider_projectile_deformed_beta2
See user guide description for more information.
Definition: input_keys.h:3467
static const Key< std::string > modi_collider_projectile_custom_fileName
See user guide description for more information.
Definition: input_keys.h:3408
static const Key< double > modi_collider_projectile_deformed_gamma
See user guide description for more information.
Definition: input_keys.h:3527
static const Key< double > modi_collider_projectile_pLab
See user guide description for more information.
Definition: input_keys.h:3365
static const Key< double > modi_collider_target_deformed_gamma
See user guide description for more information.
Definition: input_keys.h:3532
static const Key< Sampling > modi_collider_impact_sample
See user guide description for more information.
Definition: input_keys.h:3743
static const Key< double > modi_collider_initialConditions_rapidityCut
See user guide description for more information.
Definition: input_keys.h:3882
static const Key< double > modi_collider_projectile_eTot
See user guide description for more information.
Definition: input_keys.h:3338
static const Key< std::string > modi_collider_target_custom_fileDirectory
See user guide description for more information.
Definition: input_keys.h:3396
static const Key< FermiMotion > modi_collider_fermiMotion
See user guide description for more information.
Definition: input_keys.h:3179
static const Key< double > modi_collider_initialConditions_properTime
See user guide description for more information.
Definition: input_keys.h:3842
static const Key< double > modi_collider_initialConditions_pTCut
See user guide description for more information.
Definition: input_keys.h:3862
static const Key< bool > modi_collider_target_alphaClustered_automatic
See user guide description for more information.
Definition: input_keys.h:3574
static const Key< double > modi_collider_target_deformed_beta3
See user guide description for more information.
Definition: input_keys.h:3492
static const Section m_c_p_alphaClustered
Subsection for the alpha-clustered projectile in collider modus.
Definition: input_keys.h:105
static const Section m_c_p_custom
Subsection for the custom projectile in collider modus.
Definition: input_keys.h:108
static const Section m_collider
Subsection for the collider modus.
Definition: input_keys.h:95
static const Section m_c_p_deformed
Subsection for the deformed projectile in collider modus.
Definition: input_keys.h:111
static const Section m_c_projectile
Subsection for the projectile in collider modus.
Definition: input_keys.h:102
static const Section m_c_t_deformed
Subsection for the deformed target in collider modus.
Definition: input_keys.h:125
static const Section m_c_target
Subsection for the target in collider modus.
Definition: input_keys.h:117
static const Section m_c_initialConditions
Subsection for the initial conditions in collider modus.
Definition: input_keys.h:99
static const Section m_c_t_custom
Subsection for the custom target in collider modus.
Definition: input_keys.h:122
static const Section m_c_t_alphaClustered
Subsection for the alpha-clustered target in collider modus.
Definition: input_keys.h:119
Thrown when the requested energy is smaller than the masses of two particles.
Definition: modusdefault.h:203