Geant4  10.02.p03
G4WentzelVIRelXSection Class Reference

#include <G4WentzelVIRelXSection.hh>

Collaboration diagram for G4WentzelVIRelXSection:

Public Member Functions

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

Private Member Functions

void ComputeMaxElectronScattering (G4double cut)
 
G4WentzelVIRelXSectionoperator= (const G4WentzelVIRelXSection &right)
 
 G4WentzelVIRelXSection (const G4WentzelVIRelXSection &)
 

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 ScreenRSquare [100] = {0.0}
 
static G4double FormFactor [100] = {0.0}
 

Detailed Description

Definition at line 71 of file G4WentzelVIRelXSection.hh.

Constructor & Destructor Documentation

◆ G4WentzelVIRelXSection() [1/2]

G4WentzelVIRelXSection::G4WentzelVIRelXSection ( G4bool  combined = true)

Definition at line 67 of file G4WentzelVIRelXSection.cc.

67  :
68  temp(0.,0.,0.),
69  numlimit(0.1),
70  nwarnings(0),
71  nwarnlimit(50),
72  isCombined(combined),
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;
93  for(G4int j=1; j<100; ++j) {
94  G4double x = a0*fG4pow->Z13(j);
95  //ScreenRSquare[j] = 0.5*(1 + exp(-j*j*0.001))*alpha2*x*x;
96  ScreenRSquare[j] = 0.5*alpha2*x*x;
97  x = fNistManager->GetA27(j);
98  FormFactor[j] = constn*x*x;
99  }
100  }
101  currentMaterial = 0;
102  factB = factD = formfactA = screenZ = 0.0;
104  cosThetaMax = 1.0;
105 
107 
108  tkin = mom2 = momCM2 = factorA2 = mass = spin = chargeSquare = charge3 = 0.0;
109  ecut = etag = DBL_MAX;
110  targetZ = 0;
112 }
const G4double a0
static G4Pow * GetInstance()
Definition: G4Pow.cc:55
static const double MeV
Definition: G4SIunits.hh:211
static G4double ScreenRSquare[100]
const G4ParticleDefinition * theElectron
G4double GetA27(G4int Z)
int G4int
Definition: G4Types.hh:78
static G4NistManager * Instance()
const G4ParticleDefinition * theProton
int fine_structure_const
Definition: hepunit.py:287
static const double twopi
Definition: G4SIunits.hh:75
static const double pi
Definition: SystemOfUnits.h:53
const G4ParticleDefinition * particle
static G4Proton * Proton()
Definition: G4Proton.cc:93
float proton_mass_c2
Definition: hepunit.py:275
float electron_mass_c2
Definition: hepunit.py:274
static G4double FormFactor[100]
G4double Z13(G4int Z) const
Definition: G4Pow.hh:127
static const double eV
Definition: G4SIunits.hh:212
static G4Positron * Positron()
Definition: G4Positron.cc:94
int classic_electr_radius
Definition: hepunit.py:288
const G4Material * currentMaterial
static G4Electron * Electron()
Definition: G4Electron.cc:94
double G4double
Definition: G4Types.hh:76
#define DBL_MAX
Definition: templates.hh:83
const G4ParticleDefinition * thePositron
Here is the call graph for this function:

◆ ~G4WentzelVIRelXSection()

G4WentzelVIRelXSection::~G4WentzelVIRelXSection ( )
virtual

Definition at line 116 of file G4WentzelVIRelXSection.cc.

117 {}

◆ G4WentzelVIRelXSection() [2/2]

G4WentzelVIRelXSection::G4WentzelVIRelXSection ( const G4WentzelVIRelXSection )
private

Member Function Documentation

◆ ComputeElectronCrossSection()

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

Definition at line 258 of file G4WentzelVIRelXSection.hh.

260 {
261  G4double xsec = 0.0;
262  G4double cost1 = std::max(cosTMin,cosTetMaxElec);
263  G4double cost2 = std::max(cosTMax,cosTetMaxElec);
264  if(cost1 > cost2) {
265  xsec = kinFactor*(cost1 - cost2)/
266  ((1.0 - cost1 + screenZ)*(1.0 - cost2 + screenZ));
267  }
268  return xsec;
269 }
double G4double
Definition: G4Types.hh:76
Here is the caller graph for this function:

◆ ComputeMaxElectronScattering()

void G4WentzelVIRelXSection::ComputeMaxElectronScattering ( G4double  cut)
private

Definition at line 329 of file G4WentzelVIRelXSection.cc.

330 {
331  if(mass > MeV) {
333  G4double tau = tkin/mass;
334  G4double tmax = 2.0*electron_mass_c2*tau*(tau + 2.)/
335  (1.0 + 2.0*ratio*(tau + 1.0) + ratio*ratio);
336  //tmax = std::min(tmax, targetZ*targetZ*10*eV);
337  cosTetMaxElec = 1.0 - std::min(cutEnergy, tmax)*electron_mass_c2/mom2;
338  } else {
339 
340  G4double tmax = tkin;
341  if(particle == theElectron) { tmax *= 0.5; }
342  //tmax = std::min(tmax, targetZ*targetZ*10*eV);
343  G4double t = std::min(cutEnergy, tmax);
344  G4double mom21 = t*(t + 2.0*electron_mass_c2);
345  G4double t1 = tkin - t;
346  //G4cout <<"tkin=" <<tkin<<" tmax= "<<tmax<<" t= "
347  //<<t<< " t1= "<<t1<<" cut= "<<ecut<<G4endl;
348  if(t1 > 0.0) {
349  G4double mom22 = t1*(t1 + 2.0*mass);
350  G4double ctm = (mom2 + mom22 - mom21)*0.5/sqrt(mom2*mom22);
351  if(ctm < 1.0) { cosTetMaxElec = ctm; }
352  if(particle == theElectron && cosTetMaxElec < 0.0) { cosTetMaxElec = 0.0; }
353  }
354  }
355 }
TTree * t1
Definition: plottest35.C:26
static const double MeV
Definition: G4SIunits.hh:211
const G4ParticleDefinition * theElectron
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 G4WentzelVIRelXSection::ComputeNuclearCrossSection ( G4double  CosThetaMin,
G4double  CosThetaMax 
)
inline

Definition at line 244 of file G4WentzelVIRelXSection.hh.

246 {
247  G4double xsec = 0.0;
248  if(cosTMax < cosTMin) {
249  xsec = targetZ*kinFactor*(cosTMin - cosTMax)/
250  ((1.0 - cosTMin + screenZ)*(1.0 - cosTMax + screenZ));
251  }
252  return xsec;
253 }
double G4double
Definition: G4Types.hh:76
Here is the caller graph for this function:

◆ ComputeTransportCrossSectionPerAtom()

G4double G4WentzelVIRelXSection::ComputeTransportCrossSectionPerAtom ( G4double  CosThetaMax)

Definition at line 184 of file G4WentzelVIRelXSection.cc.

185 {
186  G4double xsec = 0.0;
187  if(cosTMax >= 1.0) { return xsec; }
188 
189  G4double xSection = 0.0;
190  G4double x = 0;
191  G4double y = 0;
192  G4double x1= 0;
193  G4double x2= 0;
194  G4double xlog = 0.0;
195 
196  G4double costm = std::max(cosTMax,cosTetMaxElec);
198 
199  // scattering off electrons
200  if(costm < 1.0) {
201  x = (1.0 - costm)/screenZ;
202  if(x < numlimit) {
203  x2 = 0.5*x*x;
204  y = x2*(1.0 - 1.3333333*x + 3*x2);
205  if(0.0 < factB) { y -= fb*x2*x*(0.6666667 - x); }
206  } else {
207  x1= x/(1 + x);
208  xlog = G4Log(1.0 + x);
209  y = xlog - x1;
210  if(0.0 < factB) { y -= fb*(x + x1 - 2*xlog); }
211  }
212 
213  if(y < 0.0) {
214  ++nwarnings;
215  if(nwarnings < nwarnlimit) {
216  G4cout << "G4WentzelVIRelXSection::ComputeTransportCrossSectionPerAtom scattering on e- <0"
217  << G4endl;
218  G4cout << "y= " << y
219  << " e(MeV)= " << tkin << " p(MeV/c)= " << sqrt(mom2)
220  << " Z= " << targetZ << " "
222  G4cout << " 1-costm= " << 1.0-costm << " screenZ= " << screenZ
223  << " x= " << x << G4endl;
224  }
225  y = 0.0;
226  }
227  xSection = y;
228  }
229  /*
230  G4cout << "G4WentzelVI:XS per A " << " Z= " << targetZ
231  << " e(MeV)= " << tkin/MeV << " XSel= " << xSection
232  << " cut(MeV)= " << ecut/MeV
233  << " zmaxE= " << (1.0 - cosTetMaxElec)/screenZ
234  << " zmaxN= " << (1.0 - cosThetaMax)/screenZ
235  << " 1-costm= " << 1.0 - cosThetaMax << G4endl;
236  */
237  // scattering off nucleus
238  if(cosTMax < 1.0) {
239  x = (1.0 - cosTMax)/screenZ;
240  if(x < numlimit) {
241  x2 = 0.5*x*x;
242  y = x2*(1.0 - 1.3333333*x + 3*x2);
243  if(0.0 < factB) { y -= fb*x2*x*(0.6666667 - x); }
244  } else {
245  x1= x/(1 + x);
246  xlog = G4Log(1.0 + x);
247  y = xlog - x1;
248  if(0.0 < factB) { y -= fb*(x + x1 - 2*xlog); }
249  }
250 
251  if(y < 0.0) {
252  ++nwarnings;
253  if(nwarnings < nwarnlimit) {
254  G4cout << "G4WentzelVIRelXSection::ComputeTransportCrossSectionPerAtom scattering on e- <0"
255  << G4endl;
256  G4cout << "y= " << y
257  << " e(MeV)= " << tkin << " Z= " << targetZ << " "
259  G4cout << " formfactA= " << formfactA << " screenZ= " << screenZ
260  << " x= " << " x1= " << x1 <<G4endl;
261  }
262  y = 0.0;
263  }
264  xSection += y*targetZ;
265  }
266  xSection *= kinFactor;
267  /*
268  G4cout << "Z= " << targetZ << " XStot= " << xSection/barn
269  << " screenZ= " << screenZ << " formF= " << formfactA
270  << " for " << particle->GetParticleName()
271  << " m= " << mass << " 1/v= " << sqrt(invbeta2) << " p= " << sqrt(mom2)
272  << " x= " << x
273  << G4endl;
274  */
275  return xSection;
276 }
Double_t x2[nxs]
TFile fb
Definition: plot2.C:13
Double_t y
const G4String & GetParticleName() const
G4GLOB_DLL std::ostream G4cout
Double_t x1[nxs]
const G4ParticleDefinition * particle
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 G4WentzelVIRelXSection::GetCosThetaElec ( ) const
inline

Definition at line 236 of file G4WentzelVIRelXSection.hh.

237 {
238  return cosTetMaxElec;
239 }

◆ GetCosThetaNuc()

G4double G4WentzelVIRelXSection::GetCosThetaNuc ( ) const
inline

Definition at line 229 of file G4WentzelVIRelXSection.hh.

230 {
231  return cosTetMaxNuc;
232 }

◆ GetMomentumSquare()

G4double G4WentzelVIRelXSection::GetMomentumSquare ( ) const
inline

Definition at line 222 of file G4WentzelVIRelXSection.hh.

223 {
224  return mom2;
225 }

◆ Initialise()

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

Definition at line 121 of file G4WentzelVIRelXSection.cc.

123 {
124  SetupParticle(p);
125  tkin = mom2 = momCM2 = 0.0;
126  ecut = etag = DBL_MAX;
127  targetZ = 0;
128 
129  // cosThetaMax is below 1.0 only when MSC is combined with SS
130  if(isCombined) { cosThetaMax = cosThetaLim; }
131 
134  factorA2 = 0.5*a*a;
135  currentMaterial = 0;
136 }
static const double hbarc
G4double FactorForAngleLimit() const
void SetupParticle(const G4ParticleDefinition *)
static const double fermi
Definition: SystemOfUnits.h:82
static G4EmParameters * Instance()
const G4Material * currentMaterial
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=()

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

◆ SampleSingleScattering()

G4ThreeVector & G4WentzelVIRelXSection::SampleSingleScattering ( G4double  CosThetaMin,
G4double  CosThetaMax,
G4double  elecRatio 
)

Definition at line 281 of file G4WentzelVIRelXSection.cc.

284 {
285  temp.set(0.0,0.0,1.0);
286 
287  CLHEP::HepRandomEngine* rndmEngine = G4Random::getTheEngine();
288 
289  G4double formf = formfactA;
290  G4double cost1 = cosTMin;
291  G4double cost2 = cosTMax;
292  if(elecRatio > 0.0) {
293  if(rndmEngine->flat() <= elecRatio) {
294  formf = 0.0;
295  cost1 = std::max(cost1,cosTetMaxElec);
296  cost2 = std::max(cost2,cosTetMaxElec);
297  }
298  }
299  if(cost1 < cost2) { return temp; }
300 
301  G4double w1 = 1. - cost1 + screenZ;
302  G4double w2 = 1. - cost2 + screenZ;
303  G4double z1 = w1*w2/(w1 + rndmEngine->flat()*(w2 - w1)) - screenZ;
304 
305  G4double fm = 1.0 + formf*z1;
306  G4double grej = (1. - z1*factB + factB1*targetZ*sqrt(z1*factB)*(2 - z1))
307  /( (1.0 + z1*factD)*fm*fm );
308  // "false" scattering
309  if(rndmEngine->flat() > grej ) { return temp; }
310  // }
311  G4double cost = 1.0 - z1;
312 
313  if(cost > 1.0) { cost = 1.0; }
314  else if(cost < -1.0) { cost =-1.0; }
315  G4double sint = sqrt((1.0 - cost)*(1.0 + cost));
316  //G4cout << "sint= " << sint << G4endl;
317  G4double phi = twopi*rndmEngine->flat();
318  G4double vx1 = sint*cos(phi);
319  G4double vy1 = sint*sin(phi);
320 
321  // only direction is changed
322  temp.set(vx1,vy1,cost);
323  return temp;
324 }
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:

◆ SetupKinematic()

G4double G4WentzelVIRelXSection::SetupKinematic ( G4double  kinEnergy,
const G4Material mat,
G4double  cut,
G4double  tmass 
)
inline

Definition at line 179 of file G4WentzelVIRelXSection.hh.

183 {
184  if(kinEnergy != tkin || mat != currentMaterial ||
185  ecut != cut || tmass != targetMass) {
186 
188  ecut = cut;
189  tkin = kinEnergy;
190  G4double momLab2 = tkin*(tkin + 2.0*mass);
191 
192  G4double etot = tkin + mass;
193  G4double ptot = std::sqrt(momLab2);
194  G4double m12 = mass*mass;
195 
196  targetMass = tmass;
197 
198  // relativistic reduced mass from publucation
199  // A.P. Martynenko, R.N. Faustov, Teoret. mat. Fiz. 64 (1985) 179
200 
201  //incident particle & target nucleus
202  G4double Ecm = std::sqrt(m12 + targetMass*targetMass + 2.0*etot*targetMass);
203  G4double mu_rel = mass*targetMass/Ecm;
204  G4double momCM = ptot*targetMass/Ecm;
205  // relative system
206  mom2 = momCM*momCM;
207  invbeta2 = 1.0 + mu_rel*mu_rel/mom2;
208 
209  factB = spin/invbeta2;
210  factD = std::sqrt(mom2)/tmass;
211  if(isCombined) {
212  G4double cost = 1.-factorA2*mat->GetIonisation()->GetInvA23()/mom2;
213  if(cost > cosTetMaxNuc) { cosTetMaxNuc = cost; }
214  }
215  }
216  return cosTetMaxNuc;
217 
218 }
G4IonisParamMat * GetIonisation() const
Definition: G4Material.hh:226
Float_t mat
const G4Material * currentMaterial
double G4double
Definition: G4Types.hh:76
G4double GetInvA23() const
Here is the call graph for this function:
Here is the caller graph for this function:

◆ SetupParticle()

void G4WentzelVIRelXSection::SetupParticle ( const G4ParticleDefinition p)

Definition at line 140 of file G4WentzelVIRelXSection.cc.

141 {
142  particle = p;
143  mass = particle->GetPDGMass();
144  spin = particle->GetPDGSpin();
145  if(0.0 != spin) { spin = 0.5; }
146  G4double q = std::fabs(particle->GetPDGCharge()/eplus);
147  chargeSquare = q*q;
148  charge3 = chargeSquare*q;
149  tkin = 0.0;
150  currentMaterial = 0;
151  targetZ = 0;
152 }
const G4ParticleDefinition * particle
const G4Material * currentMaterial
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 G4WentzelVIRelXSection::SetupTarget ( G4int  Z,
G4double  cut 
)

Definition at line 157 of file G4WentzelVIRelXSection.cc.

158 {
159  G4double cosTetMaxNuc2 = cosTetMaxNuc;
160  if(Z != targetZ || tkin != etag) {
161  etag = tkin;
162  targetZ = Z;
163 
165 
167  if(Z > 1) {
168  screenZ *= std::min(Z*1.13,1.13 +3.76*Z*Z*invbeta2*alpha2*chargeSquare);
169  }
170  if(targetZ == 1 && cosTetMaxNuc2 < 0.0 && particle == theProton) {
171  cosTetMaxNuc2 = 0.0;
172  }
174 
175  cosTetMaxElec = 1.0;
177  }
178  return cosTetMaxNuc2;
179 }
static G4double ScreenRSquare[100]
const G4ParticleDefinition * theProton
Float_t Z
const G4ParticleDefinition * particle
static G4double FormFactor[100]
void ComputeMaxElectronScattering(G4double cut)
double G4double
Definition: G4Types.hh:76
Here is the call graph for this function:
Here is the caller graph for this function:

Member Data Documentation

◆ alpha2

G4double G4WentzelVIRelXSection::alpha2
private

Definition at line 142 of file G4WentzelVIRelXSection.hh.

◆ charge3

G4double G4WentzelVIRelXSection::charge3
private

Definition at line 148 of file G4WentzelVIRelXSection.hh.

◆ chargeSquare

G4double G4WentzelVIRelXSection::chargeSquare
private

Definition at line 147 of file G4WentzelVIRelXSection.hh.

◆ coeff

G4double G4WentzelVIRelXSection::coeff
private

Definition at line 138 of file G4WentzelVIRelXSection.hh.

◆ cosTetMaxElec

G4double G4WentzelVIRelXSection::cosTetMaxElec
private

Definition at line 139 of file G4WentzelVIRelXSection.hh.

◆ cosTetMaxNuc

G4double G4WentzelVIRelXSection::cosTetMaxNuc
private

Definition at line 140 of file G4WentzelVIRelXSection.hh.

◆ cosThetaMax

G4double G4WentzelVIRelXSection::cosThetaMax
private

Definition at line 141 of file G4WentzelVIRelXSection.hh.

◆ currentMaterial

const G4Material* G4WentzelVIRelXSection::currentMaterial
private

Definition at line 122 of file G4WentzelVIRelXSection.hh.

◆ ecut

G4double G4WentzelVIRelXSection::ecut
private

Definition at line 157 of file G4WentzelVIRelXSection.hh.

◆ etag

G4double G4WentzelVIRelXSection::etag
private

Definition at line 156 of file G4WentzelVIRelXSection.hh.

◆ factB

G4double G4WentzelVIRelXSection::factB
private

Definition at line 166 of file G4WentzelVIRelXSection.hh.

◆ factB1

G4double G4WentzelVIRelXSection::factB1
private

Definition at line 167 of file G4WentzelVIRelXSection.hh.

◆ factD

G4double G4WentzelVIRelXSection::factD
private

Definition at line 168 of file G4WentzelVIRelXSection.hh.

◆ factorA2

G4double G4WentzelVIRelXSection::factorA2
private

Definition at line 165 of file G4WentzelVIRelXSection.hh.

◆ fG4pow

G4Pow* G4WentzelVIRelXSection::fG4pow
private

Definition at line 125 of file G4WentzelVIRelXSection.hh.

◆ fNistManager

G4NistManager* G4WentzelVIRelXSection::fNistManager
private

Definition at line 124 of file G4WentzelVIRelXSection.hh.

◆ formfactA

G4double G4WentzelVIRelXSection::formfactA
private

Definition at line 164 of file G4WentzelVIRelXSection.hh.

◆ FormFactor

G4double G4WentzelVIRelXSection::FormFactor = {0.0}
staticprivate

Definition at line 173 of file G4WentzelVIRelXSection.hh.

◆ gam0pcmp

G4double G4WentzelVIRelXSection::gam0pcmp
private

Definition at line 169 of file G4WentzelVIRelXSection.hh.

◆ invbeta2

G4double G4WentzelVIRelXSection::invbeta2
private

Definition at line 154 of file G4WentzelVIRelXSection.hh.

◆ isCombined

G4bool G4WentzelVIRelXSection::isCombined
private

Definition at line 135 of file G4WentzelVIRelXSection.hh.

◆ kinFactor

G4double G4WentzelVIRelXSection::kinFactor
private

Definition at line 155 of file G4WentzelVIRelXSection.hh.

◆ lowEnergyLimit

G4double G4WentzelVIRelXSection::lowEnergyLimit
private

Definition at line 158 of file G4WentzelVIRelXSection.hh.

◆ mass

G4double G4WentzelVIRelXSection::mass
private

Definition at line 150 of file G4WentzelVIRelXSection.hh.

◆ mom2

G4double G4WentzelVIRelXSection::mom2
private

Definition at line 152 of file G4WentzelVIRelXSection.hh.

◆ momCM2

G4double G4WentzelVIRelXSection::momCM2
private

Definition at line 153 of file G4WentzelVIRelXSection.hh.

◆ numlimit

G4double G4WentzelVIRelXSection::numlimit
private

Definition at line 129 of file G4WentzelVIRelXSection.hh.

◆ nwarnings

G4int G4WentzelVIRelXSection::nwarnings
private

Definition at line 132 of file G4WentzelVIRelXSection.hh.

◆ nwarnlimit

G4int G4WentzelVIRelXSection::nwarnlimit
private

Definition at line 133 of file G4WentzelVIRelXSection.hh.

◆ particle

const G4ParticleDefinition* G4WentzelVIRelXSection::particle
private

Definition at line 145 of file G4WentzelVIRelXSection.hh.

◆ pcmp2

G4double G4WentzelVIRelXSection::pcmp2
private

Definition at line 170 of file G4WentzelVIRelXSection.hh.

◆ ScreenRSquare

G4double G4WentzelVIRelXSection::ScreenRSquare = {0.0}
staticprivate

Definition at line 172 of file G4WentzelVIRelXSection.hh.

◆ screenZ

G4double G4WentzelVIRelXSection::screenZ
private

Definition at line 163 of file G4WentzelVIRelXSection.hh.

◆ spin

G4double G4WentzelVIRelXSection::spin
private

Definition at line 149 of file G4WentzelVIRelXSection.hh.

◆ targetMass

G4double G4WentzelVIRelXSection::targetMass
private

Definition at line 162 of file G4WentzelVIRelXSection.hh.

◆ targetZ

G4int G4WentzelVIRelXSection::targetZ
private

Definition at line 161 of file G4WentzelVIRelXSection.hh.

◆ temp

G4ThreeVector G4WentzelVIRelXSection::temp
private

Definition at line 127 of file G4WentzelVIRelXSection.hh.

◆ theElectron

const G4ParticleDefinition* G4WentzelVIRelXSection::theElectron
private

Definition at line 120 of file G4WentzelVIRelXSection.hh.

◆ thePositron

const G4ParticleDefinition* G4WentzelVIRelXSection::thePositron
private

Definition at line 121 of file G4WentzelVIRelXSection.hh.

◆ theProton

const G4ParticleDefinition* G4WentzelVIRelXSection::theProton
private

Definition at line 119 of file G4WentzelVIRelXSection.hh.

◆ tkin

G4double G4WentzelVIRelXSection::tkin
private

Definition at line 151 of file G4WentzelVIRelXSection.hh.


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