Version: SMASH-3.2
smash::ColliderModus Class Reference

#include <collidermodus.h>

ColliderModus: Provides a modus for colliding nuclei.

To use this modus, choose

General:
Modus: Collider

in the configuration file.

Options for ColliderModus go in the "Modi"→"Collider" section of the configuration.

The following configuration options are understood: Collider

Definition at line 48 of file collidermodus.h.

Inheritance diagram for smash::ColliderModus:
smash::ModusDefault

Classes

struct  ColliderEmpty
 Thrown when either projectile_ or target_ nuclei are empty. More...
 

Public Member Functions

 ColliderModus (Configuration modus_config, const ExperimentParameters &parameters)
 Constructor. More...
 
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 customnucleus. More...
 
double initial_conditions (Particles *particles, const ExperimentParameters &parameters)
 Generates initial state of the particles in the system. More...
 
void sample_impact ()
 Sample impact parameter. More...
 
double nuclei_passing_time () const
 Time until nuclei have passed through each other. More...
 
double velocity_projectile () const
 
double velocity_target () const
 
FermiMotion fermi_motion ()
 
bool is_collider () const
 
double sqrt_s_NN () const
 
double impact_parameter () const
 
bool calculation_frame_is_fixed_target () const
 
bool is_IC_for_hybrid () const
 
const InitialConditionParametersIC_parameters () const
 
const std::map< int32_t, double > & fluid_background () const
 
const RectangularLattice< EnergyMomentumTensor > & fluid_lattice () const
 
void build_fluidization_lattice (double t, const std::vector< Particles > &ensembles, const DensityParameters &dens_par)
 Build lattice of energy momentum tensor. More...
 
void update_fluidization_background (std::map< int32_t, double > &&background)
 Update the background energy density due to hydrodynamics, to be called by an external manager. More...
 
- Public Member Functions inherited from smash::ModusDefault
int impose_boundary_conditions (Particles *, const OutputsList &={})
 Enforces sensible positions for the particles. More...
 
bool is_collider () const
 
bool is_box () const
 
bool is_list () const
 
bool is_sphere () const
 
double sqrt_s_NN () const
 
double impact_parameter () const
 
void sample_impact () const
 sample impact parameter for collider modus More...
 
double velocity_projectile () const
 
double velocity_target () const
 
FermiMotion fermi_motion () const
 
double max_timestep (double) const
 
double equilibration_time () const
 
double length () const
 
double radius () const
 
bool calculation_frame_is_fixed_target () const
 
double nuclei_passing_time () const
 Get the passing time of the two nuclei in a collision. More...
 
bool is_IC_for_hybrid () const
 
const InitialConditionParametersIC_parameters () const
 
const std::map< int32_t, double > & fluid_background ()
 
const RectangularLattice< EnergyMomentumTensor > & fluid_lattice ()
 
void build_fluidization_lattice ([[maybe_unused]] const double t, [[maybe_unused]] const std::vector< Particles > &ensembles, [[maybe_unused]] const DensityParameters &dens_par)
 Build lattice of energy momentum tensor. More...
 
Grid< GridOptions::Normalcreate_grid (const Particles &particles, double min_cell_length, double timestep_duration, CollisionCriterion crit, const bool include_unformed_particles, CellSizeStrategy strategy=CellSizeStrategy::Optimal) const
 Creates the Grid with normal boundary conditions. More...
 
std::unique_ptr< GrandCanThermalizercreate_grandcan_thermalizer (Configuration &conf) const
 Creates GrandCanThermalizer. More...
 

Private Member Functions

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 a customnucleus. More...
 
void rotate_reaction_plane (double phi, Particles *particles)
 Rotate the reaction plane about the angle phi. More...
 
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. More...
 

Static Private Member Functions

static std::unique_ptr< DeformedNucleuscreate_deformed_nucleus (Configuration &nucleus_cfg, const int ntest, const std::string &nucleus_type)
 Configure Deformed Nucleus. More...
 
static std::unique_ptr< AlphaClusteredNucleuscreate_alphaclustered_nucleus (Configuration &nucleus_cfg, const int ntest, const std::string &nucleus_type)
 Configure Alpha-Clustered Nucleus. More...
 

Private Attributes

std::unique_ptr< Nucleusprojectile_
 Projectile. More...
 
std::unique_ptr< Nucleustarget_
 Target. More...
 
double total_s_
 Center-of-mass energy squared of the nucleus-nucleus collision. More...
 
double sqrt_s_NN_
 Center-of-mass energy of a nucleon-nucleon collision. More...
 
double impact_ = 0.
 Impact parameter. More...
 
bool random_reaction_plane_
 Whether the reaction plane should be randomized. More...
 
bool IC_for_hybrid_ = false
 Whether the particles will serve as initial conditions for hydrodynamics. More...
 
Sampling sampling_ = InputKeys::modi_collider_impact_sample.default_value()
 Method used for sampling of impact parameter. More...
 
double imp_min_ = InputKeys::modi_collider_impact_value.default_value()
 Minimum value of impact parameter. More...
 
double imp_max_ = InputKeys::modi_collider_impact_value.default_value()
 Maximum value of impact parameter. More...
 
double yield_max_ = 0.0
 Maximum value of yield. Needed for custom impact parameter sampling. More...
 
std::unique_ptr< InterpolateDataLinear< double > > impact_interpolation_
 Pointer to the impact parameter interpolation. More...
 
double initial_z_displacement_
 Initial z-displacement of nuclei. More...
 
CalculationFrame frame_
 Reference frame for the system, as specified from config. More...
 
FermiMotion fermi_motion_
 An option to include Fermi motion ("off", "on", "frozen") More...
 
double velocity_projectile_ = 0.0
 Beam velocity of the projectile. More...
 
double velocity_target_ = 0.0
 Beam velocity of the target. More...
 
std::unique_ptr< InitialConditionParametersIC_parameters_
 Plain Old Data type to hold parameters for initial conditions. More...
 
std::unique_ptr< RectangularLattice< EnergyMomentumTensor > > fluid_lattice_
 Energy-momentum tensor lattice for dynamic fluidization. More...
 
std::unique_ptr< std::map< int32_t, double > > fluid_background_ = nullptr
 Energy density background from hydrodynamic evolution, with particle indices as keys. More...
 

Friends

std::ostream & operator<< (std::ostream &, const ColliderModus &)
 Writes the initial state for the ColliderModus to the output stream. More...
 

Constructor & Destructor Documentation

◆ ColliderModus()

smash::ColliderModus::ColliderModus ( Configuration  modus_config,
const ExperimentParameters parameters 
)
explicit

Constructor.

Takes all there is to take from the (truncated!) configuration object (only contains configuration for this modus).

Parameters
[in]modus_configThe configuration object that sets all initial conditions of the experiment.
[in]parametersUnused, but necessary because of templated initialization
Exceptions
ColliderEmptyif projectile or nucleus are empty (i.e. do not contain particles)
InvalidEnergyif sqrts from config is not large enough to support the colliding masses of the nuclei, or if E_kin or P_lab are negative
domain_errorif more or less than exactly one of the input energy options is specified, or if custom impact parameter Values and Yields are improperly supplied
Todo:
include a check that only one method of specifying impact is used

Definition at line 34 of file collidermodus.cc.

35  {
36  Configuration modus_cfg = modus_config.extract_complete_sub_configuration(
38  // Get the reference frame for the collision calculation.
40 
41  Configuration proj_cfg = modus_cfg.extract_complete_sub_configuration(
43  Configuration targ_cfg =
44  modus_cfg.extract_complete_sub_configuration(InputSections::m_c_target);
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
49  if (proj_cfg.has_section(InputSections::m_c_p_deformed)) {
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.";
59  projectile_ = create_alphaclustered_nucleus(proj_cfg, params.testparticles,
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
70  if (targ_cfg.has_section(InputSections::m_c_t_deformed)) {
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.
109  if (modus_cfg.has_value(InputKeys::modi_collider_sqrtSNN)) {
111  // Check that input satisfies the lower bound (everything at rest).
112  if (sqrt_s_NN_ <= mass_a + mass_b) {
113  throw ModusDefault::InvalidEnergy(
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) {
129  throw ModusDefault::InvalidEnergy(
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) {
144  throw ModusDefault::InvalidEnergy(
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) {
158  throw ModusDefault::InvalidEnergy(
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
169  if (proj_cfg.has_value(InputKeys::modi_collider_projectile_eTot) &&
170  targ_cfg.has_value(InputKeys::modi_collider_target_eTot)) {
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) {
175  throw ModusDefault::InvalidEnergy(
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
186  if (proj_cfg.has_value(InputKeys::modi_collider_projectile_eKin) &&
187  targ_cfg.has_value(InputKeys::modi_collider_target_eKin)) {
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) {
192  throw ModusDefault::InvalidEnergy(
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
203  if (proj_cfg.has_value(InputKeys::modi_collider_projectile_pLab) &&
204  targ_cfg.has_value(InputKeys::modi_collider_target_pLab)) {
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) {
209  throw ModusDefault::InvalidEnergy(
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.*/
232  if (modus_cfg.has_value(InputKeys::modi_collider_impact_value)) {
234  imp_min_ = impact_;
235  imp_max_ = impact_;
236  } else {
237  // If impact is not supplied by value, inspect sampling parameters:
238  if (modus_cfg.has_value(InputKeys::modi_collider_impact_sample)) {
240  if (sampling_ == Sampling::Custom) {
241  if (!(modus_cfg.has_value(InputKeys::modi_collider_impact_values) ||
242  modus_cfg.has_value(InputKeys::modi_collider_impact_yields))) {
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  }
266  if (modus_cfg.has_value(InputKeys::modi_collider_impact_range)) {
267  const std::array<double, 2> range =
269  imp_min_ = range[0];
270  imp_max_ = range[1];
271  }
272  if (modus_cfg.has_value(InputKeys::modi_collider_impact_max)) {
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)
285  modus_cfg.take(InputKeys::modi_collider_initialDistance) / 2.0;
286  if (modus_cfg.has_section(InputSections::m_c_initialConditions)) {
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 }
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.
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.
Sampling sampling_
Method used for sampling of impact parameter.
std::unique_ptr< RectangularLattice< EnergyMomentumTensor > > fluid_lattice_
Energy-momentum tensor lattice for dynamic fluidization.
double total_s_
Center-of-mass energy squared of the nucleus-nucleus collision.
std::unique_ptr< Nucleus > target_
Target.
double impact_
Impact parameter.
double sqrt_s_NN_
Center-of-mass energy of a nucleon-nucleon collision.
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.
std::unique_ptr< InitialConditionParameters > IC_parameters_
Plain Old Data type to hold parameters for initial conditions.
double imp_max_
Maximum value of impact parameter.
double length() const
Definition: modusdefault.h:93
@ 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.
@ Custom
Sample from custom, user-defined distribution.
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
Definition: logging.cc:40
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
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
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< 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< 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< 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_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< double > modi_collider_projectile_pLab
See user guide description for more information.
Definition: input_keys.h:3365
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< 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 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

Member Function Documentation

◆ custom_file_path()

std::string smash::ColliderModus::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 customnucleus.

Parameters
[in]file_directoryis the path to the external file
[in]file_nameis the name of the external file

Definition at line 602 of file collidermodus.cc.

603  {
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 }

◆ initial_conditions()

double smash::ColliderModus::initial_conditions ( Particles particles,
const ExperimentParameters parameters 
)

Generates initial state of the particles in the system.

In particular, it initializes the momenta and positions of nucleons withing the colliding nuclei.

Parameters
[out]particlesAn empty list that gets filled up by this function
[in]parametersThe initialization parameters of the system
Returns
The starting time of the simulation (negative, so that nuclei collide exactly at t=0)
Exceptions
domain_errorif the velocities of each nucleus are >= 1, or if input for Fermi motion is invalid

Definition at line 462 of file collidermodus.cc.

463  {
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 }
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.
double velocity_projectile_
Beam velocity of the projectile.
double velocity_target_
Beam velocity of the target.
T uniform(T min, T max)
Definition: random.h:88

◆ sample_impact()

void smash::ColliderModus::sample_impact ( )

Sample impact parameter.

Samples the impact parameter from values between imp_min_ and imp_max_, if linear or quadratic sampling is used. By specifying impact parameters and corresponding yields, custom sampling can be used. This depends on the value of sampling_.

Note that imp_max_ less than imp_min_ also works fine.

Definition at line 544 of file collidermodus.cc.

544  {
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 }
@ Quadratic
Sample from areal / quadratic distribution.
@ Uniform
Sample from uniform distribution.
T canonical()
Definition: random.h:113

◆ nuclei_passing_time()

double smash::ColliderModus::nuclei_passing_time ( ) const
inline

Time until nuclei have passed through each other.

Definition at line 108 of file collidermodus.h.

108  {
109  const double passing_distance =
110  projectile_->get_nuclear_radius() + target_->get_nuclear_radius();
111  const double passing_time =
112  passing_distance /
113  std::sqrt(sqrt_s_NN_ * sqrt_s_NN_ /
114  ((2 * nucleon_mass) * (2 * nucleon_mass)) -
115  1);
116  return passing_time;
117  }
constexpr double nucleon_mass
Nucleon mass in GeV.
Definition: constants.h:58

◆ velocity_projectile()

double smash::ColliderModus::velocity_projectile ( ) const
inline
Returns
the beam velocity of the projectile, which will be used to calculate the beam momenta in experiment.cc if Fermi motion is frozen.

Definition at line 123 of file collidermodus.h.

123 { return velocity_projectile_; }

◆ velocity_target()

double smash::ColliderModus::velocity_target ( ) const
inline
Returns
the beam velocity of the target, which will be used to calculate the beam momenta in experiment.cc if Fermi motion is frozen.

Definition at line 128 of file collidermodus.h.

128 { return velocity_target_; }

◆ fermi_motion()

FermiMotion smash::ColliderModus::fermi_motion ( )
inline
Returns
The Fermi motion type

Definition at line 130 of file collidermodus.h.

130 { return fermi_motion_; }

◆ is_collider()

bool smash::ColliderModus::is_collider ( ) const
inline
Returns
whether the modus is collider (which is, yes, trivially true)

Definition at line 132 of file collidermodus.h.

132 { return true; }

◆ sqrt_s_NN()

double smash::ColliderModus::sqrt_s_NN ( ) const
inline
Returns
center of mass energy per nucleon pair

Definition at line 134 of file collidermodus.h.

134 { return sqrt_s_NN_; }

◆ impact_parameter()

double smash::ColliderModus::impact_parameter ( ) const
inline
Returns
impact parameter of the collision

Definition at line 136 of file collidermodus.h.

136 { return impact_; }

◆ calculation_frame_is_fixed_target()

bool smash::ColliderModus::calculation_frame_is_fixed_target ( ) const
inline
Returns
Whether the calculation frame is the fixed target frame

Definition at line 138 of file collidermodus.h.

138  {
139  return frame_ == CalculationFrame::FixedTarget ? true : false;
140  }

◆ is_IC_for_hybrid()

bool smash::ColliderModus::is_IC_for_hybrid ( ) const
inline
Returns
Whether this is an initial condition for hydrodynamics

Definition at line 142 of file collidermodus.h.

142 { return IC_for_hybrid_; }

◆ IC_parameters()

const InitialConditionParameters& smash::ColliderModus::IC_parameters ( ) const
inline
Returns
Parameters used in initial conditions for hydrodynamics

Definition at line 144 of file collidermodus.h.

144  {
145  return *IC_parameters_;
146  }

◆ fluid_background()

const std::map<int32_t, double>& smash::ColliderModus::fluid_background ( ) const
inline
Returns
The background energy density map

Definition at line 148 of file collidermodus.h.

148  {
149  return *fluid_background_;
150  }

◆ fluid_lattice()

const RectangularLattice<EnergyMomentumTensor>& smash::ColliderModus::fluid_lattice ( ) const
inline
Returns
Lattice where fluidization is evaluated

Definition at line 152 of file collidermodus.h.

152  {
153  return *fluid_lattice_;
154  }

◆ build_fluidization_lattice()

void smash::ColliderModus::build_fluidization_lattice ( double  t,
const std::vector< Particles > &  ensembles,
const DensityParameters dens_par 
)

Build lattice of energy momentum tensor.

After t>25 fm, the lattice grows at every 5 fm to accommodate for the system expansion.

Parameters
[in]tCurrent time.
[in]ensemblesOnly the first Particles element is actually used.
[in]dens_parContains parameters for density smearing.

Definition at line 641 of file collidermodus.cc.

643  {
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 }
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

◆ update_fluidization_background()

void smash::ColliderModus::update_fluidization_background ( std::map< int32_t, double > &&  background)
inline

Update the background energy density due to hydrodynamics, to be called by an external manager.

Parameters
[in]backgroundMap with particle indices as keys and their corresponding background energy density as values.

Definition at line 174 of file collidermodus.h.

174  {
175  *fluid_background_ = std::move(background);
176  }

◆ create_deformed_nucleus()

std::unique_ptr< DeformedNucleus > smash::ColliderModus::create_deformed_nucleus ( Configuration nucleus_cfg,
const int  ntest,
const std::string &  nucleus_type 
)
staticprivate

Configure Deformed Nucleus.

Sets up a deformed nucleus object based on the input parameters in the configuration file.

Parameters
[in]nucleus_cfgSubset of configuration, projectile or target section.
[in]ntestNumber of test particles
[in]nucleus_typeString 'projectile' or 'target'. To display an appropriate error message.
Returns
Pointer to the created deformed nucleus object.

Definition at line 373 of file collidermodus.cc.

374  {
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(
387  InputKeys::modi_collider_target_deformed_automatic,
388  InputKeys::modi_collider_target_deformed_beta2,
389  InputKeys::modi_collider_target_deformed_beta3,
390  InputKeys::modi_collider_target_deformed_beta4,
391  InputKeys::modi_collider_target_deformed_gamma);
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 }
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
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< double > modi_collider_projectile_deformed_beta4
See user guide description for more information.
Definition: input_keys.h:3507
static const Key< double > modi_collider_projectile_deformed_beta2
See user guide description for more information.
Definition: input_keys.h:3467
static const Key< double > modi_collider_projectile_deformed_gamma
See user guide description for more information.
Definition: input_keys.h:3527

◆ create_alphaclustered_nucleus()

std::unique_ptr< AlphaClusteredNucleus > smash::ColliderModus::create_alphaclustered_nucleus ( Configuration nucleus_cfg,
const int  ntest,
const std::string &  nucleus_type 
)
staticprivate

Configure Alpha-Clustered Nucleus.

Sets up an alpha-clustered nucleus object based on the input parameters in the configuration file.

Parameters
[in]nucleus_cfgSubset of configuration, projectile or target section.
[in]ntestNumber of test particles
[in]nucleus_typeString 'projectile' or 'target'. To display an appropriate error message.
Returns
Pointer to the created deformed nucleus object.

Definition at line 426 of file collidermodus.cc.

428  {
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(
438  InputKeys::modi_collider_target_alphaClustered_automatic,
439  InputKeys::modi_collider_target_alphaClustered_sideLength);
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 }

◆ same_inputfile()

bool smash::ColliderModus::same_inputfile ( Configuration proj_config,
Configuration targ_config 
)
private

Checks if target and projectile are read from the same external file if they are both initialized as a customnucleus.

Function is only called if, projectile is customnucleus. /param[in] proj_config Configuration of projectile nucleus /param[in] targ_config Configuration of target nucleus

Definition at line 612 of file collidermodus.cc.

613  {
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 }
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...
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< std::string > modi_collider_target_custom_fileName
See user guide description for more information.
Definition: input_keys.h:3413
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< std::string > modi_collider_target_custom_fileDirectory
See user guide description for more information.
Definition: input_keys.h:3396

◆ rotate_reaction_plane()

void smash::ColliderModus::rotate_reaction_plane ( double  phi,
Particles particles 
)
private

Rotate the reaction plane about the angle phi.

Parameters
[in]phiAngle about which to rotate
[in]particlesParticles, whose position is rotated

Definition at line 533 of file collidermodus.cc.

533  {
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 }
constexpr int p
Proton.

◆ get_velocities()

std::pair< double, double > smash::ColliderModus::get_velocities ( double  mandelstam_s,
double  m_a,
double  m_b 
)
private

Get the frame dependent velocity for each nucleus, using the current reference frame.

See also
frame_
Parameters
[in]mandelstam_sThe total center-of-mass energy of the system.
[in]m_aThe (positive) mass of the projectile.
[in]m_bThe (positive) mass of the target.
Returns
A pair < v_a, v_b > containing the velocities of the nuclei.
Exceptions
domain_errorif the reference frame is not properly specified

Definition at line 575 of file collidermodus.cc.

576  {
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 }
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 center_of_velocity_v(double s, double ma, double mb)
Definition: kinematics.h:26
T pCM_from_s(const T s, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:66

Member Data Documentation

◆ projectile_

std::unique_ptr<Nucleus> smash::ColliderModus::projectile_
private

Projectile.

The object that goes from negative z-values to positive z-values with positive velocity.

Definition at line 193 of file collidermodus.h.

◆ target_

std::unique_ptr<Nucleus> smash::ColliderModus::target_
private

Target.

The object that goes from positive z-values to negative z-values with negative velocity. In fixed target experiments, the target is at rest.

Definition at line 201 of file collidermodus.h.

◆ total_s_

double smash::ColliderModus::total_s_
private

Center-of-mass energy squared of the nucleus-nucleus collision.

Needs to be double to allow for calculations at LHC energies

Definition at line 207 of file collidermodus.h.

◆ sqrt_s_NN_

double smash::ColliderModus::sqrt_s_NN_
private

Center-of-mass energy of a nucleon-nucleon collision.

Needs to be double to allow for calculations at LHC energies

Definition at line 213 of file collidermodus.h.

◆ impact_

double smash::ColliderModus::impact_ = 0.
private

Impact parameter.

The nuclei projectile_ and target_ will be shifted along the x-axis so that their centers move on antiparallel lines that are this distance apart from each other.

Definition at line 255 of file collidermodus.h.

◆ random_reaction_plane_

bool smash::ColliderModus::random_reaction_plane_
private

Whether the reaction plane should be randomized.

Definition at line 257 of file collidermodus.h.

◆ IC_for_hybrid_

bool smash::ColliderModus::IC_for_hybrid_ = false
private

Whether the particles will serve as initial conditions for hydrodynamics.

Definition at line 259 of file collidermodus.h.

◆ sampling_

Sampling smash::ColliderModus::sampling_ = InputKeys::modi_collider_impact_sample.default_value()
private

Method used for sampling of impact parameter.

Definition at line 261 of file collidermodus.h.

◆ imp_min_

double smash::ColliderModus::imp_min_ = InputKeys::modi_collider_impact_value.default_value()
private

Minimum value of impact parameter.

Definition at line 263 of file collidermodus.h.

◆ imp_max_

double smash::ColliderModus::imp_max_ = InputKeys::modi_collider_impact_value.default_value()
private

Maximum value of impact parameter.

Definition at line 265 of file collidermodus.h.

◆ yield_max_

double smash::ColliderModus::yield_max_ = 0.0
private

Maximum value of yield. Needed for custom impact parameter sampling.

Definition at line 267 of file collidermodus.h.

◆ impact_interpolation_

std::unique_ptr<InterpolateDataLinear<double> > smash::ColliderModus::impact_interpolation_
private
Initial value:
=
nullptr

Pointer to the impact parameter interpolation.

Definition at line 269 of file collidermodus.h.

◆ initial_z_displacement_

double smash::ColliderModus::initial_z_displacement_
private

Initial z-displacement of nuclei.

Projectile is shifted on -(this value) in z-direction and target on +(this value)*v_target/v_projectile. In this way projectile and target touch at t=0 in z=0.

Definition at line 286 of file collidermodus.h.

◆ frame_

CalculationFrame smash::ColliderModus::frame_
private

Reference frame for the system, as specified from config.

Definition at line 290 of file collidermodus.h.

◆ fermi_motion_

FermiMotion smash::ColliderModus::fermi_motion_
private

An option to include Fermi motion ("off", "on", "frozen")

Definition at line 294 of file collidermodus.h.

◆ velocity_projectile_

double smash::ColliderModus::velocity_projectile_ = 0.0
private

Beam velocity of the projectile.

Definition at line 298 of file collidermodus.h.

◆ velocity_target_

double smash::ColliderModus::velocity_target_ = 0.0
private

Beam velocity of the target.

Definition at line 302 of file collidermodus.h.

◆ IC_parameters_

std::unique_ptr<InitialConditionParameters> smash::ColliderModus::IC_parameters_
private

Plain Old Data type to hold parameters for initial conditions.

Definition at line 304 of file collidermodus.h.

◆ fluid_lattice_

std::unique_ptr<RectangularLattice<EnergyMomentumTensor> > smash::ColliderModus::fluid_lattice_
private
Initial value:
=
nullptr

Energy-momentum tensor lattice for dynamic fluidization.

Definition at line 306 of file collidermodus.h.

◆ fluid_background_

std::unique_ptr<std::map<int32_t, double> > smash::ColliderModus::fluid_background_ = nullptr
private

Energy density background from hydrodynamic evolution, with particle indices as keys.

Useful when using SMASH as a library.

Definition at line 312 of file collidermodus.h.


The documentation for this class was generated from the following files: