Version: SMASH-3.3
scatteraction.cc
Go to the documentation of this file.
1 /*
2  *
3  * Copyright (c) 2014-2025
4  * SMASH Team
5  *
6  * GNU General Public License (GPLv3 or later)
7  *
8  */
9 
10 #include "smash/scatteraction.h"
11 
12 #include <cmath>
13 
14 #include "Pythia8/Pythia.h"
15 
16 #include "smash/angles.h"
17 #include "smash/constants.h"
18 #include "smash/crosssections.h"
19 #include "smash/fpenvironment.h"
20 #include "smash/logging.h"
21 #include "smash/pdgcode.h"
22 #include "smash/pow.h"
23 #include "smash/random.h"
24 
25 namespace smash {
26 static constexpr int LScatterAction = LogArea::ScatterAction::id;
27 
29  const ParticleData &in_part_b, const double time,
30  const bool isotropic,
31  const double string_formation_time,
32  const double box_length,
33  const bool is_total_parametrized,
34  const SpinInteractionType spin_interaction_type)
35  : Action({in_part_a, in_part_b}, time),
36  sum_of_partial_cross_sections_(0.),
37  isotropic_(isotropic),
38  string_formation_time_(string_formation_time),
39  is_total_parametrized_(is_total_parametrized),
40  spin_interaction_type_(spin_interaction_type) {
41  box_length_ = box_length;
42  if (is_total_parametrized_) {
43  parametrized_total_cross_section_ = smash_NaN<double>;
44  }
45 }
46 
47 void ScatterAction::add_collision(CollisionBranchPtr p) {
48  add_process<CollisionBranch>(p, collision_channels_,
50 }
51 
52 void ScatterAction::add_collisions(CollisionBranchList pv) {
53  add_processes<CollisionBranch>(std::move(pv), collision_channels_,
55 }
56 
58  logg[LScatterAction].debug("Incoming particles: ", incoming_particles_);
59 
60  const CollisionBranch *proc = choose_channel<CollisionBranch>(
64  process_type_ = proc->get_type();
67 
68  logg[LScatterAction].debug("Chosen channel: ", process_type_,
70 
71  /* The production point of the new particles. */
72  FourVector middle_point = get_interaction_point();
73 
74  switch (process_type_) {
76  /* 2->2 elastic scattering */
79  break;
81  /* resonance formation */
83  break;
85  /* 2->2 inelastic scattering */
86  /* Sample the particle momenta in CM system. */
89  break;
93  /* 2->m scattering */
95  break;
104  break;
105  default:
106  throw InvalidScatterAction(
107  "ScatterAction::generate_final_state: Invalid process type " +
108  std::to_string(static_cast<int>(process_type_)) + " was requested. " +
109  "(PDGcode1=" + incoming_particles_[0].pdgcode().string() +
110  ", PDGcode2=" + incoming_particles_[1].pdgcode().string() + ")");
111  }
112 
113  const bool core_in_incoming =
114  std::any_of(incoming_particles_.begin(), incoming_particles_.end(),
115  [](const ParticleData &p) { return p.is_core(); });
116  for (ParticleData &new_particle : outgoing_particles_) {
117  // Boost to the computational frame
118  new_particle.boost_momentum(
120  /* Set positions of the outgoing particles */
121  if (proc->get_type() != ProcessType::Elastic) {
122  new_particle.set_4position(middle_point);
123  if (core_in_incoming) {
124  new_particle.fluidize();
125  }
126  if (new_particle.type().pdgcode().is_heavy_flavor()) {
127  // Particle weight is the product of incoming weights
128  const double perturbative_weight = std::accumulate(
129  incoming_particles_.begin(), incoming_particles_.end(), 1.0,
130  [](double w, const ParticleData &p) {
131  return w * p.perturbative_weight();
132  });
133  new_particle.set_perturbative_weight(perturbative_weight);
134  }
135  }
136  }
137 }
138 
140  const ScatterActionsFinderParameters &finder_parameters) {
141  if (were_processes_added_) {
142  logg[LScatterAction].fatal() << "Trying to add processes again.";
143  throw std::logic_error(
144  "add_all_scatterings should be called only once per ScatterAction "
145  "instance");
146  } else {
147  were_processes_added_ = true;
148  }
151  CollisionBranchList processes =
152  xs.generate_collision_list(finder_parameters, string_process_);
153 
154  /* Add various subprocesses.*/
155  add_collisions(std::move(processes));
156 
157  /* If the string processes are not triggered by a probability, then they
158  * always happen as long as the parametrized total cross section is larger
159  * than the sum of the cross sections of the non-string processes, and the
160  * square root s exceeds the threshold by at least 0.9 GeV. The cross section
161  * of the string processes are counted by taking the difference between the
162  * parametrized total and the sum of the non-strings. */
163  if (!finder_parameters.strings_with_probability &&
164  xs.string_probability(finder_parameters) > 0) {
165  const double xs_diff =
166  xs.high_energy(finder_parameters) - sum_of_partial_cross_sections_;
167  if (xs_diff > 0.) {
169  xs.string_excitation(xs_diff, string_process_, finder_parameters));
170  }
171  }
172 
173  ParticleTypePtr pseudoresonance =
175  finder_parameters.transition_high_energy);
176  if (pseudoresonance && finder_parameters.two_to_one) {
177  const double xs_total = is_total_parametrized_
179  : xs.high_energy(finder_parameters);
180  const double xs_gap = xs_total - sum_of_partial_cross_sections_;
181  // The pseudo-resonance is only created if there is a (positive) cross
182  // section gap
183  if (xs_gap > really_small) {
184  auto pseudoresonance_branch = std::make_unique<CollisionBranch>(
185  *pseudoresonance, xs_gap, ProcessType::TwoToOne);
186  add_collision(std::move(pseudoresonance_branch));
187  logg[LScatterAction].debug()
188  << "Pseudoresonance between " << incoming_particles_[0].type().name()
189  << " and " << incoming_particles_[1].type().name() << "is"
190  << pseudoresonance->name() << " with cross section " << xs_gap
191  << "mb.";
192  }
193  }
194  were_processes_added_ = true;
195  // Rescale the branches so that their sum matches the parametrization
198  }
199 }
200 
202  if (!were_processes_added_) {
203  logg[LScatterAction].fatal()
204  << "Trying to rescale branches before adding processes.";
205  throw std::logic_error(
206  "This function can only be called after having added processes.");
207  }
209  const ParticleTypePtr type_a = &incoming_particles_[0].type();
210  const ParticleTypePtr type_b = &incoming_particles_[1].type();
211  // This is a std::set instead of std::pair because the order of particles
212  // does not matter here
213  const std::set<ParticleTypePtr> pair{type_a, type_b};
214  if (!warned_no_rescaling_available.count(pair)) {
215  logg[LScatterAction].warn()
216  << "Total cross section between " << type_a->name() << " and "
217  << type_b->name() << "is roughly zero at sqrt(s) = " << sqrt_s()
218  << " GeV, and no rescaling to match the parametrized value will be "
219  "done.\nAn elastic process will be added, instead, to match the "
220  "total cross section.\nFor this pair of particles, this warning "
221  "will be subsequently suppressed.";
222  warned_no_rescaling_available.insert(pair);
223  }
224  auto elastic_branch = std::make_unique<CollisionBranch>(
225  *type_a, *type_b, *parametrized_total_cross_section_,
227  add_collision(std::move(elastic_branch));
228  } else {
229  const double reweight =
231  logg[LScatterAction].debug("Reweighting ", sum_of_partial_cross_sections_,
233  for (auto &proc : collision_channels_) {
234  proc->set_weight(proc->weight() * reweight);
235  }
236  }
237 }
238 
240  const PseudoResonance method,
241  const StringTransitionParameters &transition) const {
242  const ParticleTypePtr type_a = &incoming_particles_[0].type();
243  const ParticleTypePtr type_b = &incoming_particles_[1].type();
244  const double desired_mass = sqrt_s();
245 
246  double string_offset = 0.5 * transition.sqrts_add_lower;
247  const bool nucleon_and_pion = (type_a->is_nucleon() && type_b->is_pion()) ||
248  (type_a->is_pion() && type_b->is_nucleon());
249  const bool two_nucleons = type_a->is_nucleon() && type_b->is_nucleon();
250  const bool two_pions = type_a->is_pion() && type_b->is_pion();
251  const bool nucleon_and_kaon = (type_a->is_nucleon() && type_b->is_kaon()) ||
252  (type_a->is_kaon() && type_b->is_nucleon());
253  if (nucleon_and_pion) {
254  string_offset = transition.sqrts_range_Npi.first - pion_mass - nucleon_mass;
255  } else if (two_nucleons) {
256  string_offset = transition.sqrts_range_NN.first - 2 * nucleon_mass;
257  } else if (two_pions) {
258  string_offset = transition.pipi_offset;
259  } else if (nucleon_and_kaon) {
260  string_offset = transition.KN_offset;
261  }
262  /*
263  * Artificial cutoff to create a pseudo-resonance only close to the string
264  * transition, where data or first-principle models are unhelpful
265  */
266  if (desired_mass < incoming_particles_[0].effective_mass() +
267  incoming_particles_[1].effective_mass() +
268  string_offset) {
269  return {};
270  }
271 
272  if (method == PseudoResonance::None) {
273  return {};
274  } else if (method == PseudoResonance::LargestFromUnstable ||
276  if (type_a->is_stable() && type_b->is_stable()) {
277  return {};
278  }
279  }
280 
281  // If this list is empty, there are no possible pseudo-resonances.
282  ParticleTypePtrList list = list_possible_resonances(type_a, type_b);
283  if (std::empty(list)) {
284  return {};
285  }
286 
287  if (method == PseudoResonance::Largest ||
289  auto largest = *std::max_element(list.begin(), list.end(),
291  return a->mass() < b->mass();
292  });
293  return largest;
294  } else if (method == PseudoResonance::Closest ||
296  auto comparison = [&desired_mass](ParticleTypePtr a, ParticleTypePtr b) {
297  return std::abs(a->mass() - desired_mass) <
298  std::abs(b->mass() - desired_mass);
299  };
300  auto closest = *std::min_element(list.begin(), list.end(), comparison);
301  return closest;
302  } else {
303  throw std::logic_error("Unknown method for selecting pseudoresonance.");
304  }
305 }
306 
308  const ScatterActionsFinderParameters &finder_parameters) {
311 
314  xs.parametrized_total(finder_parameters);
315  } else {
316  logg[LScatterAction].fatal()
317  << "Trying to parametrize total cross section when it shouldn't be.";
318  throw std::logic_error(
319  "This function can only be called on ScatterAction objects with "
320  "parametrized cross section.");
321  }
322 }
323 
326  incoming_particles_[0].xsec_scaling_factor() *
327  incoming_particles_[1].xsec_scaling_factor();
328 }
329 
331  return partial_cross_section_ * incoming_particles_[0].xsec_scaling_factor() *
332  incoming_particles_[1].xsec_scaling_factor();
333 }
334 
336  return total_momentum().velocity();
337 }
338 
339 double ScatterAction::gamma_cm() const {
340  return (1. / std::sqrt(1.0 - beta_cm().sqr()));
341 }
342 
343 double ScatterAction::mandelstam_s() const { return total_momentum().sqr(); }
344 
346  const double m1 = incoming_particles_[0].effective_mass();
347  const double m2 = incoming_particles_[1].effective_mass();
348  return pCM(sqrt_s(), m1, m2);
349 }
350 
352  const double m1 = incoming_particles_[0].effective_mass();
353  const double m2 = incoming_particles_[1].effective_mass();
354  return pCM_sqr(sqrt_s(), m1, m2);
355 }
356 
358  const double m1 = incoming_particles()[0].effective_mass();
359  const double m2 = incoming_particles()[1].effective_mass();
360  const double m_s = mandelstam_s();
361  const double lamb = lambda_tilde(m_s, m1 * m1, m2 * m2);
362  return std::sqrt(lamb) / (2. * incoming_particles()[0].momentum().x0() *
363  incoming_particles()[1].momentum().x0());
364 }
365 
367  // local copy of particles (since we need to boost them)
370  /* Boost particles to center-of-momentum frame. */
371  const ThreeVector velocity = beta_cm();
372  p_a.boost(velocity);
373  p_b.boost(velocity);
374  const ThreeVector pos_diff =
375  p_a.position().threevec() - p_b.position().threevec();
376  const ThreeVector mom_diff =
377  p_a.momentum().threevec() - p_b.momentum().threevec();
378 
379  logg[LScatterAction].debug("Particle ", incoming_particles_,
380  " position difference [fm]: ", pos_diff,
381  ", momentum difference [GeV]: ", mom_diff);
382 
383  const double dp2 = mom_diff.sqr();
384  const double dr2 = pos_diff.sqr();
385  /* Zero momentum leads to infite distance. */
386  if (dp2 < really_small) {
387  return dr2;
388  }
389  const double dpdr = pos_diff * mom_diff;
390 
391  /* UrQMD squared distance criterion, in the center of momentum frame:
392  * position of particle a: x_a
393  * position of particle b: x_b
394  * momentum of particle a: p_a
395  * momentum of particle b: p_b
396  * d^2_{coll} = (x_a - x_b)^2 - ((x_a - x_b) . (p_a - p_b))^2 / (p_a - p_b)^2
397  */
398  const double result = dr2 - dpdr * dpdr / dp2;
399  return result > 0.0 ? result : 0.0;
400 }
401 
403  // local copy of particles (since we need to boost them)
406 
407  const FourVector delta_x = p_a.position() - p_b.position();
408  const double mom_diff_sqr =
409  (p_a.momentum().threevec() - p_b.momentum().threevec()).sqr();
410  const double x_sqr = delta_x.sqr();
411 
412  if (mom_diff_sqr < really_small) {
413  return -x_sqr;
414  }
415 
416  const double p_a_sqr = p_a.momentum().sqr();
417  const double p_b_sqr = p_b.momentum().sqr();
418  const double p_a_dot_x = p_a.momentum().Dot(delta_x);
419  const double p_b_dot_x = p_b.momentum().Dot(delta_x);
420  const double p_a_dot_p_b = p_a.momentum().Dot(p_b.momentum());
421 
422  const double b_sqr =
423  -x_sqr -
424  (p_a_sqr * std::pow(p_b_dot_x, 2) + p_b_sqr * std::pow(p_a_dot_x, 2) -
425  2 * p_a_dot_p_b * p_a_dot_x * p_b_dot_x) /
426  (std::pow(p_a_dot_p_b, 2) - p_a_sqr * p_b_sqr);
427  return b_sqr > 0.0 ? b_sqr : 0.0;
428 }
429 
438 static double high_energy_bpp(double plab) {
439  double mandelstam_s = s_from_plab(plab, nucleon_mass, nucleon_mass);
440  return 7.6 + 0.66 * std::log(mandelstam_s);
441 }
442 
455 static double Cugnon_bpp(double plab) {
456  if (plab < 2.) {
457  double p8 = pow_int(plab, 8);
458  return 5.5 * p8 / (7.7 + p8);
459  } else {
460  return std::min(high_energy_bpp(plab), 5.334 + 0.67 * (plab - 2.));
461  }
462 }
463 
474 static double Cugnon_bnp(double plab) {
475  if (plab < 0.225) {
476  return 0.;
477  } else if (plab < 0.6) {
478  return 16.53 * (plab - 0.225);
479  } else if (plab < 1.6) {
480  return -1.63 * plab + 7.16;
481  } else {
482  return Cugnon_bpp(plab);
483  }
484 }
485 
486 void ScatterAction::sample_angles(std::pair<double, double> masses,
487  double kinetic_energy_cm) {
490  // We potentially have more than two particles, so the following angular
491  // distributions don't work. Instead we just keep the angular
492  // distributions generated by string fragmentation.
493  return;
494  }
495  assert(outgoing_particles_.size() == 2);
496 
497  // NN scattering is anisotropic currently
498  const bool nn_scattering = incoming_particles_[0].type().is_nucleon() &&
499  incoming_particles_[1].type().is_nucleon();
500  /* Elastic process is anisotropic and
501  * the angular distribution is based on the NN elastic scattering. */
502  const bool el_scattering = process_type_ == ProcessType::Elastic;
503 
504  const double mass_in_a = incoming_particles_[0].effective_mass();
505  const double mass_in_b = incoming_particles_[1].effective_mass();
506 
509 
510  const double mass_a = masses.first;
511  const double mass_b = masses.second;
512 
513  const std::array<double, 2> t_range = get_t_range<double>(
514  kinetic_energy_cm, mass_in_a, mass_in_b, mass_a, mass_b);
515  Angles phitheta;
516  if (el_scattering && !isotropic_) {
520  double mandelstam_s_new = 0.;
521  if (nn_scattering) {
522  mandelstam_s_new = mandelstam_s();
523  } else {
524  /* In the case of elastic collisions other than NN collisions,
525  * there is an ambiguity on how to get the lab-frame momentum (plab),
526  * since the incoming particles can have different masses.
527  * Right now, we first obtain the center-of-mass momentum
528  * of the collision (pcom_now).
529  * Then, the lab-frame momentum is evaluated from the mandelstam s,
530  * which yields the original center-of-mass momentum
531  * when nucleon mass is assumed. */
532  const double pcm_now = pCM_from_s(mandelstam_s(), mass_in_a, mass_in_b);
533  mandelstam_s_new =
534  4. * std::sqrt(pcm_now * pcm_now + nucleon_mass * nucleon_mass);
535  }
536  double bb, a, plab = plab_from_s(mandelstam_s_new);
537  if (nn_scattering &&
538  p_a->pdgcode().antiparticle_sign() ==
539  p_b->pdgcode().antiparticle_sign() &&
540  std::abs(p_a->type().charge() + p_b->type().charge()) == 1) {
541  // proton-neutron and antiproton-antineutron
542  bb = std::max(Cugnon_bnp(plab), really_small);
543  a = (plab < 0.8) ? 1. : 0.64 / (plab * plab);
544  } else {
545  /* all others including pp, nn and AQM elastic processes
546  * This is applied for all particle pairs, which are allowed to
547  * interact elastically. */
548  bb = std::max(Cugnon_bpp(plab), really_small);
549  a = 1.;
550  }
551  double t = random::expo(bb, t_range[0], t_range[1]);
552  if (random::canonical() > 1. / (1. + a)) {
553  t = t_range[0] + t_range[1] - t;
554  }
555  // determine scattering angles in center-of-mass frame
556  phitheta = Angles(2. * M_PI * random::canonical(),
557  1. - 2. * (t - t_range[0]) / (t_range[1] - t_range[0]));
558  } else if (nn_scattering && p_a->pdgcode().is_Delta() &&
559  p_b->pdgcode().is_nucleon() &&
560  p_a->pdgcode().antiparticle_sign() ==
561  p_b->pdgcode().antiparticle_sign() &&
562  !isotropic_) {
566  const double plab = plab_from_s(mandelstam_s());
567  const double bb = std::max(Cugnon_bpp(plab), really_small);
568  double t = random::expo(bb, t_range[0], t_range[1]);
569  if (random::canonical() > 0.5) {
570  t = t_range[0] + t_range[1] - t; // symmetrize
571  }
572  phitheta = Angles(2. * M_PI * random::canonical(),
573  1. - 2. * (t - t_range[0]) / (t_range[1] - t_range[0]));
574  } else if (nn_scattering && p_b->pdgcode().is_nucleon() && !isotropic_ &&
575  (p_a->type().is_Nstar() || p_a->type().is_Deltastar())) {
577  const std::array<double, 4> p{1.46434, 5.80311, -6.89358, 1.94302};
578  const double a = p[0] + mass_a * (p[1] + mass_a * (p[2] + mass_a * p[3]));
579  /* If the resonance is so heavy that the index "a" exceeds 30,
580  * the power function turns out to be too sharp. Take t directly to be
581  * t_0 in such a case. */
582  double t = t_range[0];
583  if (a < 30) {
584  t = random::power(-a, t_range[0], t_range[1]);
585  }
586  if (random::canonical() > 0.5) {
587  t = t_range[0] + t_range[1] - t; // symmetrize
588  }
589  phitheta = Angles(2. * M_PI * random::canonical(),
590  1. - 2. * (t - t_range[0]) / (t_range[1] - t_range[0]));
591  } else {
592  /* isotropic angular distribution */
593  phitheta.distribute_isotropically();
594  }
595 
596  ThreeVector pscatt = phitheta.threevec();
597  // 3-momentum of first incoming particle in center-of-mass frame
598  ThreeVector pcm =
599  incoming_particles_[0].momentum().lorentz_boost(beta_cm()).threevec();
600  pscatt.rotate_z_axis_to(pcm);
601 
602  // final-state CM momentum
603  const double p_f = pCM(kinetic_energy_cm, mass_a, mass_b);
604  if (!(p_f > 0.0)) {
605  logg[LScatterAction].warn("Particle: ", p_a->pdgcode(),
606  " radial momentum: ", p_f);
607  logg[LScatterAction].warn("Etot: ", kinetic_energy_cm, " m_a: ", mass_a,
608  " m_b: ", mass_b);
609  }
610  p_a->set_4momentum(mass_a, pscatt * p_f);
611  p_b->set_4momentum(mass_b, -pscatt * p_f);
612 
613  /* Debug message is printed before boost, so that p_a and p_b are
614  * the momenta in the center of mass frame and thus opposite to
615  * each other.*/
616  logg[LScatterAction].debug("p_a: ", *p_a, "\np_b: ", *p_b);
617 }
618 
620  // copy initial particles into final state
623  // resample momenta
624  sample_angles({outgoing_particles_[0].effective_mass(),
625  outgoing_particles_[1].effective_mass()},
626  sqrt_s());
627 }
628 
630  // create new particles
635  }
636 }
637 
643  }
644  logg[LScatterAction].debug("2->", outgoing_particles_.size(),
645  " scattering:", incoming_particles_, " -> ",
647 }
648 
650  if (outgoing_particles_.size() != 1) {
651  std::string s =
652  "resonance_formation: "
653  "Incorrect number of particles in final state: ";
654  s += std::to_string(outgoing_particles_.size()) + " (";
655  s += incoming_particles_[0].pdgcode().string() + " + ";
656  s += incoming_particles_[1].pdgcode().string() + ")";
657  throw InvalidResonanceFormation(s);
658  }
659  // Set the momentum of the formed resonance in its rest frame.
660  outgoing_particles_[0].set_4momentum(
661  total_momentum_of_outgoing_particles().abs(), 0., 0., 0.);
665  }
666  /* this momentum is evaluated in the computational frame. */
667  logg[LScatterAction].debug("Momentum of the new particle: ",
668  outgoing_particles_[0].momentum());
669 }
670 
671 /* This function generates the outgoing state when
672  * ScatterAction::string_excitation() is used */
673 
677  /* Check momentum difference for debugging */
678  FourVector out_mom;
679  for (ParticleData data : outgoing_particles_) {
680  out_mom += data.momentum();
681  }
682  logg[LPythia].debug("Incoming momenta string:", total_momentum());
683  logg[LPythia].debug("Outgoing momenta string:", out_mom);
684 }
685 
686 /* This function will generate outgoing particles in computational frame
687  * from a hard process.
688  * The way to excite soft strings is based on the UrQMD model */
689 
691  assert(incoming_particles_.size() == 2);
692  // Disable floating point exception trap for Pythia
693  {
694  DisableFloatTraps guard;
695  /* initialize the string_process_ object for this particular collision */
697  /* implement collision */
698  bool success = false;
699  int ntry = 0;
700  const int ntry_max = 10000;
701  while (!success && ntry < ntry_max) {
702  ntry++;
703  switch (process_type_) {
705  /* single diffractive to A+X */
706  success = string_process_->next_SDiff(true);
707  break;
709  /* single diffractive to X+B */
710  success = string_process_->next_SDiff(false);
711  break;
713  /* double diffractive */
714  success = string_process_->next_DDiff();
715  break;
717  /* soft non-diffractive */
718  success = string_process_->next_NDiffSoft();
719  break;
721  /* soft BBbar 2 mesonic annihilation */
722  success = string_process_->next_BBbarAnn();
723  break;
725  success = string_process_->next_NDiffHard();
726  break;
727  default:
728  logg[LPythia].error("Unknown string process required.");
729  success = false;
730  }
731  }
732  if (ntry == ntry_max) {
733  /* If pythia fails to form a string, it is usually because the energy
734  * is not large enough. In this case, annihilation is then enforced. If
735  * this process still does not not produce any results, it defaults to
736  * an elastic collision. */
737  bool success_newtry = false;
738 
739  /* Check if the initial state is a baryon-antibaryon state.*/
740  PdgCode part1 = incoming_particles_[0].pdgcode(),
741  part2 = incoming_particles_[1].pdgcode();
742  bool is_BBbar_Pair = (part1.baryon_number() != 0) &&
743  (part1.baryon_number() == -part2.baryon_number());
744 
745  /* Decide on the new process .*/
746  if (is_BBbar_Pair) {
748  } else {
750  }
751  /* Perform the new process*/
752  int ntry_new = 0;
753  while (!success_newtry && ntry_new < ntry_max) {
754  ntry_new++;
755  if (is_BBbar_Pair) {
756  success_newtry = string_process_->next_BBbarAnn();
757  } else {
758  success_newtry = string_process_->next_DDiff();
759  }
760  }
761 
762  if (success_newtry) {
764  }
765 
766  if (!success_newtry) {
767  /* If annihilation fails:
768  * Particles are normally added after process selection for
769  * strings, outgoing_particles is still uninitialized, and memory
770  * needs to be allocated. We also shift the process_type_ to elastic
771  * so that sample_angles does a proper treatment. */
772  outgoing_particles_.reserve(2);
777  }
778  } else {
780  }
781  }
782 }
783 
785  ParticleData &outgoing_particle_a, ParticleData &outgoing_particle_b) {
786  // Boost spin vectors
787  outgoing_particle_a.set_spin_vector(
788  outgoing_particle_a.spin_vector().lorentz_boost(
789  outgoing_particle_a.velocity()));
790  outgoing_particle_b.set_spin_vector(
791  outgoing_particle_b.spin_vector().lorentz_boost(
792  outgoing_particle_b.velocity()));
793 }
794 
797  /* 2->2 elastic scattering */
799  // Final boost to the outgoing particle momenta
802  }
803 
804  /* 2->1 resonance formation */
806  /*
807  * @brief Λ+π → Σ* resonance formation with Λ–spin bookkeeping.
808  *
809  * We do not simulate a direct inelastic Λ+π scattering; instead we form a
810  * Σ* resonance and let it decay later. To preserve Λ polarization per
811  * arXiv:2404.15890v2, we treat the Σ* spin vector as a proxy for the
812  * would-be outgoing Λ spin: at formation, we set the Σ* spin to the
813  * incoming Λ spin and apply a possible spin flip according to the
814  * Λ–flip/non-flip fractions extracted from the paper. On Σ* → Λ+π decay,
815  * the Σ* spin vector is copied to the Λ, thus transporting Λ polarization
816  * through the resonance stage.
817  */
818  // Identify if the outgoing resonance is a Σ*
819  if (outgoing_particles_[0].is_sigmastar()) {
820  // Check that one of the incoming particles is a Λ and the other a π
821  const bool has_lambda = incoming_particles_[0].pdgcode().is_Lambda() ||
822  incoming_particles_[1].pdgcode().is_Lambda();
823  const bool has_pion = incoming_particles_[0].is_pion() ||
824  incoming_particles_[1].is_pion();
825  if (has_lambda && has_pion) {
826  auto &lambda = (incoming_particles_[0].pdgcode().is_Lambda())
828  : incoming_particles_[1];
829  auto &sigma_star = outgoing_particles_[0];
830 
831  // Perform spin flip with probability of 2/9
832  int random_int = random::uniform_int(1, 9);
833  FourVector final_spin_vector = lambda.spin_vector();
834 
835  if (random_int <= 7) {
836  // No spin flip
837  final_spin_vector = final_spin_vector.lorentz_boost(
838  outgoing_particles_[0].velocity());
839  outgoing_particles_[0].set_spin_vector(final_spin_vector);
840  } else {
841  // Spin flip in Lambda rest frame
842  ThreeVector lambda_velocity = lambda.velocity();
843  final_spin_vector =
844  final_spin_vector.lorentz_boost(lambda_velocity);
845 
846  // Flip the spatial spin vector components
847  final_spin_vector[1] = -final_spin_vector[1];
848  final_spin_vector[2] = -final_spin_vector[2];
849  final_spin_vector[3] = -final_spin_vector[3];
850 
851  // Boost back to computational frame and to Sigma* frame
852  final_spin_vector =
853  final_spin_vector.lorentz_boost(-lambda_velocity);
854  final_spin_vector =
855  final_spin_vector.lorentz_boost(sigma_star.velocity());
856  sigma_star.set_spin_vector(final_spin_vector);
857  }
858  }
859  }
860  }
861  }
862 }
863 
865  // Check if spin interaction is disabled
867  return;
868  }
869  const bool is_AB_to_AX =
871  const bool is_AB_to_XB =
873 
874  /* This logic relies on the assumption that the surviving hadron is
875  * always appended as the final element in the outgoing particle list.
876  * This ordering is guaranteed by StringProcess::next_SDiff(bool
877  * is_AB_to_AX). If that implementation changes, the behavior here must
878  * be re-evaluated. */
879  if (is_AB_to_AX || is_AB_to_XB) {
880  const std::size_t idx_hadron_in = is_AB_to_AX ? 0 : 1;
881 
882  // Boost spin vector of surviving hadron to outgoing frame
883  const FourVector final_spin_vector =
884  incoming_particles_[idx_hadron_in].spin_vector().lorentz_boost(
885  outgoing_particles_.back().velocity());
886 
887  outgoing_particles_.back().set_spin_vector(final_spin_vector);
888 
889  /* Set unpolarized spin vector for all newly created particles (all but
890  * the last one) */
891  for (auto it = outgoing_particles_.begin();
892  it != outgoing_particles_.end() - 1; ++it) {
893  it->set_unpolarized_spin_vector();
894  }
895  } else {
896  for (auto &particle : outgoing_particles_) {
897  particle.set_unpolarized_spin_vector();
898  }
899  }
900 }
901 
902 void ScatterAction::format_debug_output(std::ostream &out) const {
903  out << "Scatter of " << incoming_particles_;
904  if (outgoing_particles_.empty()) {
905  out << " (not performed)";
906  } else {
907  out << " to " << outgoing_particles_;
908  }
909 }
910 
911 } // namespace smash
Thrown for example when ScatterAction is called to perform with a wrong number of final-state particl...
Definition: action.h:330
Action is the base class for a generic process that takes a number of incoming particles and transfor...
Definition: action.h:35
virtual void sample_2body_phasespace()
Sample the full 2-body phase-space (masses, momenta, angles) in the center-of-mass frame for the fina...
Definition: action.cc:305
FourVector total_momentum_of_outgoing_particles() const
Calculate the total kinetic momentum of the outgoing particles.
Definition: action.cc:160
void assign_formation_time_to_outgoing_particles()
Assign the formation time to the outgoing particles.
Definition: action.cc:191
std::pair< FourVector, FourVector > get_potential_at_interaction_point() const
Get the skyrme and asymmetry potential at the interaction point.
Definition: action.cc:112
ParticleList outgoing_particles_
Initially this stores only the PDG codes of final-state particles.
Definition: action.h:372
FourVector total_momentum() const
Sum of 4-momenta of incoming particles.
Definition: action.h:398
virtual void sample_manybody_phasespace()
Sample the full n-body phase-space (masses, momenta, angles) in the center-of-mass frame for the fina...
Definition: action.cc:449
const double time_of_execution_
Time at which the action is supposed to be performed (absolute time in the lab frame in fm).
Definition: action.h:378
void assign_unpolarized_spin_vector_to_outgoing_particles()
Assign an unpolarized spin vector to all outgoing particles.
Definition: action.cc:478
const ParticleList & incoming_particles() const
Get the list of particles that go into the action.
Definition: action.cc:58
double sqrt_s() const
Determine the total energy in the center-of-mass frame [GeV].
Definition: action.h:271
ParticleList incoming_particles_
List with data of incoming particles.
Definition: action.h:364
FourVector get_interaction_point() const
Get the interaction point.
Definition: action.cc:68
static double lambda_tilde(double a, double b, double c)
Little helper function that calculates the lambda function (sometimes written with a tilde to better ...
Definition: action.h:315
ProcessType process_type_
type of process
Definition: action.h:381
Angles provides a common interface for generating directions: i.e., two angles that should be interpr...
Definition: angles.h:59
ThreeVector threevec() const
Definition: angles.h:288
void distribute_isotropically()
Populate the object with a new direction.
Definition: angles.h:199
CollisionBranch is a derivative of ProcessBranch, which is used to represent particular final-state c...
ProcessType get_type() const override
The cross section class assembels everything that is needed to calculate the cross section and return...
Definition: crosssections.h:31
double high_energy(const ScatterActionsFinderParameters &finder_parameters) const
Determine the parametrized total cross section at high energies for the given collision,...
double string_probability(const ScatterActionsFinderParameters &finder_parameters) const
CollisionBranchList string_excitation(double total_string_xs, StringProcess *string_process, const ScatterActionsFinderParameters &finder_parameters) const
Determine the cross section for string excitations, which is given by the difference between the para...
double parametrized_total(const ScatterActionsFinderParameters &finder_parameters) const
Select the parametrization for the total cross section, given the types of incoming particles.
CollisionBranchList generate_collision_list(const ScatterActionsFinderParameters &finder_parameters, StringProcess *string_process) const
Generate a list of all possible collisions between the incoming particles with the given c....
Guard type that safely disables floating point traps for the scope in which it is placed.
Definition: fpenvironment.h:79
The FourVector class holds relevant values in Minkowski spacetime with (+, −, −, −) metric signature.
Definition: fourvector.h:33
double sqr() const
calculate the square of the vector (which is a scalar)
Definition: fourvector.h:460
FourVector lorentz_boost(const ThreeVector &v) const
Returns the FourVector boosted with velocity v.
Definition: fourvector.cc:17
ThreeVector threevec() const
Definition: fourvector.h:329
double Dot(const FourVector &a) const
calculate the scalar product with another four-vector
Definition: fourvector.h:456
ThreeVector velocity() const
Get the velocity (3-vector divided by zero component).
Definition: fourvector.h:333
ParticleData contains the dynamic information of a certain particle.
Definition: particledata.h:59
PdgCode pdgcode() const
Get the pdgcode of the particle.
Definition: particledata.h:88
void set_4momentum(const FourVector &momentum_vector)
Set the particle's 4-momentum directly.
Definition: particledata.h:177
const ParticleType & type() const
Get the type of the particle.
Definition: particledata.h:132
const FourVector & momentum() const
Get the particle's 4-momentum.
Definition: particledata.h:171
ThreeVector velocity() const
Get the velocity 3-vector.
Definition: particledata.h:321
const FourVector & spin_vector() const
Get the mean spin 4-vector (Pauli–Lubanski vector) of the particle (const reference,...
Definition: particledata.h:365
void set_spin_vector(const FourVector &s)
Set the mean spin 4-vector (Pauli–Lubanski vector) of the particle.
Definition: particledata.h:375
void boost(const ThreeVector &v)
Apply a full Lorentz boost of momentum and position.
Definition: particledata.h:343
const FourVector & position() const
Get the particle's position in Minkowski space.
Definition: particledata.h:217
A pointer-like interface to global references to ParticleType objects.
Definition: particletype.h:682
bool is_pion() const
Definition: particletype.h:219
bool is_Nstar() const
Definition: particletype.h:231
const std::string & name() const
Definition: particletype.h:142
int32_t charge() const
The charge of the particle.
Definition: particletype.h:189
bool is_stable() const
Definition: particletype.h:249
bool is_nucleon() const
Definition: particletype.h:216
double mass() const
Definition: particletype.h:145
bool is_kaon() const
Definition: particletype.h:222
bool is_Deltastar() const
Definition: particletype.h:243
PdgCode stores a Particle Data Group Particle Numbering Scheme particle type number.
Definition: pdgcode.h:108
int antiparticle_sign() const
Definition: pdgcode.h:719
int baryon_number() const
Definition: pdgcode.h:388
bool is_nucleon() const
Definition: pdgcode.h:404
bool is_Delta() const
Definition: pdgcode.h:428
ParticleList particle_list() const
double weight() const
Thrown when ScatterAction is called to perform with unknown ProcessType.
SpinInteractionType spin_interaction_type_
What kind of spin interaction to use.
bool isotropic_
Do this collision isotropically?
std::optional< double > parametrized_total_cross_section_
If cross section is parametrized, store the value.
void string_spin_interaction()
Perform spin interaction in string excitations.
void rescale_outgoing_branches()
Loop over the possible branches and rescales their weight according to the desired total cross sectio...
void add_collision(CollisionBranchPtr p)
Add a new collision channel.
ScatterAction(const ParticleData &in_part1, const ParticleData &in_part2, double time, bool isotropic=false, double string_formation_time=1.0, double box_length=-1.0, bool is_total_parametrized=false, const SpinInteractionType spin_interaction_type=SpinInteractionType::Off)
Construct a ScatterAction object.
void resonance_formation()
Perform a 2->1 resonance-formation process.
ThreeVector beta_cm() const
Get the velocity of the center of mass of the scattering/incoming particles in the calculation frame.
double partial_cross_section_
Partial cross-section to the chosen outgoing channel.
double relative_velocity() const
Get the relative velocity of the two incoming particles.
double mandelstam_s() const
Determine the Mandelstam s variable,.
void set_parametrized_total_cross_section(const ScatterActionsFinderParameters &finder_parameters)
Given the incoming particles, assigns the correct parametrization of the total cross section.
double get_partial_weight() const override
Get the partial cross section of the chosen channel.
StringProcess * string_process_
Pointer to interface class for strings.
bool is_total_parametrized_
Whether the total cross section is parametrized.
void create_string_final_state()
Creates the final states for string-processes after they are performed.
double sum_of_partial_cross_sections_
Current sum of partial hadronic cross sections.
double cm_momentum_squared() const
Get the squared momentum of the center of mass of the incoming particles in the calculation frame.
void generate_final_state() override
Generate the final-state of the scattering process.
void add_all_scatterings(const ScatterActionsFinderParameters &finder_parameters)
Add all possible scattering subprocesses for this action object.
void two_to_many_scattering()
Perform an inelastic two-to-many-body scattering (more than 2)
double get_total_weight() const override
Get the total cross section of scattering particles.
void string_excitation()
Todo(ryu): document better - it is not really UrQMD-based, isn't it? Perform the UrQMD-based string e...
void elastic_scattering()
Perform an elastic two-body scattering, i.e. just exchange momentum.
void inelastic_scattering()
Perform an inelastic two-body scattering, i.e. new particles are formed.
void spin_interaction()
Perform spin interaction in binary interactions.
void sample_angles(std::pair< double, double > masses, double kinetic_energy_cm) override
Sample final-state angles in a 2->2 collision (possibly anisotropic).
void add_collisions(CollisionBranchList pv)
Add several new collision channels at once.
double gamma_cm() const
Get the gamma factor corresponding to a boost to the center of mass frame of the colliding particles.
double cm_momentum() const
Get the momentum of the center of mass of the incoming particles in the calculation frame.
bool were_processes_added_
Lock for calling add_all_scatterings only once.
static std::set< std::set< ParticleTypePtr > > warned_no_rescaling_available
Warn about zero cross section only once per particle type pair.
double cov_transverse_distance_sqr() const
Calculate the transverse distance of the two incoming particles in their local rest frame written in ...
ParticleTypePtr try_find_pseudoresonance(const PseudoResonance method, const StringTransitionParameters &transition) const
Try to find a pseudo-resonance that can be created from the incoming particles using a given method.
CollisionBranchList collision_channels_
List of possible collisions.
double transverse_distance_sqr() const
Calculate the transverse distance of the two incoming particles in their local rest frame.
Helper class for ScatterActionsFinder.
const bool strings_with_probability
This indicates whether the string fragmentation is swiched on with a probability smoothly increasing ...
const StringTransitionParameters transition_high_energy
Constants related to transition between low collision energies - mediated via resonances - and high c...
const PseudoResonance pseudoresonance_method
Which pseudo-resonance to choose.
const bool two_to_one
Enables resonance production.
bool next_SDiff(bool is_AB_to_AX)
Single-diffractive process is based on single pomeron exchange described in Ingelman:1984ns .
bool next_NDiffSoft()
Soft Non-diffractive process is modelled in accordance with dual-topological approach Capella:1978ig ...
bool next_DDiff()
Double-diffractive process ( A + B -> X + X ) is similar to the single-diffractive process,...
ParticleList get_final_state()
a function to get the final state particle list which is called after the collision
bool next_BBbarAnn()
Baryon-antibaryon annihilation process Based on what UrQMD Bass:1998ca , Bleicher:1999xi does,...
void init(const ParticleList &incoming, double tcoll)
initialization feed intial particles, time of collision and gamma factor of the center of mass.
bool next_NDiffHard()
Hard Non-diffractive process is based on PYTHIA 8 with partonic showers and interactions.
The ThreeVector class represents a physical three-vector with the components .
Definition: threevector.h:31
double sqr() const
Definition: threevector.h:275
void rotate_z_axis_to(ThreeVector &r)
Rotate the z-axis onto the vector r.
Definition: threevector.h:335
Collection of useful constants that are known at compile time.
PseudoResonance
Which pseudo-resonance fills the inelastic gap in the transition to string region of cross sections.
@ Closest
Resonance with the pole mass closest from the invariant mass of incoming particles for all processes.
@ ClosestFromUnstable
Closest resonance for a given mass from processes with at least one resonance in the incoming particl...
@ None
No pseudo-resonance is created.
@ LargestFromUnstable
Heaviest possible resonance from processes with at least one resonance in the incoming particles.
@ Largest
Resonance of largest mass for all processes.
SpinInteractionType
Possible spin interaction types.
@ Off
No spin interactions.
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
Definition: logging.cc:40
void format_debug_output(std::ostream &out) const override
Writes information about this scatter action to the out stream.
constexpr int p
Proton.
T power(T n, T xMin, T xMax)
Draws a random number according to a power-law distribution ~ x^n.
Definition: random.h:203
T expo(T A, T x1, T x2)
Draws a random number x from an exponential distribution exp(A*x), where A is assumed to be positive,...
Definition: random.h:166
T uniform_int(T min, T max)
Definition: random.h:100
T canonical()
Definition: random.h:113
Definition: action.h:24
double plab_from_s(double mandelstam_s, double mass)
Convert Mandelstam-s to p_lab in a fixed-target collision.
Definition: kinematics.h:157
static double Cugnon_bnp(double plab)
Computes the B coefficients from the Cugnon parametrization of the angular distribution in elastic np...
T pCM(const T sqrts, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:79
ParticleTypePtrList list_possible_resonances(const ParticleTypePtr type_a, const ParticleTypePtr type_b)
Lists the possible resonances that decay into two particles.
T pCM_sqr(const T sqrts, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:91
@ FailedString
See here for a short description.
@ TwoToOne
See here for a short description.
@ StringSoftDoubleDiffractive
See here for a short description.
@ TwoToFive
See here for a short description.
@ StringSoftSingleDiffractiveXB
See here for a short description.
@ TwoToTwo
See here for a short description.
@ Elastic
See here for a short description.
@ TwoToFour
See here for a short description.
@ StringSoftAnnihilation
See here for a short description.
@ StringSoftNonDiffractive
See here for a short description.
@ StringSoftSingleDiffractiveAX
See here for a short description.
@ StringHard
See here for a short description.
@ TwoToThree
See here for a short description.
static double high_energy_bpp(double plab)
Computes the B coefficients from the STAR fit, see fig.
std::string to_string(ThermodynamicQuantity quantity)
Convert a ThermodynamicQuantity enum value to its corresponding string.
Definition: stringify.cc:26
constexpr double nucleon_mass
Nucleon mass in GeV.
Definition: constants.h:62
constexpr T pow_int(const T base, unsigned const exponent)
Efficient template for calculating integer powers using squaring.
Definition: pow.h:23
constexpr double pion_mass
Pion mass in GeV.
Definition: constants.h:69
T pCM_from_s(const T s, const T mass_a, const T mass_b) noexcept
Definition: kinematics.h:66
constexpr double really_small
Numerical error tolerance.
Definition: constants.h:41
static constexpr int LScatterAction
static constexpr int LPythia
Definition: stringprocess.h:26
bool is_string_soft_process(ProcessType p)
Check if a given process type is a soft string excitation.
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 void boost_spin_vectors_after_elastic_scattering(ParticleData &outgoing_particle_a, ParticleData &outgoing_particle_b)
static double Cugnon_bpp(double plab)
Computes the B coefficients from the Cugnon parametrization of the angular distribution in elastic pp...
Constants related to transition between low and high collision energies.
const std::pair< double, double > sqrts_range_Npi
Transition range in N collisions.
const double pipi_offset
Constant offset as to where to turn on the strings and elastic processes for reactions (this is an e...
const double sqrts_add_lower
Constant for the lower end of transition region in the case of AQM this is added to the sum of masses...
const double KN_offset
Constant offset as to where to shift from 2to2 to string processes (in GeV) in the case of KN reactio...
const std::pair< double, double > sqrts_range_NN
Transition range in NN collisions.