Geant4 11.1.1
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4eBremsstrahlungRelModel Class Reference

#include <G4eBremsstrahlungRelModel.hh>

+ Inheritance diagram for G4eBremsstrahlungRelModel:

Public Member Functions

 G4eBremsstrahlungRelModel (const G4ParticleDefinition *p=nullptr, const G4String &nam="eBremLPM")
 
 ~G4eBremsstrahlungRelModel () override
 
void Initialise (const G4ParticleDefinition *, const G4DataVector &) override
 
void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel) override
 
G4double ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double ekin, G4double cutEnergy) override
 
G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double ekin, G4double zet, G4double, G4double cutEnergy, G4double maxEnergy=DBL_MAX) override
 
void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double cutEnergy, G4double maxEnergy) override
 
void SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double) override
 
G4double MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cutEnergy) override
 
- Public Member Functions inherited from G4VEmModel
 G4VEmModel (const G4String &nam)
 
virtual ~G4VEmModel ()
 
virtual void Initialise (const G4ParticleDefinition *, const G4DataVector &)=0
 
virtual void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin=0.0, G4double tmax=DBL_MAX)=0
 
virtual void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel)
 
virtual void InitialiseForMaterial (const G4ParticleDefinition *, const G4Material *)
 
virtual void InitialiseForElement (const G4ParticleDefinition *, G4int Z)
 
virtual G4double ComputeDEDXPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX)
 
virtual G4double CrossSectionPerVolume (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double GetPartialCrossSection (const G4Material *, G4int level, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A=0., G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double ComputeCrossSectionPerShell (const G4ParticleDefinition *, G4int Z, G4int shellIdx, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
virtual G4double ChargeSquareRatio (const G4Track &)
 
virtual G4double GetChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual G4double GetParticleCharge (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void StartTracking (G4Track *)
 
virtual void CorrectionsAlongStep (const G4MaterialCutsCouple *, const G4DynamicParticle *, const G4double &length, G4double &eloss)
 
virtual G4double Value (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy)
 
virtual G4double MinPrimaryEnergy (const G4Material *, const G4ParticleDefinition *, G4double cut=0.0)
 
virtual G4double MinEnergyCut (const G4ParticleDefinition *, const G4MaterialCutsCouple *)
 
virtual void SetupForMaterial (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
virtual void DefineForRegion (const G4Region *)
 
virtual void FillNumberOfSecondaries (G4int &numberOfTriplets, G4int &numberOfRecoil)
 
virtual void ModelDescription (std::ostream &outFile) const
 
void InitialiseElementSelectors (const G4ParticleDefinition *, const G4DataVector &)
 
std::vector< G4EmElementSelector * > * GetElementSelectors ()
 
void SetElementSelectors (std::vector< G4EmElementSelector * > *)
 
G4double ComputeDEDX (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=DBL_MAX)
 
G4double CrossSection (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4double ComputeMeanFreePath (const G4ParticleDefinition *, G4double kineticEnergy, const G4Material *, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, const G4Element *, G4double kinEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectRandomAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectTargetAtom (const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double logKineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementSelectRandomAtom (const G4Material *, const G4ParticleDefinition *, G4double kineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
 
const G4ElementGetCurrentElement (const G4Material *mat=nullptr) const
 
G4int SelectRandomAtomNumber (const G4Material *) const
 
const G4IsotopeGetCurrentIsotope (const G4Element *elm=nullptr) const
 
G4int SelectIsotopeNumber (const G4Element *) const
 
void SetParticleChange (G4VParticleChange *, G4VEmFluctuationModel *f=nullptr)
 
void SetCrossSectionTable (G4PhysicsTable *, G4bool isLocal)
 
G4ElementDataGetElementData ()
 
G4PhysicsTableGetCrossSectionTable ()
 
G4VEmFluctuationModelGetModelOfFluctuations ()
 
G4VEmAngularDistributionGetAngularDistribution ()
 
G4VEmModelGetTripletModel ()
 
void SetTripletModel (G4VEmModel *)
 
void SetAngularDistribution (G4VEmAngularDistribution *)
 
G4double HighEnergyLimit () const
 
G4double LowEnergyLimit () const
 
G4double HighEnergyActivationLimit () const
 
G4double LowEnergyActivationLimit () const
 
G4double PolarAngleLimit () const
 
G4double SecondaryThreshold () const
 
G4bool LPMFlag () const
 
G4bool DeexcitationFlag () const
 
G4bool ForceBuildTableFlag () const
 
G4bool UseAngularGeneratorFlag () const
 
void SetAngularGeneratorFlag (G4bool)
 
void SetHighEnergyLimit (G4double)
 
void SetLowEnergyLimit (G4double)
 
void SetActivationHighEnergyLimit (G4double)
 
void SetActivationLowEnergyLimit (G4double)
 
G4bool IsActive (G4double kinEnergy) const
 
void SetPolarAngleLimit (G4double)
 
void SetSecondaryThreshold (G4double)
 
void SetLPMFlag (G4bool val)
 
void SetDeexcitationFlag (G4bool val)
 
void SetForceBuildTable (G4bool val)
 
void SetFluctuationFlag (G4bool val)
 
void SetMasterThread (G4bool val)
 
G4bool IsMaster () const
 
void SetUseBaseMaterials (G4bool val)
 
G4bool UseBaseMaterials () const
 
G4double MaxSecondaryKinEnergy (const G4DynamicParticle *dynParticle)
 
const G4StringGetName () const
 
void SetCurrentCouple (const G4MaterialCutsCouple *)
 
G4bool IsLocked () const
 
void SetLocked (G4bool)
 
G4VEmModeloperator= (const G4VEmModel &right)=delete
 
 G4VEmModel (const G4VEmModel &)=delete
 

Protected Member Functions

virtual G4double ComputeDXSectionPerAtom (G4double gammaEnergy)
 
void SetParticle (const G4ParticleDefinition *p)
 
- Protected Member Functions inherited from G4VEmModel
G4ParticleChangeForLossGetParticleChangeForLoss ()
 
G4ParticleChangeForGammaGetParticleChangeForGamma ()
 
virtual G4double MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kineticEnergy)
 
const G4MaterialCutsCoupleCurrentCouple () const
 
void SetCurrentElement (const G4Element *)
 

Protected Attributes

G4bool fIsElectron = true
 
G4bool fIsScatOffElectron = false
 
G4bool fIsLPMActive = false
 
G4int fCurrentIZ = 0
 
const G4ParticleDefinitionfPrimaryParticle = nullptr
 
G4ParticleDefinitionfGammaParticle = nullptr
 
G4ParticleChangeForLossfParticleChange = nullptr
 
G4double fPrimaryParticleMass = 0.
 
G4double fPrimaryKinEnergy = 0.
 
G4double fPrimaryTotalEnergy = 0.
 
G4double fDensityFactor = 0.
 
G4double fDensityCorr = 0.
 
G4double fLowestKinEnergy
 
G4double fNucTerm = 0.
 
G4double fSumTerm = 0.
 
- Protected Attributes inherited from G4VEmModel
G4ElementDatafElementData = nullptr
 
G4VParticleChangepParticleChange = nullptr
 
G4PhysicsTablexSectionTable = nullptr
 
const G4MaterialpBaseMaterial = nullptr
 
const std::vector< G4double > * theDensityFactor = nullptr
 
const std::vector< G4int > * theDensityIdx = nullptr
 
G4double inveplus
 
G4double pFactor = 1.0
 
size_t currentCoupleIndex = 0
 
size_t basedCoupleIndex = 0
 
G4bool lossFlucFlag = true
 

Static Protected Attributes

static const G4double gBremFactor
 
static const G4double gMigdalConstant
 

Detailed Description

Definition at line 59 of file G4eBremsstrahlungRelModel.hh.

Constructor & Destructor Documentation

◆ G4eBremsstrahlungRelModel()

G4eBremsstrahlungRelModel::G4eBremsstrahlungRelModel ( const G4ParticleDefinition p = nullptr,
const G4String nam = "eBremLPM" 
)
explicit

Definition at line 117 of file G4eBremsstrahlungRelModel.cc.

119: G4VEmModel(nam)
120{
122 //
123 fLowestKinEnergy = 1.0*MeV;
125 //
126 fLPMEnergyThreshold = 1.e+39;
127 fLPMEnergy = 0.;
128
129 SetLPMFlag(true);
130 //
132 //
133 if (nullptr != p) {
134 SetParticle(p);
135 }
136}
static G4Gamma * Gamma()
Definition: G4Gamma.cc:85
void SetLPMFlag(G4bool val)
Definition: G4VEmModel.hh:795
void SetLowEnergyLimit(G4double)
Definition: G4VEmModel.hh:753
void SetAngularDistribution(G4VEmAngularDistribution *)
Definition: G4VEmModel.hh:607
void SetParticle(const G4ParticleDefinition *p)
G4ParticleDefinition * fGammaParticle

◆ ~G4eBremsstrahlungRelModel()

G4eBremsstrahlungRelModel::~G4eBremsstrahlungRelModel ( )
override

Definition at line 138 of file G4eBremsstrahlungRelModel.cc.

139{
140 if (IsMaster()) {
141 // clear ElementData container
142 for (std::size_t iz = 0; iz < gElementData.size(); ++iz) {
143 if (nullptr != gElementData[iz]) {
144 delete gElementData[iz];
145 }
146 }
147 gElementData.clear();
148 // clear LPMFunctions (if any)
149 if (LPMFlag()) {
150 gLPMFuncs.fLPMFuncG.clear();
151 gLPMFuncs.fLPMFuncPhi.clear();
152 gLPMFuncs.fIsInitialized = false;
153 }
154 }
155}
G4bool IsMaster() const
Definition: G4VEmModel.hh:725
G4bool LPMFlag() const
Definition: G4VEmModel.hh:676

Member Function Documentation

◆ ComputeCrossSectionPerAtom()

G4double G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom ( const G4ParticleDefinition p,
G4double  ekin,
G4double  zet,
G4double  ,
G4double  cutEnergy,
G4double  maxEnergy = DBL_MAX 
)
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 313 of file G4eBremsstrahlungRelModel.cc.

320{
321 G4double crossSection = 0.0;
322 if (nullptr == fPrimaryParticle) {
323 SetParticle(p);
324 }
325 if (kineticEnergy < LowEnergyLimit()) {
326 return crossSection;
327 }
328 // min/max kinetic energy limits of the DCS integration:
329 const G4double tmin = std::min(cut, kineticEnergy);
330 const G4double tmax = std::min(maxEnergy, kineticEnergy);
331 // zero restricted x-section if e- kinetic energy is below gamma cut
332 if (tmin >= tmax) {
333 return crossSection;
334 }
335 fCurrentIZ = std::min(G4lrint(Z), gMaxZet);
336 // integrate numerically (dependent part of) the DCS between the kin. limits:
337 // a. integrate between tmin and kineticEnergy of the e-
338 crossSection = ComputeXSectionPerAtom(tmin);
339 // allow partial integration: only if maxEnergy < kineticEnergy
340 // b. integrate between tmax and kineticEnergy (tmax=maxEnergy in this case)
341 // (so the result in this case is the integral of DCS between tmin and
342 // maxEnergy)
343 if (tmax < kineticEnergy) {
344 crossSection -= ComputeXSectionPerAtom(tmax);
345 }
346 // multiply with the constant factors: 16\alpha r_0^2/3 Z^2
347 crossSection *= Z*Z*gBremFactor;
348 return std::max(crossSection, 0.);
349}
double G4double
Definition: G4Types.hh:83
const G4int Z[17]
G4double LowEnergyLimit() const
Definition: G4VEmModel.hh:641
const G4ParticleDefinition * fPrimaryParticle
int G4lrint(double ad)
Definition: templates.hh:134

◆ ComputeDEDXPerVolume()

G4double G4eBremsstrahlungRelModel::ComputeDEDXPerVolume ( const G4Material material,
const G4ParticleDefinition p,
G4double  ekin,
G4double  cutEnergy 
)
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 230 of file G4eBremsstrahlungRelModel.cc.

234{
235 G4double dedx = 0.0;
236 if (nullptr == fPrimaryParticle) {
237 SetParticle(p);
238 }
239 if (kineticEnergy < LowEnergyLimit()) {
240 return dedx;
241 }
242 // maximum value of the dE/dx integral (the minimum is 0 of course)
243 G4double tmax = std::min(cutEnergy, kineticEnergy);
244 if (tmax == 0.0) {
245 return dedx;
246 }
247 // sets kinematical and material related variables
248 SetupForMaterial(fPrimaryParticle, material,kineticEnergy);
249 // get element compositions of the material
250 const G4ElementVector* theElemVector = material->GetElementVector();
251 const G4double* theAtomNumDensVector = material->GetAtomicNumDensityVector();
252 const std::size_t numberOfElements = theElemVector->size();
253 // loop over the elements of the material and compute their contributions to
254 // the restricted dE/dx by numerical integration of the dependent part of DCS
255 for (std::size_t ie = 0; ie < numberOfElements; ++ie) {
256 G4VEmModel::SetCurrentElement((*theElemVector)[ie]);
257 G4int zet = (*theElemVector)[ie]->GetZasInt();
258 fCurrentIZ = std::min(zet, gMaxZet);
259 dedx += (zet*zet)*theAtomNumDensVector[ie]*ComputeBremLoss(tmax);
260 }
261 // apply the constant factor C/Z = 16\alpha r_0^2/3
262 dedx *= gBremFactor;
263 return std::max(dedx,0.);
264}
std::vector< const G4Element * > G4ElementVector
int G4int
Definition: G4Types.hh:85
const G4ElementVector * GetElementVector() const
Definition: G4Material.hh:185
const G4double * GetAtomicNumDensityVector() const
Definition: G4Material.hh:211
void SetCurrentElement(const G4Element *)
Definition: G4VEmModel.hh:493
void SetupForMaterial(const G4ParticleDefinition *, const G4Material *, G4double) override

◆ ComputeDXSectionPerAtom()

G4double G4eBremsstrahlungRelModel::ComputeDXSectionPerAtom ( G4double  gammaEnergy)
protectedvirtual

Reimplemented in G4LivermoreBremsstrahlungModel, and G4SeltzerBergerModel.

Definition at line 469 of file G4eBremsstrahlungRelModel.cc.

470{
471 G4double dxsec = 0.0;
472 if (gammaEnergy < 0.) {
473 return dxsec;
474 }
475 const G4double y = gammaEnergy/fPrimaryTotalEnergy;
476 const G4double onemy = 1.-y;
477 const G4double dum0 = onemy+0.75*y*y;
478 const ElementData* elDat = gElementData[fCurrentIZ];
479 // use complete screening and L_el, L_inel from Dirac-Fock model instead of TF
480 if (fCurrentIZ < 5 || fIsUseCompleteScreening) {
481 dxsec = dum0*elDat->fZFactor1;
482 dxsec += onemy*elDat->fZFactor2;
483 if (fIsScatOffElectron) {
484 fSumTerm = dxsec;
485 fNucTerm = dum0*elDat->fZFactor11+onemy/12.;
486 }
487 } else {
488 // use Tsai's analytical approx. (Tsai Eqs. [3.38-3.41]) to the 'universal'
489 // numerical screening functions computed by using the TF model of the atom
490 const G4double invZ = 1./(G4double)fCurrentIZ;
491 const G4double Fz = elDat->fFz;
492 const G4double logZ = elDat->fLogZ;
493 const G4double dum1 = y/(fPrimaryTotalEnergy-gammaEnergy);
494 const G4double gamma = dum1*elDat->fGammaFactor;
495 const G4double epsilon = dum1*elDat->fEpsilonFactor;
496 // evaluate the screening functions
497 G4double phi1, phi1m2, psi1, psi1m2;
498 ComputeScreeningFunctions(phi1, phi1m2, psi1, psi1m2, gamma, epsilon);
499 dxsec = dum0*((0.25*phi1-Fz) + (0.25*psi1-2.*logZ/3.)*invZ);
500 dxsec += 0.125*onemy*(phi1m2 + psi1m2*invZ);
501 if (fIsScatOffElectron) {
502 fSumTerm = dxsec;
503 fNucTerm = dum0*(0.25*phi1-Fz) + 0.125*onemy*phi1m2;
504 }
505 }
506 return std::max(dxsec,0.0);
507}
G4double epsilon(G4double density, G4double temperature)

Referenced by SampleSecondaries().

◆ Initialise()

void G4eBremsstrahlungRelModel::Initialise ( const G4ParticleDefinition p,
const G4DataVector cuts 
)
overridevirtual

Implements G4VEmModel.

Reimplemented in G4SeltzerBergerModel.

Definition at line 157 of file G4eBremsstrahlungRelModel.cc.

159{
160 if (nullptr != p) {
161 SetParticle(p);
162 }
163 fCurrentIZ = 0;
164 // init element data and precompute LPM functions (only if lpmflag is true)
165 if (IsMaster()) {
166 InitialiseElementData();
167 if (LPMFlag()) { InitLPMFunctions(); }
170 }
171 }
172 if (nullptr == fParticleChange) {
174 }
175 if (GetTripletModel()) {
176 GetTripletModel()->Initialise(p, cuts);
177 fIsScatOffElectron = true;
178 }
179}
G4VEmModel * GetTripletModel()
Definition: G4VEmModel.hh:617
G4double HighEnergyLimit() const
Definition: G4VEmModel.hh:634
void InitialiseElementSelectors(const G4ParticleDefinition *, const G4DataVector &)
Definition: G4VEmModel.cc:139
virtual void Initialise(const G4ParticleDefinition *, const G4DataVector &)=0
G4ParticleChangeForLoss * GetParticleChangeForLoss()
Definition: G4VEmModel.cc:109
G4ParticleChangeForLoss * fParticleChange

Referenced by G4LivermoreBremsstrahlungModel::Initialise().

◆ InitialiseLocal()

void G4eBremsstrahlungRelModel::InitialiseLocal ( const G4ParticleDefinition ,
G4VEmModel masterModel 
)
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 181 of file G4eBremsstrahlungRelModel.cc.

183{
186 }
187}
void SetElementSelectors(std::vector< G4EmElementSelector * > *)
Definition: G4VEmModel.hh:831
std::vector< G4EmElementSelector * > * GetElementSelectors()
Definition: G4VEmModel.hh:823

◆ MinPrimaryEnergy()

G4double G4eBremsstrahlungRelModel::MinPrimaryEnergy ( const G4Material ,
const G4ParticleDefinition ,
G4double  cutEnergy 
)
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 220 of file G4eBremsstrahlungRelModel.cc.

223{
224 return std::max(fLowestKinEnergy, cut);
225}

◆ SampleSecondaries()

void G4eBremsstrahlungRelModel::SampleSecondaries ( std::vector< G4DynamicParticle * > *  vdp,
const G4MaterialCutsCouple couple,
const G4DynamicParticle dp,
G4double  cutEnergy,
G4double  maxEnergy 
)
overridevirtual

Implements G4VEmModel.

Reimplemented in G4SeltzerBergerModel.

Definition at line 533 of file G4eBremsstrahlungRelModel.cc.

538{
539 const G4double kineticEnergy = dp->GetKineticEnergy();
540// const G4double logKineticEnergy = dp->GetLogKineticEnergy();
541 if (kineticEnergy < LowEnergyLimit()) {
542 return;
543 }
544 // min, max kinetic energy limits
545 const G4double tmin = std::min(cutEnergy, kineticEnergy);
546 const G4double tmax = std::min(maxEnergy, kineticEnergy);
547 if (tmin >= tmax) {
548 return;
549 }
550 //
551 SetupForMaterial(fPrimaryParticle, couple->GetMaterial(), kineticEnergy);
552 const G4Element* elm = SelectTargetAtom(couple,fPrimaryParticle,kineticEnergy,
553 dp->GetLogKineticEnergy(),tmin,tmax);
554 //
555 fCurrentIZ = elm->GetZasInt();
556 const ElementData* elDat = gElementData[fCurrentIZ];
557 const G4double funcMax = elDat->fZFactor1+elDat->fZFactor2;
558 // get the random engine
559 G4double rndm[2];
560 CLHEP::HepRandomEngine* rndmEngine = G4Random::getTheEngine();
561 // min max of the transformed variable: x(k) = ln(k^2+k_p^2) that is in [ln(k_c^2+k_p^2), ln(E_k^2+k_p^2)]
562 const G4double xmin = G4Log(tmin*tmin+fDensityCorr);
563 const G4double xrange = G4Log(tmax*tmax+fDensityCorr)-xmin;
564 G4double gammaEnergy, funcVal;
565 do {
566 rndmEngine->flatArray(2, rndm);
567 gammaEnergy = std::sqrt(std::max(G4Exp(xmin+rndm[0]*xrange)-fDensityCorr, 0.0));
568 funcVal = fIsLPMActive
569 ? ComputeRelDXSectionPerAtom(gammaEnergy)
570 : ComputeDXSectionPerAtom(gammaEnergy);
571 // cross-check of proper function maximum in the rejection
572// if (funcVal > funcMax) {
573// G4cout << "### G4eBremsstrahlungRelModel Warning: Majoranta exceeded! "
574// << funcVal << " > " << funcMax
575// << " Egamma(MeV)= " << gammaEnergy
576// << " Ee(MeV)= " << kineticEnergy
577// << " " << GetName()
578// << G4endl;
579// }
580 // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
581 } while (funcVal < funcMax*rndm[1]);
582 //
583 // scattering off nucleus or off e- by triplet model
584 if (fIsScatOffElectron && rndmEngine->flat()*fSumTerm>fNucTerm) {
585 GetTripletModel()->SampleSecondaries(vdp, couple, dp, cutEnergy, maxEnergy);
586 return;
587 }
588 //
589 // angles of the emitted gamma. ( Z - axis along the parent particle)
590 // use general interface
591 G4ThreeVector gamDir =
593 fCurrentIZ, couple->GetMaterial());
594 // create G4DynamicParticle object for the Gamma
595 auto gamma = new G4DynamicParticle(fGammaParticle, gamDir, gammaEnergy);
596 vdp->push_back(gamma);
597 // compute post-interaction kinematics of primary e-/e+ based on
598 // energy-momentum conservation
599 const G4double totMomentum = std::sqrt(kineticEnergy*(
600 fPrimaryTotalEnergy + CLHEP::electron_mass_c2));
601 G4ThreeVector dir =
602 (totMomentum*dp->GetMomentumDirection()-gammaEnergy*gamDir).unit();
603 const G4double finalE = kineticEnergy-gammaEnergy;
604 // if secondary gamma energy is higher than threshold(very high by default)
605 // then stop tracking the primary particle and create new secondary e-/e+
606 // instead of the primary one
607 if (gammaEnergy > SecondaryThreshold()) {
610 auto el = new G4DynamicParticle(
611 const_cast<G4ParticleDefinition*>(fPrimaryParticle), dir, finalE);
612 vdp->push_back(el);
613 } else { // continue tracking the primary e-/e+ otherwise
616 }
617}
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:180
G4double G4Log(G4double x)
Definition: G4Log.hh:227
@ fStopAndKill
virtual double flat()=0
virtual void flatArray(const int size, double *vect)=0
const G4ThreeVector & GetMomentumDirection() const
G4double GetLogKineticEnergy() const
G4double GetKineticEnergy() const
G4int GetZasInt() const
Definition: G4Element.hh:132
const G4Material * GetMaterial() const
void SetProposedKineticEnergy(G4double proposedKinEnergy)
void SetProposedMomentumDirection(const G4ThreeVector &dir)
virtual G4ThreeVector & SampleDirection(const G4DynamicParticle *dp, G4double finalTotalEnergy, G4int Z, const G4Material *)=0
G4VEmAngularDistribution * GetAngularDistribution()
Definition: G4VEmModel.hh:600
virtual void SampleSecondaries(std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin=0.0, G4double tmax=DBL_MAX)=0
const G4Element * SelectTargetAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double logKineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)
Definition: G4VEmModel.hh:577
G4double SecondaryThreshold() const
Definition: G4VEmModel.hh:669
void ProposeTrackStatus(G4TrackStatus status)
virtual G4double ComputeDXSectionPerAtom(G4double gammaEnergy)

◆ SetParticle()

void G4eBremsstrahlungRelModel::SetParticle ( const G4ParticleDefinition p)
protected

◆ SetupForMaterial()

void G4eBremsstrahlungRelModel::SetupForMaterial ( const G4ParticleDefinition ,
const G4Material mat,
G4double  kineticEnergy 
)
overridevirtual

Reimplemented from G4VEmModel.

Reimplemented in G4SeltzerBergerModel.

Definition at line 199 of file G4eBremsstrahlungRelModel.cc.

202{
204 fLPMEnergy = gLPMconstant*mat->GetRadlen();
205 // threshold for LPM effect (i.e. below which LPM hidden by density effect)
206 if (LPMFlag()) {
207 fLPMEnergyThreshold = std::sqrt(fDensityFactor)*fLPMEnergy;
208 } else {
209 fLPMEnergyThreshold = 1.e+39; // i.e. do not use LPM effect
210 }
211 // calculate threshold for density effect: k_p = sqrt(fDensityCorr)
212 fPrimaryKinEnergy = kineticEnergy;
215 // set activation flag for LPM effects in the DCS
216 fIsLPMActive = (fPrimaryTotalEnergy>fLPMEnergyThreshold);
217}
G4double GetElectronDensity() const
Definition: G4Material.hh:212
G4double GetRadlen() const
Definition: G4Material.hh:215

Referenced by ComputeDEDXPerVolume(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), and SampleSecondaries().

Member Data Documentation

◆ fCurrentIZ

◆ fDensityCorr

◆ fDensityFactor

G4double G4eBremsstrahlungRelModel::fDensityFactor = 0.
protected

◆ fGammaParticle

◆ fIsElectron

◆ fIsLPMActive

G4bool G4eBremsstrahlungRelModel::fIsLPMActive = false
protected

◆ fIsScatOffElectron

G4bool G4eBremsstrahlungRelModel::fIsScatOffElectron = false
protected

◆ fLowestKinEnergy

G4double G4eBremsstrahlungRelModel::fLowestKinEnergy
protected

◆ fNucTerm

G4double G4eBremsstrahlungRelModel::fNucTerm = 0.
protected

Definition at line 165 of file G4eBremsstrahlungRelModel.hh.

Referenced by ComputeDXSectionPerAtom(), and SampleSecondaries().

◆ fParticleChange

◆ fPrimaryKinEnergy

◆ fPrimaryParticle

◆ fPrimaryParticleMass

G4double G4eBremsstrahlungRelModel::fPrimaryParticleMass = 0.
protected

◆ fPrimaryTotalEnergy

◆ fSumTerm

G4double G4eBremsstrahlungRelModel::fSumTerm = 0.
protected

Definition at line 166 of file G4eBremsstrahlungRelModel.hh.

Referenced by ComputeDXSectionPerAtom(), and SampleSecondaries().

◆ gBremFactor

const G4double G4eBremsstrahlungRelModel::gBremFactor
staticprotected
Initial value:
= 16. * CLHEP::fine_structure_const * CLHEP::classic_electr_radius
* CLHEP::classic_electr_radius/3.

Definition at line 176 of file G4eBremsstrahlungRelModel.hh.

Referenced by ComputeCrossSectionPerAtom(), ComputeDEDXPerVolume(), G4LivermoreBremsstrahlungModel::ComputeDXSectionPerAtom(), and G4SeltzerBergerModel::ComputeDXSectionPerAtom().

◆ gMigdalConstant

const G4double G4eBremsstrahlungRelModel::gMigdalConstant
staticprotected
Initial value:
= 4. * CLHEP::pi * CLHEP::classic_electr_radius
* CLHEP::electron_Compton_length * CLHEP::electron_Compton_length

Definition at line 177 of file G4eBremsstrahlungRelModel.hh.

Referenced by SetupForMaterial(), and G4SeltzerBergerModel::SetupForMaterial().


The documentation for this class was generated from the following files: