20 static constexpr
int LOutput = LogArea::Output::id;
23 double string_tension,
double time_formation,
double gluon_beta,
24 double gluon_pmin,
double quark_alpha,
double quark_beta,
25 double strange_supp,
double diquark_supp,
double sigma_perp,
26 double stringz_a_leading,
double stringz_b_leading,
double stringz_a,
27 double stringz_b,
double string_sigma_T,
double factor_t_form,
28 bool mass_dependent_formation_times,
double prob_proton_to_d_uu,
29 bool separate_fragment_baryon,
double popcorn_rate,
bool use_monash_tune)
30 : pmin_gluon_lightcone_(gluon_pmin),
31 pow_fgluon_beta_(gluon_beta),
32 pow_fquark_alpha_(quark_alpha),
33 pow_fquark_beta_(quark_beta),
34 sigma_qperp_(sigma_perp),
35 stringz_a_leading_(stringz_a_leading),
36 stringz_b_leading_(stringz_b_leading),
37 stringz_a_produce_(stringz_a),
38 stringz_b_produce_(stringz_b),
39 strange_supp_(strange_supp),
40 diquark_supp_(diquark_supp),
41 popcorn_rate_(popcorn_rate),
42 string_sigma_T_(string_sigma_T),
43 kappa_tension_string_(string_tension),
44 additional_xsec_supp_(0.7),
45 time_formation_const_(time_formation),
46 soft_t_form_(factor_t_form),
48 mass_dependent_formation_times_(mass_dependent_formation_times),
49 prob_proton_to_d_uu_(prob_proton_to_d_uu),
50 separate_fragment_baryon_(separate_fragment_baryon),
51 use_monash_tune_(use_monash_tune) {
53 pythia_hadron_ = std::make_unique<Pythia8::Pythia>(PYTHIA_XML_DIR,
false);
57 popcorn_rate, stringz_a, stringz_b, string_sigma_T);
82 for (
int imu = 0; imu < 3; imu++) {
92 double popcorn_rate,
double stringz_a,
94 double string_sigma_T) {
96 pythia_in->readString(
"ParticleData:modeBreitWigner = 4");
99 pythia_in->readString(
"MultipartonInteractions:pTmin = 1.5");
100 pythia_in->readString(
"MultipartonInteractions:nSample = 100000");
102 pythia_in->readString(
"StringPT:sigma = " +
std::to_string(string_sigma_T));
104 pythia_in->readString(
"StringFlav:probQQtoQ = " +
107 pythia_in->readString(
"StringFlav:probStoUD = " +
109 pythia_in->readString(
"StringFlav:popcornRate = " +
112 pythia_in->readString(
"StringZ:aLund = " +
std::to_string(stringz_a));
113 pythia_in->readString(
"StringZ:bLund = " +
std::to_string(stringz_b));
116 pythia_in->readString(
"PDF:pSet = 13");
117 pythia_in->readString(
"PDF:pSetB = 13");
118 pythia_in->readString(
"PDF:piSet = 1");
119 pythia_in->readString(
"PDF:piSetB = 1");
120 pythia_in->readString(
"Beams:idA = 2212");
121 pythia_in->readString(
"Beams:idB = 2212");
122 pythia_in->readString(
"Beams:eCM = 10.");
125 pythia_in->readString(
"Random:setSeed = on");
127 pythia_in->readString(
"Print:quiet = on");
129 pythia_in->readString(
"HadronLevel:Decay = off");
132 int pdgid = ptype.pdgcode().get_decimal();
133 double mass_pole = ptype.mass();
134 double width_pole = ptype.width_at_pole();
136 if (pythia_in->particleData.isParticle(pdgid)) {
138 pythia_in->particleData.m0(pdgid, mass_pole);
139 pythia_in->particleData.mWidth(pdgid, width_pole);
140 }
else if (pdgid == 310 || pdgid == 130) {
142 pythia_in->particleData.m0(pdgid,
kaon_mass);
143 pythia_in->particleData.mWidth(pdgid, 0.);
148 pythia_in->readString(
"Check:epTolErr = 1e-6");
149 pythia_in->readString(
"Check:epTolWarn = 1e-8");
151 pythia_in->readString(
"Tune:ee = 7");
152 pythia_in->readString(
"Tune:pp = 14");
165 bstring += data.pdgcode().baryon_number();
178 for (
int i = 0; i < nfrag; i++) {
179 ThreeVector velocity = intermediate_particles[i].momentum().velocity();
180 double gamma = 1. / intermediate_particles[i].inverse_gamma();
183 intermediate_particles[i].momentum().
lorentz_boost(-vstring);
184 intermediate_particles[i].set_4momentum(momentum);
188 double tau_prod = M_SQRT2 * intermediate_particles[i].effective_mass() /
190 double t_prod = tau_prod * gamma;
194 fragment_position = fragment_position.
lorentz_boost(-vstring);
196 intermediate_particles[i].set_slow_formation_times(
201 double gamma_factor = 1.0 / std::sqrt(1 - (v_calc).sqr());
202 intermediate_particles[i].set_slow_formation_times(
216 massA_ = incoming[0].effective_mass();
217 massB_ = incoming[1].effective_mass();
219 plab_[0] = incoming[0].momentum();
220 plab_[1] = incoming[1].momentum();
253 double QTrn, QTrx, QTry;
254 double pabscomHX_sqr, massX;
263 if (mstrMin > mstrMax) {
269 QTrn = std::sqrt(QTrx * QTrx + QTry * QTry);
276 const bool foundPabsX = pabscomHX_sqr > QTrn * QTrn;
281 double sign_direction = is_AB_to_AX ? 1. : -1.;
285 (
evecBasisAB_[0] * std::sqrt(pabscomHX_sqr - QTrn * QTrn) +
287 const FourVector pstrHcom(std::sqrt(pabscomHX_sqr + massH * massH),
289 const FourVector pstrXcom(std::sqrt(pabscomHX_sqr + massX * massX),
297 is_AB_to_AX ?
pcom_[1].threevec() :
pcom_[0].threevec();
302 ParticleList new_intermediate_particles;
304 new_intermediate_particles);
326 const std::array<std::array<int, 2>, 2> &quarks,
327 const std::array<FourVector, 2> &pstr_com, std::array<double, 2> &m_str,
328 std::array<ThreeVector, 2> &evec_str) {
329 std::array<bool, 2> found_mass;
330 for (
int i = 0; i < 2; i++) {
331 found_mass[i] =
false;
333 m_str[i] = pstr_com[i].sqr();
334 m_str[i] = (m_str[i] > 0.) ? std::sqrt(m_str[i]) : 0.;
335 const double threshold =
pythia_hadron_->particleData.m0(quarks[i][0]) +
338 if (m_str[i] > threshold) {
339 found_mass[i] =
true;
359 return found_mass[0] && found_mass[1];
363 const std::array<std::array<int, 2>, 2> &quarks,
364 const std::array<FourVector, 2> &pstr_com,
365 const std::array<double, 2> &m_str,
366 const std::array<ThreeVector, 2> &evec_str,
bool flip_string_ends,
367 bool separate_fragment_baryon) {
368 const std::array<FourVector, 2> ustr_com = {pstr_com[0] / m_str[0],
369 pstr_com[1] / m_str[1]};
370 for (
int i = 0; i < 2; i++) {
371 ParticleList new_intermediate_particles;
376 int nfrag =
fragment_string(quarks[i][0], quarks[i][1], m_str[i], evec,
377 flip_string_ends, separate_fragment_baryon,
378 new_intermediate_particles);
402 std::array<std::array<int, 2>, 2> quarks;
403 std::array<FourVector, 2> pstr_com;
404 std::array<double, 2> m_str;
405 std::array<ThreeVector, 2> evec_str;
415 const double xfracA =
417 const double xfracB =
422 const double QTrn = std::sqrt(QTrx * QTrx + QTry * QTry);
424 const double QPos = -QTrn * QTrn / (2. * xfracB *
PNegB_);
425 const double QNeg = QTrn * QTrn / (2. * xfracA *
PPosA_);
439 const bool found_masses =
444 const bool flip_string_ends =
true;
446 quarks, pstr_com, m_str, evec_str, flip_string_ends,
false);
457 std::array<std::array<int, 2>, 2> quarks;
458 std::array<FourVector, 2> pstr_com;
459 std::array<double, 2> m_str;
460 std::array<ThreeVector, 2> evec_str;
463 int idqA1, idqA2, idqB1, idqB2;
467 const int bar_a =
PDGcodes_[0].baryon_number(),
470 (bar_a == 0 && bar_b == 1) ||
471 (bar_a == 0 && bar_b == 0)) {
472 quarks[0][0] = idqB1;
473 quarks[0][1] = idqA2;
474 quarks[1][0] = idqA1;
475 quarks[1][1] = idqB2;
476 }
else if (((bar_a == 0) && (bar_b == -1)) ||
479 quarks[0][0] = idqA1;
480 quarks[0][1] = idqB2;
481 quarks[1][0] = idqB1;
482 quarks[1][1] = idqA2;
484 std::stringstream ss;
485 ss <<
" StringProcess::next_NDiff : baryonA = " << bar_a
486 <<
", baryonB = " << bar_b;
487 throw std::runtime_error(ss.str());
495 const double QTrn = std::sqrt(QTrx * QTrx + QTry * QTry);
497 const double QPos = -QTrn * QTrn / (2. * xfracB *
PNegB_);
498 const double QNeg = QTrn * QTrn / (2. * xfracA *
PPosA_);
499 const double dPPos = -xfracA *
PPosA_ - QPos;
500 const double dPNeg = xfracB *
PNegB_ - QNeg;
507 m_str[0] = pstr_com[0].sqr();
515 const bool found_masses =
520 const bool flip_string_ends =
false;
535 std::array<int, 2> pdg_for_pythia;
536 std::array<std::array<int, 5>, 2> excess_quark;
537 std::array<std::array<int, 5>, 2> excess_antiq;
538 for (
int i = 0; i < 2; i++) {
539 for (
int j = 0; j < 5; j++) {
540 excess_quark[i][j] = 0;
541 excess_antiq[i][j] = 0;
547 " is mapped onto ", pdg_for_pythia[i]);
554 logg[
LPythia].debug(
" excess_quark[", i,
"] = (", excess_quark[i][0],
555 ", ", excess_quark[i][1],
", ", excess_quark[i][2],
556 ", ", excess_quark[i][3],
", ", excess_quark[i][4],
558 logg[
LPythia].debug(
" excess_antiq[", i,
"] = (", excess_antiq[i][0],
559 ", ", excess_antiq[i][1],
", ", excess_antiq[i][2],
560 ", ", excess_antiq[i][3],
", ", excess_antiq[i][4],
564 std::pair<int, int> idAB{pdg_for_pythia[0], pdg_for_pythia[1]};
569 hard_map_[idAB] = std::make_unique<Pythia8::Pythia>(PYTHIA_XML_DIR,
false);
570 hard_map_[idAB]->readString(
"SoftQCD:nonDiffractive = on");
571 hard_map_[idAB]->readString(
"MultipartonInteractions:pTmin = 1.5");
572 hard_map_[idAB]->readString(
"HadronLevel:all = off");
578 hard_map_[idAB]->settings.flag(
"Beams:allowVariableEnergy",
true);
580 hard_map_[idAB]->settings.mode(
"Beams:idA", idAB.first);
581 hard_map_[idAB]->settings.mode(
"Beams:idB", idAB.second);
584 logg[
LPythia].debug(
"Pythia object initialized with ", pdg_for_pythia[0],
585 " + ", pdg_for_pythia[1],
" at CM energy [GeV] ",
589 throw std::runtime_error(
"Pythia failed to initialize.");
595 logg[
LPythia].debug(
"hard_map_[", idAB.first,
"][", idAB.second,
596 "] : rndm is initialized with seed ", seed_new);
605 bool final_state_success =
hard_map_[idAB]->next();
606 logg[
LPythia].debug(
"Pythia final state computed, success = ",
607 final_state_success);
608 if (!final_state_success) {
612 ParticleList new_intermediate_particles;
613 ParticleList new_non_hadron_particles;
615 Pythia8::Vec4 pSum = 0.;
620 for (
int i = 0; i <
hard_map_[idAB]->event.size(); i++) {
621 if (
hard_map_[idAB]->event[i].isFinal()) {
622 const int pdgid =
hard_map_[idAB]->event[i].id();
623 Pythia8::Vec4 pquark =
hard_map_[idAB]->event[i].p();
624 const double mass =
hard_map_[idAB]->particleData.m0(pdgid);
626 const int status =
hard_map_[idAB]->event[i].status();
627 const int color =
hard_map_[idAB]->event[i].col();
628 const int anticolor =
hard_map_[idAB]->event[i].acol();
636 for (
int i = 0; i <
hard_map_[idAB]->event.sizeJunction(); i++) {
637 const int kind =
hard_map_[idAB]->event.kindJunction(i);
638 std::array<int, 3> col;
639 for (
int j = 0; j < 3; j++) {
640 col[j] =
hard_map_[idAB]->event.colJunction(i, j);
652 bool correct_constituents =
654 if (!correct_constituents) {
655 logg[
LPythia].debug(
"failed to find correct partonic constituents.");
661 while (ipart < npart) {
665 !
hard_map_[idAB]->particleData.isOctetHadron(pdgid)) {
666 logg[
LPythia].debug(
"PDG ID from Pythia: ", pdgid);
668 logg[
LPythia].debug(
"4-momentum from Pythia: ", momentum);
673 " does not exist in ParticleType - start over.");
674 final_state_success =
false;
683 bool hadronize_success =
false;
684 bool find_forward_string =
true;
685 logg[
LPythia].debug(
"Hard non-diff: partonic process gives ",
692 logg[
LPythia].debug(
" Dummy event in hard string routine failed.");
693 hadronize_success =
false;
710 logg[
LPythia].debug(
"Pythia hadronized, success = ", hadronize_success);
712 new_intermediate_particles.clear();
713 if (hadronize_success) {
714 for (
int i = 0; i < event_hadron.size(); i++) {
715 if (event_hadron[i].isFinal()) {
716 int pythia_id = event_hadron[i].id();
717 logg[
LPythia].debug(
"PDG ID from Pythia: ", pythia_id);
730 logg[
LPythia].debug(
"4-momentum from Pythia: ", momentum);
731 logg[
LPythia].debug(
"appending the particle ", pythia_id,
732 " to the intermediate particle list.");
733 bool found_ptype =
false;
734 if (event_hadron[i].isHadron()) {
736 new_intermediate_particles);
739 new_non_hadron_particles);
743 " does not exist in ParticleType - start over.");
744 hadronize_success =
false;
752 if (!hadronize_success) {
761 find_forward_string = !find_forward_string;
764 if (hadronize_success) {
767 data.set_cross_section_scaling_factor(1.);
775 return hadronize_success;
780 std::array<int, 5> &excess_quark,
781 std::array<int, 5> &excess_antiq) {
784 std::array<int, 3> qcontent_actual = pdg_actual.
quark_content();
785 std::array<int, 3> qcontent_mapped = pdg_mapped.
quark_content();
787 excess_quark = {0, 0, 0, 0, 0};
788 excess_antiq = {0, 0, 0, 0, 0};
789 for (
int i = 0; i < 3; i++) {
790 if (qcontent_actual[i] > 0) {
791 int j = qcontent_actual[i] - 1;
792 excess_quark[j] += 1;
795 if (qcontent_mapped[i] > 0) {
796 int j = qcontent_mapped[i] - 1;
797 excess_quark[j] -= 1;
800 if (qcontent_actual[i] < 0) {
801 int j = std::abs(qcontent_actual[i]) - 1;
802 excess_antiq[j] += 1;
805 if (qcontent_mapped[i] < 0) {
806 int j = std::abs(qcontent_mapped[i]) - 1;
807 excess_antiq[j] -= 1;
813 Pythia8::Particle &particle, std::array<int, 5> &excess_constituent) {
815 if (!particle.isQuark() && !particle.isDiquark()) {
820 const std::array<int, 5> excess_null = {0, 0, 0, 0, 0};
821 if (excess_constituent == excess_null) {
826 std::array<int, 2> pdgid = {0, 0};
829 if (particle.isQuark()) {
831 pdgid[0] = particle.id();
832 }
else if (particle.isDiquark()) {
837 for (
int iq = 0; iq < nq; iq++) {
838 int jq = std::abs(pdgid[iq]) - 1;
840 std::vector<int> k_found;
843 if (excess_constituent[jq] < 0) {
844 for (
int k = 0; k < 5; k++) {
846 if (k != jq && excess_constituent[k] > 0) {
847 k_found.push_back(k);
853 if (k_found.size() > 0) {
856 k_select = k_found[l];
859 pdgid[iq] = pdgid[iq] > 0 ? k_select + 1 : -(k_select + 1);
860 excess_constituent[jq] += 1;
861 excess_constituent[k_select] -= 1;
866 if (particle.isQuark()) {
867 pdgid_new = pdgid[0];
868 }
else if (particle.isDiquark()) {
869 if (std::abs(pdgid[0]) < std::abs(pdgid[1])) {
870 std::swap(pdgid[0], pdgid[1]);
873 pdgid_new = std::abs(pdgid[0]) * 1000 + std::abs(pdgid[1]) * 100;
874 if (std::abs(pdgid[0]) == std::abs(pdgid[1])) {
877 pdgid_new += spin_deg;
880 if (particle.id() < 0) {
884 logg[
LPythia].debug(
" parton id = ", particle.id(),
" is converted to ",
888 Pythia8::Vec4 pquark = particle.p();
890 double e_new = std::sqrt(mass_new * mass_new + pquark.pAbs() * pquark.pAbs());
892 particle.id(pdgid_new);
894 particle.m(mass_new);
898 Pythia8::Event &event_intermediate, std::array<int, 5> &nquark_total,
899 std::array<int, 5> &nantiq_total) {
900 for (
int iflav = 0; iflav < 5; iflav++) {
901 nquark_total[iflav] = 0;
902 nantiq_total[iflav] = 0;
905 for (
int ip = 1; ip < event_intermediate.size(); ip++) {
906 if (!event_intermediate[ip].isFinal()) {
909 const int pdgid = event_intermediate[ip].id();
912 for (
int iflav = 0; iflav < 5; iflav++) {
913 nquark_total[iflav] +=
918 for (
int iflav = 0; iflav < 5; iflav++) {
919 nantiq_total[iflav] +=
pythia_hadron_->particleData.nQuarksInCode(
920 std::abs(pdgid), iflav + 1);
927 Pythia8::Event &event_intermediate, std::array<int, 5> &nquark_total,
928 std::array<int, 5> &nantiq_total,
bool sign_constituent,
929 std::array<std::array<int, 5>, 2> &excess_constituent) {
930 Pythia8::Vec4 pSum = event_intermediate[0].p();
936 for (
int iflav = 0; iflav < 5; iflav++) {
943 excess_constituent[0][iflav] + excess_constituent[1][iflav];
944 if (sign_constituent) {
945 nquark_final += nquark_total[iflav];
947 nquark_final += nantiq_total[iflav];
952 bool enough_quark = nquark_final >= 0;
956 logg[
LPythia].debug(
" not enough constituents with flavor ", iflav + 1,
957 " : try to split a gluon to qqbar.");
958 for (
int ic = 0; ic < std::abs(nquark_final); ic++) {
962 if (excess_constituent[0][iflav] < 0) {
971 for (
int ip = 2; ip < event_intermediate.size(); ip++) {
972 if (!event_intermediate[ip].isFinal() ||
973 !event_intermediate[ip].isGluon()) {
977 const double y_gluon_current = event_intermediate[ip].y();
978 const double y_gluon_forward = event_intermediate[iforward].y();
979 if ((ih_mod == 0 && y_gluon_current > y_gluon_forward) ||
980 (ih_mod == 1 && y_gluon_current < y_gluon_forward)) {
985 if (!event_intermediate[iforward].isGluon()) {
986 logg[
LPythia].debug(
"There is no gluon to split into qqbar.");
991 Pythia8::Vec4 pgluon = event_intermediate[iforward].p();
993 const int pdgid = iflav + 1;
995 const int status = event_intermediate[iforward].status();
999 const int col = event_intermediate[iforward].col();
1000 const int acol = event_intermediate[iforward].acol();
1003 std::array<double, 2> px_quark;
1004 std::array<double, 2> py_quark;
1005 std::array<double, 2> pz_quark;
1007 std::array<double, 2> e_quark;
1009 std::array<Pythia8::Vec4, 2> pquark;
1011 const double sigma_qt_frag =
pythia_hadron_->parm(
"StringPT:sigma");
1016 for (
int isign = 0; isign < 2; isign++) {
1020 px_quark[isign] = 0.5 * pgluon.px() + (isign == 0 ? 1. : -1.) * qx;
1021 py_quark[isign] = 0.5 * pgluon.py() + (isign == 0 ? 1. : -1.) * qy;
1022 pz_quark[isign] = 0.5 * pgluon.pz();
1024 std::sqrt(mass * mass + px_quark[isign] * px_quark[isign] +
1025 py_quark[isign] * py_quark[isign] +
1026 pz_quark[isign] * pz_quark[isign]);
1027 pquark[isign] = Pythia8::Vec4(px_quark[isign], py_quark[isign],
1028 pz_quark[isign], e_quark[isign]);
1033 pSum += pquark[0] + pquark[1] - pgluon;
1035 event_intermediate.append(pdgid, status, col, 0, pquark[0], mass);
1036 event_intermediate.append(-pdgid, status, 0, acol, pquark[1], mass);
1038 event_intermediate.remove(iforward, iforward);
1040 logg[
LPythia].debug(
" gluon at iforward = ", iforward,
1041 " is splitted into ", pdgid,
",", -pdgid,
1045 nquark_total[iflav] += 1;
1046 nantiq_total[iflav] += 1;
1053 event_intermediate[0].p(pSum);
1054 event_intermediate[0].m(pSum.mCalc());
1060 std::array<int, 5> &nquark_total,
1061 std::array<std::array<int, 5>, 2> &excess_quark,
1062 std::array<std::array<int, 5>, 2> &excess_antiq) {
1063 for (
int iflav = 0; iflav < 5; iflav++) {
1070 nquark_total[iflav] + excess_quark[0][iflav] + excess_quark[1][iflav];
1074 bool enough_quark = nquark_final >= 0;
1076 if (!enough_quark) {
1077 logg[
LPythia].debug(
" not enough constituents with flavor ", iflav + 1,
1078 " : try to modify excess of constituents.");
1079 for (
int ic = 0; ic < std::abs(nquark_final); ic++) {
1083 if (excess_quark[0][iflav] < 0) {
1091 excess_quark[ih_mod][iflav] += 1;
1092 excess_antiq[ih_mod][iflav] += 1;
1099 for (
int jflav = 0; jflav < 5; jflav++) {
1101 if (jflav != iflav && excess_quark[ih_mod][jflav] > 0) {
1104 excess_quark[ih_mod][jflav] -= 1;
1105 excess_antiq[ih_mod][jflav] -= 1;
1117 Pythia8::Event &event_intermediate,
1118 std::array<std::array<int, 5>, 2> &excess_quark,
1119 std::array<std::array<int, 5>, 2> &excess_antiq) {
1120 Pythia8::Vec4 pSum = event_intermediate[0].p();
1121 const double energy_init = pSum.e();
1122 logg[
LPythia].debug(
" initial total energy [GeV] : ", energy_init);
1125 std::array<int, 5> nquark_total;
1126 std::array<int, 5> nantiq_total;
1131 event_intermediate, nquark_total, nantiq_total,
true, excess_quark);
1133 event_intermediate, nquark_total, nantiq_total,
false, excess_antiq);
1137 if (!split_for_quark || !split_for_antiq) {
1143 for (
int iflav = 0; iflav < 5; iflav++) {
1144 if (nquark_total[iflav] + excess_quark[0][iflav] + excess_quark[1][iflav] <
1146 logg[
LPythia].debug(
"Not enough quark constituents of flavor ",
1151 if (nantiq_total[iflav] + excess_antiq[0][iflav] + excess_antiq[1][iflav] <
1153 logg[
LPythia].debug(
"Not enough antiquark constituents of flavor ",
1159 for (
int ih = 0; ih < 2; ih++) {
1160 logg[
LPythia].debug(
" initial excess_quark[", ih,
"] = (",
1161 excess_quark[ih][0],
", ", excess_quark[ih][1],
", ",
1162 excess_quark[ih][2],
", ", excess_quark[ih][3],
", ",
1163 excess_quark[ih][4],
")");
1164 logg[
LPythia].debug(
" initial excess_antiq[", ih,
"] = (",
1165 excess_antiq[ih][0],
", ", excess_antiq[ih][1],
", ",
1166 excess_antiq[ih][2],
", ", excess_antiq[ih][3],
", ",
1167 excess_antiq[ih][4],
")");
1170 bool recovered_quarks =
false;
1171 while (!recovered_quarks) {
1174 std::array<bool, 2> find_forward = {
true,
false};
1175 const std::array<int, 5> excess_null = {0, 0, 0, 0, 0};
1176 std::array<int, 5> excess_total = excess_null;
1178 for (
int ih = 0; ih < 2; ih++) {
1179 int nfrag = event_intermediate.size();
1180 for (
int np_end = 0; np_end < nfrag - 1; np_end++) {
1187 pSum -= event_intermediate[iforward].p();
1189 if (event_intermediate[iforward].
id() > 0) {
1192 " excess_quark[", ih,
"] = (", excess_quark[ih][0],
", ",
1193 excess_quark[ih][1],
", ", excess_quark[ih][2],
", ",
1194 excess_quark[ih][3],
", ", excess_quark[ih][4],
")");
1198 " excess_antiq[", ih,
"] = (", excess_antiq[ih][0],
", ",
1199 excess_antiq[ih][1],
", ", excess_antiq[ih][2],
", ",
1200 excess_antiq[ih][3],
", ", excess_antiq[ih][4],
")");
1203 const int pdgid = event_intermediate[iforward].id();
1204 Pythia8::Vec4 pquark = event_intermediate[iforward].p();
1207 const int status = event_intermediate[iforward].status();
1208 const int color = event_intermediate[iforward].col();
1209 const int anticolor = event_intermediate[iforward].acol();
1212 event_intermediate.append(pdgid, status, color, anticolor, pquark,
1215 event_intermediate.remove(iforward, iforward);
1221 for (
int j = 0; j < 5; j++) {
1222 excess_total[j] += (excess_quark[ih][j] - excess_antiq[ih][j]);
1228 recovered_quarks = excess_total == excess_null;
1230 logg[
LPythia].debug(
" valence quark contents of hadons are recovered.");
1232 logg[
LPythia].debug(
" current total energy [GeV] : ", pSum.e());
1236 if (std::abs(pSum.e() - energy_init) <=
1241 double energy_current = pSum.e();
1243 for (
int i = 1; i < event_intermediate.size(); i++) {
1244 slope += event_intermediate[i].pAbs2() / event_intermediate[i].e();
1247 const double rescale_factor = 1. + (energy_init - energy_current) / slope;
1249 for (
int i = 1; i < event_intermediate.size(); i++) {
1250 const double px = rescale_factor * event_intermediate[i].px();
1251 const double py = rescale_factor * event_intermediate[i].py();
1252 const double pz = rescale_factor * event_intermediate[i].pz();
1253 const double pabs = rescale_factor * event_intermediate[i].pAbs();
1254 const double mass = event_intermediate[i].m();
1256 event_intermediate[i].px(px);
1257 event_intermediate[i].py(py);
1258 event_intermediate[i].pz(pz);
1259 event_intermediate[i].e(std::sqrt(mass * mass + pabs * pabs));
1260 pSum += event_intermediate[i].p();
1262 logg[
LPythia].debug(
" parton momenta are rescaled by factor of ",
1266 logg[
LPythia].debug(
" final total energy [GeV] : ", pSum.e());
1269 event_intermediate[0].p(pSum);
1270 event_intermediate[0].m(pSum.mCalc());
1276 Pythia8::Event &event_intermediate,
1277 Pythia8::Event &event_hadronize) {
1278 Pythia8::Vec4 pSum = 0.;
1279 event_hadronize.reset();
1283 logg[
LPythia].debug(
"Hard non-diff: iforward = ", iforward,
"(",
1284 event_intermediate[iforward].
id(),
")");
1286 pSum += event_intermediate[iforward].p();
1287 event_hadronize.append(event_intermediate[iforward]);
1289 int col_to_find = event_intermediate[iforward].acol();
1290 int acol_to_find = event_intermediate[iforward].col();
1291 event_intermediate.remove(iforward, iforward);
1292 logg[
LPythia].debug(
"Hard non-diff: event_intermediate reduces in size to ",
1293 event_intermediate.size());
1296 while (col_to_find != 0 || acol_to_find != 0) {
1297 logg[
LPythia].debug(
" col_to_find = ", col_to_find,
1298 ", acol_to_find = ", acol_to_find);
1301 for (
int i = 1; i < event_intermediate.size(); i++) {
1302 const int pdgid = event_intermediate[i].id();
1304 col_to_find != 0 && col_to_find == event_intermediate[i].col();
1306 acol_to_find != 0 && acol_to_find == event_intermediate[i].acol();
1308 logg[
LPythia].debug(
" col_to_find ", col_to_find,
" from i ", i,
"(",
1312 logg[
LPythia].debug(
" acol_to_find ", acol_to_find,
" from i ", i,
"(",
1316 if (found_col && !found_acol) {
1318 col_to_find = event_intermediate[i].acol();
1320 }
else if (!found_col && found_acol) {
1322 acol_to_find = event_intermediate[i].col();
1324 }
else if (found_col && found_acol) {
1333 event_intermediate.list();
1334 event_intermediate.listJunctions();
1335 event_hadronize.list();
1336 event_hadronize.listJunctions();
1337 if (col_to_find != 0) {
1338 logg[
LPythia].error(
"No parton with col = ", col_to_find);
1340 if (acol_to_find != 0) {
1341 logg[
LPythia].error(
"No parton with acol = ", acol_to_find);
1343 throw std::runtime_error(
"Hard string could not be identified.");
1345 pSum += event_intermediate[ifound].p();
1347 event_hadronize.append(event_intermediate[ifound]);
1349 event_intermediate.remove(ifound, ifound);
1351 "Hard non-diff: event_intermediate reduces in size to ",
1352 event_intermediate.size());
1358 event_hadronize[0].p(pSum);
1359 event_hadronize[0].m(pSum.mCalc());
1363 Pythia8::Event &event_intermediate,
1364 Pythia8::Event &event_hadronize) {
1365 event_hadronize.reset();
1373 const int kind = event_intermediate.kindJunction(0);
1374 bool sign_color = kind % 2 == 1;
1375 std::vector<int> col;
1376 for (
int j = 0; j < 3; j++) {
1377 col.push_back(event_intermediate.colJunction(0, j));
1379 event_hadronize.appendJunction(kind, col[0], col[1], col[2]);
1380 event_intermediate.eraseJunction(0);
1381 logg[
LPythia].debug(
"junction (", col[0],
", ", col[1],
", ", col[2],
1382 ") with kind ", kind,
" will be handled.");
1384 bool found_string =
false;
1385 while (!found_string) {
1388 found_string =
true;
1389 for (
unsigned int j = 0; j < col.size(); j++) {
1390 found_string = found_string && col[j] == 0;
1392 if (!found_string) {
1395 logg[
LPythia].debug(
" still has leg(s) unfinished.");
1396 sign_color = !sign_color;
1397 std::vector<int> junction_to_move;
1398 for (
int i = 0; i < event_intermediate.sizeJunction(); i++) {
1399 const int kind_new = event_intermediate.kindJunction(i);
1403 if (sign_color != (kind_new % 2 == 1)) {
1407 std::array<int, 3> col_new;
1408 for (
int k = 0; k < 3; k++) {
1409 col_new[k] = event_intermediate.colJunction(i, k);
1412 int n_legs_connected = 0;
1414 for (
unsigned int j = 0; j < col.size(); j++) {
1418 for (
int k = 0; k < 3; k++) {
1419 if (col[j] == col_new[k]) {
1420 n_legs_connected += 1;
1428 if (n_legs_connected > 0) {
1429 for (
int k = 0; k < 3; k++) {
1430 if (col_new[k] != 0) {
1431 col.push_back(col_new[k]);
1435 event_intermediate.colJunction(i, 0),
", ",
1436 event_intermediate.colJunction(i, 1),
", ",
1437 event_intermediate.colJunction(i, 2),
1438 ") with kind ", kind_new,
" will be added.");
1439 junction_to_move.push_back(i);
1445 for (
unsigned int i = 0; i < junction_to_move.size(); i++) {
1446 unsigned int imove = junction_to_move[i] - i;
1447 const int kind_add = event_intermediate.kindJunction(imove);
1448 std::array<int, 3> col_add;
1449 for (
int k = 0; k < 3; k++) {
1450 col_add[k] = event_intermediate.colJunction(imove, k);
1453 event_hadronize.appendJunction(kind_add, col_add[0], col_add[1],
1456 event_intermediate.eraseJunction(imove);
1461 Pythia8::Vec4 pSum = event_hadronize[0].p();
1462 find_forward_string = pSum.pz() > 0.;
1466 Pythia8::Event &event_intermediate,
1467 Pythia8::Event &event_hadronize) {
1468 Pythia8::Vec4 pSum = event_hadronize[0].p();
1469 for (
unsigned int j = 0; j < col.size(); j++) {
1473 bool found_leg =
false;
1474 while (!found_leg) {
1476 for (
int i = 1; i < event_intermediate.size(); i++) {
1477 const int pdgid = event_intermediate[i].id();
1478 if (sign_color && col[j] == event_intermediate[i].col()) {
1479 logg[
LPythia].debug(
" col[", j,
"] = ", col[j],
" from i ", i,
"(",
1482 col[j] = event_intermediate[i].acol();
1484 }
else if (!sign_color && col[j] == event_intermediate[i].acol()) {
1485 logg[
LPythia].debug(
" acol[", j,
"] = ", col[j],
" from i ", i,
"(",
1488 col[j] = event_intermediate[i].col();
1495 if (event_intermediate.sizeJunction() == 0) {
1496 event_intermediate.list();
1497 event_intermediate.listJunctions();
1498 event_hadronize.list();
1499 event_hadronize.listJunctions();
1500 logg[
LPythia].error(
"No parton with col = ", col[j],
1501 " connected with junction leg ", j);
1502 throw std::runtime_error(
"Hard string could not be identified.");
1505 pSum += event_intermediate[ifound].p();
1507 event_hadronize.append(event_intermediate[ifound]);
1509 event_intermediate.remove(ifound, ifound);
1511 "Hard non-diff: event_intermediate reduces in size to ",
1512 event_intermediate.size());
1522 event_hadronize[0].p(pSum);
1523 event_hadronize[0].m(pSum.mCalc());
1528 const std::array<FourVector, 2> ustrcom = {
FourVector(1., 0., 0., 0.),
1542 std::swap(baryon, antibaryon);
1544 if (baryon.
baryon_number() != 1 || antibaryon.baryon_number() != -1) {
1545 throw std::invalid_argument(
"Expected baryon-antibaryon pair.");
1549 constexpr
int n_q_types = 5;
1550 std::vector<int> qcount_bar, qcount_antibar;
1551 std::vector<int> n_combinations;
1552 bool no_combinations =
true;
1553 for (
int i = 0; i < n_q_types; i++) {
1555 qcount_antibar.push_back(-antibaryon.net_quark_number(i + 1));
1556 const int n_i = qcount_bar[i] * qcount_antibar[i];
1557 n_combinations.push_back(n_i);
1559 no_combinations =
false;
1565 if (no_combinations) {
1566 for (
int i = 0; i < 2; i++) {
1580 const int q_annihilate = discrete_distr() + 1;
1581 qcount_bar[q_annihilate - 1]--;
1582 qcount_antibar[q_annihilate - 1]--;
1585 std::vector<int> remaining_quarks, remaining_antiquarks;
1586 for (
int i = 0; i < n_q_types; i++) {
1587 for (
int j = 0; j < qcount_bar[i]; j++) {
1588 remaining_quarks.push_back(i + 1);
1590 for (
int j = 0; j < qcount_antibar[i]; j++) {
1591 remaining_antiquarks.push_back(-(i + 1));
1594 assert(remaining_quarks.size() == 2);
1595 assert(remaining_antiquarks.size() == 2);
1601 std::swap(remaining_quarks[0], remaining_quarks[1]);
1604 std::swap(remaining_antiquarks[0], remaining_antiquarks[1]);
1607 bool kin_threshold_satisfied =
true;
1608 for (
int i = 0; i < 2; i++) {
1609 const double mstr_min =
1612 if (mstr_min > mstr[i]) {
1613 kin_threshold_satisfied =
false;
1616 if (!kin_threshold_satisfied) {
1620 for (
int i = 0; i < 2; i++) {
1621 ParticleList new_intermediate_particles;
1625 fragment_string(remaining_quarks[i], remaining_antiquarks[i], mstr[i],
1626 evec,
true,
false, new_intermediate_particles);
1639 ThreeVector &evec_polar, std::array<ThreeVector, 3> &evec_basis) {
1642 if (std::abs(evec_polar.
x3()) < (1. - 1.0e-8)) {
1647 evec_basis[0] = evec_polar;
1649 theta = std::acos(evec_basis[0].x3());
1651 ex = evec_basis[0].x1();
1652 ey = evec_basis[0].x2();
1653 et = std::sqrt(ex * ex + ey * ey);
1655 phi = std::acos(ex / et);
1657 phi = -std::acos(ex / et);
1662 evec_basis[1].set_x1(std::cos(theta) * std::cos(phi));
1663 evec_basis[1].set_x2(std::cos(theta) * std::sin(phi));
1664 evec_basis[1].set_x3(-std::sin(theta));
1666 evec_basis[2].set_x1(-std::sin(phi));
1667 evec_basis[2].set_x2(std::cos(phi));
1668 evec_basis[2].set_x3(0.);
1671 if (evec_polar.
x3() > 0.) {
1682 assert(std::fabs(evec_basis[1] * evec_basis[2]) <
really_small);
1683 assert(std::fabs(evec_basis[2] * evec_basis[0]) <
really_small);
1684 assert(std::fabs(evec_basis[0] * evec_basis[1]) <
really_small);
1697 assert((std::abs(diquark) > 1000) && (std::abs(diquark) < 5510) &&
1698 (std::abs(diquark) % 100 < 10));
1701 deg_spin = std::abs(diquark) % 10;
1703 const int sign_anti = diquark > 0 ? 1 : -1;
1706 q1 = sign_anti * (std::abs(diquark) - (std::abs(diquark) % 1000)) / 1000;
1707 q2 = sign_anti * (std::abs(diquark) % 1000 - deg_spin) / 100;
1711 assert((q1 > 0 && q2 > 0) || (q1 < 0 && q2 < 0));
1712 if (std::abs(q1) < std::abs(q2)) {
1715 int diquark = std::abs(q1 * 1000 + q2 * 100);
1720 return (q1 < 0) ? -diquark : diquark;
1767 std::swap(idq1, idq2);
1773 bool separate_fragment_baryon,
1774 ParticleList &intermediate_particles) {
1776 intermediate_particles.clear();
1778 logg[
LPythia].debug(
"initial quark content for fragment_string : ", idq1,
1780 logg[
LPythia].debug(
"initial string mass (GeV) for fragment_string : ",
1783 std::array<int, 2> idqIn;
1789 std::array<double, 2> m_const;
1791 for (
int i = 0; i < 2; i++) {
1793 bstring +=
pythia_hadron_->particleData.baryonNumberType(idqIn[i]);
1797 logg[
LPythia].debug(
"baryon number of string times 3 : ", bstring);
1804 evecLong = -evecLong;
1807 if (m_const[0] + m_const[1] > mString) {
1808 throw std::runtime_error(
"String fragmentation: m1 + m2 > mString");
1810 Pythia8::Vec4 pSum = 0.;
1812 int number_of_fragments = 0;
1813 bool do_string_fragmentation =
false;
1817 double ppos_string_new, pneg_string_new;
1820 double QTrx_string_new, QTry_string_new, QTrn_string_new;
1822 double mTrn_string_new;
1824 double mass_string_new;
1828 double QTrx_add_pos, QTry_add_pos;
1831 double QTrx_add_neg, QTry_add_neg;
1843 std::array<ThreeVector, 3> evec_basis;
1846 if (separate_fragment_baryon && (std::abs(bstring) == 3) &&
1847 (mString > m_const[0] + m_const[1] + 1.)) {
1854 std::vector<int> pdgid_frag_prior;
1857 std::vector<FourVector> momentum_frag_prior;
1860 double QTrx_string_pos;
1862 double QTrx_string_neg;
1864 double QTry_string_pos;
1866 double QTry_string_neg;
1869 double QTrn_string_pos;
1872 double QTrn_string_neg;
1874 std::array<double, 2> m_trans;
1877 const int niter_max = 10000;
1878 bool found_leading_baryon =
false;
1879 for (
int iiter = 0; iiter < niter_max; iiter++) {
1881 pdgid_frag_prior.clear();
1882 momentum_frag_prior.clear();
1884 std::vector<int> pdgid_frag;
1885 std::vector<FourVector> momentum_frag;
1887 ppos_string_new = mString * M_SQRT1_2;
1888 pneg_string_new = mString * M_SQRT1_2;
1890 QTrx_string_pos = 0.;
1891 QTrx_string_neg = 0.;
1892 QTrx_string_new = 0.;
1893 QTry_string_pos = 0.;
1894 QTry_string_neg = 0.;
1895 QTry_string_new = 0.;
1897 Pythia8::FlavContainer flav_string_pos =
1898 bstring > 0 ? Pythia8::FlavContainer(idq2)
1899 : Pythia8::FlavContainer(idq1);
1901 Pythia8::FlavContainer flav_string_neg =
1902 bstring > 0 ? Pythia8::FlavContainer(idq1)
1903 : Pythia8::FlavContainer(idq2);
1905 bool found_forward_baryon =
false;
1907 bool done_forward_end =
false;
1910 bool energy_used_up =
false;
1911 while (!found_forward_baryon && !energy_used_up) {
1922 separate_fragment_baryon && from_forward && !done_forward_end,
1923 evec_basis, ppos_string_new, pneg_string_new, QTrx_string_pos,
1924 QTrx_string_neg, QTry_string_pos, QTry_string_neg, flav_string_pos,
1925 flav_string_neg, pdgid_frag, momentum_frag);
1931 QTrx_string_new = QTrx_string_pos + QTrx_string_neg;
1932 QTry_string_new = QTry_string_pos + QTry_string_neg;
1936 idqIn[0] = bstring > 0 ? flav_string_neg.id : flav_string_pos.id;
1937 idqIn[1] = bstring > 0 ? flav_string_pos.id : flav_string_neg.id;
1938 for (
int i = 0; i < 2; i++) {
1941 QTrn_string_pos = std::sqrt(QTrx_string_pos * QTrx_string_pos +
1942 QTry_string_pos * QTry_string_pos);
1943 QTrn_string_neg = std::sqrt(QTrx_string_neg * QTrx_string_neg +
1944 QTry_string_neg * QTry_string_neg);
1949 m_trans[0] = std::sqrt(m_const[0] * m_const[0] +
1950 QTrn_string_neg * QTrn_string_neg);
1954 m_trans[1] = std::sqrt(m_const[1] * m_const[1] +
1955 QTrn_string_pos * QTrn_string_pos);
1960 m_trans[0] = std::sqrt(m_const[0] * m_const[0] +
1961 QTrn_string_pos * QTrn_string_pos);
1965 m_trans[1] = std::sqrt(m_const[1] * m_const[1] +
1966 QTrn_string_neg * QTrn_string_neg);
1968 done_forward_end = done_forward_end || from_forward;
1969 found_forward_baryon =
1970 found_forward_baryon ||
1975 energy_used_up =
true;
1979 n_frag_prior += n_frag;
1980 for (
int i_frag = 0; i_frag < n_frag; i_frag++) {
1981 pdgid_frag_prior.push_back(pdgid_frag[i_frag]);
1982 momentum_frag_prior.push_back(momentum_frag[i_frag]);
1990 double mTsqr_string = 2. * ppos_string_new * pneg_string_new;
1991 mTrn_string_new = std::sqrt(mTsqr_string);
1992 QTrn_string_new = std::sqrt(QTrx_string_new * QTrx_string_new +
1993 QTry_string_new * QTry_string_new);
1994 if (mTrn_string_new < QTrn_string_new) {
1997 found_leading_baryon =
false;
2001 std::sqrt(mTsqr_string - QTrn_string_new * QTrn_string_new);
2005 if (mass_string_new > m_const[0] + m_const[1]) {
2006 do_string_fragmentation =
true;
2007 found_leading_baryon =
true;
2008 QTrx_add_pos = QTrx_string_pos;
2009 QTry_add_pos = QTry_string_pos;
2010 QTrx_add_neg = QTrx_string_neg;
2011 QTry_add_neg = QTry_string_neg;
2013 found_leading_baryon =
false;
2016 }
else if (n_frag == 2) {
2019 do_string_fragmentation =
false;
2020 found_leading_baryon =
true;
2024 if (found_leading_baryon) {
2028 if (found_leading_baryon) {
2031 for (
int i_frag = 0; i_frag < n_frag_prior; i_frag++) {
2032 logg[
LPythia].debug(
"appending the the fragmented hadron ",
2033 pdgid_frag_prior[i_frag],
2034 " to the intermediate particle list.");
2037 momentum_frag_prior[i_frag],
2038 intermediate_particles);
2040 logg[
LPythia].error(
"PDG ID ", pdgid_frag_prior[i_frag],
2041 " should exist in ParticleType.");
2042 throw std::runtime_error(
"string fragmentation failed.");
2044 number_of_fragments++;
2052 if (do_string_fragmentation) {
2053 mTrn_string_new = std::sqrt(2. * ppos_string_new * pneg_string_new);
2055 std::array<double, 2> ppos_parton;
2057 std::array<double, 2> pneg_parton;
2065 const double pb_const =
2066 (mTrn_string_new * mTrn_string_new + m_trans[0] * m_trans[0] -
2067 m_trans[1] * m_trans[1]) /
2068 (4. * pneg_string_new);
2069 const double pc_const =
2070 0.5 * m_trans[0] * m_trans[0] * ppos_string_new / pneg_string_new;
2071 ppos_parton[0] = pb_const + (bstring > 0 ? -1. : 1.) *
2072 std::sqrt(pb_const * pb_const - pc_const);
2073 ppos_parton[1] = ppos_string_new - ppos_parton[0];
2077 for (
int i = 0; i < 2; i++) {
2078 pneg_parton[i] = 0.5 * m_trans[i] * m_trans[i] / ppos_parton[i];
2081 const int status = 1;
2082 int color, anticolor;
2085 Pythia8::Vec4 pquark;
2105 bstring > 0 ? evec_basis[1] * (QTrx_string_neg - QTrx_add_neg) +
2106 evec_basis[2] * (QTry_string_neg - QTry_add_neg)
2107 : evec_basis[1] * (QTrx_string_pos - QTrx_add_pos) +
2108 evec_basis[2] * (QTry_string_pos - QTry_add_pos);
2110 evec_basis[0] * (ppos_parton[0] - pneg_parton[0]) * M_SQRT1_2 +
2112 const double E_quark =
2113 std::sqrt(m_const[0] * m_const[0] + three_mom.
sqr());
2114 pquark =
set_Vec4(E_quark, three_mom);
2116 pythia_hadron_->event.append(idqIn[0], status, color, anticolor, pquark,
2137 bstring > 0 ? evec_basis[1] * (QTrx_string_pos - QTrx_add_pos) +
2138 evec_basis[2] * (QTry_string_pos - QTry_add_pos)
2139 : evec_basis[1] * (QTrx_string_neg - QTrx_add_neg) +
2140 evec_basis[2] * (QTry_string_neg - QTry_add_neg);
2142 evec_basis[0] * (ppos_parton[1] - pneg_parton[1]) * M_SQRT1_2 +
2144 const double E_antiq =
2145 std::sqrt(m_const[1] * m_const[1] + three_mom.
sqr());
2146 pquark =
set_Vec4(E_antiq, three_mom);
2148 pythia_hadron_->event.append(idqIn[1], status, color, anticolor, pquark,
2152 do_string_fragmentation =
true;
2154 ppos_string_new = mString * M_SQRT1_2;
2155 pneg_string_new = mString * M_SQRT1_2;
2156 QTrx_string_new = 0.;
2157 QTry_string_new = 0.;
2158 QTrn_string_new = 0.;
2159 mTrn_string_new = mString;
2160 mass_string_new = mString;
2165 double sign_direction = 1.;
2166 if (bstring == -3) {
2170 sign_direction = -1;
2174 const double pCMquark =
pCM(mString, m_const[0], m_const[1]);
2175 const double E1 = std::sqrt(m_const[0] * m_const[0] + pCMquark * pCMquark);
2176 const double E2 = std::sqrt(m_const[1] * m_const[1] + pCMquark * pCMquark);
2178 ThreeVector direction = sign_direction * evecLong;
2181 const int status1 = 1, color1 = 1, anticolor1 = 0;
2182 Pythia8::Vec4 pquark =
set_Vec4(E1, -direction * pCMquark);
2184 pythia_hadron_->event.append(idqIn[0], status1, color1, anticolor1, pquark,
2187 const int status2 = 1, color2 = 0, anticolor2 = 1;
2188 pquark =
set_Vec4(E2, direction * pCMquark);
2190 pythia_hadron_->event.append(idqIn[1], status2, color2, anticolor2, pquark,
2194 if (do_string_fragmentation) {
2195 logg[
LPythia].debug(
"fragmenting a string with ", idqIn[0],
", ", idqIn[1]);
2201 if (!successful_hadronization) {
2208 pythia_hadron_->event, evec_basis, ppos_string_new, pneg_string_new,
2209 QTrx_string_new, QTry_string_new, QTrx_add_pos, QTry_add_pos,
2210 QTrx_add_neg, QTry_add_neg);
2211 if (!successful_kinematics) {
2215 for (
int ipyth = 0; ipyth <
pythia_hadron_->event.size(); ipyth++) {
2226 logg[
LPythia].debug(
"appending the fragmented hadron ", pythia_id,
2227 " to the intermediate particle list.");
2232 " does not exist in ParticleType - start over.");
2233 intermediate_particles.clear();
2237 number_of_fragments++;
2240 return number_of_fragments;
2244 bool from_forward,
bool separate_fragment_baryon,
2245 std::array<ThreeVector, 3> &evec_basis,
double &ppos_string,
2246 double &pneg_string,
double &QTrx_string_pos,
double &QTrx_string_neg,
2247 double &QTry_string_pos,
double &QTry_string_neg,
2248 Pythia8::FlavContainer &flav_string_pos,
2249 Pythia8::FlavContainer &flav_string_neg, std::vector<int> &pdgid_frag,
2250 std::vector<FourVector> &momentum_frag) {
2253 const int n_try = 10;
2255 momentum_frag.clear();
2257 if (ppos_string < 0. || pneg_string < 0.) {
2258 throw std::runtime_error(
"string has a negative lightcone momentum.");
2260 double mTsqr_string = 2. * ppos_string * pneg_string;
2262 double mTrn_string = std::sqrt(mTsqr_string);
2264 double QTrx_string_tot = QTrx_string_pos + QTrx_string_neg;
2265 double QTry_string_tot = QTry_string_pos + QTry_string_neg;
2266 double QTsqr_string_tot = std::fabs(QTrx_string_tot * QTrx_string_tot) +
2267 std::fabs(QTry_string_tot * QTry_string_tot);
2268 double QTrn_string_tot = std::sqrt(QTsqr_string_tot);
2269 if (mTrn_string < QTrn_string_tot) {
2273 double mass_string = std::sqrt(mTsqr_string - QTsqr_string_tot);
2274 logg[
LPythia].debug(
" Fragment off one hadron from a string ( ",
2275 flav_string_pos.id,
" , ", flav_string_neg.id,
2276 " ) with mass ", mass_string,
" GeV.");
2279 const double sigma_qt_frag =
pythia_hadron_->parm(
"StringPT:sigma");
2280 const double stop_string_mass =
2282 const double stop_string_smear =
2286 const double prob_enhance_qt =
2288 double fac_enhance_qt;
2292 fac_enhance_qt = 1.;
2306 logg[
LPythia].debug(
" Transverse momentum (", QTrx_new,
", ", QTry_new,
2307 ") GeV selected for the new qqbar pair.");
2316 double QTrx_had_1st =
2317 from_forward ? QTrx_string_pos + QTrx_new : QTrx_string_neg + QTrx_new;
2318 double QTry_had_1st =
2319 from_forward ? QTry_string_pos + QTry_new : QTry_string_neg + QTry_new;
2320 double QTrn_had_1st =
2321 std::sqrt(QTrx_had_1st * QTrx_had_1st + QTry_had_1st * QTry_had_1st);
2324 int pdgid_had_1st = 0;
2326 double mass_had_1st = 0.;
2329 Pythia8::FlavContainer flav_old =
2330 from_forward ? flav_string_pos : flav_string_neg;
2335 Pythia8::FlavContainer flav_new = Pythia8::FlavContainer(0);
2339 for (
int i_try = 0; i_try < n_try; i_try++) {
2344 if (pdgid_had_1st != 0) {
2347 logg[
LPythia].debug(
" number of tries of flavor selection : ",
2348 i_try + 1,
" in StringProcess::fragment_off_hadron.");
2352 if (pdgid_had_1st == 0) {
2356 " selected for the string end with ", flav_old.id);
2358 " selected for the (first) fragmented hadron.");
2359 bool had_1st_baryon =
pythia_hadron_->particleData.isBaryon(pdgid_had_1st);
2361 double mTrn_had_1st =
2362 std::sqrt(mass_had_1st * mass_had_1st + QTrn_had_1st * QTrn_had_1st);
2363 logg[
LPythia].debug(
" Transverse momentum (", QTrx_had_1st,
", ",
2365 ") GeV selected for the (first) fragmented hadron.");
2370 const double mass_min_to_continue =
2371 (stop_string_mass +
pythia_hadron_->particleData.m0(flav_new.id) +
2377 bool string_into_final_two = mass_string < mass_min_to_continue;
2378 if (string_into_final_two) {
2379 logg[
LPythia].debug(
" The string mass is below the mass threshold ",
2380 mass_min_to_continue,
2381 " GeV : finishing with two hadrons.");
2385 double ppos_had_1st = 0.;
2386 double pneg_had_1st = 0.;
2390 bool from_diquark_end =
2391 from_forward ?
pythia_hadron_->particleData.isDiquark(flav_string_pos.id)
2394 bool has_diquark_pos =
2398 if (string_into_final_two) {
2402 int pdgid_had_2nd = 0.;
2404 double mass_had_2nd = 0.;
2407 Pythia8::FlavContainer flav_new2 = Pythia8::FlavContainer(0);
2408 flav_new2.anti(flav_new);
2411 if (
pythia_hadron_->particleData.isDiquark(flav_string_neg.id) &&
2412 pythia_hadron_->particleData.isDiquark(flav_new2.id) && from_forward) {
2415 if (
pythia_hadron_->particleData.isDiquark(flav_string_pos.id) &&
2416 pythia_hadron_->particleData.isDiquark(flav_new2.id) && !from_forward) {
2419 for (
int i_try = 0; i_try < n_try; i_try++) {
2424 if (pdgid_had_2nd != 0) {
2430 if (pdgid_had_2nd == 0) {
2434 " selected for the (second) fragmented hadron.");
2435 bool had_2nd_baryon =
pythia_hadron_->particleData.isBaryon(pdgid_had_2nd);
2443 double QTrx_had_2nd =
2444 from_forward ? QTrx_string_neg - QTrx_new : QTrx_string_pos - QTrx_new;
2445 double QTry_had_2nd =
2446 from_forward ? QTry_string_neg - QTry_new : QTry_string_pos - QTry_new;
2447 double QTrn_had_2nd =
2448 std::sqrt(QTrx_had_2nd * QTrx_had_2nd + QTry_had_2nd * QTry_had_2nd);
2449 double mTrn_had_2nd =
2450 std::sqrt(mass_had_2nd * mass_had_2nd + QTrn_had_2nd * QTrn_had_2nd);
2451 logg[
LPythia].debug(
" Transverse momentum (", QTrx_had_2nd,
", ",
2453 ") GeV selected for the (second) fragmented hadron.");
2455 double ppos_had_2nd = 0.;
2456 double pneg_had_2nd = 0.;
2462 bool found_kinematics =
2465 separate_fragment_baryon && has_diquark_pos && had_1st_baryon,
2466 ppos_string, pneg_string, mTrn_had_1st, mTrn_had_2nd,
2467 ppos_had_1st, ppos_had_2nd, pneg_had_1st, pneg_had_2nd)
2469 separate_fragment_baryon && has_diquark_pos && had_2nd_baryon,
2470 ppos_string, pneg_string, mTrn_had_2nd, mTrn_had_1st,
2471 ppos_had_2nd, ppos_had_1st, pneg_had_2nd, pneg_had_1st);
2472 if (!found_kinematics) {
2479 QTrx_string_pos = 0.;
2480 QTry_string_pos = 0.;
2483 pdgid_frag.push_back(pdgid_had_1st);
2485 (ppos_had_1st + pneg_had_1st) * M_SQRT1_2,
2486 evec_basis[0] * (ppos_had_1st - pneg_had_1st) * M_SQRT1_2 +
2487 evec_basis[1] * QTrx_had_1st + evec_basis[2] * QTry_had_1st);
2488 momentum_frag.push_back(mom_had_1st);
2491 pdgid_frag.push_back(pdgid_had_2nd);
2493 (ppos_had_2nd + pneg_had_2nd) * M_SQRT1_2,
2494 evec_basis[0] * (ppos_had_2nd - pneg_had_2nd) * M_SQRT1_2 +
2495 evec_basis[1] * QTrx_had_2nd + evec_basis[2] * QTry_had_2nd);
2496 momentum_frag.push_back(mom_had_2nd);
2505 double stringz_a_use, stringz_b_use;
2508 if (separate_fragment_baryon && from_diquark_end && had_1st_baryon) {
2518 double xfrac =
sample_zLund(stringz_a_use, stringz_b_use, mTrn_had_1st);
2522 ppos_had_1st = xfrac * ppos_string;
2523 pneg_had_1st = 0.5 * mTrn_had_1st * mTrn_had_1st / ppos_had_1st;
2524 if (pneg_had_1st > pneg_string) {
2530 pneg_had_1st = xfrac * pneg_string;
2531 ppos_had_1st = 0.5 * mTrn_had_1st * mTrn_had_1st / pneg_had_1st;
2532 if (ppos_had_1st > ppos_string) {
2538 pdgid_frag.push_back(pdgid_had_1st);
2540 (ppos_had_1st + pneg_had_1st) * M_SQRT1_2,
2541 evec_basis[0] * (ppos_had_1st - pneg_had_1st) * M_SQRT1_2 +
2542 evec_basis[1] * QTrx_had_1st + evec_basis[2] * QTry_had_1st);
2543 momentum_frag.push_back(mom_had_1st);
2546 ppos_string -= ppos_had_1st;
2547 pneg_string -= pneg_had_1st;
2557 flav_string_pos.anti(flav_new);
2558 QTrx_string_pos = -QTrx_new;
2559 QTry_string_pos = -QTry_new;
2563 flav_string_neg.anti(flav_new);
2564 QTrx_string_neg = -QTrx_new;
2565 QTry_string_neg = -QTry_new;
2575 const int baryon_number =
2579 int pdgid_hadron = 0;
2582 Pythia8::FlavContainer flav1 = Pythia8::FlavContainer(idq1);
2583 Pythia8::FlavContainer flav2 = Pythia8::FlavContainer(idq2);
2584 const int n_try = 10;
2585 for (
int i_try = 0; i_try < n_try; i_try++) {
2587 if (pdgid_hadron != 0) {
2588 return pdgid_hadron;
2596 std::array<int, 5> frag_net_q;
2599 for (
int iq = 0; iq < 5; iq++) {
2601 pythia_hadron_->particleData.nQuarksInCode(std::abs(idq1), iq + 1);
2603 pythia_hadron_->particleData.nQuarksInCode(std::abs(idq2), iq + 1);
2604 nq1 = idq1 > 0 ? nq1 : -nq1;
2605 nq2 = idq2 > 0 ? nq2 : -nq2;
2606 frag_net_q[iq] = nq1 + nq2;
2608 const int frag_iso3 = frag_net_q[1] - frag_net_q[0];
2609 const int frag_strange = -frag_net_q[2];
2610 const int frag_charm = frag_net_q[3];
2611 const int frag_bottom = -frag_net_q[4];
2612 logg[
LPythia].debug(
" conserved charges : iso3 = ", frag_iso3,
2613 ", strangeness = ", frag_strange,
2614 ", charmness = ", frag_charm,
2615 ", bottomness = ", frag_bottom);
2617 std::vector<int> pdgid_possible;
2618 std::vector<double> weight_possible;
2619 std::vector<double> weight_summed;
2624 if (!ptype.is_hadron()) {
2627 const int pdgid = ptype.pdgcode().get_decimal();
2629 (baryon_number == 3 * ptype.pdgcode().baryon_number()) &&
2630 (frag_iso3 == ptype.pdgcode().isospin3()) &&
2631 (frag_strange == ptype.pdgcode().strangeness()) &&
2632 (frag_charm == ptype.pdgcode().charmness()) &&
2633 (frag_bottom == ptype.pdgcode().bottomness())) {
2634 const int spin_degeneracy = ptype.pdgcode().spin_degeneracy();
2635 const double mass_pole = ptype.mass();
2636 const double weight =
static_cast<double>(spin_degeneracy) / mass_pole;
2637 pdgid_possible.push_back(pdgid);
2638 weight_possible.push_back(weight);
2640 logg[
LPythia].debug(
" PDG id ", pdgid,
" is possible with weight ",
2644 const int n_possible = pdgid_possible.size();
2645 weight_summed.push_back(0.);
2646 for (
int i = 0; i < n_possible; i++) {
2647 weight_summed.push_back(weight_summed[i] + weight_possible[i]);
2653 for (
int i = 0; i < n_possible; i++) {
2654 if ((uspc >= weight_summed[i]) && (uspc < weight_summed[i + 1])) {
2655 return pdgid_possible[i];
2672 bool end1_is_quark = idq1 > 0 &&
pythia_hadron_->particleData.isQuark(idq1);
2673 bool end1_is_antidiq =
2676 bool end2_is_antiq = idq2 < 0 &&
pythia_hadron_->particleData.isQuark(idq2);
2677 bool end2_is_diquark =
2681 if (end1_is_quark) {
2682 if (end2_is_antiq) {
2685 }
else if (end2_is_diquark) {
2691 }
else if (end1_is_antidiq) {
2692 if (end2_is_antiq) {
2705 std::array<int, 5> net_qnumber;
2706 for (
int iflav = 0; iflav < 5; iflav++) {
2707 net_qnumber[iflav] = 0;
2710 pythia_hadron_->particleData.nQuarksInCode(std::abs(idq1), iflav + 1);
2713 qnumber1 = -qnumber1;
2715 net_qnumber[iflav] += qnumber1;
2718 pythia_hadron_->particleData.nQuarksInCode(std::abs(idq2), iflav + 1);
2721 qnumber2 = -qnumber2;
2723 net_qnumber[iflav] += qnumber2;
2727 std::vector<int> pdgid_possible;
2729 std::vector<double> mass_diff;
2731 if (!ptype.is_hadron() || ptype.is_stable() ||
2732 ptype.pdgcode().baryon_number() != baryon) {
2736 const int pdgid = ptype.pdgcode().get_decimal();
2737 const double mass_min = ptype.min_mass_spectral();
2738 if (mass < mass_min) {
2743 if (ptype.pdgcode().isospin3() != net_qnumber[1] - net_qnumber[0]) {
2747 if (ptype.pdgcode().strangeness() != -net_qnumber[2]) {
2751 if (ptype.pdgcode().charmness() != net_qnumber[3]) {
2755 if (ptype.pdgcode().bottomness() != -net_qnumber[4]) {
2760 const double mass_pole = ptype.mass();
2762 pdgid_possible.push_back(pdgid);
2763 mass_diff.push_back(mass - mass_pole);
2766 const int n_res = pdgid_possible.size();
2772 int ires_closest = 0;
2773 double mass_diff_min = std::fabs(mass_diff[0]);
2776 for (
int ires = 1; ires < n_res; ires++) {
2777 if (std::fabs(mass_diff[ires]) < mass_diff_min) {
2778 ires_closest = ires;
2779 mass_diff_min = mass_diff[ires];
2782 logg[
LPythia].debug(
"Quark constituents ", idq1,
" and ", idq2,
" with mass ",
2783 mass,
" (GeV) turned into a resonance ",
2784 pdgid_possible[ires_closest]);
2785 return pdgid_possible[ires_closest];
2789 bool separate_fragment_hadron,
double ppos_string,
double pneg_string,
2790 double mTrn_had_forward,
double mTrn_had_backward,
double &ppos_had_forward,
2791 double &ppos_had_backward,
double &pneg_had_forward,
2792 double &pneg_had_backward) {
2793 const double mTsqr_string = 2. * ppos_string * pneg_string;
2794 if (mTsqr_string < 0.) {
2797 const double mTrn_string = std::sqrt(mTsqr_string);
2798 if (mTrn_string < mTrn_had_forward + mTrn_had_backward) {
2803 const double mTsqr_had_forward = mTrn_had_forward * mTrn_had_forward;
2805 const double mTsqr_had_backward = mTrn_had_backward * mTrn_had_backward;
2819 const double xm_diff =
2820 (mTsqr_had_forward - mTsqr_had_backward) / mTsqr_string;
2821 const double xe_pos = 0.5 * (1. + xm_diff);
2822 const double xe_neg = 0.5 * (1. - xm_diff);
2825 const double lambda_sqr =
2826 pow_int(mTsqr_string - mTsqr_had_forward - mTsqr_had_backward, 2) -
2827 4. * mTsqr_had_forward * mTsqr_had_backward;
2828 if (lambda_sqr <= 0.) {
2831 const double lambda = std::sqrt(lambda_sqr);
2832 const double b_lund =
2837 const double prob_reverse =
2838 std::exp(-b_lund * lambda) / (1. + std::exp(-b_lund * lambda));
2839 double xpz_pos = 0.5 * lambda / mTsqr_string;
2844 ppos_had_forward = (xe_pos + xpz_pos) * ppos_string;
2845 ppos_had_backward = (xe_neg - xpz_pos) * ppos_string;
2847 pneg_had_forward = 0.5 * mTsqr_had_forward / ppos_had_forward;
2848 pneg_had_backward = 0.5 * mTsqr_had_backward / ppos_had_backward;
2856 bool xfrac_accepted =
false;
2864 while (!xfrac_accepted) {
2865 const double fac_env = b * mTrn * mTrn;
2869 const double xfrac_inv = 1. - std::log(u_aux) / fac_env;
2870 assert(xfrac_inv >= 1.);
2873 const double xf_ratio = std::pow(1. - 1. / xfrac_inv, a) / xfrac_inv;
2878 xfrac = 1. / xfrac_inv;
2879 xfrac_accepted =
true;
2886 Pythia8::Event &event_fragments, std::array<ThreeVector, 3> &evec_basis,
2887 double ppos_string,
double pneg_string,
double QTrx_string,
2888 double QTry_string,
double QTrx_add_pos,
double QTry_add_pos,
2889 double QTrx_add_neg,
double QTry_add_neg) {
2890 logg[
LPythia].debug(
"Correcting the kinematics of fragmented hadrons...");
2892 if (ppos_string < 0. || pneg_string < 0.) {
2894 " wrong lightcone momenta of string : ppos_string (GeV) = ",
2895 ppos_string,
" pneg_string (GeV) = ", pneg_string);
2899 const double yrapid_string = 0.5 * std::log(ppos_string / pneg_string);
2900 logg[
LOutput].debug(
"Momentum-space rapidity of the string should be ",
2904 const double mTrn_string = std::sqrt(2. * ppos_string * pneg_string);
2905 logg[
LOutput].debug(
"Transvere mass (GeV) of the string should be ",
2908 const double QTrn_string =
2909 std::sqrt(QTrx_string * QTrx_string + QTry_string * QTry_string);
2910 if (mTrn_string < QTrn_string) {
2912 " wrong transverse mass of string : mTrn_string (GeV) = ", mTrn_string,
2913 " QTrn_string (GeV) = ", QTrn_string);
2916 const double msqr_string =
2917 mTrn_string * mTrn_string - QTrn_string * QTrn_string;
2919 const double mass_string = std::sqrt(msqr_string);
2920 logg[
LOutput].debug(
"The string mass (GeV) should be ", mass_string);
2924 if (std::fabs(QTrx_add_pos) <
small_number * mass_string &&
2925 std::fabs(QTry_add_pos) <
small_number * mass_string &&
2926 std::fabs(QTrx_add_neg) <
small_number * mass_string &&
2927 std::fabs(QTry_add_neg) <
small_number * mass_string) {
2928 logg[
LOutput].debug(
" no need to add transverse momenta - skipping.");
2934 for (
int ipyth = 1; ipyth < event_fragments.size(); ipyth++) {
2935 if (!event_fragments[ipyth].isFinal()) {
2940 FourVector(event_fragments[ipyth].e(), event_fragments[ipyth].px(),
2941 event_fragments[ipyth].py(), event_fragments[ipyth].pz());
2942 ptot_string_ini += p_frag;
2944 const double E_string_ini = ptot_string_ini.
x0();
2945 const double pz_string_ini = ptot_string_ini.
threevec() * evec_basis[0];
2946 const double ppos_string_ini = (E_string_ini + pz_string_ini) * M_SQRT1_2;
2947 const double pneg_string_ini = (E_string_ini - pz_string_ini) * M_SQRT1_2;
2949 const double yrapid_string_ini =
2950 0.5 * std::log(ppos_string_ini / pneg_string_ini);
2956 int ip_backward = 0;
2957 double y_forward = 0.;
2958 double y_backward = 0.;
2959 ptot_string_ini =
FourVector(0., 0., 0., 0.);
2961 for (
int ipyth = 1; ipyth < event_fragments.size(); ipyth++) {
2962 if (!event_fragments[ipyth].isFinal()) {
2967 FourVector(event_fragments[ipyth].e(), event_fragments[ipyth].px(),
2968 event_fragments[ipyth].py(), event_fragments[ipyth].pz());
2969 ptot_string_ini += p_frag;
2971 const double E_frag = p_frag.
x0();
2972 const double pl_frag = p_frag.
threevec() * evec_basis[0];
2973 double y_current = 0.5 * std::log((E_frag + pl_frag) / (E_frag - pl_frag));
2974 if (y_current > y_forward) {
2976 y_forward = y_current;
2978 if (y_current < y_backward) {
2979 ip_backward = ipyth;
2980 y_backward = y_current;
2983 logg[
LOutput].debug(
" The most forward hadron is ip_forward = ", ip_forward,
2984 " with rapidity ", y_forward);
2985 logg[
LOutput].debug(
" The most backward hadron is ip_backward = ",
2986 ip_backward,
" with rapidity ", y_backward);
2988 const double px_string_ini = ptot_string_ini.
threevec() * evec_basis[1];
2989 const double py_string_ini = ptot_string_ini.
threevec() * evec_basis[2];
2993 bool correct_px = std::fabs(px_string_ini + QTrx_add_pos + QTrx_add_neg -
2997 " input transverse momenta in x-axis are not consistent.");
3002 bool correct_py = std::fabs(py_string_ini + QTry_add_pos + QTry_add_neg -
3006 " input transverse momenta in y-axis are not consistent.");
3010 Pythia8::Vec4 pvec_string_now =
3014 " Adding transverse momentum to the most forward hadron.");
3015 pvec_string_now -= event_fragments[ip_forward].p();
3016 const double mass_frag_pos = event_fragments[ip_forward].p().mCalc();
3019 event_fragments[ip_forward].e(), event_fragments[ip_forward].px(),
3020 event_fragments[ip_forward].py(), event_fragments[ip_forward].pz());
3023 QTrx_add_pos * evec_basis[1] +
3024 QTry_add_pos * evec_basis[2];
3026 double E_new_frag_pos =
3027 std::sqrt(mom_new_frag_pos.
sqr() + mass_frag_pos * mass_frag_pos);
3028 Pythia8::Vec4 pvec_new_frag_pos =
set_Vec4(E_new_frag_pos, mom_new_frag_pos);
3029 pvec_string_now += pvec_new_frag_pos;
3031 event_fragments[ip_forward].p(pvec_new_frag_pos);
3034 " Adding transverse momentum to the most backward hadron.");
3035 pvec_string_now -= event_fragments[ip_backward].p();
3036 const double mass_frag_neg = event_fragments[ip_backward].p().mCalc();
3039 event_fragments[ip_backward].e(), event_fragments[ip_backward].px(),
3040 event_fragments[ip_backward].py(), event_fragments[ip_backward].pz());
3043 QTrx_add_neg * evec_basis[1] +
3044 QTry_add_neg * evec_basis[2];
3046 double E_new_frag_neg =
3047 std::sqrt(mom_new_frag_neg.
sqr() + mass_frag_neg * mass_frag_neg);
3048 Pythia8::Vec4 pvec_new_frag_neg =
set_Vec4(E_new_frag_neg, mom_new_frag_neg);
3049 pvec_string_now += pvec_new_frag_neg;
3051 event_fragments[ip_backward].p(pvec_new_frag_neg);
3054 event_fragments[0].p(pvec_string_now);
3055 event_fragments[0].m(pvec_string_now.mCalc());
3058 double mTrn_frag_all = 0.;
3059 for (
int ipyth = 1; ipyth < event_fragments.size(); ipyth++) {
3060 if (!event_fragments[ipyth].isFinal()) {
3065 FourVector(event_fragments[ipyth].e(), event_fragments[ipyth].px(),
3066 event_fragments[ipyth].py(), event_fragments[ipyth].pz());
3067 ptot_string_ini += p_frag;
3069 const double E_frag = p_frag.
x0();
3070 const double pl_frag = p_frag.
threevec() * evec_basis[0];
3071 const double ppos_frag = (E_frag + pl_frag) * M_SQRT1_2;
3072 const double pneg_frag = (E_frag - pl_frag) * M_SQRT1_2;
3073 const double mTrn_frag = std::sqrt(2. * ppos_frag * pneg_frag);
3074 mTrn_frag_all += mTrn_frag;
3077 "Sum of transverse masses (GeV) of all fragmented hadrons : ",
3081 if (mTrn_string < mTrn_frag_all) {
3082 logg[
LOutput].debug(
" which is larger than mT of the actual string ",
3087 double mass_string_now = pvec_string_now.mCalc();
3088 double msqr_string_now = mass_string_now * mass_string_now;
3091 FourVector(pvec_string_now.e(), pvec_string_now.px(),
3092 pvec_string_now.py(), pvec_string_now.pz());
3093 double E_string_now = p_string_now.
x0();
3094 double pz_string_now = p_string_now.
threevec() * evec_basis[0];
3095 logg[
LOutput].debug(
"The string mass (GeV) at this point : ",
3097 double ppos_string_now = (E_string_now + pz_string_now) * M_SQRT1_2;
3098 double pneg_string_now = (E_string_now - pz_string_now) * M_SQRT1_2;
3100 double yrapid_string_now = 0.5 * std::log(ppos_string_now / pneg_string_now);
3101 logg[
LOutput].debug(
"The momentum-space rapidity of string at this point : ",
3104 "The momentum-space rapidities of hadrons will be changed.");
3105 const int niter_max = 10000;
3106 bool accepted =
false;
3107 double fac_all_yrapid = 1.;
3112 for (
int iiter = 0; iiter < niter_max; iiter++) {
3113 if (std::fabs(mass_string_now - mass_string) <
really_small * mass_string) {
3117 double E_deriv = 0.;
3118 double pz_deriv = 0.;
3122 for (
int ipyth = 1; ipyth < event_fragments.size(); ipyth++) {
3123 if (!event_fragments[ipyth].isFinal()) {
3128 FourVector(event_fragments[ipyth].e(), event_fragments[ipyth].px(),
3129 event_fragments[ipyth].py(), event_fragments[ipyth].pz());
3130 const double E_frag = p_frag.
x0();
3131 const double pl_frag = p_frag.
threevec() * evec_basis[0];
3132 const double ppos_frag = (E_frag + pl_frag) * M_SQRT1_2;
3133 const double pneg_frag = (E_frag - pl_frag) * M_SQRT1_2;
3134 const double mTrn_frag = std::sqrt(2. * ppos_frag * pneg_frag);
3135 const double y_frag = 0.5 * std::log(ppos_frag / pneg_frag);
3137 E_deriv += mTrn_frag * (y_frag - yrapid_string_now) * std::sinh(y_frag);
3138 pz_deriv += mTrn_frag * (y_frag - yrapid_string_now) * std::cosh(y_frag);
3140 double slope = 2. * (E_string_now * E_deriv - pz_string_now * pz_deriv);
3141 double fac_yrapid = 1. + std::tanh((msqr_string - msqr_string_now) / slope);
3142 fac_all_yrapid *= fac_yrapid;
3146 (1. - fac_yrapid) * yrapid_string_now);
3148 pvec_string_now = event_fragments[0].p();
3149 mass_string_now = pvec_string_now.mCalc();
3150 msqr_string_now = mass_string_now * mass_string_now;
3151 p_string_now =
FourVector(pvec_string_now.e(), pvec_string_now.px(),
3152 pvec_string_now.py(), pvec_string_now.pz());
3153 E_string_now = p_string_now.
x0();
3154 pz_string_now = p_string_now.
threevec() * evec_basis[0];
3155 ppos_string_now = (E_string_now + pz_string_now) * M_SQRT1_2;
3156 pneg_string_now = (E_string_now - pz_string_now) * M_SQRT1_2;
3157 yrapid_string_now = 0.5 * std::log(ppos_string_now / pneg_string_now);
3158 logg[
LOutput].debug(
" step ", iiter + 1,
" : fac_yrapid = ", fac_yrapid,
3159 " , string mass (GeV) = ", mass_string_now,
3160 " , string rapidity = ", yrapid_string_now);
3164 logg[
LOutput].debug(
" Too many iterations in rapidity rescaling.");
3168 "The overall factor multiplied to the rapidities of hadrons = ",
3170 logg[
LOutput].debug(
"The momentum-space rapidity of string at this point : ",
3172 const double y_diff = yrapid_string - yrapid_string_now;
3173 logg[
LOutput].debug(
"The hadrons will be boosted by rapidity ", y_diff,
3174 " for the longitudinal momentum conservation.");
3183 double suppression_factor) {
3198 ParticleList &list) {
3199 assert(list.size() >= 2);
3200 int end = list.size() - 1;
3203 i1 <= end && !list[i1].pdgcode().contains_enough_valence_quarks(nq1);
3207 i2 >= 0 && !list[i2].pdgcode().contains_enough_valence_quarks(nq2);
3210 std::pair<int, int> indices(i1, i2);
3215 ParticleList &outgoing_particles,
3217 double suppression_factor) {
3220 data.set_cross_section_scaling_factor(0.0);
3223 std::sort(outgoing_particles.begin(), outgoing_particles.end(),
3225 return i.momentum().velocity() * evecLong >
3226 j.momentum().velocity() * evecLong;
3229 switch (baryon_string) {
3243 throw std::runtime_error(
"string is neither mesonic nor baryonic");
3248 std::pair<int, int> i =
find_leading(nq1, nq2, outgoing_particles);
3249 std::pair<int, int> j =
find_leading(nq2, nq1, outgoing_particles);
3250 if (baryon_string == 0 && i.second - i.first < j.second - j.first) {
3253 suppression_factor);
3257 suppression_factor);
3277 throw std::runtime_error(
"StringProcess::pdg_map_for_pythia failed.");
The FourVector class holds relevant values in Minkowski spacetime with (+, −, −, −) metric signature.
FourVector lorentz_boost(const ThreeVector &v) const
Returns the FourVector boosted with velocity v.
ThreeVector threevec() const
ThreeVector velocity() const
Get the velocity (3-vector divided by zero component).
ParticleData contains the dynamic information of a certain particle.
PdgCode pdgcode() const
Get the pdgcode of the particle.
void set_4momentum(const FourVector &momentum_vector)
Set the particle's 4-momentum directly.
void set_formation_time(double form_time)
Set the absolute formation time.
void set_cross_section_scaling_factor(const double &xsec_scal)
Set the particle's initial cross_section_scaling_factor.
static const ParticleType & find(PdgCode pdgcode)
Returns the ParticleType object for the given pdgcode.
static const ParticleTypeList & list_all()
PdgCode stores a Particle Data Group Particle Numbering Scheme particle type number.
int baryon_number() const
int net_quark_number(const int quark) const
Returns the net number of quarks with given flavour number For public use, see strangeness(),...
std::array< int, 3 > quark_content() const
The return is always an array of three numbers, which are pdgcodes of quarks: 1 - d,...
int32_t get_decimal() const
int charge() const
The charge of the particle.
Pythia8::StringFlav pythia_stringflav_
An object for the flavor selection in string fragmentation in the case of separate fragmentation func...
bool remake_kinematics_fragments(Pythia8::Event &event_fragments, std::array< ThreeVector, 3 > &evec_basis, double ppos_string, double pneg_string, double QTrx_string, double QTry_string, double QTrx_add_pos, double QTry_add_pos, double QTrx_add_neg, double QTry_add_neg)
bool next_SDiff(bool is_AB_to_AX)
Single-diffractive process is based on single pomeron exchange described in Ingelman:1984ns .
pythia_map hard_map_
Map object to contain the different pythia objects.
static FourVector reorient(Pythia8::Particle &particle, std::array< ThreeVector, 3 > &evec_basis)
compute the four-momentum properly oriented in the lab frame.
Pythia8::SigmaTotal pythia_sigmatot_
An object to compute cross-sections.
double pow_fgluon_beta_
parameter for the gluon distribution function
std::array< int, 2 > NpartString_
number of particles fragmented from strings
Pythia8::Event event_intermediate_
event record for intermediate partonic state in the hard string routine
std::array< PdgCode, 2 > PDGcodes_
PdgCodes of incoming particles.
double time_formation_const_
constant proper time in the case of constant formation time [fm]
double PNegB_
backward lightcone momentum p^{-} of incoming particle B in CM-frame [GeV]
void find_junction_leg(bool sign_color, std::vector< int > &col, Pythia8::Event &event_intermediate, Pythia8::Event &event_hadronize)
Identify partons, which are associated with junction legs, from a given PYTHIA event record.
double pow_fquark_beta_
parameter for the quark distribution function
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,...
static int pdg_map_for_pythia(PdgCode &pdg)
Take pdg code and map onto particle specie which can be handled by PYTHIA.
double prob_proton_to_d_uu_
Probability of splitting a nucleon into the quark flavour it has only once and a diquark it has twice...
FourVector ucomAB_
velocity four vector of the center of mass in the lab frame
ThreeVector vcomAB_
velocity three vector of the center of mass in the lab frame
bool make_final_state_2strings(const std::array< std::array< int, 2 >, 2 > &quarks, const std::array< FourVector, 2 > &pstr_com, const std::array< double, 2 > &m_str, const std::array< ThreeVector, 2 > &evec_str, bool flip_string_ends, bool separate_fragment_baryon)
Prepare kinematics of two strings, fragment them and append to final_state.
void compute_incoming_lightcone_momenta()
compute the lightcone momenta of incoming particles where the longitudinal direction is set to be sam...
int fragment_string(int idq1, int idq2, double mString, ThreeVector &evecLong, bool flip_string_ends, bool separate_fragment_baryon, ParticleList &intermediate_particles)
perform string fragmentation to determine species and momenta of hadrons by exploiting PYTHIA 8....
double popcorn_rate_
popcorn rate
double pmin_gluon_lightcone_
the minimum lightcone momentum scale carried by a gluon [GeV]
bool splitting_gluon_qqbar(Pythia8::Event &event_intermediate, std::array< int, 5 > &nquark_total, std::array< int, 5 > &nantiq_total, bool sign_constituent, std::array< std::array< int, 5 >, 2 > &excess_constituent)
Take total number of quarks and check if the system has enough constituents that need to be converted...
static std::pair< int, int > find_leading(int nq1, int nq2, ParticleList &list)
Find the leading string fragments.
double PPosA_
forward lightcone momentum p^{+} of incoming particle A in CM-frame [GeV]
double sqrtsAB_
sqrt of Mandelstam variable s of collision [GeV]
ParticleList final_state_
final state array which must be accessed after the collision
double PNegA_
backward lightcone momentum p^{-} of incoming particle A in CM-frame [GeV]
static double sample_zLund(double a, double b, double mTrn)
Sample lightcone momentum fraction according to the LUND fragmentation function.
int append_final_state(ParticleList &intermediate_particles, const FourVector &uString, const ThreeVector &evecLong)
compute the formation time and fill the arrays with final-state particles as described in Andersson:1...
bool use_monash_tune_
Whether to use the monash tune Skands:2014pea for all string processes.
double soft_t_form_
factor to be multiplied to formation times in soft strings
static void make_string_ends(const PdgCode &pdgcode_in, int &idq1, int &idq2, double xi)
make a random selection to determine partonic contents at the string ends.
std::unique_ptr< Pythia8::Pythia > pythia_hadron_
PYTHIA object used in fragmentation.
double massA_
mass of incoming particle A [GeV]
void common_setup_pythia(Pythia8::Pythia *pythia_in, double strange_supp, double diquark_supp, double popcorn_rate, double stringz_a, double stringz_b, double string_sigma_T)
Common setup of PYTHIA objects for soft and hard string routines.
double PPosB_
forward lightcone momentum p^{+} of incoming particle B in CM-frame [GeV]
std::array< ThreeVector, 3 > evecBasisAB_
Orthonormal basis vectors in the center of mass frame, where the 0th one is parallel to momentum of i...
int fragment_off_hadron(bool from_forward, bool separate_fragment_baryon, std::array< ThreeVector, 3 > &evec_basis, double &ppos_string, double &pneg_string, double &QTrx_string_pos, double &QTrx_string_neg, double &QTry_string_pos, double &QTry_string_neg, Pythia8::FlavContainer &flav_string_pos, Pythia8::FlavContainer &flav_string_neg, std::vector< int > &pdgid_frag, std::vector< FourVector > &momentum_frag)
Fragment one hadron from a given string configuration if the string mass is above threshold (given by...
bool restore_constituent(Pythia8::Event &event_intermediate, std::array< std::array< int, 5 >, 2 > &excess_quark, std::array< std::array< int, 5 >, 2 > &excess_antiq)
Take the intermediate partonic state from PYTHIA event with mapped hadrons and convert constituents i...
double string_sigma_T_
transverse momentum spread in string fragmentation
static void make_orthonormal_basis(ThreeVector &evec_polar, std::array< ThreeVector, 3 > &evec_basis)
compute three orthonormal basis vectors from unit vector in the longitudinal direction
int get_index_forward(bool find_forward, int np_end, Pythia8::Event &event)
Obtain index of the most forward or backward particle in a given PYTHIA event record.
static void convert_KaonLS(int &pythia_id)
convert Kaon-L or Kaon-S into K0 or Anti-K0
double additional_xsec_supp_
additional cross-section suppression factor to take coherence effect into account.
static void assign_all_scaling_factors(int baryon_string, ParticleList &outgoing_particles, const ThreeVector &evecLong, double suppression_factor)
Assign a cross section scaling factor to all outgoing particles.
double strange_supp_
strange quark suppression factor
static int diquark_from_quarks(int q1, int q2)
Construct diquark from two quarks.
bool make_lightcone_final_two(bool separate_fragment_hadron, double ppos_string, double pneg_string, double mTrn_had_forward, double mTrn_had_backward, double &ppos_had_forward, double &ppos_had_backward, double &pneg_had_forward, double &pneg_had_backward)
Determines lightcone momenta of two final hadrons fragmented from a string in the same way as StringF...
void replace_constituent(Pythia8::Particle &particle, std::array< int, 5 > &excess_constituent)
Convert a partonic PYTHIA particle into the desired species and update the excess of constituents.
double kappa_tension_string_
string tension [GeV/fm]
double pow_fquark_alpha_
parameter for the quark distribution function
void shift_rapidity_event(Pythia8::Event &event, std::array< ThreeVector, 3 > &evec_basis, double factor_yrapid, double diff_yrapid)
Shift the momentum rapidity of all particles in a given event record.
double stringz_b_leading_
parameter (StringZ:bLund) for the fragmentation function of leading baryon in soft non-diffractive st...
static bool append_intermediate_list(int pdgid, FourVector momentum, ParticleList &intermediate_particles)
append new particle from PYTHIA to a specific particle list
bool mass_dependent_formation_times_
Whether the formation time should depend on the mass of the fragment according to Andersson:1983ia e...
double stringz_b_produce_
parameter (StringZ:bLund) for the fragmentation function of other (produced) hadrons in soft non-diff...
bool next_BBbarAnn()
Baryon-antibaryon annihilation process Based on what UrQMD Bass:1998ca , Bleicher:1999xi does,...
int NpartFinal_
total number of final state particles
static Pythia8::Vec4 set_Vec4(double energy, const ThreeVector &mom)
Easy setter of Pythia Vec4 from SMASH.
double stringz_a_leading_
parameter (StringZ:aLund) for the fragmentation function of leading baryon in soft non-diffractive st...
bool set_mass_and_direction_2strings(const std::array< std::array< int, 2 >, 2 > &quarks, const std::array< FourVector, 2 > &pstr_com, std::array< double, 2 > &m_str, std::array< ThreeVector, 2 > &evec_str)
Determine string masses and directions in which strings are stretched.
void init(const ParticleList &incoming, double tcoll)
initialization feed intial particles, time of collision and gamma factor of the center of mass.
double sigma_qperp_
Transverse momentum spread of the excited strings.
void rearrange_excess(std::array< int, 5 > &nquark_total, std::array< std::array< int, 5 >, 2 > &excess_quark, std::array< std::array< int, 5 >, 2 > &excess_antiq)
Take total number of quarks and check if the system has enough constituents that need to be converted...
int get_resonance_from_quark(int idq1, int idq2, double mass)
bool next_NDiffHard()
Hard Non-diffractive process is based on PYTHIA 8 with partonic showers and interactions.
bool separate_fragment_baryon_
Whether to use a separate fragmentation function for leading baryons.
std::array< FourVector, 2 > plab_
momenta of incoming particles in the lab frame [GeV]
StringProcess(double string_tension, double time_formation, double gluon_beta, double gluon_pmin, double quark_alpha, double quark_beta, double strange_supp, double diquark_supp, double sigma_perp, double stringz_a_leading, double stringz_b_leading, double stringz_a, double stringz_b, double string_sigma_T, double factor_t_form, bool mass_dependent_formation_times, double prob_proton_to_d_uu, bool separate_fragment_baryon, double popcorn_rate, bool use_monash_tune)
Constructor, initializes pythia.
std::array< FourVector, 2 > pcom_
momenta of incoming particles in the center of mass frame [GeV]
double time_collision_
time of collision in the computational frame [fm]
int get_hadrontype_from_quark(int idq1, int idq2)
Determines hadron type from valence quark constituents.
double diquark_supp_
diquark suppression factor
static void find_excess_constituent(PdgCode &pdg_actual, PdgCode &pdg_mapped, std::array< int, 5 > &excess_quark, std::array< int, 5 > &excess_antiq)
Compare the valence quark contents of the actual and mapped hadrons and evaluate how many more consti...
double massB_
mass of incoming particle B [GeV]
void compose_string_parton(bool find_forward_string, Pythia8::Event &event_intermediate, Pythia8::Event &event_hadronize)
Identify a set of partons, which are connected to form a color-neutral string, from a given PYTHIA ev...
void find_total_number_constituent(Pythia8::Event &event_intermediate, std::array< int, 5 > &nquark_total, std::array< int, 5 > &nantiq_total)
Compute how many quarks and antiquarks we have in the system, and update the correspoing arrays with ...
double stringz_a_produce_
parameter (StringZ:aLund) for the fragmentation function of other (produced) hadrons in soft non-diff...
static void assign_scaling_factor(int nquark, ParticleData &data, double suppression_factor)
Assign a cross section scaling factor to the given particle.
void compose_string_junction(bool &find_forward_string, Pythia8::Event &event_intermediate, Pythia8::Event &event_hadronize)
Identify a set of partons and junction(s), which are connected to form a color-neutral string,...
static void quarks_from_diquark(int diquark, int &q1, int &q2, int °_spin)
find two quarks from a diquark.
The ThreeVector class represents a physical three-vector with the components .
Discrete distribution with weight given by probability vector.
std::array< einhard::Logger<>, std::tuple_size< LogArea::AreaTuple >::value > logg
An array that stores all pre-configured Logger objects.
T power(T n, T xMin, T xMax)
Draws a random number according to a power-law distribution ~ x^n.
T beta_a0(T xmin, T b)
Draws a random number from a beta-distribution with a = 0.
T beta(T a, T b)
Draws a random number from a beta-distribution, where probability density of is .
double normal(const T &mean, const T &sigma)
Returns a random number drawn from a normal distribution.
T uniform_int(T min, T max)
T pCM(const T sqrts, const T mass_a, const T mass_b) noexcept
T pCM_sqr(const T sqrts, const T mass_a, const T mass_b) noexcept
constexpr int maximum_rndm_seed_in_pythia
The maximum value of the random seed used in PYTHIA.
constexpr double small_number
Physical error tolerance.
std::string to_string(ThermodynamicQuantity quantity)
Convert a ThermodynamicQuantity enum value to its corresponding string.
constexpr T pow_int(const T base, unsigned const exponent)
Efficient template for calculating integer powers using squaring.
static constexpr int LOutput
constexpr double pion_mass
Pion mass in GeV.
constexpr double really_small
Numerical error tolerance.
constexpr double kaon_mass
Kaon mass in GeV.
static constexpr int LPythia