Geant4  10.00.p02
G4EmCorrections Class Reference

#include <G4EmCorrections.hh>

+ Collaboration diagram for G4EmCorrections:

Public Member Functions

 G4EmCorrections ()
 
virtual ~G4EmCorrections ()
 
G4double HighOrderCorrections (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy, G4double cutEnergy)
 
G4double IonHighOrderCorrections (const G4ParticleDefinition *, const G4MaterialCutsCouple *, G4double kineticEnergy)
 
G4double ComputeIonCorrections (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double IonBarkasCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double Bethe (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double SpinCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double KShellCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double LShellCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double ShellCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double ShellCorrectionSTD (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double DensityCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double BarkasCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double BlochCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double MottCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double NuclearDEDX (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy, G4bool fluct=true)
 
void AddStoppingData (G4int Z, G4int A, const G4String &materialName, G4PhysicsVector *dVector)
 
void InitialiseForNewRun ()
 
G4double EffectiveChargeCorrection (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double GetParticleCharge (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double EffectiveChargeSquareRatio (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
void SetIonisationModels (G4VEmModel *m1=0, G4VEmModel *m2=0)
 
G4int GetNumberOfStoppingVectors ()
 

Private Member Functions

void Initialise ()
 
void BuildCorrectionVector ()
 
void SetupKinematics (const G4ParticleDefinition *, const G4Material *, G4double kineticEnergy)
 
G4double KShell (G4double theta, G4double eta)
 
G4double LShell (G4double theta, G4double eta)
 
G4int Index (G4double x, G4double *y, G4int n)
 
G4double Value (G4double xv, G4double x1, G4double x2, G4double y1, G4double y2)
 
G4double Value2 (G4double xv, G4double yv, G4double x1, G4double x2, G4double y1, G4double y2, G4double z11, G4double z21, G4double z12, G4double z22)
 
G4double NuclearStoppingPower (G4double e, G4double z1, G4double z2, G4double m1, G4double m2)
 
G4EmCorrectionsoperator= (const G4EmCorrections &right)
 
 G4EmCorrections (const G4EmCorrections &)
 

Private Attributes

G4double ed [104]
 
G4double a [104]
 
G4double theZieglerFactor
 
G4double alpha2
 
G4bool lossFlucFlag
 
G4int verbose
 
G4int nK
 
G4int nL
 
G4int nEtaK
 
G4int nEtaL
 
G4double COSEB [14]
 
G4double COSXI [14]
 
G4double ZD [11]
 
G4double TheK [20]
 
G4double SK [20]
 
G4double TK [20]
 
G4double UK [20]
 
G4double VK [20]
 
G4double ZK [20]
 
G4double TheL [26]
 
G4double SL [26]
 
G4double TL [26]
 
G4double UL [26]
 
G4double VL [26]
 
G4double Eta [29]
 
G4double CK [20][29]
 
G4double CL [26][28]
 
G4double HM [53]
 
G4double HN [31]
 
G4double Z23 [100]
 
G4LPhysicsFreeVectorBarkasCorr
 
G4LPhysicsFreeVectorThetaK
 
G4LPhysicsFreeVectorThetaL
 
std::vector< const G4Material * > currmat
 
std::map< G4int, std::vector
< G4double > > 
thcorr
 
size_t ncouples
 
const G4ParticleDefinitionparticle
 
const G4ParticleDefinitioncurParticle
 
const G4Materialmaterial
 
const G4MaterialcurMaterial
 
const G4ElementVectortheElementVector
 
const G4doubleatomDensity
 
G4int numberOfElements
 
G4double kinEnergy
 
G4double mass
 
G4double massFactor
 
G4double formfact
 
G4double eth
 
G4double tau
 
G4double gamma
 
G4double bg2
 
G4double beta2
 
G4double beta
 
G4double ba2
 
G4double tmax
 
G4double charge
 
G4double q2
 
G4double eCorrMin
 
G4double eCorrMax
 
G4int nbinCorr
 
G4ionEffectiveCharge effCharge
 
G4NistManagernist
 
G4IonTableionTable
 
G4VEmModelionLEModel
 
G4VEmModelionHEModel
 
G4int nIons
 
G4int idx
 
G4int currentZ
 
std::vector< G4intZion
 
std::vector< G4intAion
 
std::vector< G4StringmaterialName
 
std::vector< const
G4ParticleDefinition * > 
ionList
 
std::vector< const G4Material * > materialList
 
std::vector< G4PhysicsVector * > stopData
 
G4PhysicsVectorcurVector
 

Detailed Description

Definition at line 71 of file G4EmCorrections.hh.

Constructor & Destructor Documentation

G4EmCorrections::G4EmCorrections ( )

Definition at line 77 of file G4EmCorrections.cc.

References BarkasCorr, curMaterial, curParticle, curVector, eCorrMax, eCorrMin, eth, G4ParticleTable::GetIonTable(), G4ParticleTable::GetParticleTable(), Initialise(), G4NistManager::Instance(), ionHEModel, ionLEModel, ionTable, keV, kinEnergy, massFactor, material, MeV, nbinCorr, ncouples, nIons, nist, particle, ThetaK, ThetaL, and verbose.

+ Here is the call graph for this function:

G4EmCorrections::~G4EmCorrections ( )
virtual

Definition at line 103 of file G4EmCorrections.cc.

G4EmCorrections::G4EmCorrections ( const G4EmCorrections )
private

Member Function Documentation

void G4EmCorrections::AddStoppingData ( G4int  Z,
G4int  A,
const G4String materialName,
G4PhysicsVector dVector 
)

Definition at line 791 of file G4EmCorrections.cc.

References Aion, G4cout, G4endl, ionList, materialList, materialName, nIons, stopData, verbose, and Zion.

Referenced by G4ionIonisation::AddStoppingData(), and G4WaterStopping::Initialise().

+ Here is the caller graph for this function:

G4double G4EmCorrections::BarkasCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 575 of file G4EmCorrections.cc.

References atomDensity, ba2, BarkasCorr, beta, charge, G4PhysicsVector::Energy(), G4Material::GetName(), G4Material::GetTotNbOfAtomsPerVolume(), iz, material, numberOfElements, SetupKinematics(), and G4PhysicsVector::Value().

Referenced by ComputeIonCorrections(), HighOrderCorrections(), and IonBarkasCorrection().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::Bethe ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 249 of file G4EmCorrections.cc.

References beta2, bg2, G4Material::GetIonisation(), G4IonisParamMat::GetMeanExcitationEnergy(), material, SetupKinematics(), and tmax.

+ Here is the call graph for this function:

G4double G4EmCorrections::BlochCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 632 of file G4EmCorrections.cc.

References ba2, q2, and SetupKinematics().

Referenced by ComputeIonCorrections(), and HighOrderCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4EmCorrections::BuildCorrectionVector ( )
private

Definition at line 816 of file G4EmCorrections.cc.

References A, Aion, G4VEmModel::ComputeDEDXPerVolume(), ComputeIonCorrections(), curMaterial, curParticle, currentZ, eCorrMax, eCorrMin, effCharge, G4ionEffectiveCharge::EffectiveChargeSquareRatio(), G4PhysicsVector::Energy(), eth, G4cout, G4endl, G4GenericIon::GenericIon(), G4ParticleDefinition::GetBaryonNumber(), G4IonTable::GetIon(), G4ParticleDefinition::GetParticleName(), G4ParticleDefinition::GetPDGMass(), idx, ionHEModel, ionLEModel, ionList, ionTable, massFactor, materialName, MeV, nbinCorr, G4PhysicsVector::PutValue(), G4PhysicsVector::SetSpline(), stopData, verbose, and Zion.

Referenced by EffectiveChargeCorrection().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::ComputeIonCorrections ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 168 of file G4EmCorrections.cc.

References BarkasCorrection(), beta2, BlochCorrection(), charge, G4cout, G4endl, G4Material::GetElectronDensity(), material, MeV, MottCorrection(), q2, SetupKinematics(), tau, and verbose.

Referenced by BuildCorrectionVector(), and IonHighOrderCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::DensityCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 548 of file G4EmCorrections.cc.

References bg2, G4IonisParamMat::GetAdensity(), G4IonisParamMat::GetCdensity(), G4Material::GetIonisation(), G4IonisParamMat::GetMdensity(), G4IonisParamMat::GetX0density(), G4IonisParamMat::GetX1density(), material, and SetupKinematics().

+ Here is the call graph for this function:

G4double G4EmCorrections::EffectiveChargeCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 742 of file G4EmCorrections.cc.

References BuildCorrectionVector(), curMaterial, curParticle, currentZ, curVector, eplus, G4cout, G4endl, G4ParticleDefinition::GetAtomicNumber(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGMass(), idx, ionList, massFactor, materialList, nIons, stopData, G4PhysicsVector::Value(), verbose, and Zion.

Referenced by G4BetheBlochModel::CorrectionsAlongStep(), G4BraggIonModel::CorrectionsAlongStep(), G4BetheBlochModel::GetChargeSquareRatio(), G4BraggModel::GetChargeSquareRatio(), G4BraggIonModel::GetChargeSquareRatio(), and G4EmCalculator::UpdateParticle().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::EffectiveChargeSquareRatio ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)
inline

Definition at line 335 of file G4EmCorrections.hh.

References effCharge, and G4ionEffectiveCharge::EffectiveChargeSquareRatio().

Referenced by G4BetheBlochModel::CorrectionsAlongStep(), G4BraggIonModel::CorrectionsAlongStep(), G4BetheBlochModel::GetChargeSquareRatio(), G4BraggIonModel::GetChargeSquareRatio(), G4BraggModel::GetChargeSquareRatio(), G4UAtomicDeexcitation::GetShellIonisationCrossSectionPerAtom(), G4ContinuousGainOfEnergy::SetDynamicMassCharge(), and G4EmCalculator::UpdateParticle().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4int G4EmCorrections::GetNumberOfStoppingVectors ( )
inline

Definition at line 321 of file G4EmCorrections.hh.

References nIons.

Referenced by G4ionIonisation::PrintInfo().

+ Here is the caller graph for this function:

G4double G4EmCorrections::GetParticleCharge ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)
inline

Definition at line 327 of file G4EmCorrections.hh.

References effCharge, and G4ionEffectiveCharge::EffectiveCharge().

Referenced by G4BetheBlochModel::GetParticleCharge(), G4BraggModel::GetParticleCharge(), and G4BraggIonModel::GetParticleCharge().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::HighOrderCorrections ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy,
G4double  cutEnergy 
)

Definition at line 113 of file G4EmCorrections.cc.

References BarkasCorrection(), beta2, BlochCorrection(), G4cout, G4endl, G4Material::GetElectronDensity(), G4Material::GetName(), KShellCorrection(), LShellCorrection(), material, MeV, MottCorrection(), q2, SetupKinematics(), ShellCorrection(), tau, and verbose.

Referenced by G4MuBetheBlochModel::ComputeDEDXPerVolume(), and G4BetheBlochModel::ComputeDEDXPerVolume().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4int G4EmCorrections::Index ( G4double  x,
G4double y,
G4int  n 
)
inlineprivate

Definition at line 289 of file G4EmCorrections.hh.

Referenced by KShell(), and LShell().

+ Here is the caller graph for this function:

void G4EmCorrections::Initialise ( )
private

Definition at line 915 of file G4EmCorrections.cc.

References a, alpha2, BarkasCorr, CK, CL, cm2, COSEB, COSXI, ed, Eta, eV, HM, HN, lossFlucFlag, nEtaK, nEtaL, nK, nL, G4LPhysicsFreeVector::PutValues(), G4PhysicsVector::SetSpline(), SK, SL, TheK, TheL, ThetaK, ThetaL, theZieglerFactor, TK, TL, UK, UL, VK, VL, Z23, ZD, and ZK.

Referenced by G4EmCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4EmCorrections::InitialiseForNewRun ( )

Definition at line 892 of file G4EmCorrections.cc.

References currmat, G4MaterialCutsCouple::GetMaterial(), G4ProductionCutsTable::GetMaterialCutsCouple(), G4ProductionCutsTable::GetProductionCutsTable(), G4ProductionCutsTable::GetTableSize(), materialList, materialName, ncouples, nIons, and thcorr.

Referenced by G4ionIonisation::InitialiseEnergyLossProcess().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::IonBarkasCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 148 of file G4EmCorrections.cc.

References BarkasCorrection(), beta2, G4Material::GetElectronDensity(), material, q2, SetupKinematics(), and tau.

Referenced by G4BetheBlochModel::ComputeDEDXPerVolume().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::IonHighOrderCorrections ( const G4ParticleDefinition p,
const G4MaterialCutsCouple couple,
G4double  kineticEnergy 
)

Definition at line 200 of file G4EmCorrections.cc.

References ComputeIonCorrections(), currmat, eplus, eth, G4cout, G4endl, G4MaterialCutsCouple::GetIndex(), G4MaterialCutsCouple::GetMaterial(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGEncoding(), G4ParticleDefinition::GetPDGMass(), ionHEModel, ncouples, thcorr, and verbose.

Referenced by G4BetheBlochModel::CorrectionsAlongStep().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::KShell ( G4double  theta,
G4double  eta 
)
private

Definition at line 340 of file G4EmCorrections.cc.

References CK, Eta, Index(), nEtaK, nK, TheK, UK, Value(), Value2(), VK, and ZK.

Referenced by KShellCorrection(), and ShellCorrection().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::KShellCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 273 of file G4EmCorrections.cc.

References alpha2, atomDensity, ba2, G4Material::GetTotNbOfAtomsPerVolume(), iz, KShell(), material, numberOfElements, SetupKinematics(), ThetaK, and G4PhysicsVector::Value().

Referenced by HighOrderCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::LShell ( G4double  theta,
G4double  eta 
)
private

Definition at line 382 of file G4EmCorrections.cc.

References CL, Eta, Index(), nEtaL, nL, TheL, UL, Value(), Value2(), and VL.

Referenced by LShellCorrection(), and ShellCorrection().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::LShellCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 302 of file G4EmCorrections.cc.

References alpha2, atomDensity, ba2, G4AtomicShells::GetNumberOfElectrons(), G4AtomicShells::GetNumberOfShells(), G4Material::GetTotNbOfAtomsPerVolume(), iz, LShell(), material, G4INCL::Math::min(), nmax, numberOfElements, SetupKinematics(), ThetaL, G4PhysicsVector::Value(), and ZD.

Referenced by HighOrderCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::MottCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 658 of file G4EmCorrections.cc.

References beta, charge, G4INCL::Math::pi, and SetupKinematics().

Referenced by ComputeIonCorrections(), and HighOrderCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::NuclearDEDX ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy,
G4bool  fluct = true 
)

Definition at line 669 of file G4EmCorrections.cc.

References atomDensity, eplus, g, G4Element::GetA(), G4ParticleDefinition::GetPDGCharge(), G4Element::GetZ(), kinEnergy, lossFlucFlag, mass, mole, NuclearStoppingPower(), numberOfElements, particle, SetupKinematics(), and theZieglerFactor.

Referenced by G4EmCalculator::ComputeNuclearDEDX().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::NuclearStoppingPower ( G4double  e,
G4double  z1,
G4double  z2,
G4double  m1,
G4double  m2 
)
private

Definition at line 698 of file G4EmCorrections.cc.

References a, ed, G4INCL::KinematicsUtils::energy(), G4NistManager::GetZ13(), keV, lossFlucFlag, nist, G4INCL::DeJongSpin::shoot(), and Z23.

Referenced by NuclearDEDX().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4EmCorrections& G4EmCorrections::operator= ( const G4EmCorrections right)
private
void G4EmCorrections::SetIonisationModels ( G4VEmModel m1 = 0,
G4VEmModel m2 = 0 
)
inline

Definition at line 315 of file G4EmCorrections.hh.

References ionHEModel, and ionLEModel.

Referenced by G4ionIonisation::InitialiseEnergyLossProcess().

+ Here is the caller graph for this function:

void G4EmCorrections::SetupKinematics ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)
inlineprivate

Definition at line 342 of file G4EmCorrections.hh.

References alpha2, atomDensity, ba2, beta, beta2, bg2, charge, effCharge, G4ionEffectiveCharge::EffectiveCharge(), eplus, gamma, G4Material::GetAtomicNumDensityVector(), G4Material::GetElementVector(), G4Material::GetNumberOfElements(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGMass(), kinEnergy, mass, material, numberOfElements, particle, q2, tau, theElementVector, and tmax.

Referenced by BarkasCorrection(), Bethe(), BlochCorrection(), ComputeIonCorrections(), DensityCorrection(), HighOrderCorrections(), IonBarkasCorrection(), KShellCorrection(), LShellCorrection(), MottCorrection(), NuclearDEDX(), ShellCorrection(), ShellCorrectionSTD(), and SpinCorrection().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::ShellCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 459 of file G4EmCorrections.cc.

References alpha2, atomDensity, ba2, G4AtomicShells::GetNumberOfElectrons(), G4AtomicShells::GetNumberOfShells(), G4Material::GetTotNbOfAtomsPerVolume(), HM, HN, iz, KShell(), LShell(), material, G4INCL::Math::min(), nmax, numberOfElements, SetupKinematics(), ThetaK, ThetaL, G4PhysicsVector::Value(), and ZD.

Referenced by G4MuBetheBlochModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), and HighOrderCorrections().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4EmCorrections::ShellCorrectionSTD ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 425 of file G4EmCorrections.cc.

References bg2, bg2lim, G4Material::GetIonisation(), G4IonisParamMat::GetShellCorrectionVector(), G4IonisParamMat::GetTaul(), mass, material, MeV, SetupKinematics(), and tau.

+ Here is the call graph for this function:

G4double G4EmCorrections::SpinCorrection ( const G4ParticleDefinition p,
const G4Material mat,
G4double  kineticEnergy 
)

Definition at line 262 of file G4EmCorrections.cc.

References kinEnergy, mass, SetupKinematics(), and tmax.

+ Here is the call graph for this function:

G4double G4EmCorrections::Value ( G4double  xv,
G4double  x1,
G4double  x2,
G4double  y1,
G4double  y2 
)
inlineprivate

Definition at line 296 of file G4EmCorrections.hh.

Referenced by KShell(), and LShell().

+ Here is the caller graph for this function:

G4double G4EmCorrections::Value2 ( G4double  xv,
G4double  yv,
G4double  x1,
G4double  x2,
G4double  y1,
G4double  y2,
G4double  z11,
G4double  z21,
G4double  z12,
G4double  z22 
)
inlineprivate

Definition at line 302 of file G4EmCorrections.hh.

Referenced by KShell(), and LShell().

+ Here is the caller graph for this function:

Member Data Documentation

G4double G4EmCorrections::a[104]
private

Definition at line 197 of file G4EmCorrections.hh.

Referenced by Initialise(), and NuclearStoppingPower().

std::vector<G4int> G4EmCorrections::Aion
private

Definition at line 279 of file G4EmCorrections.hh.

Referenced by AddStoppingData(), and BuildCorrectionVector().

G4double G4EmCorrections::alpha2
private
const G4double* G4EmCorrections::atomDensity
private
G4double G4EmCorrections::ba2
private
G4LPhysicsFreeVector* G4EmCorrections::BarkasCorr
private

Definition at line 233 of file G4EmCorrections.hh.

Referenced by BarkasCorrection(), G4EmCorrections(), and Initialise().

G4double G4EmCorrections::beta
private

Definition at line 258 of file G4EmCorrections.hh.

Referenced by BarkasCorrection(), MottCorrection(), and SetupKinematics().

G4double G4EmCorrections::beta2
private
G4double G4EmCorrections::bg2
private

Definition at line 256 of file G4EmCorrections.hh.

Referenced by Bethe(), DensityCorrection(), SetupKinematics(), and ShellCorrectionSTD().

G4double G4EmCorrections::charge
private
G4double G4EmCorrections::CK[20][29]
private

Definition at line 227 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4double G4EmCorrections::CL[26][28]
private

Definition at line 228 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

G4double G4EmCorrections::COSEB[14]
private

Definition at line 209 of file G4EmCorrections.hh.

Referenced by Initialise().

G4double G4EmCorrections::COSXI[14]
private

Definition at line 210 of file G4EmCorrections.hh.

Referenced by Initialise().

const G4Material* G4EmCorrections::curMaterial
private
const G4ParticleDefinition* G4EmCorrections::curParticle
private
G4int G4EmCorrections::currentZ
private

Definition at line 277 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and EffectiveChargeCorrection().

std::vector<const G4Material*> G4EmCorrections::currmat
private

Definition at line 237 of file G4EmCorrections.hh.

Referenced by InitialiseForNewRun(), and IonHighOrderCorrections().

G4PhysicsVector* G4EmCorrections::curVector
private

Definition at line 286 of file G4EmCorrections.hh.

Referenced by EffectiveChargeCorrection(), and G4EmCorrections().

G4double G4EmCorrections::eCorrMax
private

Definition at line 264 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

G4double G4EmCorrections::eCorrMin
private

Definition at line 263 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

G4double G4EmCorrections::ed[104]
private

Definition at line 196 of file G4EmCorrections.hh.

Referenced by Initialise(), and NuclearStoppingPower().

G4ionEffectiveCharge G4EmCorrections::effCharge
private
G4double G4EmCorrections::Eta[29]
private

Definition at line 226 of file G4EmCorrections.hh.

Referenced by Initialise(), KShell(), and LShell().

G4double G4EmCorrections::eth
private
G4double G4EmCorrections::formfact
private

Definition at line 252 of file G4EmCorrections.hh.

G4double G4EmCorrections::gamma
private

Definition at line 255 of file G4EmCorrections.hh.

Referenced by SetupKinematics().

G4double G4EmCorrections::HM[53]
private

Definition at line 229 of file G4EmCorrections.hh.

Referenced by Initialise(), and ShellCorrection().

G4double G4EmCorrections::HN[31]
private

Definition at line 230 of file G4EmCorrections.hh.

Referenced by Initialise(), and ShellCorrection().

G4int G4EmCorrections::idx
private

Definition at line 276 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and EffectiveChargeCorrection().

G4VEmModel* G4EmCorrections::ionHEModel
private
G4VEmModel* G4EmCorrections::ionLEModel
private

Definition at line 271 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), G4EmCorrections(), and SetIonisationModels().

std::vector<const G4ParticleDefinition*> G4EmCorrections::ionList
private
G4IonTable* G4EmCorrections::ionTable
private

Definition at line 270 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

G4double G4EmCorrections::kinEnergy
private

Definition at line 249 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), NuclearDEDX(), SetupKinematics(), and SpinCorrection().

G4bool G4EmCorrections::lossFlucFlag
private

Definition at line 200 of file G4EmCorrections.hh.

Referenced by Initialise(), NuclearDEDX(), and NuclearStoppingPower().

G4double G4EmCorrections::mass
private
G4double G4EmCorrections::massFactor
private
std::vector<const G4Material*> G4EmCorrections::materialList
private
std::vector<G4String> G4EmCorrections::materialName
private

Definition at line 280 of file G4EmCorrections.hh.

Referenced by AddStoppingData(), BuildCorrectionVector(), and InitialiseForNewRun().

G4int G4EmCorrections::nbinCorr
private

Definition at line 265 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

size_t G4EmCorrections::ncouples
private
G4int G4EmCorrections::nEtaK
private

Definition at line 206 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4int G4EmCorrections::nEtaL
private

Definition at line 207 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

G4int G4EmCorrections::nIons
private
G4NistManager* G4EmCorrections::nist
private

Definition at line 269 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), and NuclearStoppingPower().

G4int G4EmCorrections::nK
private

Definition at line 204 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4int G4EmCorrections::nL
private

Definition at line 205 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

G4int G4EmCorrections::numberOfElements
private
const G4ParticleDefinition* G4EmCorrections::particle
private

Definition at line 241 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), NuclearDEDX(), and SetupKinematics().

G4double G4EmCorrections::q2
private
G4double G4EmCorrections::SK[20]
private

Definition at line 214 of file G4EmCorrections.hh.

Referenced by Initialise().

G4double G4EmCorrections::SL[26]
private

Definition at line 221 of file G4EmCorrections.hh.

Referenced by Initialise().

std::vector<G4PhysicsVector*> G4EmCorrections::stopData
private
G4double G4EmCorrections::tau
private
std::map< G4int, std::vector<G4double> > G4EmCorrections::thcorr
private

Definition at line 238 of file G4EmCorrections.hh.

Referenced by InitialiseForNewRun(), and IonHighOrderCorrections().

const G4ElementVector* G4EmCorrections::theElementVector
private

Definition at line 245 of file G4EmCorrections.hh.

Referenced by SetupKinematics().

G4double G4EmCorrections::TheK[20]
private

Definition at line 213 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4double G4EmCorrections::TheL[26]
private

Definition at line 220 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

G4LPhysicsFreeVector* G4EmCorrections::ThetaK
private

Definition at line 234 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), Initialise(), KShellCorrection(), and ShellCorrection().

G4LPhysicsFreeVector* G4EmCorrections::ThetaL
private

Definition at line 235 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), Initialise(), LShellCorrection(), and ShellCorrection().

G4double G4EmCorrections::theZieglerFactor
private

Definition at line 198 of file G4EmCorrections.hh.

Referenced by Initialise(), and NuclearDEDX().

G4double G4EmCorrections::TK[20]
private

Definition at line 215 of file G4EmCorrections.hh.

Referenced by Initialise().

G4double G4EmCorrections::TL[26]
private

Definition at line 222 of file G4EmCorrections.hh.

Referenced by Initialise().

G4double G4EmCorrections::tmax
private

Definition at line 260 of file G4EmCorrections.hh.

Referenced by Bethe(), SetupKinematics(), and SpinCorrection().

G4double G4EmCorrections::UK[20]
private

Definition at line 216 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4double G4EmCorrections::UL[26]
private

Definition at line 223 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

G4double G4EmCorrections::VK[20]
private

Definition at line 217 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4double G4EmCorrections::VL[26]
private

Definition at line 224 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

G4double G4EmCorrections::Z23[100]
private

Definition at line 231 of file G4EmCorrections.hh.

Referenced by Initialise(), and NuclearStoppingPower().

G4double G4EmCorrections::ZD[11]
private

Definition at line 211 of file G4EmCorrections.hh.

Referenced by Initialise(), LShellCorrection(), and ShellCorrection().

std::vector<G4int> G4EmCorrections::Zion
private
G4double G4EmCorrections::ZK[20]
private

Definition at line 218 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().


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