69 for(
G4int i=0; i<3; i++)
70 {
for(
G4int j=0; j<3; j++)
71 {
for(
G4int k=0; k<6; k++)
163 for(
G4int i=0; i<3; i++)
164 {
for(
G4int j=0; j<3; j++)
165 {
for(
G4int k=0; k<3; k++)
166 {
for(
G4int l=0; l<4; l++)
394 for (
G4int i=0 ; i<35 ; i++ ) {
412 G4int Number_of_quarks=0;
413 G4int Number_of_squarks=0;
415 G4double StringM=
string->Get4Momentum().mag();
419 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
430 G4int q2=(Qleft/100)%10;
443 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
450 G4int q1=Qright/1000;
454 G4int q2=(Qright/100)%10;
467 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
471 if(Number_of_quarks==2){EstimatedMass += 70.*
MeV;}
473 if(Number_of_quarks==3)
475 if(Number_of_squarks==0) {EstimatedMass += 740.*
MeV;}
476 if(Number_of_squarks==1) {EstimatedMass += 740.*
MeV;}
477 if(Number_of_squarks==2) {EstimatedMass += 400.*
MeV;}
478 if(Number_of_squarks==3) {EstimatedMass += 382.*
MeV;}
480 if(Number_of_quarks==4)
482 if((StringM > 1880.) && ( EstimatedMass < 2100)) {EstimatedMass = 2020.;}
484 else if((StringM > 2232.) && ( EstimatedMass < 2730)){EstimatedMass = 2570.;}
485 else if((StringM > 5130.) && ( EstimatedMass < 3450)){EstimatedMass = 5130.;}
489 if(EstimatedMass <= 1600.*
MeV){EstimatedMass-=200.*
MeV;}
490 else {EstimatedMass+=100.*
MeV;}
494 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
519 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
523 <<
"------------------------------------"<<
G4endl;
536 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
537 G4cout<<
"Non fragmentable - the string is converted to one hadron "<<
G4endl;
544 LeftVector->operator[](0)->SetPosition(theString.
GetPosition());
546 if(LeftVector->size() > 1)
550 LeftVector->operator[](1)->SetPosition(theString.
GetPosition());
555 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
564 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
569 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
572 G4cout<<G4endl<<
"LUND StringFragm: String Mass "
575 <<
"------------------------------------"<<
G4endl;
582 delete theStringInCMS;
594 while(!RightVector->empty())
596 LeftVector->push_back(RightVector->back());
597 RightVector->erase(RightVector->end()-1);
608 for(
size_t C1 = 0;
C1 < LeftVector->size();
C1++)
613 Momentum = toObserverFrame*Momentum;
617 Momentum = toObserverFrame*Coordinate;
620 Hadron->
SetPosition(PositionOftheStringCreation+aPosition);
655 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
656 G4cout<<
"Split last-----------------------------------------"<<
G4endl;
659 G4ThreeVector ClusterVel=
string->Get4Momentum().boostVector();
667 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
668 G4cout<<
"StrMass "<<StringMass<<
" q "
669 <<
string->GetLeftParton()->GetParticleName()<<
" "
670 <<
string->GetRightParton()->GetParticleName()<<
G4endl;
673 string->SetLeftPartonStable();
708 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
714 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
726 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
727 G4cout<<
"Selected LeftHad RightHad "<<sampledState<<
" "
740 LeftMom.boost(ClusterVel);
741 RightMom.boost(ClusterVel);
743 LeftVector->push_back(
new G4KineticTrack(LeftHadron, 0, Pos, LeftMom));
744 RightVector->push_back(
new G4KineticTrack(RightHadron, 0, Pos, RightMom));
760 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
761 G4cout<<
"Sampling of momenta of 2 last produced hadrons ----------------"<<
G4endl;
762 G4cout<<
"Masses "<<InitialMass<<
" "<<Mass<<
" "<<AntiMass<<
G4endl;
765 if((Mass > 930. || AntiMass > 930.))
768 G4double r_val =
sqr(InitialMass*InitialMass - Mass*Mass - AntiMass*AntiMass) -
769 sqr(2.*Mass*AntiMass);
770 G4double Pabs = (r_val > 0.)? std::sqrt(r_val)/(2.*InitialMass) : 0;
775 G4double st = std::sqrt(1. - pz * pz)*Pabs;
781 Mom->setPx(px); Mom->setPy(py); Mom->setPz(pz);
782 Mom->setE(std::sqrt(Pabs*Pabs + Mass*Mass));
784 AntiMom->setPx(-px); AntiMom->setPy(-py); AntiMom->setPz(-pz);
785 AntiMom->setE (std::sqrt(Pabs*Pabs + AntiMass*AntiMass));
794 G4double termD = InitialMass*InitialMass -Mass*Mass - AntiMass*AntiMass;
796 G4double termN = 2*termD + 4*Mass*Mass + 4*AntiMass*AntiMass;
797 G4double pt2max=(termD*termD - termab )/ termN ;
802 MassMt2 = Mass * Mass + Pt2;
803 AntiMassMt2= AntiMass * AntiMass + Pt2;
805 AvailablePz2=
sqr(InitialMass*InitialMass - MassMt2 - AntiMassMt2) -
806 4.*MassMt2*AntiMassMt2;
808 while(AvailablePz2 < 0.);
810 AvailablePz2 /=(4.*InitialMass*InitialMass);
811 AvailablePz = std::sqrt(AvailablePz2);
816 Mom->setPx(Px); Mom->setPy(Py); Mom->setPz(AvailablePz);
817 Mom->setE(std::sqrt(MassMt2+AvailablePz2));
819 AntiMom->setPx(-Px); AntiMom->setPy(-Py); AntiMom->setPz(-AvailablePz);
820 AntiMom->setE (std::sqrt(AntiMassMt2+AvailablePz2));
830 G4double StringMT2=
string->MassT2();
831 G4double StringMT =std::sqrt(StringMT2);
837 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
839 G4cout<<
"String 4 mom, String M and Mt "<<String4Momentum<<
" "<<String4Momentum.mag()<<
" "<<std::sqrt(StringMT2)<<
G4endl;
847 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
848 G4cout<<
"Mass of the string is not sufficient to produce the hadron!"<<
G4endl;
853 String4Momentum.setPz(0.);
858 G4double HadronMassT2, ResidualMassT2;
868 RemSysPt = StringPt - HadronPt;
870 HadronMassT2 =
sqr(HadronMass) + HadronPt.mag2();
873 }
while(std::sqrt(HadronMassT2) + std::sqrt(ResidualMassT2) > StringMT);
878 G4double Pz2 = (
sqr(StringMT2 - HadronMassT2 - ResidualMassT2) -
879 4*HadronMassT2 * ResidualMassT2)/4./StringMT2;
881 if(Pz2 < 0 ) {
return 0;}
886 G4double zMin = (std::sqrt(HadronMassT2+Pz2) - Pz)/std::sqrt(StringMT2);
888 G4double zMax = (std::sqrt(HadronMassT2+Pz2) + Pz)/std::sqrt(StringMT2);
890 if (zMin >= zMax)
return 0;
894 HadronPt.x(), HadronPt.y());
900 (z *
string->LightConeDecay() -
901 HadronMassT2/(z *
string->LightConeDecay())));
902 G4double HadronE = 0.5* (z *
string->LightConeDecay() +
903 HadronMassT2/(z *
string->LightConeDecay()));
906 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
907 G4cout<<
"string->LightConeDecay() "<<
string->LightConeDecay()<<
G4endl;
908 G4cout<<
"HadronPt,HadronE "<<HadronPt<<
" "<<HadronE<<
G4endl;
919 G4int PDGEncodingOfDecayParton,
926 G4double Mt2 = Px*Px + Py*Py + Mass*Mass;
929 G4double zOfMaxyf(0.), maxYf(1.),
z(0.), yf(1.);
930 if(std::abs(PDGEncodingOfDecayParton) < 1000)
936 zOfMaxyf=alund*Mt2/(alund*Mt2 + 1.);
937 maxYf=(1-zOfMaxyf)/zOfMaxyf * std::exp(-alund*Mt2/zOfMaxyf);
942 yf = (1-
z)/
z * std::exp(-alund*Mt2/
z);
949 if(std::abs(PDGEncodingOfDecayParton) > 1000)
993 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
999 G4bool final_success=
false;
1000 G4bool inner_success=
true;
1009 LeftVector->clear();
1011 RightVector->clear();
1017 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
1025 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
1032 LeftVector->push_back(Hadron);
1035 RightVector->push_back(Hadron);
1037 delete currentString;
1038 currentString=newString;
1042 #ifdef debug_LUNDfragmentation // Uzhi 20.06.2014
1043 G4cout<<
"Split remaining string into 2 final hadrons."<<
G4endl;
1046 if ( inner_success &&
SplitLast(currentString, LeftVector, RightVector) )
1052 delete currentString;
1054 return final_success;
1063 G4double StringMass =
string->Mass();
1064 G4int cClusterInterrupt = 0;
1073 G4int LeftQuark1=
string->GetLeftParton()->GetPDGEncoding()/1000;
1074 G4int LeftQuark2=(
string->GetLeftParton()->GetPDGEncoding()/100)%10;
1076 G4int RightQuark1=
string->GetRightParton()->GetPDGEncoding()/1000;
1077 G4int RightQuark2=(
string->GetRightParton()->GetPDGEncoding()/100)%10;
1096 while ((StringMass <= LeftHadron->GetPDGMass() + RightHadron->
GetPDGMass()));
1109 G4double StringMass =
string->Mass();
1116 Anti_Di_Quark =
string->GetLeftParton();
1117 Di_Quark=
string->GetRightParton();
1120 Anti_Di_Quark =
string->GetRightParton();
1121 Di_Quark=
string->GetLeftParton();
1125 G4int AbsIDAnti_di_quark =std::abs(IDAnti_di_quark);
1127 G4int AbsIDdi_quark =std::abs(IDdi_quark);
1129 G4int ADi_q1=AbsIDAnti_di_quark/1000;
1130 G4int ADi_q2=(AbsIDAnti_di_quark-ADi_q1*1000)/100;
1132 G4int Di_q1=AbsIDdi_quark/1000;
1133 G4int Di_q2=(AbsIDdi_quark-Di_q1*1000)/100;
1136 for(
G4int ProdQ=1; ProdQ < 4; ProdQ++)
1142 -
Baryon[ADi_q1-1][ADi_q2-1][ProdQ-1][StateADiQ]);
1151 +
Baryon[Di_q1-1][Di_q2-1][ProdQ-1][StateDiQ]);
1154 if(StringMass > LeftHadronMass + RightHadronMass)
1159 G4Exception(
"G4LundStringFragmentation::Diquark_AntiDiquark_aboveThreshold_lastSplitting ",
1165 sqr(RightHadronMass));
1180 }
while(
Baryon[Di_q1-1][Di_q2-1][ProdQ-1][StateDiQ]!=0);
1183 }
while(
Baryon[ADi_q1-1][ADi_q2-1][ProdQ-1][StateADiQ]!=0);
1195 G4double StringMass =
string->Mass();
1203 Quark =
string->GetLeftParton();
1204 Di_Quark=
string->GetRightParton();
1207 Quark =
string->GetRightParton();
1208 Di_Quark=
string->GetLeftParton();
1212 G4int AbsIDquark =std::abs(IDquark);
1214 G4int AbsIDdi_quark=std::abs(IDdi_quark);
1215 G4int Di_q1=AbsIDdi_quark/1000;
1216 G4int Di_q2=(AbsIDdi_quark-Di_q1*1000)/100;
1219 if(IDdi_quark < 0) SignDiQ=-1;
1222 for(
G4int ProdQ=1; ProdQ < 4; ProdQ++)
1227 if(IDquark == 2) SignQ= 1;
1228 if((IDquark == 1) && (ProdQ == 3)) SignQ= 1;
1229 if((IDquark == 3) && (ProdQ == 1)) SignQ=-1;
1233 if(IDquark == -2) SignQ=-1;
1234 if((IDquark ==-1) && (ProdQ == 3)) SignQ=-1;
1235 if((IDquark ==-3) && (ProdQ == 1)) SignQ= 1;
1238 if(AbsIDquark == ProdQ) SignQ= 1;
1247 Meson[AbsIDquark-1][ProdQ-1][StateQ]);
1254 Baryon[Di_q1-1][Di_q2-1][ProdQ-1][StateDiQ]);
1257 if(StringMass > LeftHadronMass + RightHadronMass)
1262 G4Exception(
"G4LundStringFragmentation::Quark_Diquark_lastSplitting ",
1268 sqr(RightHadronMass));
1282 }
while(
Baryon[Di_q1-1][Di_q2-1][ProdQ-1][StateDiQ]!=0);
1285 }
while(
Meson[AbsIDquark-1][ProdQ-1][StateQ]!=0);
1297 G4double StringMass =
string->Mass();
1305 Quark =
string->GetLeftParton();
1306 Anti_Quark=
string->GetRightParton();
1309 Quark =
string->GetRightParton();
1310 Anti_Quark=
string->GetLeftParton();
1314 G4int AbsIDquark =std::abs(IDquark);
1316 G4int AbsIDanti_quark=std::abs(IDanti_quark);
1319 for(
G4int ProdQ=1; ProdQ < 4; ProdQ++)
1322 if(IDquark == 2) SignQ= 1;
1323 if((IDquark == 1) && (ProdQ == 3)) SignQ= 1;
1324 if((IDquark == 3) && (ProdQ == 1)) SignQ=-1;
1325 if(IDquark == ProdQ) SignQ= 1;
1328 if(IDanti_quark == -2) SignAQ=-1;
1329 if((IDanti_quark ==-1) && (ProdQ == 3)) SignAQ=-1;
1330 if((IDanti_quark ==-3) && (ProdQ == 1)) SignAQ= 1;
1331 if(AbsIDanti_quark == ProdQ) SignAQ= 1;
1337 Meson[AbsIDquark-1][ProdQ-1][StateQ]);
1344 Meson[AbsIDanti_quark-1][ProdQ-1][StateAQ]);
1347 if(StringMass > LeftHadronMass + RightHadronMass)
1352 G4Exception(
"G4LundStringFragmentation::Quark_AntiQuark_lastSplitting ",
1358 sqr(RightHadronMass));
1379 }
while(
Meson[AbsIDanti_quark-1][ProdQ-1][StateAQ]!=0);
1382 }
while(
Meson[AbsIDquark-1][ProdQ-1][StateQ]!=0);
1404 G4int indexPosition = 0;
1410 if(Sum >= ksi)
break;
1412 return indexPosition;
1429 G4int Swap = stableQuarkEncoding;
1430 stableQuarkEncoding = decayQuarkEncoding;
1431 decayQuarkEncoding = Swap;
1434 G4int IsParticle=(decayQuarkEncoding>0) ? -1 : +1;
1445 G4int QuarkEncoding=QuarkPair.second->GetPDGEncoding();
1446 G4int i10 =
std::max(std::abs(QuarkEncoding), std::abs(stableQuarkEncoding));
1447 G4int i20 =
std::min(std::abs(QuarkEncoding), std::abs(stableQuarkEncoding));
1449 G4int NewDecayEncoding = -1*IsParticle*(i10 * 1000 + i20 * 100 + spin);
1467 created = QuarkPair.second;
virtual G4KineticTrackVector * FragmentString(const G4ExcitedString &theString)
G4double Mass_of_heavy_quark
G4ParticleDefinition * GetRightParton(void) const
G4ParticleDefinition * FindParticle(G4int PDGEncoding)
G4bool Quark_AntiQuark_lastSplitting(G4FragmentingString *&string, G4ParticleDefinition *&LeftHadron, G4ParticleDefinition *&RightHadron)
std::ostringstream G4ExceptionDescription
CLHEP::Hep3Vector G4ThreeVector
virtual G4LorentzVector * SplitEandP(G4ParticleDefinition *pHadron, G4FragmentingString *string, G4FragmentingString *newString)
CLHEP::HepLorentzRotation G4LorentzRotation
G4double Mass_of_string_junction
const G4ThreeVector & GetPosition() const
G4ExcitedString * CPExcited(const G4ExcitedString &string)
virtual G4bool IsFragmentable(const G4FragmentingString *const string)
void SetFormationTime(G4double aFormationTime)
void SetStrangenessSuppression(G4double aValue)
const G4LorentzVector & Get4Momentum() const
G4double MesonWeight[3][3][6]
G4ParticleDefinition * Build(G4ParticleDefinition *black, G4ParticleDefinition *white)
G4bool Quark_Diquark_lastSplitting(G4FragmentingString *&string, G4ParticleDefinition *&LeftHadron, G4ParticleDefinition *&RightHadron)
G4int StringLoopInterrupt
G4Parton * GetLeftParton(void) const
G4int ClusterLoopInterrupt
G4int GetPDGEncoding() const
G4ThreeVector SampleQuarkPt(G4double ptMax=-1.)
std::vector< G4double > vectorMesonMix
const G4String & GetParticleSubType() const
virtual void SetMassCut(G4double aValue)
const G4String & GetParticleName() const
G4ParticleDefinition * GetDecayParton() const
virtual G4double GetLightConeZ(G4double zmin, G4double zmax, G4int PartonEncoding, G4ParticleDefinition *pHadron, G4double Px, G4double Py)
pDefPair CreatePartonPair(G4int NeedParticle, G4bool AllowDiquarks=true)
void SetStringTensionParameter(G4double aValue)
const G4ThreeVector & GetPosition() const
virtual void Sample4Momentum(G4LorentzVector *Mom, G4double Mass, G4LorentzVector *AntiMom, G4double AntiMass, G4double InitialMass)
G4ParticleDefinition * GetLeftParton(void) const
void SetDiquarkBreakProbability(G4double aValue)
G4double GetStrangeSuppress()
void SetMinimalStringMass2(const G4double aValue)
G4GLOB_DLL std::ostream G4cout
ParticleList decay(Cluster *const c)
Carries out a cluster decay.
G4KineticTrackVector * LightFragmentationTest(const G4ExcitedString *const theString)
G4LorentzVector Get4Momentum() const
G4bool Loop_toFragmentString(G4ExcitedString *&theStringInCMS, G4KineticTrackVector *&LeftVector, G4KineticTrackVector *&RightVector)
G4double GetFormationTime() const
std::pair< G4ParticleDefinition *, G4ParticleDefinition * > pDefPair
void SetMinimalStringMass(const G4FragmentingString *const string)
G4LorentzRotation TransformToAlignedCms()
G4ParticleDefinition * FindParticle(G4int Encoding)
void SetPosition(const G4ThreeVector aPosition)
virtual G4bool StopFragmenting(const G4FragmentingString *const string)
G4int GetDecayDirection() const
void Set4Momentum(const G4LorentzVector &a4Momentum)
G4LundStringFragmentation()
G4double lambda(G4double s, G4double m1_Sqr, G4double m2_Sqr)
G4bool FourQuarkString(void) const
std::vector< G4double > scalarMesonMix
virtual G4ParticleDefinition * DiQuarkSplitup(G4ParticleDefinition *decay, G4ParticleDefinition *&created)
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *comments)
G4Parton * GetRightParton(void) const
virtual ~G4LundStringFragmentation()
G4HadronBuilder * hadronizer
G4double GetPDGMass() const
G4bool Diquark_AntiDiquark_aboveThreshold_lastSplitting(G4FragmentingString *&string, G4ParticleDefinition *&LeftHadron, G4ParticleDefinition *&RightHadron)
static G4ParticleTable * GetParticleTable()
T max(const T t1, const T t2)
brief Return the largest of the two arguments
G4double MinimalStringMass
G4double Mass_of_light_quark
G4double GetTimeOfCreation() const
T min(const T t1, const T t2)
brief Return the smallest of the two arguments
G4double DiquarkBreakProb
G4int GetDirection(void) const
G4ParticleDefinition * FS_LeftHadron[35]
G4bool Diquark_AntiDiquark_belowThreshold_lastSplitting(G4FragmentingString *&string, G4ParticleDefinition *&LeftHadron, G4ParticleDefinition *&RightHadron)
virtual G4bool SplitLast(G4FragmentingString *string, G4KineticTrackVector *LeftVector, G4KineticTrackVector *RightVector)
const G4LorentzVector & Get4Momentum() const
void CalculateHadronTimePosition(G4double theInitialStringMass, G4KineticTrackVector *)
const G4ParticleDefinition * GetDefinition() const
G4double MinimalStringMass2
static const double fermi
G4double BaryonWeight[3][3][3][4]
G4KineticTrack * Splitup(G4FragmentingString *string, G4FragmentingString *&newString)
G4ParticleDefinition * FS_RightHadron[35]
void SetDiquarkSuppression(G4double aValue)
CLHEP::HepLorentzVector G4LorentzVector