32 static constexpr
int LCollider = LogArea::Collider::id;
47 bool same_file =
false;
57 logg[
LCollider].info() <<
"Projectile is alpha-clustered with woods-saxon "
58 "parameters for the He-clusters listed below.";
65 throw ColliderEmpty(
"Input Error: Projectile nucleus is empty.");
76 logg[
LCollider].info() <<
"Target is alpha-clustered with woods-saxon "
77 "parameters for the He-clusters listed below.";
101 int energy_input = 0;
103 const double mass_target =
target_->mass();
105 const double mass_a =
107 const double mass_b =
target_->mass() /
target_->number_of_particles();
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.");
120 mass_projec * mass_target / (mass_a * mass_b) +
121 mass_projec * mass_projec + mass_target * mass_target;
131 "E_Tot must be nonnegative.");
135 mass_projec, mass_target);
146 "E_Kin must be nonnegative.");
150 mass_projec, mass_target);
160 "P_Lab must be nonnegative.");
164 mass_projec, mass_target);
171 const double e_tot_p =
174 if (e_tot_p < 0 || e_tot_t < 0) {
177 "E_Tot must be nonnegative.");
180 e_tot_t *
target_->number_of_particles(),
181 mass_projec, mass_target);
188 const double e_kin_p =
191 if (e_kin_p < 0 || e_kin_t < 0) {
194 "E_Kin must be nonnegative.");
197 e_kin_t *
target_->number_of_particles(),
198 mass_projec, mass_target);
205 const double p_lab_p =
208 if (p_lab_p < 0 || p_lab_t < 0) {
211 "P_Lab must be nonnegative.");
214 p_lab_t *
target_->number_of_particles(),
215 mass_projec, mass_target);
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.");
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.");
243 throw std::invalid_argument(
244 "Input Error: Need impact parameter spectrum for custom sampling."
245 " Please provide Values and Yields.");
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.");
259 const auto imp_minmax =
260 std::minmax_element(impacts.begin(), impacts.end());
263 yield_max_ = *std::max_element(yields.begin(), yields.end());
267 const std::array<double, 2> range =
314 double threshold = modus_cfg.
take(
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) {
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
333 <<
" Formation_Time_Fraction < 0";
334 throw std::invalid_argument(
"Please adjust the configuration file.");
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};
346 std::make_unique<RectangularLattice<EnergyMomentumTensor>>(
355 <<
"Dynamic Initial Conditions with threshold " << threshold
356 <<
" GeV/fm³ in energy density, between " << min_time <<
" and "
357 << max_time <<
" fm.";
364 return out <<
"-- Collider Modus:\n"
365 <<
"sqrt(S) (nucleus-nucleus) = "
374 Configuration &nucleus_cfg,
int ntest,
const std::string &nucleus_type) {
377 const auto &[automatic_key, beta2_key, beta3_key, beta4_key,
378 gamma_key] = [&is_projectile]() {
394 bool automatic_deformation = nucleus_cfg.
take(automatic_key);
395 bool was_any_beta_given = nucleus_cfg.
has_value(beta2_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 =
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.");
420 return std::make_unique<DeformedNucleus>(nucleus_cfg, ntest,
421 automatic_deformation);
425 std::unique_ptr<AlphaClusteredNucleus>
428 const std::string &nucleus_type) {
430 const auto &[automatic_key, side_length_key] = [&is_projectile]() {
434 modi_collider_projectile_alphaClustered_automatic,
436 modi_collider_projectile_alphaClustered_sideLength)
442 bool automatic_alphaclustering = nucleus_cfg.
take(automatic_key);
443 bool was_sidelength_given = nucleus_cfg.
has_value(side_length_key);
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 "
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.");
457 return std::make_unique<AlphaClusteredNucleus>(nucleus_cfg, ntest,
458 automatic_alphaclustering);
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.");
496 target_->generate_fermi_momenta();
499 throw std::invalid_argument(
"Invalid Fermi_Motion input.");
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();
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);
528 target_->copy_particles(particles);
530 return simulation_time;
539 p.set_3position(pos);
540 p.set_3momentum(mom);
557 double probability_random = 1;
558 double probability = 0;
560 while (probability_random > probability) {
562 probability = (*impact_interpolation_)(b) /
yield_max_;
563 assert(probability < 1.);
588 v_a =
pCM / std::sqrt(m_a * m_a +
pCM *
pCM);
589 v_b = -
pCM / std::sqrt(m_b * m_b +
pCM *
pCM);
595 throw std::invalid_argument(
596 "Invalid reference frame in "
597 "ColliderModus::get_velocities.");
599 return std::make_pair(v_a, v_b);
603 const std::string &file_name) {
605 if (file_directory.back() ==
'/') {
606 return file_directory + file_name;
608 return file_directory +
'/' + file_name;
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 =
630 std::string proj_path =
632 std::string targ_path =
634 if (proj_path == targ_path) {
642 const double t,
const std::vector<Particles> &ensembles,
645 throw std::logic_error(
646 "Trying to build fluidization lattice with unset pointer in "
649 if (t < IC_parameters_->min_time.value() ||
653 const double resizing_rate = 5;
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";
666 dens_par, ensembles,
false);
ColliderModus: Provides a modus for colliding nuclei.
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 ¶meters)
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 ¶meters)
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.
Represent a piecewise linear interpolation.
ParticleData contains the dynamic information of a certain particle.
The Particles class abstracts the storage and manipulation of particles.
The ThreeVector class represents a physical three-vector with the components .
void rotate_around_z(double theta)
Rotate the vector around the z axis by the given angle theta.
@ 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.
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
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...
T pCM(const T sqrts, const T mass_a, const T mass_b) noexcept
double fixed_target_projectile_v(double s, double ma, double mb)
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...
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.
double center_of_velocity_v(double s, double ma, double mb)
bool has_projectile_or_target(const Configuration &config)
Find out whether a configuration has a projectile or a target sub-section.
bool is_about_projectile(const Configuration &config)
Find out whether a configuration is about projectile or target.
T pCM_from_s(const T s, const T mass_a, const T mass_b) noexcept
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...
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...
Thrown when either projectile_ or target_ nuclei are empty.
Helper structure for Experiment.
int testparticles
Number of test-particles.
Thrown when the requested energy is smaller than the masses of two particles.