75 CLHEP::fine_structure_const*CLHEP::electron_mass_c2*CLHEP::electron_mass_c2
76 /(4.*CLHEP::pi*CLHEP::hbarc);
81 1.98550718e-02, 1.01666761e-01, 2.37233795e-01, 4.08282679e-01,
82 5.91717321e-01, 7.62766205e-01, 8.98333239e-01, 9.80144928e-01
85 5.06142681e-02, 1.11190517e-01, 1.56853323e-01, 1.81341892e-01,
86 1.81341892e-01, 1.56853323e-01, 1.11190517e-01, 5.06142681e-02
92 0.0, 5.3104, 4.7935, 4.7402, 4.7112, 4.6694, 4.6134, 4.5520
95 0.0, 5.9173, 5.6125, 5.5377, 5.4728, 5.4174, 5.3688, 5.3236
100 4.*CLHEP::fine_structure_const*CLHEP::classic_electr_radius
101 *CLHEP::classic_electr_radius;
116 :
G4VEmModel(nam), fIsUseLPMCorrection(true), fIsUseCompleteScreening(false),
117 fLPMEnergy(0.), fG4Calc(
G4Pow::GetInstance()), fTheGamma(
G4Gamma::Gamma()),
119 fParticleChange(nullptr)
134 for (std::size_t iz = 0; iz <
gElementData.size(); ++iz) {
153 InitialiseElementData();
182 const G4double eps0 = CLHEP::electron_mass_c2/gammaEnergy;
187 const G4double eps1 = 0.5 - 0.5*std::sqrt(1.-dmin/dmax);
188 const G4double epsMin = std::max(eps0, eps1);
195 const G4int numSub = 2;
197 G4double minEti = epsMin*gammaEnergy;
198 for (
G4int i = 0; i < numSub; ++i) {
199 for (
G4int ngl = 0; ngl < 8; ++ngl) {
203 xSection +=
gWGL[ngl]*xs;
209 xSection = std::max(2.*xSection*dInterv, 0.);
234 const G4double eps = pEnergy/gammaEnergy;
241 xSection = (eps*eps + epsm*epsm + 2.*dum/3.)*(Lel-fc) - dum/9.;
244 const G4double eps0 = CLHEP::electron_mass_c2/gammaEnergy;
250 xSection = (eps*eps + epsm*epsm)*(0.25*phi1-lnZ13-fc)
251 + 2.*dum*(0.25*phi2-lnZ13-fc)/3.;
255 return std::max(xSection, 0.0)/gammaEnergy;
283 const G4double eps = pEnergy/gammaEnergy;
288 ComputeLPMfunctions(fXiS, fGS, fPhiS, eps, gammaEnergy, iz);
293 xSection = (Lel-fc)*((eps*eps+epsm*epsm)*2.*fPhiS + fGS)/3. - dum*fGS/9.;
296 const G4double eps0 = CLHEP::electron_mass_c2/gammaEnergy;
302 xSection = (eps*eps + epsm*epsm)*(2.*fPhiS+fGS)*(0.25*phi1-lnZ13-fc)/3.
303 + 2.*dum*fGS*(0.25*phi2-lnZ13-fc)/3.;
307 return std::max(fXiS*xSection, 0.0)/gammaEnergy;
316 if ( gammaEnergy <= 2.0*electron_mass_c2 ) {
return crossSection; }
338 return std::max(crossSection, 0.);
368 const G4double eps0 = CLHEP::electron_mass_c2/gammaEnergy ;
372 if (eps0 > 0.5) {
return; }
386 static const G4double Egsmall = 2.*CLHEP::MeV;
387 if (gammaEnergy < Egsmall) {
388 eps = eps0 + (0.5-eps0)*rndmEngine->
flat();
408 const G4double deltaMin = 4.*deltaFactor;
416 const G4double epsp = 0.5 - 0.5*std::sqrt(1. - deltaMin/deltaMax) ;
417 const G4double epsMin = std::max(eps0,epsp);
418 const G4double epsRange = 0.5 - epsMin;
425 const G4double NormF1 = std::max(
F10 * epsRange * epsRange, 0.);
427 const G4double NormCond = NormF1/(NormF1 + NormF2);
436 if (NormCond > rndmv[0]) {
437 eps = 0.5 - epsRange *
fG4Calc->
A13(rndmv[1]);
438 const G4double delta = deltaFactor/(eps*(1.-eps));
440 G4double lpmXiS, lpmGS, lpmPhiS, phi1, phi2;
442 ComputeLPMfunctions(lpmXiS, lpmGS, lpmPhiS, eps, gammaEnergy, iZet);
443 greject = lpmXiS*((2.*lpmPhiS+lpmGS)*phi1-lpmGS*phi2-lpmPhiS*FZ)/
F10;
448 eps = epsMin + epsRange*rndmv[1];
449 const G4double delta = deltaFactor/(eps*(1.-eps));
451 G4double lpmXiS, lpmGS, lpmPhiS, phi1, phi2;
453 ComputeLPMfunctions(lpmXiS, lpmGS, lpmPhiS, eps, gammaEnergy, iZet);
454 greject = lpmXiS*( (lpmPhiS+0.5*lpmGS)*phi1 + 0.5*lpmGS*phi2
455 -0.5*(lpmGS+lpmPhiS)*FZ )/
F20;
461 }
while (greject < rndmv[2]);
467 if (rndmEngine->
flat() > 0.5) {
468 eTotEnergy = (1.-eps)*gammaEnergy;
469 pTotEnergy = eps*gammaEnergy;
471 pTotEnergy = (1.-eps)*gammaEnergy;
472 eTotEnergy = eps*gammaEnergy;
477 const G4double eKinEnergy = std::max(0.,eTotEnergy - CLHEP::electron_mass_c2);
478 const G4double pKinEnergy = std::max(0.,pTotEnergy - CLHEP::electron_mass_c2);
483 eKinEnergy, pKinEnergy, eDirection, pDirection);
490 fvect->push_back(aParticle1);
491 fvect->push_back(aParticle2);
498void G4PairProductionRelModel::InitialiseElementData()
506 std::size_t numElems = (*elemTable).size();
507 for (std::size_t ie = 0; ie < numElems; ++ie) {
511 const G4double logZ13 =
elem->GetIonisation()->GetlogZ3();
515 const G4double FZHigh = 8.*(logZ13 + fc);
522 Fel =
G4Log(184.) - logZ13;
523 Finel =
G4Log(1194.) - 2.*logZ13;
525 auto elD =
new ElementData();
526 elD->fLogZ13 = logZ13;
529 elD->fDeltaFactor = 136./Z13;
530 elD->fDeltaMaxLow =
G4Exp((42.038 - FZLow)/8.29) - 0.958;
531 elD->fDeltaMaxHigh =
G4Exp((42.038 - FZHigh)/8.29) - 0.958;
532 elD->fEtaValue = Finel/(Fel-fc);
533 elD->fLPMVarS1Cond = std::sqrt(2.)*Z13*Z13/(184.*184.);
534 elD->fLPMILVarS1Cond = 1./
G4Log(elD->fLPMVarS1Cond);
541void G4PairProductionRelModel::InitLPMFunctions() {
546 for (
G4int i=0; i<num; ++i) {
556 if (varShat < 0.01) {
557 funcPhiS = 6.0*varShat*(1.0-CLHEP::pi*varShat);
558 funcGS = 12.0*varShat-2.0*funcPhiS;
560 const G4double varShat2 = varShat*varShat;
561 const G4double varShat3 = varShat*varShat2;
562 const G4double varShat4 = varShat2*varShat2;
563 if (varShat < 0.415827397755) {
564 funcPhiS = 1.0-
G4Exp( -6.0*varShat*(1.0+varShat*(3.0-CLHEP::pi))
565 + varShat3/(0.623+0.796*varShat+0.658*varShat2));
567 const G4double funcPsiS = 1.0-
G4Exp( -4.0*varShat - 8.0*varShat2/(1.0
568 + 3.936*varShat+4.97*varShat2-0.05*varShat3+7.5*varShat4));
570 funcGS = 3.0*funcPsiS - 2.0*funcPhiS;
571 }
else if (varShat < 1.55) {
572 funcPhiS = 1.0-
G4Exp( -6.0*varShat*(1.0+varShat*(3.0-CLHEP::pi))
573 + varShat3/(0.623+0.796*varShat+0.658*varShat2));
574 const G4double dum0 = -0.16072300849123999+3.7550300067531581*varShat
575 -1.7981383069010097 *varShat2
576 +0.67282686077812381*varShat3
577 -0.1207722909879257 *varShat4;
578 funcGS = std::tanh(dum0);
580 funcPhiS = 1.0-0.01190476/varShat4;
581 if (varShat < 1.9156) {
582 const G4double dum0 = -0.16072300849123999+3.7550300067531581*varShat
583 -1.7981383069010097 *varShat2
584 +0.67282686077812381*varShat3
585 -0.1207722909879257 *varShat4;
586 funcGS = std::tanh(dum0);
588 funcGS = 1.0-0.0230655/varShat4;
595void G4PairProductionRelModel::GetLPMFunctions(
G4double &lpmGs,
609 lpmPhis = 1.0-0.01190476/ss;
610 lpmGs = 1.0-0.0230655/ss;
614void G4PairProductionRelModel::ComputeLPMfunctions(
G4double &funcXiS,
624 if (varSprime > 1.0) {
629 funcXiS = 1.0 + funcHSprime
630 - 0.08*(1.0-funcHSprime)*funcHSprime*(2.0-funcHSprime)*dum;
633 const G4double varShat = varSprime / std::sqrt(funcXiS);
634 GetLPMFunctions(funcGS, funcPhiS, varShat);
636 if (funcXiS * funcPhiS > 1. || varShat > 0.57) {
637 funcXiS = 1. / funcPhiS;
659 static const G4double kMC2 = CLHEP::electron_mass_c2;
661 if (
Z < 0.9 || gammaE <= 2.0*kMC2) {
return xSection; }
663 static const G4double gammaEnergyLimit = 1.5*CLHEP::MeV;
665 static const G4double a0 = 8.7842e+2*CLHEP::microbarn;
666 static const G4double a1 = -1.9625e+3*CLHEP::microbarn;
667 static const G4double a2 = 1.2949e+3*CLHEP::microbarn;
668 static const G4double a3 = -2.0028e+2*CLHEP::microbarn;
669 static const G4double a4 = 1.2575e+1*CLHEP::microbarn;
670 static const G4double a5 = -2.8333e-1*CLHEP::microbarn;
672 static const G4double b0 = -1.0342e+1*CLHEP::microbarn;
673 static const G4double b1 = 1.7692e+1*CLHEP::microbarn;
674 static const G4double b2 = -8.2381 *CLHEP::microbarn;
675 static const G4double b3 = 1.3063 *CLHEP::microbarn;
676 static const G4double b4 = -9.0815e-2*CLHEP::microbarn;
677 static const G4double b5 = 2.3586e-3*CLHEP::microbarn;
679 static const G4double c0 = -4.5263e+2*CLHEP::microbarn;
680 static const G4double c1 = 1.1161e+3*CLHEP::microbarn;
681 static const G4double c2 = -8.6749e+2*CLHEP::microbarn;
682 static const G4double c3 = 2.1773e+2*CLHEP::microbarn;
683 static const G4double c4 = -2.0467e+1*CLHEP::microbarn;
684 static const G4double c5 = 6.5372e-1*CLHEP::microbarn;
687 if (gammaE < gammaEnergyLimit) { gammaE = gammaEnergyLimit; }
695 const G4double F1 =
a0 + a1*x + a2*x2 + a3*x3 + a4*x4 + a5*x5;
696 const G4double F2 = b0 + b1*x + b2*x2 + b3*x3 + b4*x4 + b5*x5;
697 const G4double F3 = c0 + c1*x + c2*x2 + c3*x3 + c4*x4 + c5*x5;
699 xSection = (
Z + 1.)*(F1*
Z + F2*
Z*
Z + F3);
701 if (gammaEnergyOrg < gammaEnergyLimit) {
702 const G4double dum = (gammaEnergyOrg-2.*kMC2)/(gammaEnergyLimit-2.*kMC2);
std::vector< G4Element * > G4ElementTable
G4double condition(const G4ErrorSymMatrix &m)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
G4double G4Log(G4double x)
virtual void flatArray(const int size, double *vect)=0
G4double GetLogKineticEnergy() const
G4double GetKineticEnergy() const
static G4ElementTable * GetElementTable()
const G4Material * GetMaterial() const
G4double GetRadlen() const
G4double ComputeRelDXSectionPerAtom(G4double eplusEnergy, G4double gammaEnergy, G4double Z)
G4bool fIsUseLPMCorrection
static const G4double gFelLowZet[8]
void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy) override
G4double ComputeParametrizedXSectionPerAtom(G4double gammaEnergy, G4double Z)
static const G4double gEgLPMActivation
G4bool fIsUseCompleteScreening
static LPMFuncs gLPMFuncs
G4double fParametrizedXSectionThreshold
void ScreenFunction12(const G4double delta, G4double &f1, G4double &f2)
G4double fCoulombCorrectionThreshold
static const G4double gFinelLowZet[8]
static std::vector< ElementData * > gElementData
static const G4int gMaxZet
G4PairProductionRelModel(const G4ParticleDefinition *p=nullptr, const G4String &nam="BetheHeitlerLPM")
static const G4double gXGL[8]
G4double ScreenFunction1(const G4double delta)
void SetupForMaterial(const G4ParticleDefinition *, const G4Material *, G4double) override
G4double ComputeCrossSectionPerAtom(const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A=0., G4double cut=0., G4double emax=DBL_MAX) override
G4ParticleDefinition * fThePositron
static const G4double gLPMconstant
~G4PairProductionRelModel() override
void ComputePhi12(const G4double delta, G4double &phi1, G4double &phi2)
static const G4double gXSecFactor
G4double ComputeXSectionPerAtom(G4double gammaEnergy, G4double Z)
G4double ScreenFunction2(const G4double delta)
void Initialise(const G4ParticleDefinition *, const G4DataVector &) override
G4ParticleDefinition * fTheGamma
G4double ComputeDXSectionPerAtom(G4double eplusEnergy, G4double gammaEnergy, G4double Z)
void InitialiseLocal(const G4ParticleDefinition *, G4VEmModel *masterModel) override
static const G4double gWGL[8]
G4ParticleChangeForGamma * fParticleChange
G4ParticleDefinition * fTheElectron
void SetProposedKineticEnergy(G4double proposedKinEnergy)
G4double A13(G4double A) const
virtual void SamplePairDirections(const G4DynamicParticle *dp, G4double elecKinEnergy, G4double posiKinEnergy, G4ThreeVector &dirElectron, G4ThreeVector &dirPositron, G4int Z=0, const G4Material *mat=nullptr)
void SetElementSelectors(std::vector< G4EmElementSelector * > *)
G4VEmAngularDistribution * GetAngularDistribution()
G4ParticleChangeForGamma * GetParticleChangeForGamma()
G4double LowEnergyLimit() const
std::vector< G4EmElementSelector * > * GetElementSelectors()
G4double HighEnergyLimit() const
void SetAngularDistribution(G4VEmAngularDistribution *)
const G4Element * SelectTargetAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double logKineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
void InitialiseElementSelectors(const G4ParticleDefinition *, const G4DataVector &)
void ProposeTrackStatus(G4TrackStatus status)