Geant4  10.02.p03
G4WentzelOKandVIxSection Class Reference

#include <G4WentzelOKandVIxSection.hh>

Collaboration diagram for G4WentzelOKandVIxSection:

Public Member Functions

 G4WentzelOKandVIxSection (G4bool combined=true)
 
virtual ~G4WentzelOKandVIxSection ()
 
void Initialise (const G4ParticleDefinition *, G4double CosThetaLim)
 
void SetupParticle (const G4ParticleDefinition *)
 
G4double SetupTarget (G4int Z, G4double cut=DBL_MAX)
 
G4double ComputeTransportCrossSectionPerAtom (G4double CosThetaMax)
 
G4ThreeVectorSampleSingleScattering (G4double CosThetaMin, G4double CosThetaMax, G4double elecRatio=0.0)
 
G4double ComputeSecondTransportMoment (G4double CosThetaMax)
 
G4double ComputeNuclearCrossSection (G4double CosThetaMin, G4double CosThetaMax)
 
G4double ComputeElectronCrossSection (G4double CosThetaMin, G4double CosThetaMax)
 
G4double SetupKinematic (G4double kinEnergy, const G4Material *mat)
 
void SetTargetMass (G4double value)
 
G4double GetMomentumSquare () const
 
G4double GetCosThetaNuc () const
 
G4double GetCosThetaElec () const
 

Private Member Functions

void ComputeMaxElectronScattering (G4double cut)
 
G4WentzelOKandVIxSectionoperator= (const G4WentzelOKandVIxSection &right)
 
 G4WentzelOKandVIxSection (const G4WentzelOKandVIxSection &)
 

Private Attributes

const G4ParticleDefinitiontheProton
 
const G4ParticleDefinitiontheElectron
 
const G4ParticleDefinitionthePositron
 
const G4MaterialcurrentMaterial
 
G4NistManagerfNistManager
 
G4PowfG4pow
 
G4ThreeVector temp
 
G4double numlimit
 
G4int nwarnings
 
G4int nwarnlimit
 
G4bool isCombined
 
G4double coeff
 
G4double cosTetMaxElec
 
G4double cosTetMaxNuc
 
G4double cosThetaMax
 
G4double alpha2
 
const G4ParticleDefinitionparticle
 
G4double chargeSquare
 
G4double charge3
 
G4double spin
 
G4double mass
 
G4double tkin
 
G4double mom2
 
G4double momCM2
 
G4double invbeta2
 
G4double kinFactor
 
G4double etag
 
G4double ecut
 
G4double lowEnergyLimit
 
G4int targetZ
 
G4double targetMass
 
G4double screenZ
 
G4double formfactA
 
G4double factorA2
 
G4double factB
 
G4double factB1
 
G4double factD
 
G4double gam0pcmp
 
G4double pcmp2
 

Static Private Attributes

static G4double ScreenRSquareElec [100] = {0.0}
 
static G4double ScreenRSquare [100] = {0.0}
 
static G4double FormFactor [100] = {0.0}
 

Detailed Description

Definition at line 71 of file G4WentzelOKandVIxSection.hh.

Constructor & Destructor Documentation

◆ G4WentzelOKandVIxSection() [1/2]

G4WentzelOKandVIxSection::G4WentzelOKandVIxSection ( G4bool  combined = true)

Definition at line 66 of file G4WentzelOKandVIxSection.cc.

66  :
67  temp(0.,0.,0.),
68  numlimit(0.1),
69  nwarnings(0),
70  nwarnlimit(50),
71  isCombined(combined),
72  cosThetaMax(-1.0),
74 {
80  lowEnergyLimit = 1.0*eV;
82  coeff = twopi*p0*p0;
83  particle = 0;
84 
85  // Thomas-Fermi screening radii
86  // Formfactors from A.V. Butkevich et al., NIM A 488 (2002) 282
87 
88  if(0.0 == ScreenRSquare[0]) {
89  G4double a0 = electron_mass_c2/0.88534;
90  G4double constn = 6.937e-6/(MeV*MeV);
91 
92  ScreenRSquare[0] = alpha2*a0*a0;
94  for(G4int j=1; j<100; ++j) {
95  G4double x = a0*fG4pow->Z13(j);
96  if(1 == j) { ScreenRSquare[j] = 0.5*alpha2*a0*a0; }
97  else {
98  ScreenRSquare[j] = 0.5*(1 + G4Exp(-j*j*0.001))*alpha2*x*x;
99  ScreenRSquareElec[j] = 0.5*alpha2*x*x;
100  }
101  x = fNistManager->GetA27(j);
102  FormFactor[j] = constn*x*x;
103  }
104  }
105  currentMaterial = 0;
106  factB = factD = formfactA = screenZ = 0.0;
108 
110 
111  tkin = mom2 = momCM2 = factorA2 = mass = spin = chargeSquare = charge3 = 0.0;
112  ecut = etag = DBL_MAX;
113  targetZ = 0;
115  particle = 0;
116 }
const G4ParticleDefinition * theElectron
const G4ParticleDefinition * theProton
const G4double a0
static G4Pow * GetInstance()
Definition: G4Pow.cc:55
static const double MeV
Definition: G4SIunits.hh:211
static G4double ScreenRSquareElec[100]
const G4ParticleDefinition * particle
G4double GetA27(G4int Z)
int G4int
Definition: G4Types.hh:78
static G4NistManager * Instance()
int fine_structure_const
Definition: hepunit.py:287
static const double twopi
Definition: G4SIunits.hh:75
static const double pi
Definition: SystemOfUnits.h:53
static G4Proton * Proton()
Definition: G4Proton.cc:93
float proton_mass_c2
Definition: hepunit.py:275
float electron_mass_c2
Definition: hepunit.py:274
G4double Z13(G4int Z) const
Definition: G4Pow.hh:127
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:183
static const double eV
Definition: G4SIunits.hh:212
static G4Positron * Positron()
Definition: G4Positron.cc:94
int classic_electr_radius
Definition: hepunit.py:288
const G4ParticleDefinition * thePositron
static G4Electron * Electron()
Definition: G4Electron.cc:94
double G4double
Definition: G4Types.hh:76
#define DBL_MAX
Definition: templates.hh:83
Here is the call graph for this function:

◆ ~G4WentzelOKandVIxSection()

G4WentzelOKandVIxSection::~G4WentzelOKandVIxSection ( )
virtual

Definition at line 120 of file G4WentzelOKandVIxSection.cc.

121 {}

◆ G4WentzelOKandVIxSection() [2/2]

G4WentzelOKandVIxSection::G4WentzelOKandVIxSection ( const G4WentzelOKandVIxSection )
private

Member Function Documentation

◆ ComputeElectronCrossSection()

G4double G4WentzelOKandVIxSection::ComputeElectronCrossSection ( G4double  CosThetaMin,
G4double  CosThetaMax 
)
inline

Definition at line 244 of file G4WentzelOKandVIxSection.hh.

246 {
247  G4double xsec = 0.0;
248  G4double cost1 = std::max(cosTMin,cosTetMaxElec);
249  G4double cost2 = std::max(cosTMax,cosTetMaxElec);
250  if(cost1 > cost2) {
251  xsec = kinFactor*(cost1 - cost2)/
252  ((1.0 - cost1 + screenZ)*(1.0 - cost2 + screenZ));
253  }
254  return xsec;
255 }
double G4double
Definition: G4Types.hh:76
Here is the caller graph for this function:

◆ ComputeMaxElectronScattering()

void G4WentzelOKandVIxSection::ComputeMaxElectronScattering ( G4double  cut)
private

Definition at line 348 of file G4WentzelOKandVIxSection.cc.

349 {
350  if(mass > MeV) {
352  G4double tau = tkin/mass;
353  G4double tmax = 2.0*electron_mass_c2*tau*(tau + 2.)/
354  (1.0 + 2.0*ratio*(tau + 1.0) + ratio*ratio);
355  //tmax = std::min(tmax, targetZ*targetZ*10*eV);
356  cosTetMaxElec = 1.0 - std::min(cutEnergy, tmax)*electron_mass_c2/mom2;
357  } else {
358 
359  G4double tmax = tkin;
360  if(particle == theElectron) { tmax *= 0.5; }
361  //tmax = std::min(tmax, targetZ*targetZ*10*eV);
362  G4double t = std::min(cutEnergy, tmax);
363  G4double mom21 = t*(t + 2.0*electron_mass_c2);
364  G4double t1 = tkin - t;
365  //G4cout <<"tkin=" <<tkin<<" tmax= "<<tmax<<" t= "
366  //<<t<< " t1= "<<t1<<" cut= "<<ecut<<G4endl;
367  if(t1 > 0.0) {
368  G4double mom22 = t1*(t1 + 2.0*mass);
369  G4double ctm = (mom2 + mom22 - mom21)*0.5/sqrt(mom2*mom22);
370  if(ctm < 1.0) { cosTetMaxElec = ctm; }
371  if(particle == theElectron && cosTetMaxElec < 0.0) {
372  cosTetMaxElec = 0.0;
373  }
374  }
375  }
376 }
const G4ParticleDefinition * theElectron
TTree * t1
Definition: plottest35.C:26
static const double MeV
Definition: G4SIunits.hh:211
const G4ParticleDefinition * particle
float electron_mass_c2
Definition: hepunit.py:274
double G4double
Definition: G4Types.hh:76
Here is the caller graph for this function:

◆ ComputeNuclearCrossSection()

G4double G4WentzelOKandVIxSection::ComputeNuclearCrossSection ( G4double  CosThetaMin,
G4double  CosThetaMax 
)
inline

Definition at line 230 of file G4WentzelOKandVIxSection.hh.

232 {
233  G4double xsec = 0.0;
234  if(cosTMax < cosTMin) {
235  xsec = targetZ*kinFactor*(cosTMin - cosTMax)/
236  ((1.0 - cosTMin + screenZ)*(1.0 - cosTMax + screenZ));
237  }
238  return xsec;
239 }
double G4double
Definition: G4Types.hh:76
Here is the caller graph for this function:

◆ ComputeSecondTransportMoment()

G4double G4WentzelOKandVIxSection::ComputeSecondTransportMoment ( G4double  CosThetaMax)

Definition at line 381 of file G4WentzelOKandVIxSection.cc.

382 {
383  return 0.0;
384 }
Here is the caller graph for this function:

◆ ComputeTransportCrossSectionPerAtom()

G4double G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom ( G4double  CosThetaMax)

Definition at line 206 of file G4WentzelOKandVIxSection.cc.

207 {
208  G4double xSection = 0.0;
209  if(cosTMax >= 1.0) { return xSection; }
210 
211  G4double x = 0;
212  G4double y = 0;
213  G4double x1= 0;
214  G4double x2= 0;
215  G4double xlog = 0.0;
216 
217  G4double costm = std::max(cosTMax,cosTetMaxElec);
219 
220  // scattering off electrons
221  if(costm < 1.0) {
222  x = (1.0 - costm)/screenZ;
223  if(x < numlimit) {
224  x2 = 0.5*x*x;
225  y = x2*(1.0 - 1.3333333*x + 3*x2);
226  if(0.0 < factB) { y -= fb*x2*x*(0.6666667 - x); }
227  } else {
228  x1= x/(1 + x);
229  xlog = G4Log(1.0 + x);
230  y = xlog - x1;
231  if(0.0 < factB) { y -= fb*(x + x1 - 2*xlog); }
232  }
233 
234  if(y < 0.0) {
235  ++nwarnings;
236  if(nwarnings < nwarnlimit) {
237  G4cout << "G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom"
238  << " scattering on e- <0"
239  << G4endl;
240  G4cout << "y= " << y
241  << " e(MeV)= " << tkin << " p(MeV/c)= " << sqrt(mom2)
242  << " Z= " << targetZ << " "
244  G4cout << " 1-costm= " << 1.0-costm << " screenZ= " << screenZ
245  << " x= " << x << G4endl;
246  }
247  y = 0.0;
248  }
249  xSection = y;
250  }
251  /*
252  G4cout << "G4WentzelVI:XS per A " << " Z= " << targetZ
253  << " e(MeV)= " << tkin/MeV << " XSel= " << xSection
254  << " cut(MeV)= " << ecut/MeV
255  << " zmaxE= " << (1.0 - cosTetMaxElec)/screenZ
256  << " zmaxN= " << (1.0 - cosThetaMax)/screenZ
257  << " 1-costm= " << 1.0 - cosThetaMax << G4endl;
258  */
259  // scattering off nucleus
260  if(cosTMax < 1.0) {
261  x = (1.0 - cosTMax)/screenZ;
262  if(x < numlimit) {
263  x2 = 0.5*x*x;
264  y = x2*(1.0 - 1.3333333*x + 3*x2);
265  if(0.0 < factB) { y -= fb*x2*x*(0.6666667 - x); }
266  } else {
267  x1= x/(1 + x);
268  xlog = G4Log(1.0 + x);
269  y = xlog - x1;
270  if(0.0 < factB) { y -= fb*(x + x1 - 2*xlog); }
271  }
272 
273  if(y < 0.0) {
274  ++nwarnings;
275  if(nwarnings < nwarnlimit) {
276  G4cout << "G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom"
277  << " scattering on nucleus <0"
278  << G4endl;
279  G4cout << "y= " << y
280  << " e(MeV)= " << tkin << " Z= " << targetZ << " "
282  G4cout << " formfactA= " << formfactA << " screenZ= " << screenZ
283  << " x= " << " x1= " << x1 <<G4endl;
284  }
285  y = 0.0;
286  }
287  xSection += y*targetZ;
288  }
289  xSection *= kinFactor;
290 
291  /*
292  G4cout << "Z= " << targetZ << " XStot= " << xSection/barn
293  << " screenZ= " << screenZ << " formF= " << formfactA
294  << " for " << particle->GetParticleName()
295  << " m= " << mass << " 1/v= " << sqrt(invbeta2) << " p= " << sqrt(mom2)
296  << " x= " << x
297  << G4endl;
298  */
299  return xSection;
300 }
Double_t x2[nxs]
const G4ParticleDefinition * particle
TFile fb
Definition: plot2.C:13
Double_t y
const G4String & GetParticleName() const
G4GLOB_DLL std::ostream G4cout
Double_t x1[nxs]
G4double G4Log(G4double x)
Definition: G4Log.hh:230
#define G4endl
Definition: G4ios.hh:61
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

◆ GetCosThetaElec()

G4double G4WentzelOKandVIxSection::GetCosThetaElec ( ) const
inline

Definition at line 222 of file G4WentzelOKandVIxSection.hh.

223 {
224  return cosTetMaxElec;
225 }

◆ GetCosThetaNuc()

G4double G4WentzelOKandVIxSection::GetCosThetaNuc ( ) const
inline

Definition at line 215 of file G4WentzelOKandVIxSection.hh.

216 {
217  return cosTetMaxNuc;
218 }

◆ GetMomentumSquare()

G4double G4WentzelOKandVIxSection::GetMomentumSquare ( ) const
inline

Definition at line 208 of file G4WentzelOKandVIxSection.hh.

209 {
210  return mom2;
211 }
Here is the caller graph for this function:

◆ Initialise()

void G4WentzelOKandVIxSection::Initialise ( const G4ParticleDefinition p,
G4double  CosThetaLim 
)

Definition at line 125 of file G4WentzelOKandVIxSection.cc.

127 {
128  SetupParticle(p);
129  tkin = mom2 = momCM2 = 0.0;
130  ecut = etag = DBL_MAX;
131  targetZ = 0;
132 
133  // cosThetaMax is below 1.0 only when MSC is combined with SS
134  if(isCombined) { cosThetaMax = cosThetaLim; }
135 
138  factorA2 = 0.5*a*a;
139  currentMaterial = 0;
140 
141  //G4cout << "G4WentzelOKandVIxSection::Initialise mass= " << mass
142  // << " " << p->GetParticleName()
143  // << " cosThetaMax= " << cosThetaMax << G4endl;
144 
145 }
void SetupParticle(const G4ParticleDefinition *)
static const double hbarc
G4double FactorForAngleLimit() const
static const double fermi
Definition: SystemOfUnits.h:82
static G4EmParameters * Instance()
double G4double
Definition: G4Types.hh:76
#define DBL_MAX
Definition: templates.hh:83
Here is the call graph for this function:
Here is the caller graph for this function:

◆ operator=()

G4WentzelOKandVIxSection& G4WentzelOKandVIxSection::operator= ( const G4WentzelOKandVIxSection right)
private

◆ SampleSingleScattering()

G4ThreeVector & G4WentzelOKandVIxSection::SampleSingleScattering ( G4double  CosThetaMin,
G4double  CosThetaMax,
G4double  elecRatio = 0.0 
)

Definition at line 305 of file G4WentzelOKandVIxSection.cc.

308 {
309  temp.set(0.0,0.0,1.0);
310  CLHEP::HepRandomEngine* rndmEngineMod = G4Random::getTheEngine();
311 
312  G4double formf = formfactA;
313  G4double cost1 = cosTMin;
314  G4double cost2 = cosTMax;
315  if(elecRatio > 0.0) {
316  if(rndmEngineMod->flat() <= elecRatio) {
317  formf = 0.0;
318  cost1 = std::max(cost1,cosTetMaxElec);
319  cost2 = std::max(cost2,cosTetMaxElec);
320  }
321  }
322  if(cost1 > cost2) {
323  G4double w1 = 1. - cost1 + screenZ;
324  G4double w2 = 1. - cost2 + screenZ;
325  G4double z1 = w1*w2/(w1 + rndmEngineMod->flat()*(w2 - w1)) - screenZ;
326 
327  G4double fm = 1.0 + formf*z1;
328  G4double grej = (1. - z1*factB + factB1*targetZ*sqrt(z1*factB)*(2 - z1))
329  /((1.0 + z1*factD)*fm*fm);
330 
331  if(rndmEngineMod->flat() <= grej) {
332  // exclude "false" scattering due to formfactor and spin effect
333  G4double cost = 1.0 - z1;
334  if(cost > 1.0) { cost = 1.0; }
335  else if(cost < -1.0) { cost =-1.0; }
336  G4double sint = sqrt((1.0 - cost)*(1.0 + cost));
337  //G4cout << "sint= " << sint << G4endl;
338  G4double phi = twopi*rndmEngineMod->flat();
339  temp.set(sint*cos(phi),sint*sin(phi),cost);
340  }
341  }
342  return temp;
343 }
void set(double x, double y, double z)
virtual double flat()=0
static const double twopi
Definition: G4SIunits.hh:75
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

◆ SetTargetMass()

void G4WentzelOKandVIxSection::SetTargetMass ( G4double  value)
inline

Definition at line 200 of file G4WentzelOKandVIxSection.hh.

201 {
202  targetMass = value;
203  factD = std::sqrt(mom2)/value;
204 }
Here is the caller graph for this function:

◆ SetupKinematic()

G4double G4WentzelOKandVIxSection::SetupKinematic ( G4double  kinEnergy,
const G4Material mat 
)
inline

Definition at line 181 of file G4WentzelOKandVIxSection.hh.

182 {
183  if(ekin != tkin || mat != currentMaterial) {
185  tkin = ekin;
186  mom2 = tkin*(tkin + 2.0*mass);
187  invbeta2 = 1.0 + mass*mass/mom2;
188  factB = spin/invbeta2;
190  if(isCombined) {
192  1.-factorA2*mat->GetIonisation()->GetInvA23()/mom2);
193  }
194  }
195  return cosTetMaxNuc;
196 }
G4IonisParamMat * GetIonisation() const
Definition: G4Material.hh:226
Float_t mat
G4double GetInvA23() const
Here is the call graph for this function:
Here is the caller graph for this function:

◆ SetupParticle()

void G4WentzelOKandVIxSection::SetupParticle ( const G4ParticleDefinition p)

Definition at line 149 of file G4WentzelOKandVIxSection.cc.

150 {
151  particle = p;
152  mass = particle->GetPDGMass();
153  spin = particle->GetPDGSpin();
154  if(0.0 != spin) { spin = 0.5; }
155  G4double q = std::fabs(particle->GetPDGCharge()/eplus);
156  chargeSquare = q*q;
157  charge3 = chargeSquare*q;
158  tkin = 0.0;
159  currentMaterial = 0;
160  targetZ = 0;
161 }
const G4ParticleDefinition * particle
double G4double
Definition: G4Types.hh:76
static const double eplus
Definition: G4SIunits.hh:196
G4double GetPDGCharge() const
Here is the call graph for this function:
Here is the caller graph for this function:

◆ SetupTarget()

G4double G4WentzelOKandVIxSection::SetupTarget ( G4int  Z,
G4double  cut = DBL_MAX 
)

Definition at line 166 of file G4WentzelOKandVIxSection.cc.

167 {
168  G4double cosTetMaxNuc2 = cosTetMaxNuc;
169  if(Z != targetZ || tkin != etag) {
170  etag = tkin;
171  targetZ = Z;
172  if(targetZ > 99) { targetZ = 99; }
173  G4double massT = proton_mass_c2;
174  if(targetZ > 1) {
176  }
177  SetTargetMass(massT);
178 
180 
181  if(1 == Z) {
183  } else if(mass > MeV) {
184  screenZ = std::min(Z*1.13,1.13 +3.76*Z*Z*invbeta2*alpha2*chargeSquare)*
186  } else {
187  G4double tau = tkin/mass;
188  screenZ = std::min(Z*1.13,(1.13 +3.76*Z*Z
189  *invbeta2*alpha2*std::sqrt(tau/(tau + fG4pow->Z23(targetZ)))))*
191  }
192  if(targetZ == 1 && cosTetMaxNuc2 < 0.0 && particle == theProton) {
193  cosTetMaxNuc2 = 0.0;
194  }
196 
197  cosTetMaxElec = 1.0;
199  }
200  return cosTetMaxNuc2;
201 }
const G4ParticleDefinition * theProton
static const double MeV
Definition: G4SIunits.hh:211
static G4double ScreenRSquareElec[100]
const G4ParticleDefinition * particle
void ComputeMaxElectronScattering(G4double cut)
Float_t Z
static const double amu_c2
float proton_mass_c2
Definition: hepunit.py:275
double G4double
Definition: G4Types.hh:76
G4double Z23(G4int Z) const
Definition: G4Pow.hh:154
G4double GetAtomicMassAmu(const G4String &symb) const
Here is the call graph for this function:
Here is the caller graph for this function:

Member Data Documentation

◆ alpha2

G4double G4WentzelOKandVIxSection::alpha2
private

Definition at line 143 of file G4WentzelOKandVIxSection.hh.

◆ charge3

G4double G4WentzelOKandVIxSection::charge3
private

Definition at line 149 of file G4WentzelOKandVIxSection.hh.

◆ chargeSquare

G4double G4WentzelOKandVIxSection::chargeSquare
private

Definition at line 148 of file G4WentzelOKandVIxSection.hh.

◆ coeff

G4double G4WentzelOKandVIxSection::coeff
private

Definition at line 139 of file G4WentzelOKandVIxSection.hh.

◆ cosTetMaxElec

G4double G4WentzelOKandVIxSection::cosTetMaxElec
private

Definition at line 140 of file G4WentzelOKandVIxSection.hh.

◆ cosTetMaxNuc

G4double G4WentzelOKandVIxSection::cosTetMaxNuc
private

Definition at line 141 of file G4WentzelOKandVIxSection.hh.

◆ cosThetaMax

G4double G4WentzelOKandVIxSection::cosThetaMax
private

Definition at line 142 of file G4WentzelOKandVIxSection.hh.

◆ currentMaterial

const G4Material* G4WentzelOKandVIxSection::currentMaterial
private

Definition at line 123 of file G4WentzelOKandVIxSection.hh.

◆ ecut

G4double G4WentzelOKandVIxSection::ecut
private

Definition at line 158 of file G4WentzelOKandVIxSection.hh.

◆ etag

G4double G4WentzelOKandVIxSection::etag
private

Definition at line 157 of file G4WentzelOKandVIxSection.hh.

◆ factB

G4double G4WentzelOKandVIxSection::factB
private

Definition at line 167 of file G4WentzelOKandVIxSection.hh.

◆ factB1

G4double G4WentzelOKandVIxSection::factB1
private

Definition at line 168 of file G4WentzelOKandVIxSection.hh.

◆ factD

G4double G4WentzelOKandVIxSection::factD
private

Definition at line 169 of file G4WentzelOKandVIxSection.hh.

◆ factorA2

G4double G4WentzelOKandVIxSection::factorA2
private

Definition at line 166 of file G4WentzelOKandVIxSection.hh.

◆ fG4pow

G4Pow* G4WentzelOKandVIxSection::fG4pow
private

Definition at line 126 of file G4WentzelOKandVIxSection.hh.

◆ fNistManager

G4NistManager* G4WentzelOKandVIxSection::fNistManager
private

Definition at line 125 of file G4WentzelOKandVIxSection.hh.

◆ formfactA

G4double G4WentzelOKandVIxSection::formfactA
private

Definition at line 165 of file G4WentzelOKandVIxSection.hh.

◆ FormFactor

G4double G4WentzelOKandVIxSection::FormFactor = {0.0}
staticprivate

Definition at line 175 of file G4WentzelOKandVIxSection.hh.

◆ gam0pcmp

G4double G4WentzelOKandVIxSection::gam0pcmp
private

Definition at line 170 of file G4WentzelOKandVIxSection.hh.

◆ invbeta2

G4double G4WentzelOKandVIxSection::invbeta2
private

Definition at line 155 of file G4WentzelOKandVIxSection.hh.

◆ isCombined

G4bool G4WentzelOKandVIxSection::isCombined
private

Definition at line 136 of file G4WentzelOKandVIxSection.hh.

◆ kinFactor

G4double G4WentzelOKandVIxSection::kinFactor
private

Definition at line 156 of file G4WentzelOKandVIxSection.hh.

◆ lowEnergyLimit

G4double G4WentzelOKandVIxSection::lowEnergyLimit
private

Definition at line 159 of file G4WentzelOKandVIxSection.hh.

◆ mass

G4double G4WentzelOKandVIxSection::mass
private

Definition at line 151 of file G4WentzelOKandVIxSection.hh.

◆ mom2

G4double G4WentzelOKandVIxSection::mom2
private

Definition at line 153 of file G4WentzelOKandVIxSection.hh.

◆ momCM2

G4double G4WentzelOKandVIxSection::momCM2
private

Definition at line 154 of file G4WentzelOKandVIxSection.hh.

◆ numlimit

G4double G4WentzelOKandVIxSection::numlimit
private

Definition at line 130 of file G4WentzelOKandVIxSection.hh.

◆ nwarnings

G4int G4WentzelOKandVIxSection::nwarnings
private

Definition at line 133 of file G4WentzelOKandVIxSection.hh.

◆ nwarnlimit

G4int G4WentzelOKandVIxSection::nwarnlimit
private

Definition at line 134 of file G4WentzelOKandVIxSection.hh.

◆ particle

const G4ParticleDefinition* G4WentzelOKandVIxSection::particle
private

Definition at line 146 of file G4WentzelOKandVIxSection.hh.

◆ pcmp2

G4double G4WentzelOKandVIxSection::pcmp2
private

Definition at line 171 of file G4WentzelOKandVIxSection.hh.

◆ ScreenRSquare

G4double G4WentzelOKandVIxSection::ScreenRSquare = {0.0}
staticprivate

Definition at line 174 of file G4WentzelOKandVIxSection.hh.

◆ ScreenRSquareElec

G4double G4WentzelOKandVIxSection::ScreenRSquareElec = {0.0}
staticprivate

Definition at line 173 of file G4WentzelOKandVIxSection.hh.

◆ screenZ

G4double G4WentzelOKandVIxSection::screenZ
private

Definition at line 164 of file G4WentzelOKandVIxSection.hh.

◆ spin

G4double G4WentzelOKandVIxSection::spin
private

Definition at line 150 of file G4WentzelOKandVIxSection.hh.

◆ targetMass

G4double G4WentzelOKandVIxSection::targetMass
private

Definition at line 163 of file G4WentzelOKandVIxSection.hh.

◆ targetZ

G4int G4WentzelOKandVIxSection::targetZ
private

Definition at line 162 of file G4WentzelOKandVIxSection.hh.

◆ temp

G4ThreeVector G4WentzelOKandVIxSection::temp
private

Definition at line 128 of file G4WentzelOKandVIxSection.hh.

◆ theElectron

const G4ParticleDefinition* G4WentzelOKandVIxSection::theElectron
private

Definition at line 121 of file G4WentzelOKandVIxSection.hh.

◆ thePositron

const G4ParticleDefinition* G4WentzelOKandVIxSection::thePositron
private

Definition at line 122 of file G4WentzelOKandVIxSection.hh.

◆ theProton

const G4ParticleDefinition* G4WentzelOKandVIxSection::theProton
private

Definition at line 120 of file G4WentzelOKandVIxSection.hh.

◆ tkin

G4double G4WentzelOKandVIxSection::tkin
private

Definition at line 152 of file G4WentzelOKandVIxSection.hh.


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