Geant4  10.03
G4EmCorrections Class Reference

#include <G4EmCorrections.hh>

+ Collaboration diagram for G4EmCorrections:

Public Member Functions

 G4EmCorrections (G4int verb)
 
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=nullptr, G4VEmModel *m2=nullptr)
 
G4int GetNumberOfStoppingVectors () const
 
void SetVerbose (G4int verb)
 

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, const G4double *y, G4int n) const
 
G4double Value (G4double xv, G4double x1, G4double x2, G4double y1, G4double y2) const
 
G4double Value2 (G4double xv, G4double yv, G4double x1, G4double x2, G4double y1, G4double y2, G4double z11, G4double z21, G4double z12, G4double z22) const
 
G4double NuclearStoppingPower (G4double e, G4double z1, G4double z2, G4double m1, G4double m2)
 
G4EmCorrectionsoperator= (const G4EmCorrections &right)=delete
 
 G4EmCorrections (const G4EmCorrections &)=delete
 

Private Attributes

G4Powg4calc
 
G4double theZieglerFactor
 
G4double alpha2
 
G4bool lossFlucFlag
 
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
 
G4PhysicsVectorcurVector
 
G4IonTableionTable
 
G4VEmModelionLEModel
 
G4VEmModelionHEModel
 
G4double kinEnergy
 
G4double mass
 
G4double massFactor
 
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 verbose
 
G4int nK
 
G4int nL
 
G4int nEtaK
 
G4int nEtaL
 
G4int nbinCorr
 
G4int numberOfElements
 
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
 
G4bool isMaster
 
G4ionEffectiveCharge effCharge
 

Static Private Attributes

static const G4double inveplus = 1.0/CLHEP::eplus
 
static const G4double ZD [11]
 
static const G4double UK [20]
 
static const G4double VK [20]
 
static G4double ZK [20] = {0.0}
 
static const G4double Eta [29]
 
static G4double CK [20][29]
 
static G4double CL [26][28]
 
static const G4double UL [26]
 
static G4double VL [26] = {0.0}
 
static G4LPhysicsFreeVectorBarkasCorr = nullptr
 
static G4LPhysicsFreeVectorThetaK = nullptr
 
static G4LPhysicsFreeVectorThetaL = nullptr
 

Detailed Description

Definition at line 71 of file G4EmCorrections.hh.

Constructor & Destructor Documentation

G4EmCorrections::G4EmCorrections ( G4int  verb)
explicit
G4EmCorrections::~G4EmCorrections ( )
virtual

Definition at line 158 of file G4EmCorrections.cc.

References BarkasCorr, isMaster, nIons, stopData, ThetaK, and ThetaL.

G4EmCorrections::G4EmCorrections ( const G4EmCorrections )
privatedelete

Member Function Documentation

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

Definition at line 991 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 659 of file G4EmCorrections.cc.

References atomDensity, ba2, BarkasCorr, beta, charge, G4PhysicsVector::Energy(), G4Exp(), G4Log(), G4lrint(), G4Material::GetName(), G4Material::GetTotNbOfAtomsPerVolume(), 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 308 of file G4EmCorrections.cc.

References beta2, bg2, G4Log(), 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 713 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 1016 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 226 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 632 of file G4EmCorrections.cc.

References bg2, G4Exp(), G4Log(), 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 942 of file G4EmCorrections.cc.

References BuildCorrectionVector(), curMaterial, curParticle, currentZ, curVector, eplus, G4cout, G4endl, G4ParticleDefinition::GetAtomicNumber(), G4Material::GetName(), G4ParticleDefinition::GetParticleName(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGMass(), idx, ionList, massFactor, materialList, MeV, 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 329 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 ( ) const
inline

Definition at line 315 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 321 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 171 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,
const G4double y,
G4int  n 
) const
inlineprivate

Definition at line 282 of file G4EmCorrections.hh.

Referenced by KShell(), and LShell().

+ Here is the caller graph for this function:

void G4EmCorrections::Initialise ( )
private

Definition at line 1114 of file G4EmCorrections.cc.

References BarkasCorr, CK, CL, Eta, G4Log(), isMaster, G4Threading::IsMasterThread(), nEtaK, nEtaL, nK, nL, G4LPhysicsFreeVector::PutValues(), G4PhysicsVector::SetSpline(), SL, ThetaK, ThetaL, UK, UL, VK, VL, 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 1091 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 206 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 258 of file G4EmCorrections.cc.

References ComputeIonCorrections(), currmat, eth, G4cout, G4endl, G4lrint(), G4MaterialCutsCouple::GetIndex(), G4MaterialCutsCouple::GetMaterial(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGEncoding(), G4ParticleDefinition::GetPDGMass(), inveplus, 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 399 of file G4EmCorrections.cc.

References CK, Eta, Index(), nEtaK, nK, tet, 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 332 of file G4EmCorrections.cc.

References alpha2, atomDensity, ba2, G4lrint(), G4Material::GetTotNbOfAtomsPerVolume(), KShell(), material, numberOfElements, SetupKinematics(), tet, 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 447 of file G4EmCorrections.cc.

References CL, Eta, Index(), nEtaL, nL, tet, 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 361 of file G4EmCorrections.cc.

References alpha2, atomDensity, ba2, G4lrint(), G4AtomicShells::GetNumberOfElectrons(), G4AtomicShells::GetNumberOfShells(), G4Material::GetTotNbOfAtomsPerVolume(), LShell(), material, G4INCL::Math::min(), nmax, numberOfElements, SetupKinematics(), tet, 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 737 of file G4EmCorrections.cc.

References beta, charge, 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 748 of file G4EmCorrections.cc.

References atomDensity, G4Element::GetN(), G4ParticleDefinition::GetPDGCharge(), G4Element::GetZ(), inveplus, kinEnergy, lossFlucFlag, mass, 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 777 of file G4EmCorrections.cc.

References G4INCL::KinematicsUtils::energy(), g4calc, G4lrint(), keV, lossFlucFlag, G4INCL::Math::max(), G4INCL::DeJongSpin::shoot(), G4Pow::Z13(), and G4Pow::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)
privatedelete
void G4EmCorrections::SetIonisationModels ( G4VEmModel m1 = nullptr,
G4VEmModel m2 = nullptr 
)
inline

Definition at line 309 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 336 of file G4EmCorrections.hh.

References alpha2, atomDensity, ba2, beta, beta2, bg2, charge, effCharge, G4ionEffectiveCharge::EffectiveCharge(), gamma, G4Material::GetAtomicNumDensityVector(), G4Material::GetElementVector(), G4Material::GetNumberOfElements(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGMass(), inveplus, 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:

void G4EmCorrections::SetVerbose ( G4int  verb)
inline

Definition at line 365 of file G4EmCorrections.hh.

References verbose.

Referenced by G4LossTableManager::ResetParameters().

+ Here is the caller graph for this function:

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

Definition at line 529 of file G4EmCorrections.cc.

References alpha2, atomDensity, ba2, G4lrint(), G4AtomicShells::GetNumberOfElectrons(), G4AtomicShells::GetNumberOfShells(), G4Material::GetTotNbOfAtomsPerVolume(), KShell(), LShell(), material, G4INCL::Math::min(), nmax, numberOfElements, SetupKinematics(), tet, 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 495 of file G4EmCorrections.cc.

References bg2, G4Log(), 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 321 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 
) const
inlineprivate

Definition at line 290 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 
) const
inlineprivate

Definition at line 296 of file G4EmCorrections.hh.

Referenced by KShell(), and LShell().

+ Here is the caller graph for this function:

Member Data Documentation

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

Definition at line 269 of file G4EmCorrections.hh.

Referenced by AddStoppingData(), and BuildCorrectionVector().

G4double G4EmCorrections::alpha2
private
const G4double* G4EmCorrections::atomDensity
private
G4LPhysicsFreeVector * G4EmCorrections::BarkasCorr = nullptr
staticprivate
G4double G4EmCorrections::beta
private
G4double G4EmCorrections::beta2
private
G4double G4EmCorrections::bg2
private
G4double G4EmCorrections::charge
private
G4double G4EmCorrections::CK
staticprivate

Definition at line 208 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4double G4EmCorrections::CL
staticprivate

Definition at line 209 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

const G4Material* G4EmCorrections::curMaterial
private
const G4ParticleDefinition* G4EmCorrections::curParticle
private
G4int G4EmCorrections::currentZ
private
std::vector<const G4Material*> G4EmCorrections::currmat
private

Definition at line 221 of file G4EmCorrections.hh.

Referenced by InitialiseForNewRun(), and IonHighOrderCorrections().

G4PhysicsVector* G4EmCorrections::curVector
private

Definition at line 232 of file G4EmCorrections.hh.

Referenced by EffectiveChargeCorrection(), and G4EmCorrections().

G4double G4EmCorrections::eCorrMax
private

Definition at line 252 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

G4double G4EmCorrections::eCorrMin
private

Definition at line 251 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

G4ionEffectiveCharge G4EmCorrections::effCharge
private
const G4double G4EmCorrections::Eta
staticprivate
Initial value:
= {0.005, 0.007, 0.01, 0.015, 0.02,
0.03, 0.04, 0.05, 0.06, 0.08,
0.1, 0.15, 0.2, 0.3, 0.4,
0.5, 0.6, 0.7, 0.8, 1.0,
1.2, 1.4, 1.5, 1.7, 2.0, 3.0, 5.0, 7.0, 10.}

Definition at line 207 of file G4EmCorrections.hh.

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

G4double G4EmCorrections::eth
private
G4Pow* G4EmCorrections::g4calc
private

Definition at line 200 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), and NuclearStoppingPower().

G4double G4EmCorrections::gamma
private

Definition at line 243 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), and SetupKinematics().

G4int G4EmCorrections::idx
private
const G4double G4EmCorrections::inveplus = 1.0/CLHEP::eplus
staticprivate

Definition at line 202 of file G4EmCorrections.hh.

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

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

Definition at line 235 of file G4EmCorrections.hh.

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

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

Definition at line 234 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

G4bool G4EmCorrections::isMaster
private

Definition at line 277 of file G4EmCorrections.hh.

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

G4double G4EmCorrections::kinEnergy
private

Definition at line 238 of file G4EmCorrections.hh.

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

G4bool G4EmCorrections::lossFlucFlag
private

Definition at line 219 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), 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 270 of file G4EmCorrections.hh.

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

G4int G4EmCorrections::nbinCorr
private

Definition at line 261 of file G4EmCorrections.hh.

Referenced by BuildCorrectionVector(), and G4EmCorrections().

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

Definition at line 258 of file G4EmCorrections.hh.

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

G4int G4EmCorrections::nEtaL
private

Definition at line 259 of file G4EmCorrections.hh.

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

G4int G4EmCorrections::nK
private

Definition at line 256 of file G4EmCorrections.hh.

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

G4int G4EmCorrections::nL
private

Definition at line 257 of file G4EmCorrections.hh.

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

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

Definition at line 225 of file G4EmCorrections.hh.

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

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

Definition at line 222 of file G4EmCorrections.hh.

Referenced by InitialiseForNewRun(), and IonHighOrderCorrections().

const G4ElementVector* G4EmCorrections::theElementVector
private

Definition at line 229 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), and SetupKinematics().

G4LPhysicsFreeVector * G4EmCorrections::ThetaK = nullptr
staticprivate
G4LPhysicsFreeVector * G4EmCorrections::ThetaL = nullptr
staticprivate
G4double G4EmCorrections::theZieglerFactor
private

Definition at line 217 of file G4EmCorrections.hh.

Referenced by G4EmCorrections(), and NuclearDEDX().

G4double G4EmCorrections::tmax
private

Definition at line 248 of file G4EmCorrections.hh.

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

const G4double G4EmCorrections::UK
staticprivate
Initial value:
= {1.9999, 2.0134, 2.0258, 2.0478, 2.0662,
2.0817, 2.0945, 2.0999, 2.1049, 2.1132,
2.1197, 2.1246, 2.1280, 2.1292, 2.1301,
2.1310, 2.1310, 2.1300, 2.1283, 2.1271}

Definition at line 204 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

const G4double G4EmCorrections::UL
staticprivate
Initial value:
= {0.1215, 0.5265, 0.8411, 1.0878, 1.2828,
1.4379, 1.5032, 1.5617, 1.6608, 1.7401,
1.8036, 1.8543, 1.8756, 1.8945, 1.9262,
1.9508, 1.9696, 1.9836, 1.9890, 1.9935,
2.0001, 2.0039, 2.0053, 2.0049, 2.0040, 2.0028}

Definition at line 210 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

const G4double G4EmCorrections::VK
staticprivate
Initial value:
= {8.3410, 8.3373, 8.3340, 8.3287, 8.3247,
8.3219, 8.3201, 8.3194, 8.3191, 8.3188,
8.3191, 8.3199, 8.3211, 8.3218, 8.3226,
8.3244, 8.3264, 8.3285, 8.3308, 8.3320}

Definition at line 205 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().

G4double G4EmCorrections::VL = {0.0}
staticprivate

Definition at line 211 of file G4EmCorrections.hh.

Referenced by Initialise(), and LShell().

const G4double G4EmCorrections::ZD
staticprivate
Initial value:
=
{0., 0., 0., 1.72, 2.09, 2.48, 2.82, 3.16, 3.53, 3.84, 4.15}

Definition at line 203 of file G4EmCorrections.hh.

Referenced by LShellCorrection(), and ShellCorrection().

std::vector<G4int> G4EmCorrections::Zion
private
G4double G4EmCorrections::ZK = {0.0}
staticprivate

Definition at line 206 of file G4EmCorrections.hh.

Referenced by Initialise(), and KShell().


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