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

#include <G4BetheHeitlerModel.hh>

+ Inheritance diagram for G4BetheHeitlerModel:

Classes

struct  ElementData
 

Public Member Functions

 G4BetheHeitlerModel (const G4ParticleDefinition *p=nullptr, const G4String &nam="BetheHeitler")
 
 ~G4BetheHeitlerModel () override
 
void Initialise (const G4ParticleDefinition *, const G4DataVector &) override
 
void InitialiseLocal (const G4ParticleDefinition *, G4VEmModel *masterModel) override
 
G4double ComputeCrossSectionPerAtom (const G4ParticleDefinition *, G4double kinEnergy, G4double Z, G4double A=0., G4double cut=0., G4double emax=DBL_MAX) override
 
void SampleSecondaries (std::vector< G4DynamicParticle * > *, const G4MaterialCutsCouple *, const G4DynamicParticle *, G4double tmin, G4double maxEnergy) override
 
G4BetheHeitlerModeloperator= (const G4BetheHeitlerModel &right)=delete
 
 G4BetheHeitlerModel (const G4BetheHeitlerModel &)=delete
 
- Public Member Functions inherited from G4VEmModel
 G4VEmModel (const G4String &nam)
 
virtual ~G4VEmModel ()
 
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 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 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 SetDeexcitationFlag (G4bool val)
 
void SetForceBuildTable (G4bool val)
 
void SetFluctuationFlag (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)
 
void SetLPMFlag (G4bool)
 
void SetMasterThread (G4bool)
 
G4VEmModeloperator= (const G4VEmModel &right)=delete
 
 G4VEmModel (const G4VEmModel &)=delete
 

Protected Member Functions

G4double ScreenFunction1 (const G4double delta)
 
G4double ScreenFunction2 (const G4double delta)
 
void ScreenFunction12 (const G4double delta, G4double &f1, G4double &f2)
 
void InitialiseElementData ()
 
- Protected Member Functions inherited from G4VEmModel
G4ParticleChangeForLossGetParticleChangeForLoss ()
 
G4ParticleChangeForGammaGetParticleChangeForGamma ()
 
virtual G4double MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kineticEnergy)
 
const G4MaterialCutsCoupleCurrentCouple () const
 
void SetCurrentElement (const G4Element *)
 

Protected Attributes

G4PowfG4Calc
 
const G4ParticleDefinitionfTheGamma
 
const G4ParticleDefinitionfTheElectron
 
const G4ParticleDefinitionfThePositron
 
G4ParticleChangeForGammafParticleChange
 
G4EmElementXSfXSection {nullptr}
 
G4bool isFirstInstance {false}
 
G4bool useEPICS2017 {false}
 
- 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
 
std::size_t currentCoupleIndex = 0
 
std::size_t basedCoupleIndex = 0
 
G4bool lossFlucFlag = true
 

Static Protected Attributes

static const G4int gMaxZet = 120
 
static std::vector< ElementData * > gElementData
 

Detailed Description

Definition at line 61 of file G4BetheHeitlerModel.hh.

Constructor & Destructor Documentation

◆ G4BetheHeitlerModel() [1/2]

G4BetheHeitlerModel::G4BetheHeitlerModel ( const G4ParticleDefinition * p = nullptr,
const G4String & nam = "BetheHeitler" )
explicit

Definition at line 68 of file G4BetheHeitlerModel.cc.

70: G4VEmModel(nam),
73 fParticleChange(nullptr)
74{
75 SetAngularDistribution(new G4ModifiedTsai());
76}
G4ParticleChangeForGamma * fParticleChange
const G4ParticleDefinition * fTheElectron
const G4ParticleDefinition * fTheGamma
const G4ParticleDefinition * fThePositron
static G4Electron * Electron()
Definition G4Electron.cc:91
static G4Gamma * Gamma()
Definition G4Gamma.cc:81
static G4Positron * Positron()
Definition G4Positron.cc:90
static G4Pow * GetInstance()
Definition G4Pow.cc:41
G4VEmModel(const G4String &nam)
Definition G4VEmModel.cc:67
void SetAngularDistribution(G4VEmAngularDistribution *)

Referenced by G4BetheHeitlerModel(), G4PolarizedGammaConversionModel::G4PolarizedGammaConversionModel(), and operator=().

◆ ~G4BetheHeitlerModel()

G4BetheHeitlerModel::~G4BetheHeitlerModel ( )
override

Definition at line 78 of file G4BetheHeitlerModel.cc.

79{
80 if (isFirstInstance) {
81 for (auto const & ptr : gElementData) { delete ptr; }
82 gElementData.clear();
83 }
84 delete fXSection;
85}
static std::vector< ElementData * > gElementData

◆ G4BetheHeitlerModel() [2/2]

G4BetheHeitlerModel::G4BetheHeitlerModel ( const G4BetheHeitlerModel & )
delete

Member Function Documentation

◆ ComputeCrossSectionPerAtom()

G4double G4BetheHeitlerModel::ComputeCrossSectionPerAtom ( const G4ParticleDefinition * ,
G4double kinEnergy,
G4double Z,
G4double A = 0.,
G4double cut = 0.,
G4double emax = DBL_MAX )
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 127 of file G4BetheHeitlerModel.cc.

130{
131 G4double xSection = 0.0 ;
132 // short versions
133 static const G4double kMC2 = CLHEP::electron_mass_c2;
134 // zero cross section below the kinematical limit: Eg<2mc^2
135 if (Z < 0.9 || gammaEnergy <= 2.0*kMC2) { return xSection; }
136
137 G4int iZ = G4lrint(Z);
138 if (useEPICS2017 && iZ < 101) {
139 return fXSection->GetXS(iZ, gammaEnergy);
140 }
141
142 //
143 static const G4double gammaEnergyLimit = 1.5*CLHEP::MeV;
144 // set coefficients a, b c
145 static const G4double a0 = 8.7842e+2*CLHEP::microbarn;
146 static const G4double a1 = -1.9625e+3*CLHEP::microbarn;
147 static const G4double a2 = 1.2949e+3*CLHEP::microbarn;
148 static const G4double a3 = -2.0028e+2*CLHEP::microbarn;
149 static const G4double a4 = 1.2575e+1*CLHEP::microbarn;
150 static const G4double a5 = -2.8333e-1*CLHEP::microbarn;
151
152 static const G4double b0 = -1.0342e+1*CLHEP::microbarn;
153 static const G4double b1 = 1.7692e+1*CLHEP::microbarn;
154 static const G4double b2 = -8.2381 *CLHEP::microbarn;
155 static const G4double b3 = 1.3063 *CLHEP::microbarn;
156 static const G4double b4 = -9.0815e-2*CLHEP::microbarn;
157 static const G4double b5 = 2.3586e-3*CLHEP::microbarn;
158
159 static const G4double c0 = -4.5263e+2*CLHEP::microbarn;
160 static const G4double c1 = 1.1161e+3*CLHEP::microbarn;
161 static const G4double c2 = -8.6749e+2*CLHEP::microbarn;
162 static const G4double c3 = 2.1773e+2*CLHEP::microbarn;
163 static const G4double c4 = -2.0467e+1*CLHEP::microbarn;
164 static const G4double c5 = 6.5372e-1*CLHEP::microbarn;
165 // check low energy limit of the approximation (1.5 MeV)
166 G4double gammaEnergyOrg = gammaEnergy;
167 if (gammaEnergy < gammaEnergyLimit) { gammaEnergy = gammaEnergyLimit; }
168 // compute gamma energy variables
169 const G4double x = G4Log(gammaEnergy/kMC2);
170 const G4double x2 = x *x;
171 const G4double x3 = x2*x;
172 const G4double x4 = x3*x;
173 const G4double x5 = x4*x;
174 //
175 const G4double F1 = a0 + a1*x + a2*x2 + a3*x3 + a4*x4 + a5*x5;
176 const G4double F2 = b0 + b1*x + b2*x2 + b3*x3 + b4*x4 + b5*x5;
177 const G4double F3 = c0 + c1*x + c2*x2 + c3*x3 + c4*x4 + c5*x5;
178 // compute the approximated cross section
179 xSection = (Z + 1.)*(F1*Z + F2*Z*Z + F3);
180 // check if we are below the limit of the approximation and apply correction
181 if (gammaEnergyOrg < gammaEnergyLimit) {
182 const G4double dum = (gammaEnergyOrg-2.*kMC2)/(gammaEnergyLimit-2.*kMC2);
183 xSection *= dum*dum;
184 }
185 // make sure that the cross section is never negative
186 xSection = std::max(xSection, 0.);
187 return xSection;
188}
const G4double a0
G4double G4Log(G4double x)
Definition G4Log.hh:227
double G4double
Definition G4Types.hh:83
int G4int
Definition G4Types.hh:85
int G4lrint(double ad)
Definition templates.hh:134

◆ Initialise()

void G4BetheHeitlerModel::Initialise ( const G4ParticleDefinition * p,
const G4DataVector & cuts )
overridevirtual

Implements G4VEmModel.

Reimplemented in G4PolarizedGammaConversionModel.

Definition at line 87 of file G4BetheHeitlerModel.cc.

89{
91
92 if (isFirstInstance || gElementData.empty()) {
93 G4AutoLock l(&theBetheHMutex);
94 if (gElementData.empty()) {
95 isFirstInstance = true;
96 gElementData.resize(gMaxZet+1, nullptr);
97
98 // EPICS2017 flag should be checked only once
100 if (useEPICS2017) {
101 fXSection = new G4EmElementXS(1, 100, "convEPICS2017", "/epics2017/pair/pp-cs-");
102 }
103 }
104 // static data should be initialised only in the one instance
106 l.unlock();
107 }
108 // element selectors should be initialised in the master thread
109 if(IsMaster()) {
111 }
112}
G4TemplateAutoLock< G4Mutex > G4AutoLock
static const G4int gMaxZet
G4bool UseEPICS2017XS() const
static G4EmParameters * Instance()
G4ParticleChangeForGamma * GetParticleChangeForGamma()
G4bool IsMaster() const
void InitialiseElementSelectors(const G4ParticleDefinition *, const G4DataVector &)

Referenced by G4PolarizedGammaConversionModel::Initialise().

◆ InitialiseElementData()

void G4BetheHeitlerModel::InitialiseElementData ( )
protected

Definition at line 323 of file G4BetheHeitlerModel.cc.

324{
325 // create for all elements that are in the detector
326 auto elemTable = G4Element::GetElementTable();
327 for (auto const & elem : *elemTable) {
328 const G4int Z = elem->GetZasInt();
329 const G4int iz = std::min(gMaxZet, Z);
330 if (nullptr == gElementData[iz]) { // create it if doesn't exist yet
331 G4double FZLow = 8.*elem->GetIonisation()->GetlogZ3();
332 G4double FZHigh = FZLow + 8.*elem->GetfCoulomb();
333 auto elD = new ElementData();
334 elD->fDeltaMaxLow = G4Exp((42.038 - FZLow )/8.29) - 0.958;
335 elD->fDeltaMaxHigh = G4Exp((42.038 - FZHigh)/8.29) - 0.958;
336 gElementData[iz] = elD;
337 }
338 if (useEPICS2017 && Z < 101) {
339 fXSection->Retrieve(Z);
340 }
341 }
342
343}
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition G4Exp.hh:180
#define elem(i, j)
static const G4ElementTable * GetElementTable()
Definition G4Element.cc:401

Referenced by Initialise().

◆ InitialiseLocal()

void G4BetheHeitlerModel::InitialiseLocal ( const G4ParticleDefinition * ,
G4VEmModel * masterModel )
overridevirtual

Reimplemented from G4VEmModel.

Definition at line 114 of file G4BetheHeitlerModel.cc.

116{
118}
void SetElementSelectors(std::vector< G4EmElementSelector * > *)
std::vector< G4EmElementSelector * > * GetElementSelectors()

◆ operator=()

G4BetheHeitlerModel & G4BetheHeitlerModel::operator= ( const G4BetheHeitlerModel & right)
delete

◆ SampleSecondaries()

void G4BetheHeitlerModel::SampleSecondaries ( std::vector< G4DynamicParticle * > * fvect,
const G4MaterialCutsCouple * couple,
const G4DynamicParticle * aDynamicGamma,
G4double tmin,
G4double maxEnergy )
overridevirtual

Implements G4VEmModel.

Reimplemented in G4PolarizedGammaConversionModel.

Definition at line 202 of file G4BetheHeitlerModel.cc.

206{
207 // set some constant values
208 const G4double gammaEnergy = aDynamicGamma->GetKineticEnergy();
209 const G4double eps0 = CLHEP::electron_mass_c2/gammaEnergy;
210 //
211 // check kinematical limit: gamma energy(Eg) must be at least 2 e- rest mass
212 if (eps0 > 0.5) { return; }
213 //
214 // select target element of the material (probs. are based on partial x-secs)
215 const G4Element* anElement = SelectTargetAtom(couple, fTheGamma, gammaEnergy,
216 aDynamicGamma->GetLogKineticEnergy());
217
218 //
219 // get the random engine
220 CLHEP::HepRandomEngine* rndmEngine = G4Random::getTheEngine();
221 //
222 // 'eps' is the total energy transferred to one of the e-/e+ pair in initial
223 // gamma energy units Eg. Since the corresponding DCS is symmetric on eps=0.5,
224 // the kinematical limits for eps0=mc^2/Eg <= eps <= 0.5
225 // 1. 'eps' is sampled uniformly on the [eps0, 0.5] inteval if Eg<Egsmall
226 // 2. otherwise, on the [eps_min, 0.5] interval according to the DCS (case 2.)
227 G4double eps;
228 // case 1.
229 static const G4double Egsmall = 2.*CLHEP::MeV;
230 if (gammaEnergy < Egsmall) {
231 eps = eps0 + (0.5-eps0)*rndmEngine->flat();
232 } else {
233 // case 2.
234 // get the Coulomb factor for the target element (Z) and gamma energy (Eg)
235 // F(Z) = 8*ln(Z)/3 if Eg <= 50 [MeV] => no Coulomb correction
236 // F(Z) = 8*ln(Z)/3 + 8*fc(Z) if Eg > 50 [MeV] => fc(Z) is the Coulomb cor.
237 //
238 // The screening variable 'delta(eps)' = 136*Z^{-1/3}*eps0/[eps(1-eps)]
239 // Due to the Coulomb correction, the DCS can go below zero even at
240 // kinematicaly allowed eps > eps0 values. In order to exclude this eps
241 // range with negative DCS, the minimum eps value will be set to eps_min =
242 // max[eps0, epsp] with epsp is the solution of SF(delta(epsp)) - F(Z)/2 = 0
243 // with SF being the screening function (SF1=SF2 at high value of delta).
244 // The solution is epsp = 0.5 - 0.5*sqrt[ 1 - 4*136*Z^{-1/3}eps0/deltap]
245 // with deltap = Exp[(42.038-F(Z))/8.29]-0.958. So the limits are:
246 // - when eps=eps_max = 0.5 => delta_min = 136*Z^{-1/3}*eps0/4
247 // - epsp = 0.5 - 0.5*sqrt[ 1 - delta_min/deltap]
248 // - and eps_min = max[eps0, epsp]
249 static const G4double midEnergy = 50.*CLHEP::MeV;
250 const G4int iZet = std::min(gMaxZet, anElement->GetZasInt());
251 const G4double deltaFactor = 136.*eps0/anElement->GetIonisation()->GetZ3();
252 G4double deltaMax = gElementData[iZet]->fDeltaMaxLow;
253 G4double FZ = 8.*anElement->GetIonisation()->GetlogZ3();
254 if (gammaEnergy > midEnergy) {
255 FZ += 8.*(anElement->GetfCoulomb());
256 deltaMax = gElementData[iZet]->fDeltaMaxHigh;
257 }
258 const G4double deltaMin = 4.*deltaFactor;
259 //
260 // compute the limits of eps
261 const G4double epsp = 0.5 - 0.5*std::sqrt(1. - deltaMin/deltaMax) ;
262 const G4double epsMin = std::max(eps0,epsp);
263 const G4double epsRange = 0.5 - epsMin;
264 //
265 // sample the energy rate (eps) of the created electron (or positron)
267 ScreenFunction12(deltaMin, F10, F20);
268 F10 -= FZ;
269 F20 -= FZ;
270 const G4double NormF1 = std::max(F10 * epsRange * epsRange, 0.);
271 const G4double NormF2 = std::max(1.5 * F20 , 0.);
272 const G4double NormCond = NormF1/(NormF1 + NormF2);
273 // we will need 3 uniform random number for each trial of sampling
274 G4double rndmv[3];
275 G4double greject = 0.;
276 do {
277 rndmEngine->flatArray(3, rndmv);
278 if (NormCond > rndmv[0]) {
279 eps = 0.5 - epsRange * fG4Calc->A13(rndmv[1]);
280 const G4double delta = deltaFactor/(eps*(1.-eps));
281 greject = (ScreenFunction1(delta)-FZ)/F10;
282 } else {
283 eps = epsMin + epsRange*rndmv[1];
284 const G4double delta = deltaFactor/(eps*(1.-eps));
285 greject = (ScreenFunction2(delta)-FZ)/F20;
286 }
287 // Loop checking, 03-Aug-2015, Vladimir Ivanchenko
288 } while (greject < rndmv[2]);
289 } // end of eps sampling
290 //
291 // select charges randomly
292 G4double eTotEnergy, pTotEnergy;
293 if (rndmEngine->flat() > 0.5) {
294 eTotEnergy = (1.-eps)*gammaEnergy;
295 pTotEnergy = eps*gammaEnergy;
296 } else {
297 pTotEnergy = (1.-eps)*gammaEnergy;
298 eTotEnergy = eps*gammaEnergy;
299 }
300 //
301 // sample pair kinematics
302 const G4double eKinEnergy = std::max(0.,eTotEnergy - CLHEP::electron_mass_c2);
303 const G4double pKinEnergy = std::max(0.,pTotEnergy - CLHEP::electron_mass_c2);
304 //
305 G4ThreeVector eDirection, pDirection;
306 //
308 eKinEnergy, pKinEnergy,
309 eDirection, pDirection);
310 // create G4DynamicParticle object for the particle1
311 auto aParticle1= new G4DynamicParticle(fTheElectron,eDirection,eKinEnergy);
312 // create G4DynamicParticle object for the particle2
313 auto aParticle2= new G4DynamicParticle(fThePositron,pDirection,pKinEnergy);
314 // Fill output vector
315 fvect->push_back(aParticle1);
316 fvect->push_back(aParticle2);
317 // kill incident photon
318 fParticleChange->SetProposedKineticEnergy(0.);
319 fParticleChange->ProposeTrackStatus(fStopAndKill);
320}
#define F10
#define F20
CLHEP::Hep3Vector G4ThreeVector
@ fStopAndKill
virtual double flat()=0
virtual void flatArray(const int size, double *vect)=0
void ScreenFunction12(const G4double delta, G4double &f1, G4double &f2)
G4double ScreenFunction1(const G4double delta)
G4double ScreenFunction2(const G4double delta)
G4double GetLogKineticEnergy() const
G4double GetKineticEnergy() const
G4double GetfCoulomb() const
Definition G4Element.hh:165
G4IonisParamElm * GetIonisation() const
Definition G4Element.hh:171
G4int GetZasInt() const
Definition G4Element.hh:120
G4double GetlogZ3() const
G4double GetZ3() const
virtual void SamplePairDirections(const G4DynamicParticle *dp, G4double elecKinEnergy, G4double posiKinEnergy, G4ThreeVector &dirElectron, G4ThreeVector &dirPositron, G4int Z=0, const G4Material *mat=nullptr)
G4VEmAngularDistribution * GetAngularDistribution()
const G4Element * SelectTargetAtom(const G4MaterialCutsCouple *, const G4ParticleDefinition *, G4double kineticEnergy, G4double logKineticEnergy, G4double cutEnergy=0.0, G4double maxEnergy=DBL_MAX)

Referenced by G4PolarizedGammaConversionModel::SampleSecondaries().

◆ ScreenFunction1()

G4double G4BetheHeitlerModel::ScreenFunction1 ( const G4double delta)
inlineprotected

Definition at line 141 of file G4BetheHeitlerModel.hh.

142{
143 return (delta > 1.4) ? 42.038 - 8.29*G4Log(delta + 0.958)
144 : 42.184 - delta*(7.444 - 1.623*delta);
145}

Referenced by SampleSecondaries().

◆ ScreenFunction12()

void G4BetheHeitlerModel::ScreenFunction12 ( const G4double delta,
G4double & f1,
G4double & f2 )
inlineprotected

Definition at line 155 of file G4BetheHeitlerModel.hh.

157{
158 if (delta > 1.4) {
159 f1 = 42.038 - 8.29*G4Log(delta + 0.958);
160 f2 = f1;
161 } else {
162 f1 = 42.184 - delta*(7.444 - 1.623*delta);
163 f2 = 41.326 - delta*(5.848 - 0.902*delta);
164 }
165}

Referenced by SampleSecondaries().

◆ ScreenFunction2()

G4double G4BetheHeitlerModel::ScreenFunction2 ( const G4double delta)
inlineprotected

Definition at line 148 of file G4BetheHeitlerModel.hh.

149{
150 return (delta > 1.4) ? 42.038 - 8.29*G4Log(delta + 0.958)
151 : 41.326 - delta*(5.848 - 0.902*delta);
152}

Referenced by SampleSecondaries().

Member Data Documentation

◆ fG4Calc

G4Pow* G4BetheHeitlerModel::fG4Calc
protected

Definition at line 110 of file G4BetheHeitlerModel.hh.

Referenced by G4BetheHeitlerModel(), and SampleSecondaries().

◆ fParticleChange

G4ParticleChangeForGamma* G4BetheHeitlerModel::fParticleChange
protected

Definition at line 114 of file G4BetheHeitlerModel.hh.

Referenced by G4BetheHeitlerModel(), Initialise(), and SampleSecondaries().

◆ fTheElectron

const G4ParticleDefinition* G4BetheHeitlerModel::fTheElectron
protected

Definition at line 112 of file G4BetheHeitlerModel.hh.

Referenced by G4BetheHeitlerModel(), and SampleSecondaries().

◆ fTheGamma

const G4ParticleDefinition* G4BetheHeitlerModel::fTheGamma
protected

Definition at line 111 of file G4BetheHeitlerModel.hh.

Referenced by G4BetheHeitlerModel(), and SampleSecondaries().

◆ fThePositron

const G4ParticleDefinition* G4BetheHeitlerModel::fThePositron
protected

Definition at line 113 of file G4BetheHeitlerModel.hh.

Referenced by G4BetheHeitlerModel(), and SampleSecondaries().

◆ fXSection

G4EmElementXS* G4BetheHeitlerModel::fXSection {nullptr}
protected

◆ gElementData

std::vector< G4BetheHeitlerModel::ElementData * > G4BetheHeitlerModel::gElementData
staticprotected

◆ gMaxZet

const G4int G4BetheHeitlerModel::gMaxZet = 120
staticprotected

Definition at line 108 of file G4BetheHeitlerModel.hh.

Referenced by Initialise(), InitialiseElementData(), and SampleSecondaries().

◆ isFirstInstance

G4bool G4BetheHeitlerModel::isFirstInstance {false}
protected

Definition at line 117 of file G4BetheHeitlerModel.hh.

117{false};

Referenced by Initialise(), and ~G4BetheHeitlerModel().

◆ useEPICS2017

G4bool G4BetheHeitlerModel::useEPICS2017 {false}
protected

Definition at line 118 of file G4BetheHeitlerModel.hh.

118{false};

Referenced by ComputeCrossSectionPerAtom(), Initialise(), and InitialiseElementData().


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