34#define INCLXX_IN_GEANT4_MODE 1
83 :propagationModel(0), theA(208), theZ(82), theS(0),
84 targetInitSuccess(false),
85 maxImpactParameter(0.),
86 maxUniverseRadius(0.),
87 maxInteractionDistance(0.),
88 fixedImpactParameter(0.),
91 forceTransparent(false),
95#ifdef INCLXX_IN_GEANT4_MODE
98 Logger::initialize(theConfig);
137 propagationModel =
new StandardPropagationModel(theConfig->getLocalEnergyBBType(),theConfig->getLocalEnergyPiType(),theConfig->getHadronizationTime());
142 cascadeAction->beforeRunAction(theConfig);
144 theGlobalInfo.cascadeModel = theConfig->getVersionString();
145 theGlobalInfo.deexcitationModel = theConfig->getDeExcitationString();
147 theGlobalInfo.rootSelection = theConfig->getROOTSelectionString();
150#ifndef INCLXX_IN_GEANT4_MODE
152 theGlobalInfo.At = theConfig->getTargetA();
153 theGlobalInfo.Zt = theConfig->getTargetZ();
154 theGlobalInfo.St = theConfig->getTargetS();
156 theGlobalInfo.Ap = theSpecies.
theA;
157 theGlobalInfo.Zp = theSpecies.
theZ;
158 theGlobalInfo.Sp = theSpecies.
theS;
159 theGlobalInfo.Ep = theConfig->getProjectileKineticEnergy();
160 theGlobalInfo.biasFactor = theConfig->getBias();
163 fixedImpactParameter = theConfig->getImpactParameter();
168#ifndef INCLXX_IN_GEANT4_MODE
169 NuclearMassTable::deleteTable();
177#ifndef INCLXX_IN_GEANT4_MODE
178 Logger::deleteLoggerSlave();
182 cascadeAction->afterRunAction();
183 delete cascadeAction;
184 delete propagationModel;
190 INCL_ERROR(
"Unsupported target: A = " <<
A <<
" Z = " << Z <<
" S = " <<
S <<
'\n'
191 <<
"Target configuration rejected." <<
'\n');
195 (projectileSpecies.
theZ==projectileSpecies.
theA || projectileSpecies.
theZ==0)) {
196 INCL_ERROR(
"Unsupported projectile: A = " << projectileSpecies.
theA <<
" Z = " << projectileSpecies.
theZ <<
" S = " << projectileSpecies.
theS <<
'\n'
197 <<
"Projectile configuration rejected." <<
'\n');
202 forceTransparent =
false;
205 initUniverseRadius(projectileSpecies, kineticEnergy,
A, Z);
210 G4bool ProtonIsTheVictim =
false;
211 G4bool NeutronIsTheVictim =
false;
212 theEventInfo.annihilationP =
false;
213 theEventInfo.annihilationN =
false;
216 if(projectileSpecies.
theType ==
antiProton && kineticEnergy <= theConfig->getAtrestThreshold()){
221 if(theConfig->isNaturalTarget()){
223 neutronprob = (theA + 1 - Z)/(theA + 1 - Z + SpOverSn*Z);
227 neutronprob = (
A - Z)/(
A - Z + SpOverSn*Z);
233 if(rndm >= neutronprob){
234 theEventInfo.annihilationP =
true;
236 ProtonIsTheVictim =
true;
240 theEventInfo.annihilationN =
true;
242 NeutronIsTheVictim =
true;
248 if(theConfig->isNaturalTarget())
255 if(ProtonIsTheVictim ==
true && NeutronIsTheVictim ==
false)
257 if(NeutronIsTheVictim ==
true && ProtonIsTheVictim ==
false)
266 INCL_DEBUG(
"Maximum impact parameter initialised: " << maxImpactParameter <<
'\n');
269 initMaxInteractionDistance(projectileSpecies, kineticEnergy);
271 if(projectileSpecies.
theType ==
antiProton && kineticEnergy <= theConfig->getAtrestThreshold()){
273 if(theConfig->isNaturalTarget()){
276 G4double kineticEnergy2=kineticEnergy;
277 if (kineticEnergy2 <= 0.) kineticEnergy2=0.001;
278 theGlobalInfo.geometricCrossSection = 9.7*
279 Math::pi*std::pow((1.840 + 1.120*std::pow(currentA,(1./3.))),2)*
284 theGlobalInfo.geometricCrossSection =
289 if(projectileSpecies.
theA > 0)
290 minRemnantSize = std::min(theA, 4);
292 minRemnantSize = std::min(theA-1, 4);
303 nucleus =
new Nucleus(
A, Z,
S, theConfig, newmaxUniverseRadius, theAType);
306 nucleus =
new Nucleus(
A, Z,
S, theConfig, maxUniverseRadius, theAType);
308 nucleus->getStore()->getBook().reset();
309 nucleus->initializeParticles();
310 propagationModel->setNucleus(nucleus);
324 if (projectileSpecies.
theType==
antiProton && (targetA==1 || targetA==2) && targetZ==1 && targetS==0) {
327 preCascade_pbarH1(projectileSpecies, kineticEnergy);
329 preCascade_pbarH2(projectileSpecies, kineticEnergy);
330 theEventInfo.annihilationP =
false;
331 theEventInfo.annihilationN =
false;
337 if (rndm <= SpOverSn) {
338 theEventInfo.annihilationP =
true;
340 starlistH2.push_back(p2);
343 theEventInfo.annihilationN =
true;
345 starlistH2.push_back(p2);
351#ifdef INCLXX_IN_GEANT4_MODE
354 ed <<
" Data missing: set environment variable G4INCLDATA\n"
355 <<
" to point to the directory containing data files needed\n"
356 <<
" by the INCL++ model" <<
G4endl;
360 const G4String& dataPathppbar(dataPath0 +
"/rawppbarFS.dat");
362 const G4String& dataPathppbark(dataPath0 +
"/rawppbarFSkaonic.dat");
366 if (theConfig) path = theConfig->getINCLXXDataFilePath();
367 const std::string& dataPathppbar(path +
"/rawppbarFS.dat");
368 INCL_DEBUG(
"Reading https://doi.org/10.1016/0375-9474(92)90362-N ppbar final states" << dataPathppbar <<
'\n');
369 const std::string& dataPathnpbar(path +
"/rawnpbarFS.dat");
370 INCL_DEBUG(
"Reading https://doi.org/10.1016/0375-9474(92)90362-N npbar final states" << dataPathnpbar <<
'\n');
371 const std::string& dataPathppbark(path +
"/rawppbarFSkaonic.dat");
372 INCL_DEBUG(
"Reading https://doi.org/10.1016/j.physrep.2005.03.002 ppbar kaonic final states" << dataPathppbark <<
'\n');
373 const std::string& dataPathnpbark(path +
"/rawnpbarFSkaonic.dat");
374 INCL_DEBUG(
"Reading https://doi.org/10.1007/BF02818764 and https://link.springer.com/article/10.1007/BF02754930 npbar kaonic final states" << dataPathnpbark <<
'\n');
378 std::vector<G4double> probabilities;
379 std::vector<std::vector<G4String>> particle_types;
388 if (rdm < (1.-kaonicFSprob)) {
389 INCL_DEBUG(
"pionic pp final state chosen" <<
'\n');
390 sum = read_file(dataPathppbar, probabilities, particle_types);
391 rdm = (rdm/(1.-kaonicFSprob))*sum;
393 G4int n = findStringNumber(rdm, std::move(probabilities))-1;
394 if ( n < 0 )
return theEventInfo;
395 for (
G4int j = 0; j < static_cast<G4int>(particle_types[n].size()); j++) {
396 if (particle_types[n][j] ==
"pi0") {
398 starlist.push_back(p);
399 }
else if (particle_types[n][j] ==
"pi-") {
401 starlist.push_back(p);
402 }
else if (particle_types[n][j] ==
"pi+") {
404 starlist.push_back(p);
405 }
else if (particle_types[n][j] ==
"omega") {
407 starlist.push_back(p);
408 }
else if (particle_types[n][j] ==
"eta") {
410 starlist.push_back(p);
411 }
else if (particle_types[n][j] ==
"rho-") {
413 starlist.push_back(p);
415 starlist.push_back(pp);
416 }
else if (particle_types[n][j] ==
"rho+") {
418 starlist.push_back(p);
420 starlist.push_back(pp);
421 }
else if (particle_types[n][j] ==
"rho0") {
423 starlist.push_back(p);
425 starlist.push_back(pp);
427 INCL_ERROR(
"Some non-existing FS particle detected when reading pbar FS files");
428 for (
G4int jj = 0; jj < static_cast<G4int>(particle_types[n].size()); jj++) {
429#ifdef INCLXX_IN_GEANT4_MODE
430 G4cout <<
"gotcha! " << particle_types[n][jj] <<
G4endl;
432 std::cout <<
"gotcha! " << particle_types[n][jj] << std::endl;
435#ifdef INCLXX_IN_GEANT4_MODE
436 G4cout <<
"Some non-existing FS particle detected when reading pbar FS files" <<
G4endl;
438 std::cout <<
"Some non-existing FS particle detected when reading pbar FS files" << std::endl;
443 INCL_DEBUG(
"kaonic pp final state chosen" <<
'\n');
444 sum = read_file(dataPathppbark, probabilities, particle_types);
445 rdm = ((1.-rdm)/kaonicFSprob)*sum;
447 G4int n = findStringNumber(rdm, probabilities)-1;
448 if ( n < 0 )
return theEventInfo;
449 for (
G4int j = 0; j < static_cast<G4int>(particle_types[n].size()); j++) {
450 if (particle_types[n][j] ==
"pi0") {
452 starlist.push_back(p);
453 }
else if (particle_types[n][j] ==
"pi-") {
455 starlist.push_back(p);
456 }
else if (particle_types[n][j] ==
"pi+") {
458 starlist.push_back(p);
459 }
else if (particle_types[n][j] ==
"omega") {
461 starlist.push_back(p);
462 }
else if (particle_types[n][j] ==
"eta") {
464 starlist.push_back(p);
465 }
else if (particle_types[n][j] ==
"K-") {
467 starlist.push_back(p);
468 }
else if (particle_types[n][j] ==
"K+") {
470 starlist.push_back(p);
471 }
else if (particle_types[n][j] ==
"K0") {
473 starlist.push_back(p);
474 }
else if (particle_types[n][j] ==
"K0b") {
476 starlist.push_back(p);
478 INCL_ERROR(
"Some non-existing FS particle detected when reading pbar FS files");
479 for (
G4int jj = 0; jj < static_cast<G4int>(particle_types[n].size()); jj++) {
480#ifdef INCLXX_IN_GEANT4_MODE
481 G4cout <<
"gotcha! " << particle_types[n][jj] <<
G4endl;
483 std::cout <<
"gotcha! " << particle_types[n][jj] << std::endl;
486#ifdef INCLXX_IN_GEANT4_MODE
487 G4cout <<
"Some non-existing FS particle detected when reading pbar FS files" <<
G4endl;
489 std::cout <<
"Some non-existing FS particle detected when reading pbar FS files" << std::endl;
497 if (starlist.size() < 2) {
498 INCL_ERROR(
"should never happen, at least 2 final state particles!" <<
'\n');
499 }
else if (starlist.size() == 2) {
504 G4double s = energyOfMesonStar*energyOfMesonStar;
505 G4double mom1 = std::sqrt(s/4. - (std::pow(m1,2) + std::pow(m2,2))/2. - std::pow(m1,2)*std::pow(m2,2)/s + (std::pow(m1,4) + 2.*std::pow(m1*m2,2) + std::pow(m2,4))/(4.*s));
507 (*first)->setMomentum(momentello);
508 (*first)->adjustEnergyFromMomentum();
509 (*last)->setMomentum(-momentello);
510 (*last)->adjustEnergyFromMomentum();
515 if (targetA==1) postCascade_pbarH1(starlist);
516 else postCascade_pbarH2(starlist,starlistH2);
518 theGlobalInfo.nShots++;
528 targetInitSuccess =
prepareReaction(projectileSpecies, kineticEnergy, targetA, targetZ, targetS);
530 if(!targetInitSuccess) {
531 INCL_WARN(
"Target initialisation failed for A=" << targetA <<
", Z=" << targetZ <<
", S=" << targetS <<
'\n');
532 theEventInfo.transparent=
true;
536 cascadeAction->beforeCascadeAction(propagationModel);
538 const G4bool canRunCascade = preCascade(projectileSpecies, kineticEnergy);
541 postCascade(projectileSpecies, kineticEnergy);
542 cascadeAction->afterCascadeAction(nucleus);
550 theEventInfo.
reset();
558 theEventInfo.
Sp = (
Short_t)projectileSpecies.theS;
559 theEventInfo.
Ep = kineticEnergy;
573 theEventInfo.At = (
Short_t)nucleus->getA();
574 theEventInfo.Zt = (
Short_t)nucleus->getZ();
577 if(maxImpactParameter<=0.) {
581 if(projectileSpecies.theType ==
antiProton && kineticEnergy <= theConfig->getAtrestThreshold()){
585 theEventInfo.transparent =
true;
594 if(fixedImpactParameter<0.) {
595 impactParameter = maxImpactParameter * std::sqrt(
Random::shoot0());
598 impactParameter = fixedImpactParameter;
601 INCL_DEBUG(
"Selected impact parameter: " << impactParameter <<
'\n');
604 theEventInfo.impactParameter = impactParameter;
606 const G4double effectiveImpactParameter = propagationModel->shoot(projectileSpecies, kineticEnergy, impactParameter, phi);
607 if(effectiveImpactParameter < 0.) {
609 theEventInfo.transparent =
true;
614 theEventInfo.transparent =
false;
615 theEventInfo.effectiveImpactParameter = effectiveImpactParameter;
620 void INCL::cascade() {
621 FinalState *finalState =
new FinalState;
623 unsigned long loopCounter = 0;
624 const unsigned long maxLoopCounter = 10000000;
627 cascadeAction->beforePropagationAction(propagationModel);
631 IAvatar *avatar = propagationModel->propagate(finalState);
636 cascadeAction->afterPropagationAction(propagationModel, avatar);
638 if(avatar == 0)
break;
641 cascadeAction->beforeAvatarAction(avatar, nucleus);
650 avatar->fillFinalState(finalState);
652 cascadeAction->afterAvatarAction(avatar, nucleus, finalState);
655 nucleus->applyFinalState(finalState);
661 }
while(continueCascade() && loopCounter<maxLoopCounter);
668 theEventInfo.stoppingTime = propagationModel->getCurrentTime();
674 if(!(projectileSpecies.theType==
antiProton && kineticEnergy<=theConfig->getAtrestThreshold())){
675 if(nucleus->getTryCompoundNucleus()) {
676 INCL_DEBUG(
"Trying compound nucleus" <<
'\n');
677 makeCompoundNucleus();
678 theEventInfo.transparent = forceTransparent;
680#ifndef INCLXX_IN_GEANT4_MODE
681 if(!theEventInfo.transparent) globalConservationChecks(
true);
687 if(!(projectileSpecies.theType==
antiProton && kineticEnergy<=theConfig->getAtrestThreshold())){
688 theEventInfo.transparent = forceTransparent || nucleus->isEventTransparent();
691 if(theEventInfo.transparent) {
692 ProjectileRemnant *
const projectileRemnant = nucleus->getProjectileRemnant();
693 if(projectileRemnant) {
695 nucleus->getStore()->clearIncoming();
698 nucleus->getStore()->deleteIncoming();
703 theEventInfo.sigmasInside = nucleus->containsSigma();
704 theEventInfo.antikaonsInside = nucleus->containsAntiKaon();
705 theEventInfo.lambdasInside = nucleus->containsLambda();
706 theEventInfo.kaonsInside = nucleus->containsKaon();
709 theEventInfo.absorbedStrangeParticle = nucleus->decayInsideStrangeParticles();
712 nucleus->emitInsideStrangeParticles();
713 theEventInfo.emitKaon = nucleus->emitInsideKaon();
715#ifdef INCLXX_IN_GEANT4_MODE
716 theEventInfo.emitLambda = nucleus->emitInsideLambda();
720 theEventInfo.deltasInside = nucleus->containsDeltas();
723 theEventInfo.forcedDeltasOutside = nucleus->decayOutgoingDeltas();
724 theEventInfo.forcedDeltasInside = nucleus->decayInsideDeltas();
727 G4double timeThreshold=theConfig->getDecayTimeThreshold();
728 theEventInfo.forcedPionResonancesOutside = nucleus->decayOutgoingPionResonances(timeThreshold);
729 nucleus->decayOutgoingSigmaZero(timeThreshold);
730 nucleus->decayOutgoingNeutralKaon();
741 if(nucleus->getStore()->getOutgoingParticles().size()==0
742 && (!nucleus->getProjectileRemnant()
743 || nucleus->getProjectileRemnant()->getParticles().size()==0)) {
745 INCL_DEBUG(
"Cascade resulted in complete fusion, using realistic fusion kinematics" <<
'\n');
747 nucleus->useFusionKinematics();
749 if(nucleus->getExcitationEnergy()<0.) {
751 INCL_WARN(
"Complete-fusion kinematics yields negative excitation energy, returning a transparent!" <<
'\n');
752 theEventInfo.transparent =
true;
759 nucleus->setExcitationEnergy(nucleus->computeExcitationEnergy());
763 theEventInfo.nUnmergedSpectators = makeProjectileRemnant();
766 if(nucleus->getA()==1 && minRemnantSize>1) {
767 INCL_ERROR(
"Computing one-nucleon recoil kinematics. We should never be here nowadays, cascade should stop earlier than this." <<
'\n');
769 nucleus->computeRecoilKinematics();
771#ifndef INCLXX_IN_GEANT4_MODE
773 globalConservationChecks(
false);
778 if(nucleus->hasRemnant()) rescaleOutgoingForRecoil();
783 theEventInfo.clusterDecay = nucleus->decayOutgoingClusters() || nucleus->decayMe();
785#ifndef INCLXX_IN_GEANT4_MODE
787 globalConservationChecks(
true);
791 nucleus->fillEventInfo(&theEventInfo);
796 void INCL::makeCompoundNucleus() {
802 if(!nucleus->isNucleusNucleusCollision()) {
803 forceTransparent =
true;
808 nucleus->getStore()->clearIncoming();
809 nucleus->getStore()->clearOutgoing();
810 nucleus->getProjectileRemnant()->reset();
811 nucleus->setA(theEventInfo.At);
812 nucleus->setZ(theEventInfo.Zt);
817 ThreeVector theCNMomentum = nucleus->getIncomingMomentum();
818 ThreeVector theCNSpin = nucleus->getIncomingAngularMomentum();
820 G4int theCNA=theEventInfo.At, theCNZ=theEventInfo.Zt, theCNS=theEventInfo.St;
821 Cluster *
const theProjectileRemnant = nucleus->getProjectileRemnant();
822 G4double theCNEnergy = theTargetMass + theProjectileRemnant->getEnergy();
825 ParticleList
const &initialProjectileComponents = theProjectileRemnant->getParticles();
826 std::vector<Particle *> shuffledComponents(initialProjectileComponents.begin(), initialProjectileComponents.end());
828 std::shuffle(shuffledComponents.begin(), shuffledComponents.end(),
Random::getAdapter());
831 G4bool atLeastOneNucleonEntering =
false;
832 for(std::vector<Particle*>::const_iterator p=shuffledComponents.begin(), e=shuffledComponents.end(); p!=e; ++p) {
836 (*p)->getPropagationVelocity(),
837 maxInteractionDistance));
838 if(!intersectionInteractionDistance.exists)
842 atLeastOneNucleonEntering =
true;
843 ParticleEntryAvatar *theAvatar =
new ParticleEntryAvatar(0.0, nucleus, *p);
844 nucleus->getStore()->addParticleEntryAvatar(theAvatar);
845 FinalState *fs = theAvatar->getFinalState();
846 nucleus->applyFinalState(fs);
855 theCNZ += (*p)->getZ();
856 theCNS += (*p)->getS();
866 if(!success || !atLeastOneNucleonEntering) {
867 INCL_DEBUG(
"No nucleon entering in forced CN, forcing a transparent" <<
'\n');
868 forceTransparent =
true;
878 theCNEnergy -= theProjectileRemnant->getEnergy();
879 theCNMomentum -= theProjectileRemnant->getMomentum();
882 nucleus->finalizeProjectileRemnant(propagationModel->getCurrentTime());
886 theCNSpin -= theProjectileRemnant->getAngularMomentum();
890 const G4double theCNInvariantMassSquared = theCNEnergy*theCNEnergy-theCNMomentum.mag2();
891 if(theCNInvariantMassSquared<0.) {
893 forceTransparent =
true;
896 const G4double theCNExcitationEnergy = std::sqrt(theCNInvariantMassSquared) - theCNMass;
897 if(theCNExcitationEnergy<0.) {
899 INCL_DEBUG(
"CN excitation energy is negative, forcing a transparent" <<
'\n'
900 <<
" theCNA = " << theCNA <<
'\n'
901 <<
" theCNZ = " << theCNZ <<
'\n'
902 <<
" theCNS = " << theCNS <<
'\n'
903 <<
" theCNEnergy = " << theCNEnergy <<
'\n'
904 <<
" theCNMomentum = (" << theCNMomentum.getX() <<
", "<< theCNMomentum.getY() <<
", " << theCNMomentum.getZ() <<
")" <<
'\n'
905 <<
" theCNExcitationEnergy = " << theCNExcitationEnergy <<
'\n'
906 <<
" theCNSpin = (" << theCNSpin.getX() <<
", "<< theCNSpin.getY() <<
", " << theCNSpin.getZ() <<
")" <<
'\n'
908 forceTransparent =
true;
912 INCL_DEBUG(
"CN excitation energy is positive, forcing a CN" <<
'\n'
913 <<
" theCNA = " << theCNA <<
'\n'
914 <<
" theCNZ = " << theCNZ <<
'\n'
915 <<
" theCNS = " << theCNS <<
'\n'
916 <<
" theCNEnergy = " << theCNEnergy <<
'\n'
917 <<
" theCNMomentum = (" << theCNMomentum.getX() <<
", "<< theCNMomentum.getY() <<
", " << theCNMomentum.getZ() <<
")" <<
'\n'
918 <<
" theCNExcitationEnergy = " << theCNExcitationEnergy <<
'\n'
919 <<
" theCNSpin = (" << theCNSpin.getX() <<
", "<< theCNSpin.getY() <<
", " << theCNSpin.getZ() <<
")" <<
'\n'
921 nucleus->setA(theCNA);
922 nucleus->setZ(theCNZ);
923 nucleus->setS(theCNS);
924 nucleus->setMomentum(theCNMomentum);
925 nucleus->setEnergy(theCNEnergy);
926 nucleus->setExcitationEnergy(theCNExcitationEnergy);
927 nucleus->setMass(theCNMass+theCNExcitationEnergy);
928 nucleus->setSpin(theCNSpin);
931 theEventInfo.forcedDeltasOutside = nucleus->decayOutgoingDeltas();
934 G4double timeThreshold=theConfig->getDecayTimeThreshold();
935 theEventInfo.forcedPionResonancesOutside = nucleus->decayOutgoingPionResonances(timeThreshold);
938 theEventInfo.emitKaon = nucleus->emitInsideKaon();
941 theEventInfo.clusterDecay = nucleus->decayOutgoingClusters() || nucleus->decayMe();
944 nucleus->fillEventInfo(&theEventInfo);
948 void INCL::rescaleOutgoingForRecoil() {
949 RecoilCMFunctor theRecoilFunctor(nucleus, theEventInfo);
952 const RootFinder::Solution theSolution =
RootFinder::solve(&theRecoilFunctor, 1.0);
953 if(theSolution.success) {
954 theRecoilFunctor(theSolution.x);
956 INCL_WARN(
"Couldn't accommodate remnant recoil while satisfying energy conservation, root-finding algorithm failed." <<
'\n');
960#ifndef INCLXX_IN_GEANT4_MODE
961 void INCL::globalConservationChecks(
G4bool afterRecoil) {
962 Nucleus::ConservationBalance theBalance = nucleus->getConservationBalance(theEventInfo,afterRecoil);
965 const G4double pLongBalance = theBalance.momentum.getZ();
966 const G4double pTransBalance = theBalance.momentum.perp();
967 if(theBalance.Z != 0) {
968 INCL_ERROR(
"Violation of charge conservation! ZBalance = " << theBalance.Z <<
" eventNumber=" << theEventInfo.eventNumber <<
'\n');
970 if(theBalance.A != 0) {
971 INCL_ERROR(
"Violation of baryon-number conservation! ABalance = " << theBalance.A <<
" Emit Lambda=" << theEventInfo.emitLambda <<
" eventNumber=" << theEventInfo.eventNumber <<
'\n');
973 if(theBalance.S != 0) {
974 INCL_ERROR(
"Violation of strange-number conservation! SBalance = " << theBalance.S <<
" eventNumber=" << theEventInfo.eventNumber <<
'\n');
976 G4double EThreshold, pLongThreshold, pTransThreshold;
981 pTransThreshold = 1.;
985 pLongThreshold = 0.1;
986 pTransThreshold = 0.1;
988 if(std::abs(theBalance.energy)>EThreshold) {
989 INCL_WARN(
"Violation of energy conservation > " << EThreshold <<
" MeV. EBalance = " << theBalance.energy <<
" Emit Lambda=" << theEventInfo.emitLambda <<
" afterRecoil = " << afterRecoil <<
" eventNumber=" << theEventInfo.eventNumber <<
'\n');
991 if(std::abs(pLongBalance)>pLongThreshold) {
992 INCL_WARN(
"Violation of longitudinal momentum conservation > " << pLongThreshold <<
" MeV/c. pLongBalance = " << pLongBalance <<
" afterRecoil = " << afterRecoil <<
" eventNumber=" << theEventInfo.eventNumber <<
'\n');
994 if(std::abs(pTransBalance)>pTransThreshold) {
995 INCL_WARN(
"Violation of transverse momentum conservation > " << pTransThreshold <<
" MeV/c. pTransBalance = " << pTransBalance <<
" afterRecoil = " << afterRecoil <<
" eventNumber=" << theEventInfo.eventNumber <<
'\n');
999 theEventInfo.EBalance = theBalance.energy;
1000 theEventInfo.pLongBalance = pLongBalance;
1001 theEventInfo.pTransBalance = pTransBalance;
1005 G4bool INCL::continueCascade() {
1007 if(propagationModel->getCurrentTime() > propagationModel->getStoppingTime()) {
1008 INCL_DEBUG(
"Cascade time (" << propagationModel->getCurrentTime()
1009 <<
") exceeded stopping time (" << propagationModel->getStoppingTime()
1010 <<
"), stopping cascade" <<
'\n');
1014 if(nucleus->getStore()->getBook().getCascading()==0 &&
1015 nucleus->getStore()->getIncomingParticles().empty()) {
1016 INCL_DEBUG(
"No participants in the nucleus and no incoming particles left, stopping cascade" <<
'\n');
1020 if(nucleus->getA() <= minRemnantSize) {
1021 INCL_DEBUG(
"Remnant size (" << nucleus->getA()
1022 <<
") smaller than or equal to minimum (" << minRemnantSize
1023 <<
"), stopping cascade" <<
'\n');
1028 if(nucleus->getTryCompoundNucleus()) {
1029 INCL_DEBUG(
"Trying to make a compound nucleus, stopping cascade" <<
'\n');
1037 const G4double normalisationFactor = theGlobalInfo.geometricCrossSection /
1039 theGlobalInfo.nucleonAbsorptionCrossSection = normalisationFactor *
1040 ((
G4double) theGlobalInfo.nNucleonAbsorptions);
1041 theGlobalInfo.pionAbsorptionCrossSection = normalisationFactor *
1042 ((
G4double) theGlobalInfo.nPionAbsorptions);
1043 theGlobalInfo.reactionCrossSection = normalisationFactor *
1044 ((
G4double) (theGlobalInfo.nShots - theGlobalInfo.nTransparents));
1045 theGlobalInfo.errorReactionCrossSection = normalisationFactor *
1046 std::sqrt((
G4double) (theGlobalInfo.nShots - theGlobalInfo.nTransparents));
1047 theGlobalInfo.forcedCNCrossSection = normalisationFactor *
1048 ((
G4double) theGlobalInfo.nForcedCompoundNucleus);
1049 theGlobalInfo.errorForcedCNCrossSection = normalisationFactor *
1050 std::sqrt((
G4double) (theGlobalInfo.nForcedCompoundNucleus));
1051 theGlobalInfo.completeFusionCrossSection = normalisationFactor *
1052 ((
G4double) theGlobalInfo.nCompleteFusion);
1053 theGlobalInfo.errorCompleteFusionCrossSection = normalisationFactor *
1054 std::sqrt((
G4double) (theGlobalInfo.nCompleteFusion));
1055 theGlobalInfo.energyViolationInteractionCrossSection = normalisationFactor *
1056 ((
G4double) theGlobalInfo.nEnergyViolationInteraction);
1058 theGlobalInfo.initialRandomSeeds.assign(initialSeeds.begin(), initialSeeds.end());
1061 theGlobalInfo.finalRandomSeeds.assign(theSeeds.begin(), theSeeds.end());
1064 G4int INCL::makeProjectileRemnant() {
1073 G4int nUnmergedSpectators = 0;
1076 if(dynSpectators.empty() && geomSpectators.empty()) {
1078 }
else if(dynSpectators.size()==1 && geomSpectators.empty()) {
1084 ProjectileRemnant *theProjectileRemnant = nucleus->getProjectileRemnant();
1087 ParticleList rejected = theProjectileRemnant->addAllDynamicalSpectators(dynSpectators);
1089 nUnmergedSpectators = (
G4int)rejected.size();
1090 nucleus->getStore()->addToOutgoing(rejected);
1093 nucleus->finalizeProjectileRemnant(propagationModel->getCurrentTime());
1097 return nUnmergedSpectators;
1100 void INCL::initMaxInteractionDistance(
ParticleSpecies const &projectileSpecies,
const G4double kineticEnergy) {
1101 if(projectileSpecies.theType !=
Composite) {
1102 maxInteractionDistance = 0.;
1110 maxInteractionDistance = r0 + theNNDistance;
1111 INCL_DEBUG(
"Initialised interaction distance: r0 = " << r0 <<
'\n'
1112 <<
" theNNDistance = " << theNNDistance <<
'\n'
1113 <<
" maxInteractionDistance = " << maxInteractionDistance <<
'\n');
1119 IsotopicDistribution
const &anIsotopicDistribution =
1121 IsotopeVector theIsotopes = anIsotopicDistribution.getIsotopes();
1122 for(
IsotopeIter i=theIsotopes.begin(), e=theIsotopes.end(); i!=e; ++i) {
1125 const G4double maximumRadius = std::max(pMaximumRadius, nMaximumRadius);
1126 rMax = std::max(maximumRadius, rMax);
1131 const G4double maximumRadius = std::max(pMaximumRadius, nMaximumRadius);
1132 rMax = std::max(maximumRadius, rMax);
1137 }
else if(p.theType==
PiPlus
1142 }
else if(p.theType==
KPlus
1143 || p.theType==
KZero) {
1150 }
else if(p.theType==
Lambda
1158 maxUniverseRadius = rMax;
1160 INCL_DEBUG(
"Initialised universe radius: " << maxUniverseRadius <<
'\n');
1170 for(
IsotopeIter i=theIsotopes.begin(), e=theIsotopes.end(); i!=e; ++i) {
1173 const G4double maximumRadius = std::max(pMaximumRadius, nMaximumRadius);
1174 rMax = std::max(maximumRadius, rMax);
1179 const G4double maximumRadius = std::max(pMaximumRadius, nMaximumRadius);
1180 rMax = std::max(maximumRadius, rMax);
1186 void INCL::updateGlobalInfo() {
1194 if(forceTransparent)
1214 G4double INCL::read_file(std::string filename, std::vector<G4double>& probabilities,
1215 std::vector<std::vector<G4String>>& particle_types) {
1216 std::ifstream file(filename);
1218 if (file.is_open()) {
1220 while (getline(file, line)) {
1221 std::istringstream iss(line);
1225 probabilities.push_back(prob);
1226 std::vector<G4String> types;
1228 while (iss >> type) {
1229 types.push_back(type);
1231 particle_types.push_back(std::move(types));
1234#ifdef INCLXX_IN_GEANT4_MODE
1235 G4cout <<
"ERROR no fread_file " << filename <<
G4endl;
1237 std::cout <<
"ERROR no fread_file " << filename << std::endl;
1244 G4int INCL::findStringNumber(
G4double rdm, std::vector<G4double> yields) {
1245 G4int stringNumber = -1;
1249 for (
G4int i = 0; i < static_cast<G4int>(yields.size()-1); i++) {
1250 if (rdm >= smallestsum && rdm <= biggestsum) {
1254 smallestsum += yields[i];
1255 biggestsum += yields[i+1];
1257 if(stringNumber==-1) stringNumber =
static_cast<G4int>(yields.size());
1258 if(stringNumber==-1){
1259 INCL_ERROR(
"ERROR in findStringNumber (stringNumber=-1)");
1260#ifdef INCLXX_IN_GEANT4_MODE
1263 std::cout <<
"ERROR in findStringNumber" << std::endl;
1266 return stringNumber;
1272 theEventInfo.reset();
1277 theEventInfo.projectileType = projectileSpecies.theType;
1278 theEventInfo.Ap = -1;
1279 theEventInfo.Zp = -1;
1280 theEventInfo.Sp = 0;
1281 theEventInfo.Ep = kineticEnergy;
1282 theEventInfo.St = 0;
1283 theEventInfo.At = 1;
1284 theEventInfo.Zt = 1;
1288 void INCL::postCascade_pbarH1(
ParticleList const &outgoingParticles) {
1289 theEventInfo.nParticles = 0;
1292 theEventInfo.nRemnants = 0;
1293 theEventInfo.history.clear();
1295 for(
ParticleIter i=outgoingParticles.begin(), e=outgoingParticles.end(); i!=e; ++i ) {
1296 theEventInfo.A[theEventInfo.nParticles] = (
Short_t)(*i)->getA();
1297 theEventInfo.Z[theEventInfo.nParticles] = (
Short_t)(*i)->getZ();
1298 theEventInfo.S[theEventInfo.nParticles] = (
Short_t)(*i)->getS();
1299 theEventInfo.EKin[theEventInfo.nParticles] = (*i)->getKineticEnergy();
1300 ThreeVector mom = (*i)->getMomentum();
1301 theEventInfo.px[theEventInfo.nParticles] = mom.getX();
1302 theEventInfo.py[theEventInfo.nParticles] = mom.getY();
1303 theEventInfo.pz[theEventInfo.nParticles] = mom.getZ();
1304 theEventInfo.theta[theEventInfo.nParticles] =
Math::toDegrees(mom.theta());
1305 theEventInfo.phi[theEventInfo.nParticles] =
Math::toDegrees(mom.phi());
1306 theEventInfo.origin[theEventInfo.nParticles] = -1;
1307#ifdef INCLXX_IN_GEANT4_MODE
1308 theEventInfo.parentResonancePDGCode[theEventInfo.nParticles] = (*i)->getParentResonancePDGCode();
1309 theEventInfo.parentResonanceID[theEventInfo.nParticles] = (*i)->getParentResonanceID();
1311 theEventInfo.history.push_back(
"");
1312 ParticleSpecies pt((*i)->getType());
1313 theEventInfo.PDGCode[theEventInfo.nParticles] = pt.getPDGCode();
1314 theEventInfo.nParticles++;
1316 theEventInfo.nCascadeParticles = theEventInfo.nParticles;
1322 theEventInfo.reset();
1327 theEventInfo.projectileType = projectileSpecies.theType;
1328 theEventInfo.Ap = -1;
1329 theEventInfo.Zp = -1;
1330 theEventInfo.Sp = 0;
1331 theEventInfo.Ep = kineticEnergy;
1332 theEventInfo.St = 0;
1333 theEventInfo.At = 2;
1334 theEventInfo.Zt = 1;
1339 theEventInfo.nParticles = 0;
1342 theEventInfo.nRemnants = 0;
1343 theEventInfo.history.clear();
1345 for(
ParticleIter i=outgoingParticles.begin(), e=outgoingParticles.end(); i!=e; ++i ) {
1346 theEventInfo.A[theEventInfo.nParticles] = (
Short_t)(*i)->getA();
1347 theEventInfo.Z[theEventInfo.nParticles] = (
Short_t)(*i)->getZ();
1348 theEventInfo.S[theEventInfo.nParticles] = (
Short_t)(*i)->getS();
1349 theEventInfo.EKin[theEventInfo.nParticles] = (*i)->getKineticEnergy();
1350 ThreeVector mom = (*i)->getMomentum();
1351 theEventInfo.px[theEventInfo.nParticles] = mom.getX();
1352 theEventInfo.py[theEventInfo.nParticles] = mom.getY();
1353 theEventInfo.pz[theEventInfo.nParticles] = mom.getZ();
1354 theEventInfo.theta[theEventInfo.nParticles] =
Math::toDegrees(mom.theta());
1355 theEventInfo.phi[theEventInfo.nParticles] =
Math::toDegrees(mom.phi());
1356 theEventInfo.origin[theEventInfo.nParticles] = -1;
1357#ifdef INCLXX_IN_GEANT4_MODE
1358 theEventInfo.parentResonancePDGCode[theEventInfo.nParticles] = (*i)->getParentResonancePDGCode();
1359 theEventInfo.parentResonanceID[theEventInfo.nParticles] = (*i)->getParentResonanceID();
1361 theEventInfo.history.push_back(
"");
1362 ParticleSpecies pt((*i)->getType());
1363 theEventInfo.PDGCode[theEventInfo.nParticles] = pt.getPDGCode();
1364 theEventInfo.nParticles++;
1367 for(
ParticleIter i=H2Particles.begin(), e=H2Particles.end(); i!=e; ++i ) {
1368 theEventInfo.A[theEventInfo.nParticles] = (
Short_t)(*i)->getA();
1369 theEventInfo.Z[theEventInfo.nParticles] = (
Short_t)(*i)->getZ();
1370 theEventInfo.S[theEventInfo.nParticles] = (
Short_t)(*i)->getS();
1371 theEventInfo.EKin[theEventInfo.nParticles] = (*i)->getKineticEnergy();
1372 ThreeVector mom = (*i)->getMomentum();
1373 theEventInfo.px[theEventInfo.nParticles] = mom.getX();
1374 theEventInfo.py[theEventInfo.nParticles] = mom.getY();
1375 theEventInfo.pz[theEventInfo.nParticles] = mom.getZ();
1376 theEventInfo.theta[theEventInfo.nParticles] =
Math::toDegrees(mom.theta());
1377 theEventInfo.phi[theEventInfo.nParticles] =
Math::toDegrees(mom.phi());
1378 theEventInfo.origin[theEventInfo.nParticles] = -1;
1379#ifdef INCLXX_IN_GEANT4_MODE
1380 theEventInfo.parentResonancePDGCode[theEventInfo.nParticles] = (*i)->getParentResonancePDGCode();
1381 theEventInfo.parentResonanceID[theEventInfo.nParticles] = (*i)->getParentResonanceID();
1383 theEventInfo.history.push_back(
"");
1384 ParticleSpecies pt((*i)->getType());
1385 theEventInfo.PDGCode[theEventInfo.nParticles] = pt.getPDGCode();
1386 theEventInfo.nParticles++;
1388 theEventInfo.nCascadeParticles = theEventInfo.nParticles;
G4double S(G4double temp)
const char * G4FindDataDir(const char *)
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
std::ostringstream G4ExceptionDescription
Alternative CascadeAction for dumping avatars.
Class containing default actions to be performed at intermediate cascade steps.
Static class for cluster formation.
Static class for selecting Coulomb distortion.
Simple container for output of calculation-wide results.
Abstract interface to the nuclear potential.
Simple class for computing intersections between a straight line and a sphere.
Functions that encapsulate a mass table.
G4GLOB_DLL std::ostream G4cout
static void setBias(const G4double b)
Set the global bias factor.
static void setCutNN(const G4double c)
ParticleList const & getParticles() const
void finalizeGlobalInfo(Random::SeedVector const &initialSeeds)
G4bool prepareReaction(const ParticleSpecies &projectileSpecies, const G4double kineticEnergy, const G4int A, const G4int Z, const G4int S)
INCL(Config const *const config)
const EventInfo & processEvent()
G4double initUniverseRadiusForAntiprotonAtRest(const G4int A, const G4int Z)
G4bool initializeTarget(const G4int A, const G4int Z, const G4int S, AnnihilationType theAType)
static void deleteBackupParticles()
Release the memory allocated for the backup particles.
Class that stores isotopic abundances for a given element.
IsotopeVector const & getIsotopes() const
Get the isotope vector.
ProjectileRemnant * getProjectileRemnant() const
Get the projectile remnant.
AnnihilationType getAnnihilationType() const
Getter for theAnnihilationType.
G4bool getTryCompoundNucleus()
G4int getS() const
Returns the strangeness number.
static std::vector< G4double > INCLBiasVector
Time ordered vector of all bias applied.
G4int getZ() const
Returns the charge number.
static G4double getTotalBias()
General bias vector function.
static G4ThreadLocal G4int nextBiasedCollisionID
G4int getA() const
Returns the baryon number.
void addToOutgoing(Particle *p)
add the particle to the outgoing particle list.
ParticleList extractDynamicalSpectators()
Returns a list of dynamical spectators.
void initialize(Config const *const theConfig)
Initialize the clustering model based on the Config object.
void deleteClusteringModel()
Delete the clustering model.
void initialize(Config const *const theConfig)
Initialize the Coulomb-distortion algorithm.
void deleteCoulomb()
Delete the Coulomb-distortion object.
void distortOut(ParticleList const &pL, Nucleus const *const n)
Modify the momentum of an outgoing particle.
G4double maxImpactParameter(ParticleSpecies const &p, const G4double kinE, Nucleus const *const n)
Return the maximum impact parameter for Coulomb-distorted trajectories.
G4double interactionDistanceKbarN(const G4double projectileKineticEnergy)
Compute the "interaction distance".
G4double interactionDistancePiN(const G4double projectileKineticEnergy)
Compute the "interaction distance".
G4double interactionDistanceKN(const G4double projectileKineticEnergy)
Compute the "interaction distance".
G4double interactionDistanceYN(const G4double projectileKineticEnergy)
Compute the "interaction distance".
void deleteCrossSections()
void initialize(Config const *const theConfig)
G4double interactionDistanceNN(const ParticleSpecies &aSpecies, const G4double kineticEnergy)
Compute the "interaction distance".
Intersection getEarlierTrajectoryIntersection(const ThreeVector &x0, const ThreeVector &p, const G4double r)
Compute the first intersection of a straight particle trajectory with a sphere.
void initVerbosityLevelFromEnvvar()
G4double toDegrees(G4double radians)
void clearCache()
Clear the INuclearPotential cache.
G4ThreadLocal NuclearMassFn getTableMass
Static pointer to the mass function for nuclei.
void initialize(Config const *const theConfig=0)
Initialize the particle table.
G4int drawRandomNaturalIsotope(const G4int Z)
G4double getRealMass(const G4INCL::ParticleType t)
Get particle mass (in MeV/c^2)
G4double getMaximumNuclearRadius(const ParticleType t, const G4int A, const G4int Z)
IsotopicDistribution const & getNaturalIsotopicDistribution(const G4int Z)
G4double getNuclearRadius(const ParticleType t, const G4int A, const G4int Z)
void initialize(Config const *const aConfig)
Initialise blockers according to a Config object.
void deleteBlockers()
Delete blockers.
void initialize(Config const *const theConfig)
void deletePhaseSpaceGenerator()
void generate(const G4double sqrtS, ParticleList &particles)
Generate an event in the CM system.
const G4double eSquared
Coulomb conversion factor [MeV*fm].
ThreeVector normVector(G4double norm=1.)
Adapter const & getAdapter()
void initialize(Config const *const)
Initialize generator according to a Config object.
Solution solve(RootFunctor const *const f, const G4double x0)
Numerically solve a one-dimensional equation.
ParticleList::const_iterator ParticleIter
IsotopeVector::iterator IsotopeIter
std::vector< Isotope > IsotopeVector
Bool_t pionAbsorption
True if the event is a pion absorption.
void reset()
Reset the EventInfo members.
Short_t At
Mass number of the target nucleus.
Short_t Zp
Charge number of the projectile nucleus.
Bool_t annihilationP
True if annihilation at rest on a proton.
Int_t projectileType
Projectile particle type.
Float_t Ep
Projectile kinetic energy given as input.
Short_t nCascadeParticles
Number of cascade particles.
Bool_t transparent
True if the event is transparent.
Bool_t nucleonAbsorption
True if the event is a nucleon absorption.
Short_t St
Strangeness number of the target nucleus.
Int_t nEnergyViolationInteraction
Number of attempted collisions/decays for which the energy-conservation algorithm failed to find a so...
Short_t Ap
Mass number of the projectile nucleus.
Short_t Sp
Strangeness number of the projectile nucleus.
Bool_t annihilationN
True if annihilation at rest on a neutron.
Short_t Zt
Charge number of the target nucleus.
static G4ThreadLocal Int_t eventNumber
Number of the event.
Int_t nNucleonAbsorptions
Number of nucleon absorptions (no outcoming particles)
Int_t nEnergyViolationInteraction
Number of attempted collisions/decays for which the energy-conservation algorithm failed to find a so...
Int_t nShots
Number of shots.
Int_t nPionAbsorptions
Number of nucleon absorptions (no outcoming pions)
Int_t nCompleteFusion
Number of complete-fusion events (nParticles==0)
Int_t nTransparents
Number of transparent shots.
Int_t nForcedCompoundNucleus
Number of forced compound-nucleus events.
Int_t nForcedTransparents
Number of forced transparents.