66 std::ostringstream ost;
69 std::ifstream from(aName, std::ios::in);
73 std::ifstream theGammaData(aName, std::ios::in);
82 if(!getenv(
"G4NEUTRONHPDATA"))
83 throw G4HadronicException(__FILE__, __LINE__,
"Please setenv G4NEUTRONHPDATA to point to the neutron cross-section files.");
84 G4String tBase = getenv(
"G4NEUTRONHPDATA");
98 if(getenv(
"NeutronHPNamesLogging"))
G4cout <<
"Skipped = "<< filename <<
" "<<A<<
" "<<Z<<
G4endl;
107 std::istringstream theData(std::ios::in);
118 G4int infoType, dataType, dummy;
121 while (theData >> infoType)
125 theData >> sfType >> dummy;
127 if(sfType>=600||(sfType<100&&sfType>=50)) it = sfType%50;
135 theData >> dqi >> ilr;
160 else if(dataType==12)
165 else if(dataType==13)
170 else if(dataType==14)
174 else if(dataType==15)
180 throw G4HadronicException(__FILE__, __LINE__,
"Data-type unknown to G4NeutronHPInelasticCompFS");
195 if(i!=0) running[i]=running[i-1];
207 for(i0=0; i0<50; i0++)
210 if(random < running[i0]/sum)
break;
259 boosted.
Lorentz(theNeutron, theTarget);
276 if ( availableEnergy < 0 )
281 G4int nothingWasKnownOnHadron = 0;
302 if ( p2 > 0.0 ) p = std::sqrt( p );
325 if (
QI[it] < 0 || 849 <
QI[it] ) dqi =
QI[it];
330 }
while(eSecN>MaxEne);
333 eGamm = eKinetic-eSecN;
339 iLevel+=
G4int(random);
346 while (eKinetic-eExcitation < 0 && iLevel>0)
355 if ( dqi < 0 || 849 < dqi ) useQI =
true;
360 eExcitation = -
QI[it];
378 if ( iLevel == -1 ) iLevel = 0;
384 if ( !find ) iLevel = imaxEx;
388 if(getenv(
"InelasticCompFSLogging") && eKinetic-eExcitation < 0)
390 throw G4HadronicException(__FILE__, __LINE__,
"SEVERE: InelasticCompFS: Consistency of data not good enough, please file report");
392 if(eKinetic-eExcitation < 0) eExcitation = 0;
411 theRestEnergy->
SetMomentum(eGamm*std::sin(std::acos(costh))*std::cos(phi),
412 eGamm*std::sin(std::acos(costh))*std::sin(phi),
415 thePhotons->push_back(theRestEnergy);
426 nothingWasKnownOnHadron = 1;
440 boosted_tmp.
Lorentz(theNeutron, theTarget);
445 if(thePhotons!=0 && thePhotons->size()!=0)
446 { aBaseEnergy-=thePhotons->operator[](0)->GetTotalEnergy(); }
449 while(aBaseEnergy>0.01*
keV)
452 G4bool foundMatchingLevel =
false;
455 for(
G4int j=1; j<it; j++)
465 G4double deltaE = std::abs(testEnergy-aBaseEnergy);
470 thePhotons->push_back(theNext->operator[](0));
471 aBaseEnergy = testEnergy-theNext->operator[](0)->GetTotalEnergy();
473 foundMatchingLevel =
true;
482 if(!foundMatchingLevel)
486 thePhotons->push_back(theNext->operator[](0));
487 aBaseEnergy = aBaseEnergy-theNext->operator[](0)->GetTotalEnergy();
496 for(i0=0; i0<thePhotons->size(); i0++)
499 thePhotons->operator[](i0)->Lorentz(*(thePhotons->operator[](i0)), -1.*theTarget);
503 if(nothingWasKnownOnHadron)
510 if ( thePhotons != 0 )
512 unsigned int nPhotons = thePhotons->size();
514 for ( ii0=0; ii0<nPhotons; ii0++)
517 totalPhotonEnergy += thePhotons->operator[](ii0)->GetTotalEnergy();
526 G4ThreeVector boostToTargetRest = -target_in_LAB.boostVector();
533 two_body_reaction ( proj , targ , hadron , mu );
585 G4int nSecondaries = 2;
586 G4bool needsSeparateRecoil =
false;
587 G4int totalBaryonNumber = 0;
588 G4int totalCharge = 0;
590 if(theParticles != 0)
592 nSecondaries = theParticles->size();
595 for(ii0=0; ii0<theParticles->size(); ii0++)
597 aDef = theParticles->operator[](ii0)->GetDefinition();
600 totalMomentum += theParticles->operator[](ii0)->GetMomentum();
604 needsSeparateRecoil =
true;
614 if(thePhotons!=0) { nPhotons = thePhotons->size(); }
615 nSecondaries += nPhotons;
619 if( theParticles==0 )
626 aHadron.
Lorentz(aHadron, theTarget);
629 ->GetIon(static_cast<G4int>(residualZ), static_cast<G4int>(residualA), 0));
637 theResidual.
Lorentz(theResidual, -1.*theTarget);
641 for(i=0; i<nPhotons; i++)
643 totalPhotonMomentum += thePhotons->operator[](i)->GetMomentum();
653 for(i0=0; i0<theParticles->size(); i0++)
656 theSec->
SetDefinition(theParticles->operator[](i0)->GetDefinition());
657 theSec->
SetMomentum(theParticles->operator[](i0)->GetMomentum());
659 delete theParticles->operator[](i0);
662 if(needsSeparateRecoil && residualZ!=0)
666 ->GetIon(static_cast<G4int>(residualZ), static_cast<G4int>(residualA), 0));
668 resiualKineticEnergy += totalMomentum*totalMomentum;
669 resiualKineticEnergy = std::sqrt(resiualKineticEnergy) - theResidual.
GetMass();
688 for(i=0; i<nPhotons; i++)
693 theSec->
SetDefinition( thePhotons->operator[](i)->GetDefinition() );
695 theSec->
SetMomentum(thePhotons->operator[](i)->GetMomentum());
697 delete thePhotons->operator[](i);
754 if ( ( 1 + (1+A)/A*Q/E1 ) < 0 )
757 Q = -( A/(1+A)*E1 ) + 1.0e-6*
eV;
760 G4double beta = std::sqrt ( A*(A+1-AA)/AA*( 1 + (1+A)/A*Q/E1 ) );
762 G4double E3 = AA/std::pow((1+A),2)*(beta*beta+1+2*beta*mu)*E1;
763 G4double omega3 = (1+beta*mu)/std::sqrt(beta*beta+1+2*beta*mu);
764 if ( omega3 > 1.0 ) omega3 = 1.0;
766 G4double E4 = (A+1-AA)/std::pow((1+A),2)*(gamma*gamma+1-2*gamma*mu)*E1;
767 G4double omega4 = (1-gamma*mu)/std::sqrt(gamma*gamma+1-2*gamma*mu);
768 if ( omega4 > 1.0 ) omega4 = 1.0;
773 G4double pmag = std::sqrt ((E3+M)*(E3+M)-M*M) ;
774 G4ThreeVector p ( 0 , pmag*std::sqrt(1-omega3*omega3), pmag*omega3 );
777 G4double pmag4 = std::sqrt ((E4+M4)*(E4+M4)-M4*M4) ;
778 G4ThreeVector p4 ( 0 , -pmag4*std::sqrt(1-omega4*omega4), pmag4*omega4 );
G4ReactionProductVector * GetPhotons(G4double anEnergy)
static G4double GetNuclearMass(const G4double A, const G4double Z)
G4double GetLevelEnergy()
G4NeutronHPNames theNames
void SetMomentum(const G4ThreeVector &momentum)
G4double GetTotalMomentum() const
G4NeutronHPLevel * GetLevel(G4int i)
void Lorentz(const G4ReactionProduct &p1, const G4ReactionProduct &p2)
G4double GetKineticEnergy() const
CLHEP::Hep3Vector G4ThreeVector
void SetKineticEnergy(const G4double en)
static G4NeutronHPManager * GetInstance()
void SetMomentum(const G4double x, const G4double y, const G4double z)
G4NeutronHPVector * theXsection[51]
G4ParticleDefinition * GetIon(G4int Z, G4int A, G4int lvl=0)
void Init(std::istream &aDataFile)
G4double Sample(G4double anEnergy, G4int &it)
virtual G4NeutronHPVector * GetXsec()
void Init(std::istream &aDataFile, G4int total, G4double ux=1., G4double uy=1.)
G4NeutronHPDeExGammas theGammas
G4ParticleDefinition * GetDefinition() const
void GetDataStream(G4String, std::istringstream &iss)
G4NeutronHPDataUsed GetName(G4int A, G4int Z, G4String base, G4String rest, G4bool &active)
std::vector< G4double > QI
HepRotation inverse() const
G4ParticleDefinition * GetDefinition() const
void SetStatusChange(G4HadFinalStateStatus aS)
std::vector< G4ReactionProduct * > G4ReactionProductVector
void InitAngular(std::istream &aDataFile)
G4ReactionProduct GetBiasedThermalNucleus(G4double aMass, G4ThreeVector aVelocity, G4double temp=-1) const
G4HadFinalState theResult
G4GLOB_DLL std::ostream G4cout
G4NeutronHPEnergyDistribution * theEnergyDistribution[51]
const G4ParticleDefinition * GetDefinition() const
void CompositeApply(const G4HadProjectile &theTrack, G4ParticleDefinition *aHadron)
HepLorentzVector & boost(double, double, double)
G4double GetKineticEnergy() const
void setTheta(double theta)
G4int SelectExitChannel(G4double eKinetic)
G4ErrorTarget * theTarget
void InitEnergies(std::istream &aDataFile)
void Init(std::istream &aDataFile)
static G4Neutron * Neutron()
const G4LorentzVector & Get4Momentum() const
void InitGammas(G4double AR, G4double ZR)
void SetKineticEnergy(G4double aEnergy)
G4NeutronHPEnAngCorrelation * theEnergyAngData[51]
G4LorentzVector Get4Momentum() const
static G4IonTable * GetIonTable()
G4double GetKineticEnergy() const
void SampleAndUpdate(G4ReactionProduct &aNeutron)
G4NeutronHPAngular * theAngularDistribution[51]
G4int GetNumberOfLevels()
G4double GetTotalEnergy() const
G4bool InitMean(std::istream &aDataFile)
G4double total(Particle const *const p1, Particle const *const p2)
G4double GetPDGMass() const
G4double GetLevelEnergy(G4int aLevel)
T max(const T t1, const T t2)
brief Return the largest of the two arguments
G4NeutronHPPhotonDist * theFinalStatePhotons[51]
void SetDefinition(G4ParticleDefinition *aParticleDefinition)
void Init(std::istream &theData)
G4ThreeVector GetMomentum() const
G4double GetTemperature() const
const G4Material * GetMaterial() const
G4ReactionProductVector * Sample(G4double anEnergy)
void Init(G4double A, G4double Z, G4int M, G4String &dirName, G4String &aSFType)
G4ReactionProductVector * GetDecayGammas(G4int aLevel)
void SetAZMs(G4double anA, G4double aZ, G4int aM, G4NeutronHPDataUsed used)
void InitDistributionInitialState(G4ReactionProduct &aNeutron, G4ReactionProduct &aTarget, G4int it)
void SetDefinition(const G4ParticleDefinition *aParticleDefinition)
void adjust_final_state(G4LorentzVector)
G4double GetPDGCharge() const
G4double GetLevelEnergy()
void InitPartials(std::istream &aDataFile)
void AddSecondary(G4DynamicParticle *aP)
void Init(std::istream &aDataFile)
G4ThreeVector GetMomentum() const
G4int GetBaryonNumber() const