Geant4-11
Public Member Functions | Private Member Functions | Private Attributes
G4ScreeningMottCrossSection Class Reference

#include <G4ScreeningMottCrossSection.hh>

Public Member Functions

 G4ScreeningMottCrossSection ()
 
 G4ScreeningMottCrossSection (const G4ScreeningMottCrossSection &)=delete
 
G4double GetScatteringAngle (G4int form, G4int fast)
 
void Initialise (const G4ParticleDefinition *, G4double cosThetaLim)
 
G4double McFcorrection (G4double sin2t2)
 
G4double NuclearCrossSection (G4int form, G4int fast)
 
G4ScreeningMottCrossSectionoperator= (const G4ScreeningMottCrossSection &right)=delete
 
G4double RatioMottRutherford (G4double tet)
 
G4double RatioMottRutherfordCosT (G4double sin2t2)
 
void SetupKinematic (G4double kinEnergy, G4int Z)
 
void SetupParticle (const G4ParticleDefinition *)
 
 ~G4ScreeningMottCrossSection ()
 

Private Member Functions

G4double ComputeAngle (G4int idx, G4double &rand)
 
G4double DifferentialXSection (G4int idx, G4int form)
 
G4double FormFactor2ExpHof (G4double sin2t2)
 
G4double FormFactor2Gauss (G4double sin2t2)
 
G4double FormFactor2UniformHelm (G4double sin2t2)
 
G4double GetTransitionRandom ()
 

Private Attributes

G4double alpha
 
G4double As
 
G4double beta
 
G4double cosTetMaxNuc
 
G4double cosTetMinNuc
 
G4double cosThetaMax
 
G4double cosThetaMin
 
std::vector< G4doublecross
 
G4double e2
 
G4double ecut
 
G4double etag
 
G4PowfG4pow
 
G4NistManagerfNistManager
 
G4double fTotalCross
 
G4double gamma
 
G4double htc2
 
G4double invbeta2
 
G4double invbetaLab2
 
G4double mass
 
G4double mom2
 
G4double momLab2
 
G4double mu_rel
 
const G4ParticleDefinitionparticle
 
G4double spin
 
G4int targetA
 
G4double targetMass
 
G4int targetZ
 
G4double tkin
 
G4double tkinLab
 

Detailed Description

Definition at line 80 of file G4ScreeningMottCrossSection.hh.

Constructor & Destructor Documentation

◆ G4ScreeningMottCrossSection() [1/2]

G4ScreeningMottCrossSection::G4ScreeningMottCrossSection ( )
explicit

Definition at line 90 of file G4ScreeningMottCrossSection.cc.

90 :
91 cosThetaMin(1.0),
92 cosThetaMax(-1.0),
96{
98
101 particle=nullptr;
102
103 spin = mass = mu_rel = 0.0;
104 tkinLab = momLab2 = invbetaLab2 = 0.0;
105 tkin = mom2 = invbeta2 = beta = gamma = 0.0;
106
107 targetMass = As = etag = ecut = 0.0;
108
109 targetZ = targetA = 0;
110
112}
static G4NistManager * Instance()
static G4Pow * GetInstance()
Definition: G4Pow.cc:41
const G4ParticleDefinition * particle
float electron_mass_c2
Definition: hepunit.py:273
float hbarc_squared
Definition: hepunit.py:265
int classic_electr_radius
Definition: hepunit.py:287
int fine_structure_const
Definition: hepunit.py:286

References As, beta, cosTetMaxNuc, cosTetMinNuc, ecut, etag, fG4pow, fNistManager, fTotalCross, gamma, G4Pow::GetInstance(), G4NistManager::Instance(), invbeta2, invbetaLab2, mass, mom2, momLab2, mu_rel, particle, spin, targetA, targetMass, targetZ, tkin, and tkinLab.

◆ ~G4ScreeningMottCrossSection()

G4ScreeningMottCrossSection::~G4ScreeningMottCrossSection ( )

Definition at line 116 of file G4ScreeningMottCrossSection.cc.

117{}

◆ G4ScreeningMottCrossSection() [2/2]

G4ScreeningMottCrossSection::G4ScreeningMottCrossSection ( const G4ScreeningMottCrossSection )
delete

Member Function Documentation

◆ ComputeAngle()

G4double G4ScreeningMottCrossSection::ComputeAngle ( G4int  idx,
G4double rand 
)
private

Definition at line 454 of file G4ScreeningMottCrossSection.cc.

455{
456 G4double x1, x2, y;
457 if(0 == i) {
458 x1 = 0.0;
459 x2 = 0.5*(angle[0] + angle[1]);
460 y = cross[0];
461 } else if(i == DIMMOTT-1) {
462 x1 = 0.5*(angle[i] + angle[i-1]);
463 x2 = CLHEP::pi;
464 y = cross[i] - cross[i-1];
465 r -= cross[i-1];
466 } else {
467 x1 = 0.5*(angle[i] + angle[i-1]);
468 x2 = 0.5*(angle[i] + angle[i+1]);
469 y = cross[i] - cross[i-1];
470 r -= cross[i-1];
471 }
472 //G4cout << i << ". r= " << r << " y= " << y
473 // << " x1= " << " x2= " << x2 << G4endl;
474 return x1 + (x2 - x1)*r/y;
475}
static const G4double angle[DIMMOTT]
static const G4int DIMMOTT
double G4double
Definition: G4Types.hh:83
static constexpr double pi
Definition: SystemOfUnits.h:55

References angle, cross, DIMMOTT, and CLHEP::pi.

Referenced by GetScatteringAngle().

◆ DifferentialXSection()

G4double G4ScreeningMottCrossSection::DifferentialXSection ( G4int  idx,
G4int  form 
)
private

Definition at line 313 of file G4ScreeningMottCrossSection.cc.

314{
315 const G4double ang = angle[idx];
316 const G4double z1 = 1.0 - std::cos(ang);
317 G4double step;
318 if(0 == idx) {
319 step = 0.5*(angle[1] + angle[0]);
320 } else if(DIMMOTT == idx + 1) {
321 step = CLHEP::pi - 0.5*(angle[DIMMOTT-2] + angle[DIMMOTT-1]);
322 } else {
323 step = 0.5*(angle[idx+1] - angle[idx-1]);
324 }
325
326 G4double F2 = 1.;
327 switch (form) {
328 case 1:
329 F2 = FormFactor2ExpHof(z1*0.5);
330 break;
331 case 2:
332 F2 = FormFactor2Gauss(z1*0.5);
333 break;
334 case 3:
335 F2 = FormFactor2UniformHelm(z1*0.5);
336 break;
337 }
338
339 const G4double R = RatioMottRutherfordCosT(std::sqrt(z1));
340
341 G4double den = 2.*As + z1;
342 G4double func = 1./(den*den);
343
345 G4double sigma= e2*e2*fatt*fatt*func;
346 G4double pi2sintet = CLHEP::twopi*std::sqrt(z1*(2. - z1));
347
348 G4double Xsec = std::max(pi2sintet*F2*R*sigma*step, 0.);
349 return Xsec;
350}
G4double FormFactor2ExpHof(G4double sin2t2)
G4double FormFactor2Gauss(G4double sin2t2)
G4double RatioMottRutherfordCosT(G4double sin2t2)
G4double FormFactor2UniformHelm(G4double sin2t2)
static constexpr double twopi
Definition: SystemOfUnits.h:56
T max(const T t1, const T t2)
brief Return the largest of the two arguments

References angle, As, beta, DIMMOTT, e2, FormFactor2ExpHof(), FormFactor2Gauss(), FormFactor2UniformHelm(), gamma, G4INCL::Math::max(), mu_rel, CLHEP::pi, RatioMottRutherfordCosT(), targetZ, and CLHEP::twopi.

Referenced by GetScatteringAngle(), and NuclearCrossSection().

◆ FormFactor2ExpHof()

G4double G4ScreeningMottCrossSection::FormFactor2ExpHof ( G4double  sin2t2)
private

Definition at line 185 of file G4ScreeningMottCrossSection.cc.

186{
189 G4double Etot=E+mass;
190 G4double Tmax=2.*M*E*(E+2.*mass)/(mass*mass+M*M+2.*M*Etot);
191 G4double T=Tmax*sin2t2;
192 G4double q2=T*(T+2.*M);
193 q2/=htc2;//1/cm2
194 G4double RN=1.27e-13*G4Exp(fG4pow->logZ(targetA)*0.27)*CLHEP::cm;
195 G4double xN= (RN*RN*q2);
196 G4double den=(1.+xN/12.);
197 G4double FN=1./(den*den);
198 G4double form2=(FN*FN);
199
200 return form2;
201}
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:179
#define M(row, col)
G4double logZ(G4int Z) const
Definition: G4Pow.hh:137
static constexpr double cm

References CLHEP::cm, fG4pow, G4Exp(), htc2, G4Pow::logZ(), M, mass, targetA, targetMass, and tkinLab.

Referenced by DifferentialXSection().

◆ FormFactor2Gauss()

G4double G4ScreeningMottCrossSection::FormFactor2Gauss ( G4double  sin2t2)
private

Definition at line 205 of file G4ScreeningMottCrossSection.cc.

206{
209 G4double Etot=E+mass;
210 G4double Tmax=2.*M*E*(E+2.*mass)/(mass*mass+M*M+2.*M*Etot);
211 G4double T=Tmax*sin2t2;
212 G4double q2=T*(T+2.*M);
213 q2/=htc2;//1/cm2
214 G4double RN=1.27e-13*G4Exp(fG4pow->logZ(targetA)*0.27)*CLHEP::cm;
215 G4double xN= (RN*RN*q2);
216
217 G4double expo=(-xN/6.);
218 G4double FN=G4Exp(expo);
219
220 G4double form2=(FN*FN);
221
222 return form2;
223}

References CLHEP::cm, fG4pow, G4Exp(), htc2, G4Pow::logZ(), M, mass, targetA, targetMass, and tkinLab.

Referenced by DifferentialXSection().

◆ FormFactor2UniformHelm()

G4double G4ScreeningMottCrossSection::FormFactor2UniformHelm ( G4double  sin2t2)
private

Definition at line 227 of file G4ScreeningMottCrossSection.cc.

228{
231 G4double Etot=E+mass;
232 G4double Tmax=2.*M*E*(E+2.*mass)/(mass*mass+M*M+2.*M*Etot);
233 G4double T=Tmax*sin2t2;
234 G4double q2=T*(T+2.*M);
235 q2=q2/(htc2*0.01);//1/cm2
236
237 G4double q=std::sqrt(q2);
238 G4double R0=1.2E-13*fG4pow->Z13(targetA);
239 G4double R1=2.0E-13;
240
241 G4double x0=q*R0;
242 G4double F0=(3./fG4pow->powN(x0,3))*(std::sin(x0)-x0*std::cos(x0));
243
244 G4double x1=q*R1;
245 G4double F1=(3./fG4pow->powN(x1,3))*(std::sin(x1)-x1*std::cos(x1));
246
247 G4double F=F0*F1;
248
249 G4double form2=(F*F);
250
251 return form2;
252}
G4double powN(G4double x, G4int n) const
Definition: G4Pow.cc:166
G4double Z13(G4int Z) const
Definition: G4Pow.hh:123

References fG4pow, htc2, M, mass, G4Pow::powN(), targetA, targetMass, tkinLab, and G4Pow::Z13().

Referenced by DifferentialXSection().

◆ GetScatteringAngle()

G4double G4ScreeningMottCrossSection::GetScatteringAngle ( G4int  form,
G4int  fast 
)

Definition at line 402 of file G4ScreeningMottCrossSection.cc.

403{
404 G4double scattangle = 0.0;
406 //************ PRECISE COMPUTATION
407 if(fast == 0){
408 //G4cout << "r= " << r << " tot= " << fTotalCross << G4endl;
409 r *= fTotalCross;
410 for(G4int i=0; i<DIMMOTT; ++i){
411 //G4cout << i << ". r= " << r << " xs= " << cross[i] << G4endl;
412 if(r <= cross[i]) {
413 scattangle = ComputeAngle(i, r);
414 break;
415 }
416 }
417
418 //**************** FAST COMPUTATION
419 } else if(fast == 1) {
420
422 if(limit > 0.0) {
423 G4double Sz = 2*As;
424 G4double x = Sz-((Sz*(2+Sz))/(Sz+2*limit))+1.0;
425 //G4cout << "limit= " << limit << " Sz= " << Sz << " x= " << x << G4endl;
426 G4double angle_limit = (std::abs(x) < 1.0) ? std::acos(x) : 0.0;
427 //G4cout<<"ANGLE LIMIT: "<<angle_limit<<" x= " << x << G4endl;
428
429 if(r > limit && angle_limit != 0.0) {
430 x = Sz-((Sz*(2+Sz))/(Sz+2*r))+1.0;
431 scattangle = (x >= 1.0) ? 0.0 : ((x <= -1.0) ? pi : std::acos(x));
432 //G4cout<<"FAST: scattangle= "<< scattangle <<G4endl;
433 }
434 } else {
435 //G4cout<<"SLOW: total= "<<fTotalCross<< G4endl;
436 r *= fTotalCross;
437 G4double tot = 0.0;
438 for(G4int i=0; i<DIMMOTT; ++i) {
439 G4double xs = DifferentialXSection(i, form);
440 tot += xs;
441 cross[i] = tot;
442 if(r <= tot) {
443 scattangle = ComputeAngle(i, r);
444 break;
445 }
446 }
447 }
448 }
449 //************************************************
450 //G4cout<<"Energy(MeV): "<<tkinLab/MeV<<" SCATTANGLE: "<<scattangle<<G4endl;
451 return scattangle;
452}
static constexpr double pi
Definition: G4SIunits.hh:55
int G4int
Definition: G4Types.hh:85
#define G4UniformRand()
Definition: Randomize.hh:52
G4double ComputeAngle(G4int idx, G4double &rand)
G4double DifferentialXSection(G4int idx, G4int form)

References As, ComputeAngle(), cross, DifferentialXSection(), DIMMOTT, fTotalCross, G4UniformRand, GetTransitionRandom(), and pi.

Referenced by G4eSingleCoulombScatteringModel::SampleSecondaries().

◆ GetTransitionRandom()

G4double G4ScreeningMottCrossSection::GetTransitionRandom ( )
private

Definition at line 298 of file G4ScreeningMottCrossSection.cc.

299{
301 G4double res(0.), x0(1.0);
302 for(G4int i=0; i<11; ++i) {
303 res += fPRM[targetZ][i]*x0;
304 x0 *= x;
305 }
306 //G4cout << "Z= " << targetZ << " x0= " << x0 << " res= " << res << G4endl;
307 return res;
308}
G4double G4Log(G4double x)
Definition: G4Log.hh:226
static const G4double fPRM[93][11]
Definition: G4MottData.hh:57
static G4double invlog10

References fPRM, G4Log(), invlog10, targetZ, and tkinLab.

Referenced by GetScatteringAngle().

◆ Initialise()

void G4ScreeningMottCrossSection::Initialise ( const G4ParticleDefinition p,
G4double  cosThetaLim 
)

Definition at line 121 of file G4ScreeningMottCrossSection.cc.

123{
124 SetupParticle(p);
125 tkin = mom2 = 0.0;
126 ecut = etag = DBL_MAX;
127 particle = p;
128 cosThetaMin = cosThetaLim;
129}
void SetupParticle(const G4ParticleDefinition *)
#define DBL_MAX
Definition: templates.hh:62

References cosThetaMin, DBL_MAX, ecut, etag, mom2, particle, SetupParticle(), and tkin.

Referenced by G4eSingleCoulombScatteringModel::Initialise(), and G4WentzelOKandVIxSection::Initialise().

◆ McFcorrection()

G4double G4ScreeningMottCrossSection::McFcorrection ( G4double  sin2t2)

Definition at line 256 of file G4ScreeningMottCrossSection.cc.

257{
258 const G4double sint = std::sqrt(sin2t2);
259 return 1.-beta*beta*sin2t2 + targetZ*alpha*beta*pi*sint*(1.-sint);
260}

References alpha, beta, pi, and targetZ.

◆ NuclearCrossSection()

G4double G4ScreeningMottCrossSection::NuclearCrossSection ( G4int  form,
G4int  fast 
)

Definition at line 355 of file G4ScreeningMottCrossSection.cc.

356{
357 fTotalCross=0.;
359 if(0 == cross.size()) { cross.resize(DIMMOTT, 0.0); }
360
361 //G4cout<<"MODEL: "<<fast<<G4endl;
362 //************ PRECISE COMPUTATION
363 if(fast == 0){
364
365 for(G4int i=0; i<DIMMOTT; ++i){
366 G4double y = DifferentialXSection(i, form);
367 fTotalCross += y;
368 cross[i] = fTotalCross;
369 if(fTotalCross*1.e-9 > y) {
370 for(G4int j=i+1; j<DIMMOTT; ++j) {
371 cross[j] = fTotalCross;
372 }
373 break;
374 }
375 }
376 //**************** FAST COMPUTATION
377 } else if(fast == 1) {
378
380 G4double coeff = twopi*p0*p0;
381
383
384 G4double x = 1.0 - cosTetMinNuc;
385 G4double x1 = x + 2*As;
386
387 // scattering with nucleus
389 (x1*(1.0 - cosTetMaxNuc + 2*As));
390 }
391 /*
392 G4cout << "Energy(MeV): " << tkinLab/CLHEP::MeV
393 << " Total Cross(mb): " << fTotalCross
394 << " form= " << form << " fast= " << fast << G4endl;
395 */
396 return fTotalCross;
397}
static const G4double fac
static constexpr double twopi
Definition: G4SIunits.hh:56

References As, source.hepunit::classic_electr_radius, cosTetMaxNuc, cosTetMinNuc, cross, DifferentialXSection(), DIMMOTT, source.hepunit::electron_mass_c2, fac, fTotalCross, invbeta2, mom2, targetZ, and twopi.

Referenced by G4eSingleCoulombScatteringModel::ComputeCrossSectionPerAtom(), and G4eSingleCoulombScatteringModel::SampleSecondaries().

◆ operator=()

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

◆ RatioMottRutherford()

G4double G4ScreeningMottCrossSection::RatioMottRutherford ( G4double  tet)

Definition at line 264 of file G4ScreeningMottCrossSection.cc.

265{
266 return RatioMottRutherfordCosT(std::sqrt(1. - std::cos(angles)));
267}

References RatioMottRutherfordCosT().

◆ RatioMottRutherfordCosT()

G4double G4ScreeningMottCrossSection::RatioMottRutherfordCosT ( G4double  sin2t2)

Definition at line 271 of file G4ScreeningMottCrossSection.cc.

272{
273 G4double R(0.);
274 const G4double shift = 0.7181228;
275 G4double beta0 = beta - shift;
276
277 G4double b0 = 1.0;
278 G4double b[6];
279 for(G4int i=0; i<6; ++i) {
280 b[i] = b0;
281 b0 *= beta0;
282 }
283
284 b0 = 1.0;
285 for(G4int j=0; j<=4; ++j) {
286 G4double a = 0.0;
287 for(G4int k=0; k<=5; ++k){
288 a += fMottCoef[targetZ][j][k]*b[k];
289 }
290 R += a*b0;
291 b0 *= fcost;
292 }
293 return R;
294}
static const G4double fMottCoef[93][5][6]
Definition: G4MottData.hh:153

References beta, fMottCoef, and targetZ.

Referenced by DifferentialXSection(), RatioMottRutherford(), and G4WentzelOKandVIxSection::SampleSingleScattering().

◆ SetupKinematic()

void G4ScreeningMottCrossSection::SetupKinematic ( G4double  kinEnergy,
G4int  Z 
)

Definition at line 133 of file G4ScreeningMottCrossSection.cc.

134{
135 //...Target
136 const G4int iz = std::min(92, Z);
138
139 targetZ = iz;
140 targetA = ia;
142
143 //G4cout<<"......... targetA "<< targetA <<G4endl;
144 //G4cout<<"......... targetMass "<< targetMass/MeV <<G4endl;
145
146 // incident particle lab
147 tkinLab = ekin;
148 momLab2 = tkinLab*(tkinLab + 2.0*mass);
150
151 const G4double etot = tkinLab + mass;
152 const G4double ptot = std::sqrt(momLab2);
153 const G4double m12 = mass*mass;
154
155 // relativistic reduced mass from publucation
156 // A.P. Martynenko, R.N. Faustov, Teoret. mat. Fiz. 64 (1985) 179
157
158 //incident particle & target nucleus
159 const G4double Ecm = std::sqrt(m12 + targetMass*targetMass + 2.0*etot*targetMass);
160 mu_rel = mass*targetMass/Ecm;
161 const G4double momCM= ptot*targetMass/Ecm;
162 // relative system
163 mom2 = momCM*momCM;
164 const G4double x = mu_rel*mu_rel/mom2;
165 invbeta2 = 1.0 + x;
166 tkin = momCM*std::sqrt(invbeta2) - mu_rel;//Ekin of mu_rel
167 const G4double beta2 = 1./invbeta2;
168 beta = std::sqrt(beta2) ;
169 const G4double gamma2= invbeta2/x;
170 gamma = std::sqrt(gamma2);
171
172 //Thomas-Fermi screening length
173 const G4double alpha2 = alpha*alpha;
174 const G4double aU = 0.88534*CLHEP::Bohr_radius/fG4pow->Z13(targetZ);
175 const G4double twoR2 = aU*aU;
176 As = 0.25*htc2*(1.13 + 3.76*targetZ*targetZ*invbeta2*alpha2)/(twoR2*mom2);
177
178 //Integration Angles definition
181}
const G4int Z[17]
const G4double alpha2
G4double GetAtomicMassAmu(const G4String &symb) const
static G4double GetNuclearMass(const G4double A, const G4double Z)
static constexpr double Bohr_radius
T min(const T t1, const T t2)
brief Return the smallest of the two arguments
int G4lrint(double ad)
Definition: templates.hh:134

References alpha, alpha2, As, beta, CLHEP::Bohr_radius, cosTetMaxNuc, cosTetMinNuc, cosThetaMax, cosThetaMin, fG4pow, fNistManager, G4lrint(), gamma, G4NistManager::GetAtomicMassAmu(), G4NucleiProperties::GetNuclearMass(), htc2, invbeta2, invbetaLab2, mass, G4INCL::Math::min(), mom2, momLab2, mu_rel, targetA, targetMass, targetZ, tkin, tkinLab, Z, and G4Pow::Z13().

Referenced by G4eSingleCoulombScatteringModel::ComputeCrossSectionPerAtom(), G4eSingleCoulombScatteringModel::SampleSecondaries(), and G4WentzelOKandVIxSection::SampleSingleScattering().

◆ SetupParticle()

void G4ScreeningMottCrossSection::SetupParticle ( const G4ParticleDefinition p)
inline

Definition at line 169 of file G4ScreeningMottCrossSection.hh.

170{
171 particle = p;
174 if(0.0 != spin) { spin = 0.5; }
175 tkin = 0.0;
176}

References G4ParticleDefinition::GetPDGMass(), G4ParticleDefinition::GetPDGSpin(), mass, particle, spin, and tkin.

Referenced by Initialise(), and G4eSingleCoulombScatteringModel::SetupParticle().

Field Documentation

◆ alpha

G4double G4ScreeningMottCrossSection::alpha
private

Definition at line 151 of file G4ScreeningMottCrossSection.hh.

Referenced by McFcorrection(), and SetupKinematic().

◆ As

G4double G4ScreeningMottCrossSection::As
private

◆ beta

G4double G4ScreeningMottCrossSection::beta
private

◆ cosTetMaxNuc

G4double G4ScreeningMottCrossSection::cosTetMaxNuc
private

◆ cosTetMinNuc

G4double G4ScreeningMottCrossSection::cosTetMinNuc
private

◆ cosThetaMax

G4double G4ScreeningMottCrossSection::cosThetaMax
private

Definition at line 125 of file G4ScreeningMottCrossSection.hh.

Referenced by SetupKinematic().

◆ cosThetaMin

G4double G4ScreeningMottCrossSection::cosThetaMin
private

Definition at line 124 of file G4ScreeningMottCrossSection.hh.

Referenced by Initialise(), and SetupKinematic().

◆ cross

std::vector<G4double> G4ScreeningMottCrossSection::cross
private

◆ e2

G4double G4ScreeningMottCrossSection::e2
private

Definition at line 153 of file G4ScreeningMottCrossSection.hh.

Referenced by DifferentialXSection().

◆ ecut

G4double G4ScreeningMottCrossSection::ecut
private

Definition at line 131 of file G4ScreeningMottCrossSection.hh.

Referenced by G4ScreeningMottCrossSection(), and Initialise().

◆ etag

G4double G4ScreeningMottCrossSection::etag
private

Definition at line 132 of file G4ScreeningMottCrossSection.hh.

Referenced by G4ScreeningMottCrossSection(), and Initialise().

◆ fG4pow

G4Pow* G4ScreeningMottCrossSection::fG4pow
private

◆ fNistManager

G4NistManager* G4ScreeningMottCrossSection::fNistManager
private

Definition at line 117 of file G4ScreeningMottCrossSection.hh.

Referenced by G4ScreeningMottCrossSection(), and SetupKinematic().

◆ fTotalCross

G4double G4ScreeningMottCrossSection::fTotalCross
private

◆ gamma

G4double G4ScreeningMottCrossSection::gamma
private

◆ htc2

G4double G4ScreeningMottCrossSection::htc2
private

◆ invbeta2

G4double G4ScreeningMottCrossSection::invbeta2
private

◆ invbetaLab2

G4double G4ScreeningMottCrossSection::invbetaLab2
private

Definition at line 140 of file G4ScreeningMottCrossSection.hh.

Referenced by G4ScreeningMottCrossSection(), and SetupKinematic().

◆ mass

G4double G4ScreeningMottCrossSection::mass
private

◆ mom2

G4double G4ScreeningMottCrossSection::mom2
private

◆ momLab2

G4double G4ScreeningMottCrossSection::momLab2
private

Definition at line 139 of file G4ScreeningMottCrossSection.hh.

Referenced by G4ScreeningMottCrossSection(), and SetupKinematic().

◆ mu_rel

G4double G4ScreeningMottCrossSection::mu_rel
private

◆ particle

const G4ParticleDefinition* G4ScreeningMottCrossSection::particle
private

◆ spin

G4double G4ScreeningMottCrossSection::spin
private

Definition at line 134 of file G4ScreeningMottCrossSection.hh.

Referenced by G4ScreeningMottCrossSection(), and SetupParticle().

◆ targetA

G4int G4ScreeningMottCrossSection::targetA
private

◆ targetMass

G4double G4ScreeningMottCrossSection::targetMass
private

◆ targetZ

G4int G4ScreeningMottCrossSection::targetZ
private

◆ tkin

G4double G4ScreeningMottCrossSection::tkin
private

◆ tkinLab

G4double G4ScreeningMottCrossSection::tkinLab
private

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