Version: SMASH-3.2
smash::ScatterActionsFinder Class Reference

#include <scatteractionsfinder.h>

A simple scatter finder: Just loops through all particles and checks each pair for a collision.

It supports two collision criteria: a geometric and stochastic criterion.

Definition at line 31 of file scatteractionsfinder.h.

Inheritance diagram for smash::ScatterActionsFinder:
smash::ActionFinderInterface

Public Member Functions

 ScatterActionsFinder (Configuration &config, const ExperimentParameters &parameters)
 Constructor of the finder with the given parameters. More...
 
double collision_time (const ParticleData &p1, const ParticleData &p2, double dt, const std::vector< FourVector > &beam_momentum) const
 Determine the collision time of the two particles. More...
 
ActionList find_actions_in_cell (const ParticleList &search_list, double dt, const double gcell_vol, const std::vector< FourVector > &beam_momentum) const override
 Search for all the possible collisions within one cell. More...
 
ActionList find_actions_with_neighbors (const ParticleList &search_list, const ParticleList &neighbors_list, double dt, const std::vector< FourVector > &beam_momentum) const override
 Search for all the possible collisions among the neighboring cells. More...
 
ActionList find_actions_with_surrounding_particles (const ParticleList &search_list, const Particles &surrounding_list, double dt, const std::vector< FourVector > &beam_momentum) const override
 Search for all the possible secondary collisions between the outgoing particles and the rest. More...
 
ActionList find_final_actions (const Particles &, bool=false) const override
 Find some final collisions at the end of the simulation. More...
 
bool is_constant_elastic_isotropic () const
 If there is only one particle sort, no decays (only elastic scatterings are possible), scatterings are isotropic and cross-section fixed to elastic_parameter_ independently on momenta, then maximal cross-section is elastic_parameter_. More...
 
double max_transverse_distance_sqr (int testparticles) const
 The maximal distance over which particles can interact in case of the geometric criterion, related to the number of test particles and the maximal cross section. More...
 
void dump_reactions () const
 Prints out all the 2-> n (n > 1) reactions with non-zero cross-sections between all possible pairs of particle types. More...
 
void dump_cross_sections (const ParticleType &a, const ParticleType &b, double m_a, double m_b, bool final_state, std::vector< double > &plab) const
 Print out partial cross-sections of all processes that can occur in the collision of a(mass = m_a) and b(mass = m_b). More...
 
StringProcessget_process_string_ptr ()
 
- Public Member Functions inherited from smash::ActionFinderInterface
virtual ~ActionFinderInterface ()=default
 

Private Member Functions

ActionPtr check_collision_two_part (const ParticleData &data_a, const ParticleData &data_b, double dt, const std::vector< FourVector > &beam_momentum={}, const double gcell_vol=0.0) const
 Check for a single pair of particles (id_a, id_b) if a collision will happen in the next timestep and create a corresponding Action object in that case. More...
 
ActionPtr check_collision_multi_part (const ParticleList &plist, double dt, const double gcell_vol) const
 Check for multiple i.e. More...
 

Private Attributes

ScatterActionsFinderParameters finder_parameters_
 Struct collecting several parameters. More...
 
std::unique_ptr< StringProcessstring_process_interface_
 Class that deals with strings, interfacing Pythia. More...
 
const bool isotropic_
 Do all collisions isotropically. More...
 
const double box_length_
 Box length: needed to determine coordinates of collision correctly in case of collision through the wall. More...
 
const double string_formation_time_
 Parameter for formation time. More...
 

Constructor & Destructor Documentation

◆ ScatterActionsFinder()

smash::ScatterActionsFinder::ScatterActionsFinder ( Configuration config,
const ExperimentParameters parameters 
)

Constructor of the finder with the given parameters.

Parameters
[in,out]configConfiguration of smash from which we take: 1) A global elastic cross section [mb]. It will be used regardless of the species of the colliding particles. It won't be used if the value is negative. 2) An option determining whether all the scatterings are isotropic 3) Parameters of the string process
[in]parametersStruct of parameters determining whether to exclude some certain types of scatterings and switching among the methods to treat with the NNbar collisions.

Definition at line 34 of file scatteractionsfinder.cc.

36  : finder_parameters_(config, parameters),
38  box_length_(parameters.box_length),
42  logg[LFindScatter].info(
43  "Constant elastic isotropic cross-section mode:", " using ",
44  finder_parameters_.elastic_parameter, " mb as maximal cross-section.");
45  }
48  throw std::invalid_argument(
49  "Multi-body reactions (like e.g. 3->1 or 3->2) are only possible with "
50  "the stochastic "
51  "collision "
52  "criterion. Change your config accordingly.");
53  }
54 
57  1 &&
59  .included_2to2[IncludedReactions::PiDeuteron_to_pidprime] == 1 ||
61  .included_2to2[IncludedReactions::NDeuteron_to_Ndprime] == 1)) {
62  throw std::invalid_argument(
63  "To prevent double counting it is not possible to enable deuteron 3->2 "
64  "reactions\nand reactions involving the d' at the same time\ni.e. to "
65  "include \"Deuteron_3to2\" in `Multi_Particle_Reactions` and\n "
66  "\"PiDeuteron_to_pidprime\" "
67  "or \"NDeuteron_to_Ndprime\" in `Included_2to2` at the same time.\n"
68  "Change your config accordingly.");
69  }
70 
73  1 &&
75  throw std::invalid_argument(
76  "Do not use the d' resonance and enable \"Deuteron_3to2\" "
77  "`Multi_Particle_Reactions` at the same time. Either use the direct "
78  "3-to-2 reactions or the d' together with \"PiDeuteron_to_pidprime\" "
79  "and \"NDeuteron_to_Ndprime\" in `Included_2to2`. Otherwise the "
80  "deuteron 3-to-2 reactions would be double counted.");
81  }
82 
86  1) ||
89  1 &&
91  throw std::invalid_argument(
92  "In order to conserve detailed balance, when \"NNbar_5to2\" is "
93  "included in\n`Multi_Particle_Reactions`, the `NNbarTreatment` has to "
94  "be set to \"two to five\" and vice versa.");
95  }
96 
99  throw std::invalid_argument(
100  "'NNbar' has to be in the list of allowed 2 to 2 processes "
101  "to enable annihilation to go through resonances");
102  }
103 
105  string_process_interface_ = std::make_unique<StringProcess>(
126  parameters.use_monash_tune_default.value()));
127  }
128 }
static const ParticleTypePtr try_find(PdgCode pdgcode)
Returns the ParticleTypePtr for the given pdgcode.
Definition: particletype.cc:89
const ReactionsBitSet included_2to2
List of included 2<->2 reactions.
const double elastic_parameter
Elastic cross section parameter (in mb).
const bool strings_switch
Indicates whether string fragmentation is switched on.
const MultiParticleReactionsBitSet included_multi
List of included multi-particle reactions.
const NNbarTreatment nnbar_treatment
Switch for NNbar reactions.
const CollisionCriterion coll_crit
Specifies which collision criterion is used.
ScatterActionsFinderParameters finder_parameters_
Struct collecting several parameters.
const bool isotropic_
Do all collisions isotropically.
const double string_formation_time_
Parameter for formation time.
std::unique_ptr< StringProcess > string_process_interface_
Class that deals with strings, interfacing Pythia.
bool is_constant_elastic_isotropic() const
If there is only one particle sort, no decays (only elastic scatterings are possible),...
const double box_length_
Box length: needed to determine coordinates of collision correctly in case of collision through the w...
@ TwoToFive
Directly create 5 pions, use with multi-particle reactions.
@ Resonances
Use intermediate Resonances.
@ NNbar_5to2
@ Deuteron_3to2
@ Stochastic
Stochastic Criteiron.
@ PiDeuteron_to_pidprime
@ NDeuteron_to_Ndprime
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
Definition: logging.cc:40
constexpr int64_t dprime
Deuteron-prime resonance.
static constexpr int LFindScatter
static const Key< double > collTerm_stringParam_probabilityPToDUU
See user guide description for more information.
Definition: input_keys.h:2849
static const Key< double > collTerm_stringParam_formationTime
See user guide description for more information.
Definition: input_keys.h:2733
static const Key< bool > collTerm_stringParam_useMonashTune
See user guide description for more information.
Definition: input_keys.h:3002
static const Key< double > collTerm_stringParam_sigmaPerp
See user guide description for more information.
Definition: input_keys.h:2884
static const Key< double > collTerm_stringParam_gluonPMin
See user guide description for more information.
Definition: input_keys.h:2760
static const Key< double > collTerm_stringParam_stringZALeading
See user guide description for more information.
Definition: input_keys.h:2957
static const Key< bool > collTerm_stringParam_mDependentFormationTimes
See user guide description for more information.
Definition: input_keys.h:2774
static const Key< double > collTerm_stringParam_diquarkSuppression
See user guide description for more information.
Definition: input_keys.h:2708
static const Key< double > collTerm_stringParam_formTimeFactor
See user guide description for more information.
Definition: input_keys.h:2721
static const Key< double > collTerm_stringParam_quarkAlpha
See user guide description for more information.
Definition: input_keys.h:2789
static const Key< double > collTerm_stringParam_stringZA
See user guide description for more information.
Definition: input_keys.h:2943
static const Key< double > collTerm_stringParam_strangeSuppression
See user guide description for more information.
Definition: input_keys.h:2902
static const Key< double > collTerm_stringParam_stringSigmaT
See user guide description for more information.
Definition: input_keys.h:2915
static const Key< double > collTerm_stringParam_stringZB
See user guide description for more information.
Definition: input_keys.h:2970
static const Key< double > collTerm_stringParam_quarkBeta
See user guide description for more information.
Definition: input_keys.h:2802
static const Key< double > collTerm_stringParam_popcornRate
See user guide description for more information.
Definition: input_keys.h:2817
static const Key< bool > collTerm_isotropic
See user guide description for more information.
Definition: input_keys.h:2251
static const Key< double > collTerm_stringParam_stringZBLeading
See user guide description for more information.
Definition: input_keys.h:2985
static const Key< double > collTerm_stringParam_stringTension
See user guide description for more information.
Definition: input_keys.h:2930
static const Key< double > collTerm_stringParam_gluonBeta
See user guide description for more information.
Definition: input_keys.h:2746
static const Key< bool > collTerm_stringParam_separateFragmentBaryon
See user guide description for more information.
Definition: input_keys.h:2864

Member Function Documentation

◆ collision_time()

double smash::ScatterActionsFinder::collision_time ( const ParticleData p1,
const ParticleData p2,
double  dt,
const std::vector< FourVector > &  beam_momentum 
) const
inline

Determine the collision time of the two particles.

Time of the closest approach is taken as collision time, if the geometric collision criterion is used. For stochastic criterion the time is distributed uniformly within the timestep.

Parameters
[in]p1First incoming particle
[in]p2Second incoming particle
[in]dtThe maximum time interval at the current time step [fm]
[in]beam_momentum[GeV] List of beam momenta for each particle; only necessary for frozen Fermi motion
Returns
How long does it take for the two incoming particles to propagate before scattering [fm]. It's set equal to -1 if the two particles are not moving relative to each other.

JAM collision times from the closest approach in the two-particle center-of-mass-framem, see Hirano:2012yy [27] (5.13) and (5.14). The scatteraction is performed at the mean of these two times.

UrQMD collision time in computational frame, see Bass:1998ca [6] (3.28): position of particle 1: \(r_1\) [fm] position of particle 2: \(r_2\) [fm] velocity of particle 1: \(v_1\) velocity of particle 1: \(v_2\)

\[t_{coll} = - (r_1 - r_2) . (v_1 - v_2) / (v_1 - v_2)^2\]

[fm]

Definition at line 66 of file scatteractionsfinder.h.

68  {
70  return dt * random::uniform(0., 1.);
71  } else {
72  /*
73  * For frozen Fermi motion:
74  * If particles have not yet interacted and are the initial nucleons,
75  * perform action finding with beam momentum instead of Fermi motion
76  * corrected momentum. That is because the particles are propagated with
77  * the beam momentum until they interact.
78  */
79  if (p1.id() < 0 || p2.id() < 0) {
80  throw std::runtime_error("Invalid particle ID for Fermi motion");
81  }
82  const bool p1_has_no_prior_interactions =
83  (static_cast<uint64_t>(p1.id()) < // particle from
84  static_cast<uint64_t>(beam_momentum.size())) && // initial nucleus
85  (p1.get_history().collisions_per_particle == 0);
86 
87  const bool p2_has_no_prior_interactions =
88  (static_cast<uint64_t>(p2.id()) < // particle from
89  static_cast<uint64_t>(beam_momentum.size())) && // initial nucleus
90  (p2.get_history().collisions_per_particle == 0);
91 
92  const FourVector p1_mom = (p1_has_no_prior_interactions)
93  ? beam_momentum[p1.id()]
94  : p1.momentum();
95  const FourVector p2_mom = (p2_has_no_prior_interactions)
96  ? beam_momentum[p2.id()]
97  : p2.momentum();
105  const FourVector delta_x = p1.position() - p2.position();
106  const double p1_sqr = p1_mom.sqr();
107  const double p2_sqr = p2_mom.sqr();
108  const double p1_dot_x = p1_mom.Dot(delta_x);
109  const double p2_dot_x = p2_mom.Dot(delta_x);
110  const double p1_dot_p2 = p1_mom.Dot(p2_mom);
111  const double denominator = std::pow(p1_dot_p2, 2) - p1_sqr * p2_sqr;
112  if (unlikely(std::abs(denominator) < really_small * really_small)) {
113  return -1.0;
114  }
115 
116  const double time_1 = (p2_sqr * p1_dot_x - p1_dot_p2 * p2_dot_x) *
117  p1_mom.x0() / denominator;
118  const double time_2 = -(p1_sqr * p2_dot_x - p1_dot_p2 * p1_dot_x) *
119  p2_mom.x0() / denominator;
120  return (time_1 + time_2) / 2;
121  } else {
131  const ThreeVector dv_times_e1e2 =
132  p1_mom.threevec() * p2_mom.x0() - p2_mom.threevec() * p1_mom.x0();
133  const double dv_times_e1e2_sqr = dv_times_e1e2.sqr();
134  if (dv_times_e1e2_sqr < really_small) {
135  return -1.0;
136  }
137  const ThreeVector dr =
138  p1.position().threevec() - p2.position().threevec();
139  return -(dr * dv_times_e1e2) *
140  (p1_mom.x0() * p2_mom.x0() / dv_times_e1e2_sqr);
141  }
142  }
143  }
@ Covariant
Covariant Criterion.
#define unlikely(x)
Tell the branch predictor that this expression is likely false.
Definition: macros.h:16
T uniform(T min, T max)
Definition: random.h:88
constexpr double really_small
Numerical error tolerance.
Definition: constants.h:37

◆ find_actions_in_cell()

ActionList smash::ScatterActionsFinder::find_actions_in_cell ( const ParticleList &  search_list,
double  dt,
const double  gcell_vol,
const std::vector< FourVector > &  beam_momentum 
) const
overridevirtual

Search for all the possible collisions within one cell.

This function is only used for counting the primary collisions at the beginning of each time step. (Although it's also called afterwards for searching the secondary collisions among the outgoing particles, no new actions will be found since the scattered pairs cannot scatter again.)

Parameters
[in]search_listA list of particles within one cell
[in]dtThe maximum time interval at the current time step [fm]
[in]gcell_volVolume of searched grid cell [fm^3]
[in]beam_momentum[GeV] List of beam momenta for each particle; only necessary for frozen Fermi motion
Returns
A list of possible scatter actions

Implements smash::ActionFinderInterface.

Definition at line 450 of file scatteractionsfinder.cc.

452  {
453  std::vector<ActionPtr> actions;
454  for (const ParticleData& p1 : search_list) {
455  for (const ParticleData& p2 : search_list) {
456  // Check for 2 particle scattering
457  if (p1.id() < p2.id()) {
458  ActionPtr act =
459  check_collision_two_part(p1, p2, dt, beam_momentum, gcell_vol);
460  if (act) {
461  actions.push_back(std::move(act));
462  }
463  }
465  // Also, check for 3 particle scatterings with stochastic criterion
466  for (const ParticleData& p3 : search_list) {
471  if (p1.id() < p2.id() && p2.id() < p3.id()) {
472  ActionPtr act =
473  check_collision_multi_part({p1, p2, p3}, dt, gcell_vol);
474  if (act) {
475  actions.push_back(std::move(act));
476  }
477  }
478  }
479  for (const ParticleData& p4 : search_list) {
482  if (p1.id() < p2.id() && p2.id() < p3.id() && p3.id() < p4.id()) {
483  ActionPtr act =
484  check_collision_multi_part({p1, p2, p3, p4}, dt, gcell_vol);
485  if (act) {
486  actions.push_back(std::move(act));
487  }
488  }
489  }
492  search_list.size() >= 5) {
493  for (const ParticleData& p5 : search_list) {
494  if ((p1.id() < p2.id() && p2.id() < p3.id() &&
495  p3.id() < p4.id() && p4.id() < p5.id()) &&
496  (p1.is_pion() && p2.is_pion() && p3.is_pion() &&
497  p4.is_pion() && p5.is_pion())) {
498  // at the moment only pure pion 5-body reactions
499  ActionPtr act = check_collision_multi_part(
500  {p1, p2, p3, p4, p5}, dt, gcell_vol);
501  if (act) {
502  actions.push_back(std::move(act));
503  }
504  }
505  }
506  }
507  }
508  }
509  }
510  }
511  }
512  return actions;
513 }
ActionPtr check_collision_two_part(const ParticleData &data_a, const ParticleData &data_b, double dt, const std::vector< FourVector > &beam_momentum={}, const double gcell_vol=0.0) const
Check for a single pair of particles (id_a, id_b) if a collision will happen in the next timestep and...
ActionPtr check_collision_multi_part(const ParticleList &plist, double dt, const double gcell_vol) const
Check for multiple i.e.
@ A3_Nuclei_4to2
@ Meson_3to1

◆ find_actions_with_neighbors()

ActionList smash::ScatterActionsFinder::find_actions_with_neighbors ( const ParticleList &  search_list,
const ParticleList &  neighbors_list,
double  dt,
const std::vector< FourVector > &  beam_momentum 
) const
overridevirtual

Search for all the possible collisions among the neighboring cells.

This function is only used for counting the primary collisions at the beginning of each time step.

Parameters
[in]search_listA list of particles within the current cell
[in]neighbors_listA list of particles within the neighboring cell
[in]dtThe maximum time interval at the current time step [fm]
[in]beam_momentum[GeV] List of beam momenta for each particle; only necessary for frozen Fermi motion
Returns
A list of possible scatter actions

Implements smash::ActionFinderInterface.

Definition at line 515 of file scatteractionsfinder.cc.

517  {
518  std::vector<ActionPtr> actions;
520  // Only search in cells
521  return actions;
522  }
523  for (const ParticleData& p1 : search_list) {
524  for (const ParticleData& p2 : neighbors_list) {
525  assert(p1.id() != p2.id());
526  // Check if a collision is possible.
527  ActionPtr act = check_collision_two_part(p1, p2, dt, beam_momentum);
528  if (act) {
529  actions.push_back(std::move(act));
530  }
531  }
532  }
533  return actions;
534 }

◆ find_actions_with_surrounding_particles()

ActionList smash::ScatterActionsFinder::find_actions_with_surrounding_particles ( const ParticleList &  search_list,
const Particles surrounding_list,
double  dt,
const std::vector< FourVector > &  beam_momentum 
) const
overridevirtual

Search for all the possible secondary collisions between the outgoing particles and the rest.

Parameters
[in]search_listA list of particles within the current cell
[in]surrounding_listThe whole particle list
[in]dtThe maximum time interval at the current time step [fm]
[in]beam_momentum[GeV] List of beam momenta for each particle; only necessary for frozen Fermi motion
Returns
A list of possible scatter actions

Implements smash::ActionFinderInterface.

Definition at line 536 of file scatteractionsfinder.cc.

538  {
539  std::vector<ActionPtr> actions;
541  // Only search in cells
542  return actions;
543  }
544  for (const ParticleData& p2 : surrounding_list) {
545  /* don't look for collisions if the particle from the surrounding list is
546  * also in the search list */
547  auto result = std::find_if(
548  search_list.begin(), search_list.end(),
549  [&p2](const ParticleData& p) { return p.id() == p2.id(); });
550  if (result != search_list.end()) {
551  continue;
552  }
553  for (const ParticleData& p1 : search_list) {
554  // Check if a collision is possible.
555  ActionPtr act = check_collision_two_part(p1, p2, dt, beam_momentum);
556  if (act) {
557  actions.push_back(std::move(act));
558  }
559  }
560  }
561  return actions;
562 }
constexpr int p
Proton.

◆ find_final_actions()

ActionList smash::ScatterActionsFinder::find_final_actions ( const Particles ,
bool  = false 
) const
inlineoverridevirtual

Find some final collisions at the end of the simulation.

Todo:
Seems to do nothing.

Implements smash::ActionFinderInterface.

Definition at line 198 of file scatteractionsfinder.h.

199  {
200  return ActionList();
201  }

◆ is_constant_elastic_isotropic()

bool smash::ScatterActionsFinder::is_constant_elastic_isotropic ( ) const
inline

If there is only one particle sort, no decays (only elastic scatterings are possible), scatterings are isotropic and cross-section fixed to elastic_parameter_ independently on momenta, then maximal cross-section is elastic_parameter_.

This knowledge can be used for improving performance.

Returns
A boolean indicating whether all the scatterings are elastic and isotropic

Definition at line 213 of file scatteractionsfinder.h.

213  {
214  return ParticleType::list_all().size() == 1 &&
217  }
static const ParticleTypeList & list_all()
Definition: particletype.cc:51
const bool two_to_one
Enables resonance production.

◆ max_transverse_distance_sqr()

double smash::ScatterActionsFinder::max_transverse_distance_sqr ( int  testparticles) const
inline

The maximal distance over which particles can interact in case of the geometric criterion, related to the number of test particles and the maximal cross section.

Parameters
[in]testparticlesNumber of test particles.
Returns
Maximal transverse distance squared. [fm \(^{2}\)] Particle pairs whose transverse distance is larger than this are not checked for collisions in case of the default geometric collision criterion.

Definition at line 231 of file scatteractionsfinder.h.

231  {
235  testparticles * fm2_mb * M_1_PI;
236  }
constexpr double fm2_mb
mb <-> fm^2 conversion factor.
Definition: constants.h:28

◆ dump_reactions()

void smash::ScatterActionsFinder::dump_reactions ( ) const

Prints out all the 2-> n (n > 1) reactions with non-zero cross-sections between all possible pairs of particle types.

Definition at line 564 of file scatteractionsfinder.cc.

564  {
565  constexpr double time = 0.0;
566 
567  const size_t N_isotypes = IsoParticleType::list_all().size();
568  const size_t N_pairs = N_isotypes * (N_isotypes - 1) / 2;
569 
570  std::cout << N_isotypes << " iso-particle types." << std::endl;
571  std::cout << "They can make " << N_pairs << " pairs." << std::endl;
572  std::vector<double> momentum_scan_list = {0.1, 0.3, 0.5, 1.0,
573  2.0, 3.0, 5.0, 10.0};
574  for (const IsoParticleType& A_isotype : IsoParticleType::list_all()) {
575  for (const IsoParticleType& B_isotype : IsoParticleType::list_all()) {
576  if (&A_isotype > &B_isotype) {
577  continue;
578  }
579  bool any_nonzero_cs = false;
580  std::vector<std::string> r_list;
581  for (const ParticleTypePtr A_type : A_isotype.get_states()) {
582  for (const ParticleTypePtr B_type : B_isotype.get_states()) {
583  if (A_type > B_type) {
584  continue;
585  }
586  ParticleData A(*A_type), B(*B_type);
587  for (auto mom : momentum_scan_list) {
588  A.set_4momentum(A.pole_mass(), mom, 0.0, 0.0);
589  B.set_4momentum(B.pole_mass(), -mom, 0.0, 0.0);
590  ScatterActionPtr act = std::make_unique<ScatterAction>(
591  A, B, time, isotropic_, string_formation_time_, -1, false);
593  act->set_string_interface(string_process_interface_.get());
594  }
595  act->add_all_scatterings(finder_parameters_);
596  const double total_cs = act->cross_section();
597  if (total_cs <= 0.0) {
598  continue;
599  }
600  any_nonzero_cs = true;
601  for (const auto& channel : act->collision_channels()) {
602  const auto type = channel->get_type();
603  std::string r;
604  if (is_string_soft_process(type) ||
605  type == ProcessType::StringHard) {
606  r = A_type->name() + B_type->name() + std::string(" → strings");
607  } else {
608  std::string r_type =
609  (type == ProcessType::Elastic) ? std::string(" (el)")
610  : (channel->get_type() == ProcessType::TwoToTwo)
611  ? std::string(" (inel)")
612  : std::string(" (?)");
613  r = A_type->name() + B_type->name() + std::string(" → ") +
614  channel->particle_types()[0]->name() +
615  channel->particle_types()[1]->name() + r_type;
616  }
617  isoclean(r);
618  r_list.push_back(r);
619  }
620  }
621  }
622  }
623  std::sort(r_list.begin(), r_list.end());
624  r_list.erase(std::unique(r_list.begin(), r_list.end()), r_list.end());
625  if (any_nonzero_cs) {
626  for (auto r : r_list) {
627  std::cout << r;
628  if (r_list.back() != r) {
629  std::cout << ", ";
630  }
631  }
632  std::cout << std::endl;
633  }
634  }
635  }
636 }
static const IsoParticleTypeList & list_all()
Returns a list of all IsoParticleTypes.
@ TwoToTwo
See here for a short description.
@ Elastic
See here for a short description.
@ StringHard
See here for a short description.
void isoclean(std::string &s)
Remove ⁺, ⁻, ⁰ from string.
bool is_string_soft_process(ProcessType p)
Check if a given process type is a soft string excitation.

◆ dump_cross_sections()

void smash::ScatterActionsFinder::dump_cross_sections ( const ParticleType a,
const ParticleType b,
double  m_a,
double  m_b,
bool  final_state,
std::vector< double > &  plab 
) const

Print out partial cross-sections of all processes that can occur in the collision of a(mass = m_a) and b(mass = m_b).

Parameters
[in]aThe specie of the first incoming particle.
[in]bThe specie of the second incoming particle.
[in]m_aMass of species a [GeV].
[in]m_bMass of species b [GeV].
[in]final_stateWhether the final state cross sections should be printed.
[in]plabOptional momenta in lab frame to be evaluated [GeV]. Ignored if empty.

Definition at line 947 of file scatteractionsfinder.cc.

949  {
950  typedef std::vector<std::pair<double, double>> xs_saver;
951  std::map<std::string, xs_saver> xs_dump;
952  std::map<std::string, double> outgoing_total_mass;
953 
954  ParticleData a_data(a), b_data(b);
955  int n_momentum_points = 200;
956  constexpr double momentum_step = 0.02;
957  if (plab.size() > 0) {
958  n_momentum_points = plab.size();
959  // Remove duplicates.
960  std::sort(plab.begin(), plab.end());
961  plab.erase(std::unique(plab.begin(), plab.end()), plab.end());
962  }
963  for (int i = 0; i < n_momentum_points; i++) {
964  double momentum;
965  if (plab.size() > 0) {
966  momentum = pCM_from_s(s_from_plab(plab.at(i), m_a, m_b), m_a, m_b);
967  } else {
968  momentum = momentum_step * (i + 1);
969  }
970  a_data.set_4momentum(m_a, momentum, 0.0, 0.0);
971  b_data.set_4momentum(m_b, -momentum, 0.0, 0.0);
972  const double sqrts = (a_data.momentum() + b_data.momentum()).abs();
973  const ParticleList incoming = {a_data, b_data};
974  ScatterActionPtr act = std::make_unique<ScatterAction>(
975  a_data, b_data, 0., isotropic_, string_formation_time_, -1, false);
977  act->set_string_interface(string_process_interface_.get());
978  }
979  act->add_all_scatterings(finder_parameters_);
980  decaytree::Node tree(a.name() + b.name(), act->cross_section(), {&a, &b},
981  {&a, &b}, {&a, &b}, {});
982  const CollisionBranchList& processes = act->collision_channels();
983  for (const auto& process : processes) {
984  const double xs = process->weight();
985  if (xs <= 0.0) {
986  continue;
987  }
988  if (!final_state) {
989  std::stringstream process_description_stream;
990  process_description_stream << *process;
991  const std::string& description = process_description_stream.str();
992  double m_tot = 0.0;
993  for (const auto& ptype : process->particle_types()) {
994  m_tot += ptype->mass();
995  }
996  outgoing_total_mass[description] = m_tot;
997  if (!xs_dump[description].empty() &&
998  std::abs(xs_dump[description].back().first - sqrts) <
999  really_small) {
1000  xs_dump[description].back().second += xs;
1001  } else {
1002  xs_dump[description].push_back(std::make_pair(sqrts, xs));
1003  }
1004  } else {
1005  std::stringstream process_description_stream;
1006  process_description_stream << *process;
1007  const std::string& description = process_description_stream.str();
1008  ParticleTypePtrList initial_particles = {&a, &b};
1009  ParticleTypePtrList final_particles = process->particle_types();
1010  auto& process_node =
1011  tree.add_action(description, xs, std::move(initial_particles),
1012  std::move(final_particles));
1013  decaytree::add_decays(process_node, sqrts);
1014  }
1015  }
1016  xs_dump["total"].push_back(std::make_pair(sqrts, act->cross_section()));
1017  // Total cross-section should be the first in the list -> negative mass
1018  outgoing_total_mass["total"] = -1.0;
1019  if (final_state) {
1020  // tree.print();
1021  auto final_state_xs = tree.final_state_cross_sections();
1022  deduplicate(final_state_xs);
1023  for (const auto& p : final_state_xs) {
1024  // Don't print empty columns.
1025  //
1026  // FIXME(steinberg): The better fix would be to not have them in the
1027  // first place.
1028  if (p.name_ == "") {
1029  continue;
1030  }
1031  outgoing_total_mass[p.name_] = p.mass_;
1032  xs_dump[p.name_].push_back(std::make_pair(sqrts, p.cross_section_));
1033  }
1034  }
1035  }
1036  // Get rid of cross sections that are zero.
1037  // (This only happens if their is a resonance in the final state that cannot
1038  // decay with our simplified assumptions.)
1039  for (auto it = begin(xs_dump); it != end(xs_dump);) {
1040  // Sum cross section over all energies.
1041  const xs_saver& xs = (*it).second;
1042  double sum = 0;
1043  for (const auto& p : xs) {
1044  sum += p.second;
1045  }
1046  if (sum == 0.) {
1047  it = xs_dump.erase(it);
1048  } else {
1049  ++it;
1050  }
1051  }
1052 
1053  // Nice ordering of channels by summed pole mass of products
1054  std::vector<std::string> all_channels;
1055  for (const auto& channel : xs_dump) {
1056  all_channels.push_back(channel.first);
1057  }
1058  std::sort(all_channels.begin(), all_channels.end(),
1059  [&](const std::string& str_a, const std::string& str_b) {
1060  return outgoing_total_mass[str_a] < outgoing_total_mass[str_b];
1061  });
1062 
1063  // Print header
1064  std::cout << "# Dumping partial " << a.name() << b.name()
1065  << " cross-sections in mb, energies in GeV" << std::endl;
1066  std::cout << " sqrt_s";
1067  // Align everything to 24 unicode characters.
1068  // This should be enough for the longest channel name: 7 final-state
1069  // particles, or 2 of the longest named resonances (currently Ds0*(2317)⁺).
1070  for (const auto& channel : all_channels) {
1071  std::cout << utf8::fill_left(channel, 24, ' ');
1072  }
1073  std::cout << std::endl;
1074 
1075  // Print out all partial cross-sections in mb
1076  for (int i = 0; i < n_momentum_points; i++) {
1077  double momentum;
1078  if (plab.size() > 0) {
1079  momentum = pCM_from_s(s_from_plab(plab.at(i), m_a, m_b), m_a, m_b);
1080  } else {
1081  momentum = momentum_step * (i + 1);
1082  }
1083  a_data.set_4momentum(m_a, momentum, 0.0, 0.0);
1084  b_data.set_4momentum(m_b, -momentum, 0.0, 0.0);
1085  const double sqrts = (a_data.momentum() + b_data.momentum()).abs();
1086  std::printf("%9.6f", sqrts);
1087  for (const auto& channel : all_channels) {
1088  const xs_saver energy_and_xs = xs_dump[channel];
1089  size_t j = 0;
1090  for (; j < energy_and_xs.size() && energy_and_xs[j].first < sqrts; j++) {
1091  }
1092  double xs = 0.0;
1093  if (j < energy_and_xs.size() &&
1094  std::abs(energy_and_xs[j].first - sqrts) < really_small) {
1095  xs = energy_and_xs[j].second;
1096  }
1097  std::printf("%16.6f", xs); // Same alignment as in the header.
1098  }
1099  std::printf("\n");
1100  }
1101 }
static void add_decays(Node &node, double sqrts)
Add nodes for all decays possible from the given node and all of its children.
std::string fill_left(const std::string &s, size_t width, char fill=' ')
Fill string with characters to the left until the given width is reached.
static void deduplicate(std::vector< FinalStateCrossSection > &final_state_xs)
Deduplicate the final-state cross sections by summing.
T pCM_from_s(const T s, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:66
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

◆ get_process_string_ptr()

StringProcess* smash::ScatterActionsFinder::get_process_string_ptr ( )
inline
Returns
Pointer to the string process class object. If string is turned off, the null pointer is returned.

Definition at line 265 of file scatteractionsfinder.h.

265  {
267  return string_process_interface_.get();
268  } else {
269  return NULL;
270  }
271  }

◆ check_collision_two_part()

ActionPtr smash::ScatterActionsFinder::check_collision_two_part ( const ParticleData data_a,
const ParticleData data_b,
double  dt,
const std::vector< FourVector > &  beam_momentum = {},
const double  gcell_vol = 0.0 
) const
private

Check for a single pair of particles (id_a, id_b) if a collision will happen in the next timestep and create a corresponding Action object in that case.

Two criteria for the collision decision are supported: 1. The default geometric criterion from UrQMD Bass:1998ca [6] (3.27). 2. A stochastic collision criterion as introduced in Staudenmaier:2021lrg [59].

Parameters
[in]data_aFirst incoming particle
[in]data_bSecond incoming particle
[in]dtMaximum time interval within which a collision can happen
[in]beam_momentum[GeV] List of beam momenta for each particle; only necessary for frozen Fermi motion
[in]gcell_vol(optional) volume of grid cell in which the collision is checked
Returns
A null pointer if no collision happens or an action which contains the information of the outgoing particles.

Note: gcell_vol is optional, since only find_actions_in_cell has (and needs) this information for the stochastic collision criterion.

Definition at line 216 of file scatteractionsfinder.cc.

219  {
220  /* If the two particles
221  * 1) belong to one of the two colliding nuclei, and
222  * 2) both of them have never experienced any collisions,
223  * then the collisions between them are banned. */
225  assert(data_a.id() >= 0);
226  assert(data_b.id() >= 0);
227  bool in_same_nucleus = (data_a.belongs_to() == BelongsTo::Projectile &&
228  data_b.belongs_to() == BelongsTo::Projectile) ||
229  (data_a.belongs_to() == BelongsTo::Target &&
230  data_b.belongs_to() == BelongsTo::Target);
231  bool never_interacted_before =
232  data_a.get_history().collisions_per_particle == 0 &&
233  data_b.get_history().collisions_per_particle == 0;
234  if (in_same_nucleus && never_interacted_before) {
235  return nullptr;
236  }
237  }
238 
239  // No grid or search in cell means no collision for stochastic criterion
241  gcell_vol < really_small) {
242  return nullptr;
243  }
244 
245  // Determine time of collision.
246  const double time_until_collision =
247  collision_time(data_a, data_b, dt, beam_momentum);
248 
249  // Check that collision happens in this timestep.
250  if (time_until_collision < 0. || time_until_collision >= dt) {
251  return nullptr;
252  }
253 
254  // Determine which total cross section to use
255  bool incoming_parametrized = (finder_parameters_.total_xs_strategy ==
259  const PdgCode& pdg_a = data_a.type().pdgcode();
260  const PdgCode& pdg_b = data_b.type().pdgcode();
261  incoming_parametrized = parametrization_exists(pdg_a, pdg_b);
262  }
263 
264  // Create ScatterAction object.
265  ScatterActionPtr act = std::make_unique<ScatterAction>(
266  data_a, data_b, time_until_collision, isotropic_, string_formation_time_,
267  box_length_, incoming_parametrized);
268 
270  act->set_stochastic_pos_idx();
271  }
272 
274  act->set_string_interface(string_process_interface_.get());
275  }
276 
277  // Distance squared calculation not needed for stochastic criterion
278  const double distance_squared =
280  ? act->transverse_distance_sqr()
282  ? act->cov_transverse_distance_sqr()
283  : 0.0;
284 
285  // Don't calculate cross section if the particles are very far apart.
286  // Not needed for stochastic criterion because of cell structure.
288  distance_squared >=
290  return nullptr;
291  }
292 
293  if (incoming_parametrized) {
294  act->set_parametrized_total_cross_section(finder_parameters_);
295  } else {
296  // Add various subprocesses.
297  act->add_all_scatterings(finder_parameters_);
298  }
299 
300  double xs = act->cross_section() * fm2_mb /
301  static_cast<double>(finder_parameters_.testparticles);
302 
303  // Take cross section scaling factors into account
304  xs *= data_a.xsec_scaling_factor(time_until_collision);
305  xs *= data_b.xsec_scaling_factor(time_until_collision);
306 
308  const double v_rel = act->relative_velocity();
309  /* Collision probability for 2-particle scattering, see
310  * \iref{Staudenmaier:2021lrg}. */
311  const double prob = xs * v_rel * dt / gcell_vol;
312 
313  logg[LFindScatter].debug(
314  "Stochastic collison criterion parameters (2-particles):\nprob = ",
315  prob, ", xs = ", xs, ", v_rel = ", v_rel, ", dt = ", dt,
316  ", gcell_vol = ", gcell_vol,
317  ", testparticles = ", finder_parameters_.testparticles);
318 
319  if (prob > 1.) {
320  std::stringstream err;
321  err << "Probability larger than 1 for stochastic rates. ( P_22 = " << prob
322  << " )\n"
323  << data_a.type().name() << data_b.type().name() << " with masses "
324  << data_a.momentum().abs() << " and " << data_b.momentum().abs()
325  << " at sqrts[GeV] = " << act->sqrt_s()
326  << " with xs[fm^2]/Ntest = " << xs
327  << "\nConsider using smaller timesteps.";
329  logg[LFindScatter].warn(err.str());
330  } else {
331  throw std::runtime_error(err.str());
332  }
333  }
334 
335  // probability criterion
336  double random_no = random::uniform(0., 1.);
337  if (random_no > prob) {
338  return nullptr;
339  }
340 
343  // just collided with this particle
344  if (data_a.id_process() > 0 && data_a.id_process() == data_b.id_process()) {
345  logg[LFindScatter].debug("Skipping collided particles at time ",
346  data_a.position().x0(), " due to process ",
347  data_a.id_process(), "\n ", data_a, "\n<-> ",
348  data_b);
349 
350  return nullptr;
351  }
352 
353  // Cross section for collision criterion
354  const double cross_section_criterion = xs * M_1_PI;
355 
356  // distance criterion according to cross_section
357  if (distance_squared >= cross_section_criterion) {
358  return nullptr;
359  }
360 
361  logg[LFindScatter].debug("particle distance squared: ", distance_squared,
362  "\n ", data_a, "\n<-> ", data_b);
363  }
364 
365  // Include possible outgoing branches
366  if (incoming_parametrized) {
367  act->add_all_scatterings(finder_parameters_);
368  }
369 
370  return act;
371 }
const bool only_warn_for_high_prob
Switch to turn off throwing an exception for collision probabilities larger than 1.
const int testparticles
Number of test particles.
const TotalCrossSectionStrategy total_xs_strategy
Method used to evaluate total cross sections for collision finding.
const bool allow_collisions_within_nucleus
If particles within the same nucleus are allowed to collide for their first time.
double max_transverse_distance_sqr(int testparticles) const
The maximal distance over which particles can interact in case of the geometric criterion,...
double collision_time(const ParticleData &p1, const ParticleData &p2, double dt, const std::vector< FourVector > &beam_momentum) const
Determine the collision time of the two particles.
@ TopDownMeasured
Mix the two above, using the parametrizations only for measured processes, and summing up partials fo...
@ TopDown
Use parametrizations based on existing data, rescaling with AQM for unmeasured processes.
@ Geometric
Geometric criterion.
bool parametrization_exists(const PdgCode &pdg_a, const PdgCode &pdg_b)
Checks if supplied codes have existing parametrizations of total cross sections.

◆ check_collision_multi_part()

ActionPtr smash::ScatterActionsFinder::check_collision_multi_part ( const ParticleList &  plist,
double  dt,
const double  gcell_vol 
) const
private

Check for multiple i.e.

more than 2 particles if a collision will happen in the next timestep and create a corresponding Action object in that case.

This is only possible for the stochastic collision criterion, which is introduced in Staudenmaier:2021lrg [59]. Following the same general idea as for the 2-particle scatterings, probabilities for multi-particle scatterings can be derived.

Parameters
[in]plistList of incoming particles
[in]dtMaximum time interval within which a collision can happen
[in]gcell_volvolume of grid cell in which the collision is checked
Returns
A null pointer if no collision happens or an action which contains the information of the outgoing particles.

Definition at line 373 of file scatteractionsfinder.cc.

374  {
375  /* If all particles
376  * 1) belong to the two colliding nuclei
377  * 2) are within the same nucleus
378  * 3) have never experienced any collisons,
379  * then the collision between them are banned also for multi-particle
380  * interactions. */
382  bool all_projectile =
383  std::all_of(plist.begin(), plist.end(), [&](const ParticleData& data) {
384  return data.belongs_to() == BelongsTo::Projectile;
385  });
386  bool all_target =
387  std::all_of(plist.begin(), plist.end(), [&](const ParticleData& data) {
388  return data.belongs_to() == BelongsTo::Target;
389  });
390  bool none_collided =
391  std::all_of(plist.begin(), plist.end(), [&](const ParticleData& data) {
392  return data.get_history().collisions_per_particle == 0;
393  });
394  if ((all_projectile || all_target) && none_collided) {
395  return nullptr;
396  }
397  }
398  // No grid or search in cell
399  if (gcell_vol < really_small) {
400  return nullptr;
401  }
402 
403  /* Optimisation for later: Already check here at the beginning
404  * if collision with plist is possible before constructing actions. */
405 
406  // 1. Determine time of collision.
407  const double time_until_collision = dt * random::uniform(0., 1.);
408 
409  // 2. Create ScatterAction object.
410  ScatterActionMultiPtr act =
411  std::make_unique<ScatterActionMulti>(plist, time_until_collision);
412 
413  act->set_stochastic_pos_idx();
414 
415  // 3. Add possible final states (dt and gcell_vol for probability calculation)
416  act->add_possible_reactions(dt, gcell_vol, finder_parameters_.included_multi);
417 
418  /* 4. Return total collision probability
419  * Scales with 1 over the number of testpartciles to the power of the
420  * number of incoming particles - 1 */
421  const double prob =
422  act->get_total_weight() /
423  std::pow(finder_parameters_.testparticles, plist.size() - 1);
424 
425  // 5. Check that probability is smaller than one
426  if (prob > 1.) {
427  std::stringstream err;
428  err << "Probability " << prob << " larger than 1 for stochastic rates for ";
429  for (const ParticleData& data : plist) {
430  err << data.type().name();
431  }
432  err << " at sqrts[GeV] = " << act->sqrt_s()
433  << "\nConsider using smaller timesteps.";
435  logg[LFindScatter].warn(err.str());
436  } else {
437  throw std::runtime_error(err.str());
438  }
439  }
440 
441  // 6. Perform probability decisions
442  double random_no = random::uniform(0., 1.);
443  if (random_no > prob) {
444  return nullptr;
445  }
446 
447  return act;
448 }
bool all_of(Container &&c, UnaryPredicate &&p)
Convenience wrapper for std::all_of that operates on a complete container.
Definition: algorithms.h:80

Member Data Documentation

◆ finder_parameters_

ScatterActionsFinderParameters smash::ScatterActionsFinder::finder_parameters_
private

Struct collecting several parameters.

Definition at line 320 of file scatteractionsfinder.h.

◆ string_process_interface_

std::unique_ptr<StringProcess> smash::ScatterActionsFinder::string_process_interface_
private

Class that deals with strings, interfacing Pythia.

Definition at line 322 of file scatteractionsfinder.h.

◆ isotropic_

const bool smash::ScatterActionsFinder::isotropic_
private

Do all collisions isotropically.

Definition at line 324 of file scatteractionsfinder.h.

◆ box_length_

const double smash::ScatterActionsFinder::box_length_
private

Box length: needed to determine coordinates of collision correctly in case of collision through the wall.

Ignored if negative.

Definition at line 330 of file scatteractionsfinder.h.

◆ string_formation_time_

const double smash::ScatterActionsFinder::string_formation_time_
private

Parameter for formation time.

Definition at line 332 of file scatteractionsfinder.h.


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