45G4int G4LivermorePolarizedGammaConversionModel::maxZ = 99;
52 :
G4VEmModel(nam), isInitialised(false),smallEnergy(2.*MeV)
54 fParticleChange =
nullptr;
55 lowEnergyLimit = 2*electron_mass_c2;
66 if(verboseLevel > 0) {
67 G4cout <<
"Livermore Polarized GammaConversion is constructed "
78 for(
G4int i=0; i<maxZ; ++i) {
94 G4cout <<
"Calling1 G4LivermorePolarizedGammaConversionModel::Initialise()"
112 char* path = std::getenv(
"G4LEDATA");
119 for(
G4int i=0; i<numOfCouples; ++i)
126 for (
G4int j=0; j<nelm; ++j)
128 G4int Z = (
G4int)(*theElementVector)[j]->GetZ();
130 else if(Z > maxZ) { Z = maxZ; }
131 if(!data[Z]) { ReadData(Z, path); }
135 if(isInitialised) {
return; }
137 isInitialised =
true;
155 return lowEnergyLimit;
160void G4LivermorePolarizedGammaConversionModel::ReadData(
size_t Z,
const char* path)
162 if (verboseLevel > 1)
164 G4cout <<
"Calling ReadData() of G4LivermorePolarizedGammaConversionModel"
168 if(data[Z]) {
return; }
170 const char* datadir = path;
174 datadir = std::getenv(
"G4LEDATA");
177 G4Exception(
"G4LivermorePolarizedGammaConversionModel::ReadData()",
179 "Environment variable G4LEDATA not defined");
190 std::ostringstream ost;
191 ost << datadir <<
"/livermore/pair/pp-cs-" << Z <<
".dat";
192 std::ifstream fin(ost.str().c_str());
197 ed <<
"G4LivermorePolarizedGammaConversionModel data file <" << ost.str().c_str()
198 <<
"> is not opened!" <<
G4endl;
199 G4Exception(
"G4LivermorePolarizedGammaConversionModel::ReadData()",
201 ed,
"G4LEDATA version should be G4EMLOW6.27 or later.");
207 if(verboseLevel > 3) {
G4cout <<
"File " << ost.str()
208 <<
" is opened by G4LivermorePolarizedGammaConversionModel" <<
G4endl;}
226 if (verboseLevel > 1) {
227 G4cout <<
"G4LivermorePolarizedGammaConversionModel::ComputeCrossSectionPerAtom()"
230 if (GammaEnergy < lowEnergyLimit) {
return 0.0; }
236 if(intZ < 1 || intZ > maxZ) {
return xs; }
246 if(!pv) {
return xs; }
249 xs = pv->
Value(GammaEnergy);
254 G4cout <<
"****** DEBUG: tcs value for Z=" << Z <<
" at energy (MeV)="
255 << GammaEnergy/MeV <<
G4endl;
256 G4cout <<
" cs (Geant4 internal unit)=" << xs <<
G4endl;
257 G4cout <<
" -> first cs value in EADL data file (iu) =" << (*pv)[0] <<
G4endl;
258 G4cout <<
" -> last cs value in EADL data file (iu) =" << (*pv)[n] <<
G4endl;
259 G4cout <<
"*********************************************************" <<
G4endl;
280 if (verboseLevel > 3)
281 G4cout <<
"Calling SampleSecondaries() of G4LivermorePolarizedGammaConversionModel" <<
G4endl;
286 if(photonEnergy <= lowEnergyLimit)
300 if(!(gammaPolarization0.
isOrthogonal(gammaDirection0, 1e-6))||(gammaPolarization0.
mag()==0))
302 gammaPolarization0 = GetRandomPolarization(gammaDirection0);
308 gammaPolarization0 = GetPerpendicularPolarization(gammaDirection0, gammaPolarization0);
316 G4double epsilon0Local = electron_mass_c2 / photonEnergy ;
320 if (photonEnergy < smallEnergy )
335 G4cout <<
"G4LivermorePolarizedGammaConversionModel::SampleSecondaries - element = 0" <<
G4endl;
344 G4cout <<
"G4LivermorePolarizedGammaConversionModel::SampleSecondaries - ionisation = 0" <<
G4endl;
351 if (photonEnergy > 50. * MeV) fZ += 8. * (element->
GetfCoulomb());
356 G4double screenMin = std::min(4.*screenFactor,screenMax) ;
359 G4double epsilon1 = 0.5 - 0.5 * sqrt(1. - screenMin / screenMax) ;
360 G4double epsilonMin = std::max(epsilon0Local,epsilon1);
361 G4double epsilonRange = 0.5 - epsilonMin ;
367 G4double f10 = ScreenFunction1(screenMin) - fZ;
368 G4double f20 = ScreenFunction2(screenMin) - fZ;
369 G4double normF1 = std::max(f10 * epsilonRange * epsilonRange,0.);
370 G4double normF2 = std::max(1.5 * f20,0.);
377 gReject = (ScreenFunction1(screen) - fZ) / f10 ;
383 gReject = (ScreenFunction2(screen) - fZ) / f20 ;
400 electronTotEnergy = (1. -
epsilon) * photonEnergy;
401 positronTotEnergy =
epsilon * photonEnergy;
405 positronTotEnergy = (1. -
epsilon) * photonEnergy;
406 electronTotEnergy =
epsilon * photonEnergy;
428 G4double Ene = electronTotEnergy/electron_mass_c2;
433 SetTheta(&cosTheta,&sinTheta,Ene);
444 phi = SetPhi(photonEnergy);
445 psi = SetPsi(photonEnergy,phi);
500 G4double electronKineEnergy = std::max(0.,electronTotEnergy - electron_mass_c2) ;
502 SystemOfRefChange(gammaDirection0,electronDirection,
511 Ene = positronTotEnergy/electron_mass_c2;
516 SetTheta(&cosTheta,&sinTheta,Ene);
520 dirX = sinTheta*cos(phip);
521 dirY = sinTheta*sin(phip);
525 G4double positronKineEnergy = std::max(0.,positronTotEnergy - electron_mass_c2) ;
526 SystemOfRefChange(gammaDirection0,positronDirection,
531 positronDirection, positronKineEnergy);
534 fvect->push_back(particle1);
535 fvect->push_back(particle2);
545G4double G4LivermorePolarizedGammaConversionModel::ScreenFunction1(
G4double screenVariable)
551 if (screenVariable > 1.)
552 value = 42.24 - 8.368 * log(screenVariable + 0.952);
554 value = 42.392 - screenVariable * (7.796 - 1.961 * screenVariable);
561G4double G4LivermorePolarizedGammaConversionModel::ScreenFunction2(
G4double screenVariable)
567 if (screenVariable > 1.)
568 value = 42.24 - 8.368 * log(screenVariable + 0.952);
570 value = 41.405 - screenVariable * (5.828 - 0.8945 * screenVariable);
585 *p_cosTheta = (Energy*((2*Rand)- 1) +
Momentum)/((Momentum*(2*Rand-1))+Energy);
586 *p_sinTheta = (2*sqrt(Rand*(1-Rand)))/(Momentum*(2*Rand-1)+Energy);
610 const G4double ay0=5.6, by0=18.6, aa0=2.9, ba0 = 8.16E-3;
611 const G4double aw = 0.0151, bw = 10.7, cw = -410.;
613 const G4double axc = 3.1455, bxc = -1.11, cxc = 310.;
615 pl[0] = Fln(ay0,by0,Ene);
616 pl[1] = aa0 + ba0*(Ene);
617 pl[2] = Poli(aw,bw,cw,Ene);
618 pl[3] = Poli(axc,bxc,cxc,Ene);
620 const G4double abf = 3.1216, bbf = 2.68;
622 pt[1] = abf + bbf/Ene;
631 n1 = Fintlor(pl,pi) - Fintlor(pl,xe);
632 n2 = Finttan(pt,xe) - Finttan(pt,0.);
638 const G4double aw = 0.21, bw = 10.8, cw = -58.;
639 const G4double axc = 3.17, bxc = -0.87, cxc = -6.;
641 pl[0] = Fln(ay0, by0, Ene);
642 pl[1] = Fln(aa0, ba0, Ene);
643 pl[2] = Poli(aw,bw,cw,Ene);
644 pl[3] = Poli(axc,bxc,cxc,Ene);
648 n1 = Fintlor(pl,pi) - Fintlor(pl,xe);
675 value = Finvlor(pl,xe,r2);
676 xco = Glor(pl,value)/c1;
682 value = Finvtan(pt,n,r1);
690 value = Finvlor(pl,xe,r2);
691 xco = Glor(pl,value)/c1;
716 const G4double ay00 = 3.4, by00 = 9.8, aa00 = 1.34, ba00 = 5.3;
717 const G4double aw0 = 0.014, bw0 = 9.7, cw0 = -2.E4;
718 const G4double axc0 = 3.1423, bxc0 = -2.35, cxc0 = 0.;
719 const G4double ay0p = 1.53, by0p = 3.2, aap = 0.67, bap = 8.5E-3;
720 const G4double awp = 6.9E-3, bwp = 12.6, cwp = -3.8E4;
721 const G4double axcp = 2.8E-3,bxcp = -3.133;
722 const G4double abf0 = 3.1213, bbf0 = 2.61;
723 const G4double abfpm = 3.1231, bbfpm = 2.84;
725 p0l[0] = Fln(ay00, by00, Ene);
726 p0l[1] = Fln(aa00, ba00, Ene);
727 p0l[2] = Poli(aw0, bw0, cw0, Ene);
728 p0l[3] = Poli(axc0, bxc0, cxc0, Ene);
730 ppml[0] = Fln(ay0p, by0p, Ene);
731 ppml[1] = aap + bap*(Ene);
732 ppml[2] = Poli(awp, bwp, cwp, Ene);
733 ppml[3] = Fln(axcp,bxcp,Ene);
736 p0t[1] = abf0 + bbf0/Ene;
738 ppmt[1] = abfpm + bbfpm/Ene;
744 xe0 = Encu(p0l, p0t, xi);
746 xepm = Encu(ppml, ppmt, xi);
751 const G4double ay00 = 2.82, by00 = 6.35;
752 const G4double aa00 = -1.75, ba00 = 0.25;
754 const G4double aw0 = 0.028, bw0 = 5., cw0 = -50.;
755 const G4double axc0 = 3.14213, bxc0 = -2.3, cxc0 = 5.7;
756 const G4double ay0p = 1.56, by0p = 3.6;
757 const G4double aap = 0.86, bap = 8.3E-3;
758 const G4double awp = 0.022, bwp = 7.4, cwp = -51.;
761 p0l[0] = Fln(ay00, by00, Ene);
762 p0l[1] = aa00+pow(Ene, ba00);
763 p0l[2] = Poli(aw0, bw0, cw0, Ene);
764 p0l[3] = Poli(axc0, bxc0, cxc0, Ene);
765 ppml[0] = Fln(ay0p, by0p, Ene);
766 ppml[1] = aap + bap*(Ene);
767 ppml[2] = Poli(awp, bwp, cwp, Ene);
778 b = (ppml[0]+2*ppml[1]*ppml[2]*Flor(ppml,PhiLocal));
782 b = Ftan(ppmt,PhiLocal);
786 a = (p0l[0]+2*p0l[1]*p0l[2]*Flor(p0l,PhiLocal));
790 a = Ftan(p0t,PhiLocal);
795 b = (ppml[0]+2*ppml[1]*ppml[2]*Flor(ppml,PhiLocal));
796 a = (p0l[0]+2*p0l[1]*p0l[2]*Flor(p0l,PhiLocal));
817 r3 = nr*(a*cos(value)*cos(value) + b*sin(value)*sin(value));
824G4double G4LivermorePolarizedGammaConversionModel::Poli
830 value =(a + b/x + c/(x*x*x));
838G4double G4LivermorePolarizedGammaConversionModel::Fln
854G4double G4LivermorePolarizedGammaConversionModel::Encu
864 fx = (Flor(p_p1,x)*Glor(p_p1,x) - Ftan(p_p2, x))/
865 (Fdlor(p_p1,x) - Fdtan(p_p2,x));
867 if(x > xmax) {
return xmax; }
872 if(std::fabs(fx) <= x*1.0e-6) {
break; }
875 if(x < 0.0) { x = 0.0; }
888 value = 1./(
pi*(w*w + 4.*(x-xc)*(x-xc)));
901 value = (y0 *
pi*(w*w + 4.*(x-xc)*(x-xc)) + 2.*A*w);
914 value = (-16.*
A*w*(x-xc))/
915 (
pi*(w*w+4.*(x-xc)*(x-xc))*(w*w+4.*(x-xc)*(x-xc)));
928 value = y0*x +
A*atan( 2*(x-xc)/w) /
pi;
942 nor = atan(2.*(pi-xc)/w)/(2.*
pi*w) - atan(2.*(x-xc)/w)/(2.*pi*w);
943 value = xc - (w/2.)*tan(-2.*r*nor*pi*w+atan(2*(xc-x)/w));
966 value = -1.*a / ((x-b)*(x-b));
989 value = b*(1-
G4Exp(r*cnor/a));
1029 c.
setX(std::cos(angle)*(
a0.x())+std::sin(angle)*b0.
x());
1030 c.
setY(std::cos(angle)*(
a0.y())+std::sin(angle)*b0.
y());
1031 c.
setZ(std::cos(angle)*(
a0.z())+std::sin(angle)*b0.
z());
1041G4ThreeVector G4LivermorePolarizedGammaConversionModel::GetPerpendicularPolarization
1055 return gammaPolarization - gammaPolarization.
dot(gammaDirection)/gammaDirection.
dot(gammaDirection) * gammaDirection;
1061void G4LivermorePolarizedGammaConversionModel::SystemOfRefChange
1076 direction1 = (direction_x*Axis_X0 + direction_y*Axis_Y0 + direction_z*Axis_Z0).unit();
1090 G4AutoLock l(&LivermorePolarizedGammaConversionModelMutex);
1093 if(!data[Z]) { ReadData(Z); }
double epsilon(double density, double temperature)
double A(double temperature)
std::vector< G4Element * > G4ElementVector
void G4Exception(const char *originOfException, const char *exceptionCode, G4ExceptionSeverity severity, const char *description)
std::ostringstream G4ExceptionDescription
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
#define G4MUTEX_INITIALIZER
CLHEP::Hep3Vector G4ThreeVector
G4GLOB_DLL std::ostream G4cout
Hep3Vector cross(const Hep3Vector &) const
double dot(const Hep3Vector &) const
bool isOrthogonal(const Hep3Vector &v, double epsilon=tolerance) const
double howOrthogonal(const Hep3Vector &v) const
const G4ThreeVector & GetMomentumDirection() const
G4ParticleDefinition * GetDefinition() const
G4double GetKineticEnergy() const
const G4ThreeVector & GetPolarization() const
static G4Electron * Electron()
G4double GetfCoulomb() const
G4IonisParamElm * GetIonisation() const
G4double GetlogZ3() const
G4LivermorePolarizedGammaConversionModel(const G4ParticleDefinition *p=0, const G4String &nam="LivermorePolarizedGammaConversion")
virtual void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy)
virtual G4double MinPrimaryEnergy(const G4Material *, const G4ParticleDefinition *, G4double)
virtual G4double ComputeCrossSectionPerAtom(const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A=0, G4double cut=0, G4double emax=DBL_MAX)
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &)
virtual ~G4LivermorePolarizedGammaConversionModel()
virtual void InitialiseLocal(const G4ParticleDefinition *, G4VEmModel *masterModel)
virtual void InitialiseForElement(const G4ParticleDefinition *, G4int Z)
const G4Material * GetMaterial() const
const G4ElementVector * GetElementVector() const
size_t GetNumberOfElements() const
void SetProposedKineticEnergy(G4double proposedKinEnergy)
G4double Value(G4double theEnergy, std::size_t &lastidx) const
virtual G4bool Retrieve(std::ifstream &fIn, G4bool ascii=false)
std::size_t GetVectorLength() const
static G4Positron * Positron()
const G4MaterialCutsCouple * GetMaterialCutsCouple(G4int i) const
std::size_t GetTableSize() const
static G4ProductionCutsTable * GetProductionCutsTable()
void SetElementSelectors(std::vector< G4EmElementSelector * > *)
G4ParticleChangeForGamma * GetParticleChangeForGamma()
G4double LowEnergyLimit() const
std::vector< G4EmElementSelector * > * GetElementSelectors()
G4double HighEnergyLimit() const
const G4Element * SelectRandomAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
void InitialiseElementSelectors(const G4ParticleDefinition *, const G4DataVector &)
void ProposeTrackStatus(G4TrackStatus status)