Geant4  10.03
G4VEmProcess Class Referenceabstract

#include <G4VEmProcess.hh>

+ Inheritance diagram for G4VEmProcess:
+ Collaboration diagram for G4VEmProcess:

Public Member Functions

 G4VEmProcess (const G4String &name, G4ProcessType type=fElectromagnetic)
 
virtual ~G4VEmProcess ()
 
virtual G4bool IsApplicable (const G4ParticleDefinition &p) override=0
 
virtual void PrintInfo ()=0
 
virtual void ProcessDescription (std::ostream &outFile) const
 
virtual void PreparePhysicsTable (const G4ParticleDefinition &) override
 
virtual void BuildPhysicsTable (const G4ParticleDefinition &) override
 
virtual void StartTracking (G4Track *) override
 
virtual G4double PostStepGetPhysicalInteractionLength (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
 
virtual G4VParticleChangePostStepDoIt (const G4Track &, const G4Step &) override
 
virtual G4bool StorePhysicsTable (const G4ParticleDefinition *, const G4String &directory, G4bool ascii=false) override
 
virtual G4bool RetrievePhysicsTable (const G4ParticleDefinition *, const G4String &directory, G4bool ascii) override
 
G4double CrossSectionPerVolume (G4double kineticEnergy, const G4MaterialCutsCouple *couple)
 
G4double ComputeCrossSectionPerAtom (G4double kineticEnergy, G4double Z, G4double A=0., G4double cut=0.0)
 
G4double MeanFreePath (const G4Track &track)
 
G4double GetLambda (G4double &kinEnergy, const G4MaterialCutsCouple *couple)
 
void SetLambdaBinning (G4int nbins)
 
void SetMinKinEnergy (G4double e)
 
void SetMinKinEnergyPrim (G4double e)
 
void SetMaxKinEnergy (G4double e)
 
G4PhysicsTableLambdaTable () const
 
G4PhysicsTableLambdaTablePrim () const
 
const G4ParticleDefinitionParticle () const
 
const G4ParticleDefinitionSecondaryParticle () const
 
G4VEmModelSelectModelForMaterial (G4double kinEnergy, size_t &idxRegion) const
 
void AddEmModel (G4int, G4VEmModel *, const G4Region *region=nullptr)
 
G4VEmModelEmModel (G4int index=1) const
 
void SetEmModel (G4VEmModel *, G4int index=1)
 
void UpdateEmModel (const G4String &, G4double, G4double)
 
G4int GetNumberOfModels () const
 
G4int GetNumberOfRegionModels (size_t couple_index) const
 
G4VEmModelGetRegionModel (G4int idx, size_t couple_index) const
 
G4VEmModelGetModelByIndex (G4int idx=0, G4bool ver=false) const
 
const G4VEmModelGetCurrentModel () const
 
const G4ElementGetCurrentElement () const
 
void SetCrossSectionBiasingFactor (G4double f, G4bool flag=true)
 
G4double CrossSectionBiasingFactor () const
 
void ActivateForcedInteraction (G4double length=0.0, const G4String &r="", G4bool flag=true)
 
void ActivateSecondaryBiasing (const G4String &region, G4double factor, G4double energyLimit)
 
void SetIntegral (G4bool val)
 
void SetBuildTableFlag (G4bool val)
 
- Public Member Functions inherited from G4VDiscreteProcess
 G4VDiscreteProcess (const G4String &, G4ProcessType aType=fNotDefined)
 
 G4VDiscreteProcess (G4VDiscreteProcess &)
 
virtual ~G4VDiscreteProcess ()
 
virtual G4double AlongStepGetPhysicalInteractionLength (const G4Track &, G4double, G4double, G4double &, G4GPILSelection *)
 
virtual G4double AtRestGetPhysicalInteractionLength (const G4Track &, G4ForceCondition *)
 
virtual G4VParticleChangeAtRestDoIt (const G4Track &, const G4Step &)
 
virtual G4VParticleChangeAlongStepDoIt (const G4Track &, const G4Step &)
 
- Public Member Functions inherited from G4VProcess
 G4VProcess (const G4String &aName="NoName", G4ProcessType aType=fNotDefined)
 
 G4VProcess (const G4VProcess &right)
 
virtual ~G4VProcess ()
 
G4int operator== (const G4VProcess &right) const
 
G4int operator!= (const G4VProcess &right) const
 
G4double GetCurrentInteractionLength () const
 
void SetPILfactor (G4double value)
 
G4double GetPILfactor () const
 
G4double AlongStepGPIL (const G4Track &track, G4double previousStepSize, G4double currentMinimumStep, G4double &proposedSafety, G4GPILSelection *selection)
 
G4double AtRestGPIL (const G4Track &track, G4ForceCondition *condition)
 
G4double PostStepGPIL (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition)
 
const G4StringGetPhysicsTableFileName (const G4ParticleDefinition *, const G4String &directory, const G4String &tableName, G4bool ascii=false)
 
const G4StringGetProcessName () const
 
G4ProcessType GetProcessType () const
 
void SetProcessType (G4ProcessType)
 
G4int GetProcessSubType () const
 
void SetProcessSubType (G4int)
 
virtual void EndTracking ()
 
virtual void SetProcessManager (const G4ProcessManager *)
 
virtual const G4ProcessManagerGetProcessManager ()
 
virtual void ResetNumberOfInteractionLengthLeft ()
 
G4double GetNumberOfInteractionLengthLeft () const
 
G4double GetTotalNumberOfInteractionLengthTraversed () const
 
G4bool isAtRestDoItIsEnabled () const
 
G4bool isAlongStepDoItIsEnabled () const
 
G4bool isPostStepDoItIsEnabled () const
 
virtual void DumpInfo () const
 
void SetVerboseLevel (G4int value)
 
G4int GetVerboseLevel () const
 
virtual void SetMasterProcess (G4VProcess *masterP)
 
const G4VProcessGetMasterProcess () const
 
virtual void BuildWorkerPhysicsTable (const G4ParticleDefinition &part)
 
virtual void PrepareWorkerPhysicsTable (const G4ParticleDefinition &)
 

Protected Member Functions

virtual void InitialiseProcess (const G4ParticleDefinition *)=0
 
virtual G4double MinPrimaryEnergy (const G4ParticleDefinition *, const G4Material *)
 
G4VEmModelSelectModel (G4double &kinEnergy, size_t index)
 
virtual G4double GetMeanFreePath (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
 
G4PhysicsVectorLambdaPhysicsVector (const G4MaterialCutsCouple *)
 
G4int LambdaBinning () const
 
G4double MinKinEnergy () const
 
G4double MaxKinEnergy () const
 
G4double PolarAngleLimit () const
 
G4bool IsIntegral () const
 
G4double RecalculateLambda (G4double kinEnergy, const G4MaterialCutsCouple *couple)
 
G4ParticleChangeForGammaGetParticleChange ()
 
void SetParticle (const G4ParticleDefinition *p)
 
void SetSecondaryParticle (const G4ParticleDefinition *p)
 
size_t CurrentMaterialCutsCoupleIndex () const
 
G4double GetGammaEnergyCut ()
 
G4double GetElectronEnergyCut ()
 
void SetStartFromNullFlag (G4bool val)
 
void SetSplineFlag (G4bool val)
 
const G4ElementGetTargetElement () const
 
const G4IsotopeGetTargetIsotope () const
 
- Protected Member Functions inherited from G4VProcess
void SubtractNumberOfInteractionLengthLeft (G4double previousStepSize)
 
void ClearNumberOfInteractionLengthLeft ()
 

Protected Attributes

G4ParticleChangeForGamma fParticleChange
 
- Protected Attributes inherited from G4VProcess
const G4ProcessManageraProcessManager
 
G4VParticleChangepParticleChange
 
G4ParticleChange aParticleChange
 
G4double theNumberOfInteractionLengthLeft
 
G4double currentInteractionLength
 
G4double theInitialNumberOfInteractionLength
 
G4String theProcessName
 
G4String thePhysicsTableFileName
 
G4ProcessType theProcessType
 
G4int theProcessSubType
 
G4double thePILfactor
 
G4bool enableAtRestDoIt
 
G4bool enableAlongStepDoIt
 
G4bool enablePostStepDoIt
 
G4int verboseLevel
 

Private Member Functions

void Clear ()
 
void BuildLambdaTable ()
 
void PrintInfoProcess (const G4ParticleDefinition &)
 
void FindLambdaMax ()
 
void PrintWarning (G4String tit, G4double val)
 
void DefineMaterial (const G4MaterialCutsCouple *couple)
 
void ComputeIntegralLambda (G4double kinEnergy)
 
G4double GetLambdaFromTable (G4double kinEnergy)
 
G4double GetLambdaFromTablePrim (G4double kinEnergy)
 
G4double GetCurrentLambda (G4double kinEnergy)
 
G4double ComputeCurrentLambda (G4double kinEnergy)
 
 G4VEmProcess (G4VEmProcess &)=delete
 
G4VEmProcessoperator= (const G4VEmProcess &right)=delete
 

Private Attributes

G4LossTableManagerlManager
 
G4EmParameterstheParameters
 
G4EmModelManagermodelManager
 
G4EmBiasingManagerbiasManager
 
const G4ParticleDefinitiontheGamma
 
const G4ParticleDefinitiontheElectron
 
const G4ParticleDefinitionthePositron
 
const G4ParticleDefinitionsecondaryParticle
 
G4bool buildLambdaTable
 
std::vector< G4VEmModel * > emModels
 
G4int numberOfModels
 
G4PhysicsTabletheLambdaTable
 
G4PhysicsTabletheLambdaTablePrim
 
std::vector< G4doubletheEnergyOfCrossSectionMax
 
std::vector< G4doubletheCrossSectionMax
 
size_t idxLambda
 
size_t idxLambdaPrim
 
const std::vector< G4double > * theCuts
 
const std::vector< G4double > * theCutsGamma
 
const std::vector< G4double > * theCutsElectron
 
const std::vector< G4double > * theCutsPositron
 
const std::vector< G4double > * theDensityFactor
 
const std::vector< G4int > * theDensityIdx
 
G4int nLambdaBins
 
G4double minKinEnergy
 
G4double minKinEnergyPrim
 
G4double maxKinEnergy
 
G4double lambdaFactor
 
G4double biasFactor
 
G4bool integral
 
G4bool applyCuts
 
G4bool startFromNull
 
G4bool splineFlag
 
G4bool actMinKinEnergy
 
G4bool actMaxKinEnergy
 
G4bool actBinning
 
G4bool actSpline
 
std::vector< G4DynamicParticle * > secParticles
 
G4VEmModelcurrentModel
 
const G4ParticleDefinitionparticle
 
const G4ParticleDefinitioncurrentParticle
 
const G4MaterialbaseMaterial
 
const G4MaterialcurrentMaterial
 
const G4MaterialCutsCouplecurrentCouple
 
size_t currentCoupleIndex
 
size_t basedCoupleIndex
 
G4double mfpKinEnergy
 
G4double preStepKinEnergy
 
G4double preStepLambda
 
G4double fFactor
 
G4bool biasFlag
 
G4bool weightFlag
 
G4int mainSecondaries
 
G4int secID
 
G4int fluoID
 
G4int augerID
 
G4int biasID
 

Additional Inherited Members

- Static Public Member Functions inherited from G4VProcess
static const G4StringGetProcessTypeName (G4ProcessType)
 

Detailed Description

Definition at line 93 of file G4VEmProcess.hh.

Constructor & Destructor Documentation

G4VEmProcess::~G4VEmProcess ( )
virtual

Definition at line 159 of file G4VEmProcess.cc.

References biasManager, G4PhysicsTable::clearAndDestroy(), G4LossTableManager::DeRegister(), G4LossTableManager::IsMaster(), lManager, modelManager, theLambdaTable, and theLambdaTablePrim.

+ Here is the call graph for this function:

G4VEmProcess::G4VEmProcess ( G4VEmProcess )
privatedelete

Member Function Documentation

void G4VEmProcess::ActivateForcedInteraction ( G4double  length = 0.0,
const G4String r = "",
G4bool  flag = true 
)

Definition at line 1149 of file G4VEmProcess.cc.

References G4EmBiasingManager::ActivateForcedInteraction(), biasManager, G4cout, G4endl, G4ParticleDefinition::GetParticleName(), G4VProcess::GetProcessName(), mm, particle, G4VProcess::verboseLevel, and weightFlag.

Referenced by G4EmParameters::DefineRegParamForEM().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::ActivateSecondaryBiasing ( const G4String region,
G4double  factor,
G4double  energyLimit 
)

Definition at line 1169 of file G4VEmProcess.cc.

References G4EmBiasingManager::ActivateSecondaryBiasing(), biasManager, G4Electron::Electron(), G4cout, G4endl, G4VProcess::GetProcessName(), MeV, secondaryParticle, and G4VProcess::verboseLevel.

Referenced by G4EmParameters::DefineRegParamForEM().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::AddEmModel ( G4int  order,
G4VEmModel p,
const G4Region region = nullptr 
)

Definition at line 203 of file G4VEmProcess.cc.

References G4EmModelManager::AddEmModel(), modelManager, G4VProcess::pParticleChange, and G4VEmModel::SetParticleChange().

Referenced by G4EmDNAPhysics_option3::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmLivermorePolarizedPhysics::ConstructProcess(), G4EmDNAPhysics::ConstructProcess(), G4EmDNAPhysics_option4::ConstructProcess(), G4EmDNAPhysics_option5::ConstructProcess(), G4EmDNAPhysics_option7::ConstructProcess(), G4EmDNAPhysics_option2::ConstructProcess(), G4EmDNAPhysics_option1::ConstructProcess(), G4EmDNAPhysicsActivator::ConstructProcess(), ExExChPhysListEmStandardSS::ConstructProcess(), G4EmLEPTSPhysics::ConstructProcess(), PhysListEmLivermore::ConstructProcess(), PhysListEmStandardSSM::ConstructProcess(), PhysListEmPenelope::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4DNADissociation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4MuElecElastic::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4RayleighScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4MuElecInelastic::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4DNAElectronSolvation::InitialiseProcess(), G4eeToHadrons::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4ComptonScattering::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4NuclearStopping::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4PolarizedPhotoElectricEffect::InitialiseProcess(), G4EmConfigurator::PrepareModels(), and G4EmConfigurator::SetModelForRegion().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::BuildPhysicsTable ( const G4ParticleDefinition part)
overridevirtual
void G4VEmProcess::Clear ( )
private

Definition at line 185 of file G4VEmProcess.cc.

References currentCouple, DBL_MAX, idxLambda, idxLambdaPrim, mfpKinEnergy, and preStepLambda.

Referenced by PreparePhysicsTable().

+ Here is the caller graph for this function:

G4double G4VEmProcess::ComputeCrossSectionPerAtom ( G4double  kineticEnergy,
G4double  Z,
G4double  A = 0.,
G4double  cut = 0.0 
)

Definition at line 1045 of file G4VEmProcess.cc.

References G4VEmModel::ComputeCrossSectionPerAtom(), currentCoupleIndex, currentModel, currentParticle, and SelectModel().

+ Here is the call graph for this function:

G4double G4VEmProcess::ComputeCurrentLambda ( G4double  kinEnergy)
inlineprivate

Definition at line 499 of file G4VEmProcess.hh.

References baseMaterial, G4VEmModel::CrossSectionPerVolume(), currentCoupleIndex, currentModel, currentParticle, and theCuts.

Referenced by GetCurrentLambda(), and RecalculateLambda().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::ComputeIntegralLambda ( G4double  kinEnergy)
inlineprivate

Definition at line 539 of file G4VEmProcess.hh.

References currentCoupleIndex, fFactor, GetCurrentLambda(), lambdaFactor, mfpKinEnergy, preStepLambda, theCrossSectionMax, and theEnergyOfCrossSectionMax.

Referenced by PostStepGetPhysicalInteractionLength().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4VEmProcess::CrossSectionBiasingFactor ( ) const
inline

Definition at line 592 of file G4VEmProcess.hh.

References biasFactor.

G4double G4VEmProcess::CrossSectionPerVolume ( G4double  kineticEnergy,
const G4MaterialCutsCouple couple 
)

Definition at line 1002 of file G4VEmProcess.cc.

References buildLambdaTable, G4VEmModel::CrossSectionPerVolume(), currentCoupleIndex, currentMaterial, currentModel, currentParticle, DefineMaterial(), fFactor, GetCurrentLambda(), SelectModel(), and theLambdaTable.

+ Here is the call graph for this function:

size_t G4VEmProcess::CurrentMaterialCutsCoupleIndex ( ) const
inlineprotected

Definition at line 426 of file G4VEmProcess.hh.

References currentCoupleIndex.

Referenced by G4eplusPolarizedAnnihilation::ComputeSaturationFactor(), and G4PolarizedCompton::ComputeSaturationFactor().

+ Here is the caller graph for this function:

void G4VEmProcess::DefineMaterial ( const G4MaterialCutsCouple couple)
inlineprivate

Definition at line 447 of file G4VEmProcess.hh.

References basedCoupleIndex, baseMaterial, biasFactor, currentCouple, currentCoupleIndex, currentMaterial, DBL_MAX, fFactor, G4Material::GetBaseMaterial(), G4MaterialCutsCouple::GetIndex(), G4MaterialCutsCouple::GetMaterial(), idxLambda, idxLambdaPrim, and mfpKinEnergy.

Referenced by CrossSectionPerVolume(), GetLambda(), MeanFreePath(), PostStepGetPhysicalInteractionLength(), and RecalculateLambda().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4VEmModel * G4VEmProcess::EmModel ( G4int  index = 1) const

Definition at line 224 of file G4VEmProcess.cc.

References emModels.

Referenced by G4EmDNAPhysics_option2::ConstructProcess(), G4EmDNAPhysics_option5::ConstructProcess(), G4EmDNAChemistry::ConstructProcess(), G4DNAPositronium::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4MuElecElastic::InitialiseProcess(), G4RayleighScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4MuElecInelastic::InitialiseProcess(), G4DNAElectronSolvation::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4ComptonScattering::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4NuclearStopping::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4PolarizedPhotoElectricEffect::InitialiseProcess(), G4DNAPositronium::PrintInfo(), G4DNARotExcitation::PrintInfo(), G4DNADissociation::PrintInfo(), G4DNAVibExcitation::PrintInfo(), G4DNAChargeIncrease::PrintInfo(), G4DNAAttachment::PrintInfo(), G4DNAChargeDecrease::PrintInfo(), G4DNAExcitation::PrintInfo(), G4DNAElastic::PrintInfo(), G4DNAIonisation::PrintInfo(), and G4PolarizedCompton::PrintInfo().

+ Here is the caller graph for this function:

void G4VEmProcess::FindLambdaMax ( )
private

Definition at line 1059 of file G4VEmProcess.cc.

References DBL_MAX, emax, G4PhysicsVector::Energy(), G4cout, G4endl, G4ParticleDefinition::GetParticleName(), G4VProcess::GetProcessName(), G4PhysicsVector::GetVectorLength(), G4PhysicsTable::length(), MeV, n, particle, smax, theCrossSectionMax, theEnergyOfCrossSectionMax, theLambdaTable, and G4VProcess::verboseLevel.

Referenced by BuildLambdaTable(), and BuildPhysicsTable().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

const G4Element * G4VEmProcess::GetCurrentElement ( ) const

Definition at line 1122 of file G4VEmProcess.cc.

References currentModel, and G4VEmModel::GetCurrentElement().

+ Here is the call graph for this function:

G4double G4VEmProcess::GetCurrentLambda ( G4double  kinEnergy)
inlineprivate

Definition at line 507 of file G4VEmProcess.hh.

References ComputeCurrentLambda(), fFactor, GetLambdaFromTable(), GetLambdaFromTablePrim(), minKinEnergyPrim, and theLambdaTable.

Referenced by ComputeIntegralLambda(), CrossSectionPerVolume(), GetLambda(), MeanFreePath(), and PostStepGetPhysicalInteractionLength().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

const G4VEmModel * G4VEmProcess::GetCurrentModel ( ) const
inline

Definition at line 699 of file G4VEmProcess.hh.

References currentModel.

G4double G4VEmProcess::GetElectronEnergyCut ( )
inlineprotected

Definition at line 440 of file G4VEmProcess.hh.

References currentCoupleIndex, and theCutsElectron.

G4double G4VEmProcess::GetGammaEnergyCut ( )
inlineprotected

Definition at line 433 of file G4VEmProcess.hh.

References currentCoupleIndex, and theCutsGamma.

G4double G4VEmProcess::GetLambda ( G4double kinEnergy,
const G4MaterialCutsCouple couple 
)
inline

Definition at line 519 of file G4VEmProcess.hh.

References currentCoupleIndex, DefineMaterial(), GetCurrentLambda(), and SelectModel().

Referenced by PostStepDoIt(), and G4AdjointComptonModel::RapidSampleSecondaries().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4VEmProcess::GetLambdaFromTable ( G4double  kinEnergy)
inlineprivate

Definition at line 485 of file G4VEmProcess.hh.

References basedCoupleIndex, idxLambda, and theLambdaTable.

Referenced by GetCurrentLambda().

+ Here is the caller graph for this function:

G4double G4VEmProcess::GetLambdaFromTablePrim ( G4double  kinEnergy)
inlineprivate

Definition at line 492 of file G4VEmProcess.hh.

References basedCoupleIndex, idxLambdaPrim, and theLambdaTablePrim.

Referenced by GetCurrentLambda().

+ Here is the caller graph for this function:

G4double G4VEmProcess::GetMeanFreePath ( const G4Track track,
G4double  previousStepSize,
G4ForceCondition condition 
)
overrideprotectedvirtual

Implements G4VDiscreteProcess.

Reimplemented in G4PolarizedCompton, and G4eplusPolarizedAnnihilation.

Definition at line 1023 of file G4VEmProcess.cc.

References MeanFreePath(), and NotForced.

Referenced by G4eplusPolarizedAnnihilation::GetMeanFreePath(), and G4PolarizedCompton::GetMeanFreePath().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4VEmModel * G4VEmProcess::GetModelByIndex ( G4int  idx = 0,
G4bool  ver = false 
) const

Definition at line 262 of file G4VEmProcess.cc.

References G4EmModelManager::GetModel(), and modelManager.

Referenced by BuildPhysicsTable().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4int G4VEmProcess::GetNumberOfModels ( ) const

Definition at line 241 of file G4VEmProcess.cc.

References modelManager, and G4EmModelManager::NumberOfModels().

+ Here is the call graph for this function:

G4int G4VEmProcess::GetNumberOfRegionModels ( size_t  couple_index) const

Definition at line 248 of file G4VEmProcess.cc.

References modelManager, and G4EmModelManager::NumberOfRegionModels().

+ Here is the call graph for this function:

G4ParticleChangeForGamma * G4VEmProcess::GetParticleChange ( )
inlineprotected

Definition at line 648 of file G4VEmProcess.hh.

References fParticleChange.

G4VEmModel * G4VEmProcess::GetRegionModel ( G4int  idx,
size_t  couple_index 
) const

Definition at line 255 of file G4VEmProcess.cc.

References G4EmModelManager::GetRegionModel(), and modelManager.

+ Here is the call graph for this function:

const G4Element * G4VEmProcess::GetTargetElement ( ) const
inlineprotected

Definition at line 685 of file G4VEmProcess.hh.

References currentModel, and G4VEmModel::GetCurrentElement().

+ Here is the call graph for this function:

const G4Isotope * G4VEmProcess::GetTargetIsotope ( ) const
inlineprotected

Definition at line 692 of file G4VEmProcess.hh.

References currentModel, and G4VEmModel::GetCurrentIsotope().

+ Here is the call graph for this function:

G4bool G4VEmProcess::IsIntegral ( ) const
inlineprotected

Definition at line 634 of file G4VEmProcess.hh.

References integral.

G4int G4VEmProcess::LambdaBinning ( ) const
inlineprotected

Definition at line 564 of file G4VEmProcess.hh.

References nLambdaBins.

Referenced by G4PolarizedCompton::BuildAsymmetryTable(), and G4eplusPolarizedAnnihilation::BuildAsymmetryTables().

+ Here is the caller graph for this function:

G4PhysicsVector * G4VEmProcess::LambdaPhysicsVector ( const G4MaterialCutsCouple )
protected

Definition at line 1112 of file G4VEmProcess.cc.

References maxKinEnergy, minKinEnergy, nLambdaBins, G4PhysicsVector::SetSpline(), G4EmParameters::Spline(), and theParameters.

Referenced by G4eplusPolarizedAnnihilation::BuildAsymmetryTables().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4PhysicsTable * G4VEmProcess::LambdaTable ( ) const
inline

Definition at line 599 of file G4VEmProcess.hh.

References theLambdaTable.

Referenced by BuildPhysicsTable(), and G4EmCalculator::FindLambdaTable().

+ Here is the caller graph for this function:

G4PhysicsTable * G4VEmProcess::LambdaTablePrim ( ) const
inline

Definition at line 606 of file G4VEmProcess.hh.

References theLambdaTablePrim.

Referenced by BuildPhysicsTable().

+ Here is the caller graph for this function:

G4double G4VEmProcess::MaxKinEnergy ( ) const
inlineprotected

Definition at line 578 of file G4VEmProcess.hh.

References maxKinEnergy.

Referenced by G4PolarizedCompton::BuildAsymmetryTable(), and G4eplusAnnihilation::InitialiseProcess().

+ Here is the caller graph for this function:

G4double G4VEmProcess::MeanFreePath ( const G4Track track)

Definition at line 1033 of file G4VEmProcess.cc.

References DBL_MAX, DefineMaterial(), GetCurrentLambda(), G4Track::GetKineticEnergy(), G4Track::GetMaterialCutsCouple(), and preStepLambda.

Referenced by GetMeanFreePath().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4double G4VEmProcess::MinKinEnergy ( ) const
inlineprotected

Definition at line 571 of file G4VEmProcess.hh.

References minKinEnergy.

Referenced by G4PolarizedCompton::BuildAsymmetryTable(), and G4eplusAnnihilation::InitialiseProcess().

+ Here is the caller graph for this function:

G4double G4VEmProcess::MinPrimaryEnergy ( const G4ParticleDefinition ,
const G4Material  
)
protectedvirtual

Reimplemented in G4GammaConversion, and G4CoulombScattering.

Definition at line 195 of file G4VEmProcess.cc.

Referenced by BuildLambdaTable().

+ Here is the caller graph for this function:

G4VEmProcess& G4VEmProcess::operator= ( const G4VEmProcess right)
privatedelete
const G4ParticleDefinition * G4VEmProcess::Particle ( ) const
inline

Definition at line 613 of file G4VEmProcess.hh.

References particle.

G4double G4VEmProcess::PolarAngleLimit ( ) const
inlineprotected

Definition at line 585 of file G4VEmProcess.hh.

References G4EmParameters::MscThetaLimit(), and theParameters.

+ Here is the call graph for this function:

G4VParticleChange * G4VEmProcess::PostStepDoIt ( const G4Track track,
const G4Step step 
)
overridevirtual

Reimplemented from G4VDiscreteProcess.

Definition at line 718 of file G4VEmProcess.cc.

References G4VParticleChange::AddSecondary(), applyCuts, G4EmBiasingManager::ApplySecondaryBiasing(), augerID, biasFactor, biasFlag, biasID, biasManager, G4VProcess::ClearNumberOfInteractionLengthLeft(), currentCouple, currentCoupleIndex, currentModel, currentParticle, DBL_MAX, fAlive, fluoID, G4EmBiasingManager::ForcedInteractionRegion(), fParticleChange, fStopAndKill, fStopButAlive, G4cout, G4endl, G4UniformRand, G4ProcessManager::GetAtRestProcessVector(), G4Track::GetDynamicParticle(), G4Track::GetGlobalTime(), G4DynamicParticle::GetKineticEnergy(), G4Track::GetKineticEnergy(), GetLambda(), G4VParticleChange::GetLocalEnergyDeposit(), G4VParticleChange::GetParentWeight(), G4DynamicParticle::GetParticleDefinition(), G4ParticleDefinition::GetParticleName(), G4Track::GetPosition(), G4Step::GetPostStepPoint(), G4ParticleDefinition::GetProcessManager(), G4VProcess::GetProcessName(), G4ParticleChangeForGamma::GetProposedKineticEnergy(), G4StepPoint::GetSafety(), G4Track::GetTouchableHandle(), G4VParticleChange::GetTrackStatus(), G4Track::GetTrackStatus(), G4ParticleChangeForGamma::InitializeForPostStep(), integral, G4VEmModel::IsActive(), mainSecondaries, MeV, mfpKinEnergy, particle, G4VProcess::pParticleChange, preStepLambda, G4VParticleChange::ProposeLocalEnergyDeposit(), G4VParticleChange::ProposeTrackStatus(), G4VParticleChange::ProposeWeight(), G4VEmModel::SampleSecondaries(), secID, G4EmBiasingManager::SecondaryBiasingRegion(), secParticles, SelectModel(), G4Track::SetCreatorModelIndex(), G4VParticleChange::SetNumberOfSecondaries(), G4Track::SetTouchableHandle(), G4Track::SetWeight(), G4ProcessVector::size(), theCuts, theCutsElectron, theCutsGamma, theCutsPositron, theElectron, theGamma, G4VProcess::theNumberOfInteractionLengthLeft, thePositron, G4VProcess::verboseLevel, and weightFlag.

+ Here is the call graph for this function:

G4double G4VEmProcess::PostStepGetPhysicalInteractionLength ( const G4Track track,
G4double  previousStepSize,
G4ForceCondition condition 
)
overridevirtual
void G4VEmProcess::PreparePhysicsTable ( const G4ParticleDefinition part)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 269 of file G4VEmProcess.cc.

References actMaxKinEnergy, actMinKinEnergy, actSpline, G4EmParameters::ApplyCuts(), applyCuts, G4LossTableManager::AtomDeexcitation(), augerID, biasFlag, biasID, biasManager, buildLambdaTable, Clear(), currentModel, DBL_MAX, G4EmParameters::DefineRegParamForEM(), fluoID, G4cout, G4endl, G4GenericIon::GenericIon(), G4ProductionCutsTable::GetEnergyCutsVector(), G4VProcess::GetMasterProcess(), G4EmModelManager::GetModel(), G4ParticleDefinition::GetParticleName(), G4ParticleDefinition::GetParticleSubType(), G4ParticleDefinition::GetParticleType(), G4VProcess::GetProcessName(), G4ProductionCutsTable::GetProductionCutsTable(), G4LossTableManager::GetTableBuilder(), G4ProductionCutsTable::GetTableSize(), G4VEmModel::HighEnergyLimit(), idxG4ElectronCut, idxG4GammaCut, idxG4PositronCut, G4EmBiasingManager::Initialise(), G4EmModelManager::Initialise(), G4LossTableBuilder::InitialiseBaseMaterials(), InitialiseProcess(), G4EmParameters::LambdaFactor(), lambdaFactor, lManager, G4EmParameters::MaxKinEnergy(), maxKinEnergy, G4EmParameters::MinKinEnergy(), minKinEnergy, minKinEnergyPrim, modelManager, G4EmParameters::MscThetaLimit(), n, G4EmModelManager::NumberOfModels(), numberOfModels, particle, G4PhysicsTableHelper::PreparePhysicsTable(), G4LossTableManager::PreparePhysicsTable(), G4PhysicsModelCatalog::Register(), secID, secondaryParticle, G4EmModelManager::SetFluoFlag(), G4VEmModel::SetHighEnergyLimit(), G4VEmModel::SetMasterThread(), SetParticle(), G4VEmModel::SetPolarAngleLimit(), G4VProcess::SetVerboseLevel(), G4EmParameters::Spline(), splineFlag, theCrossSectionMax, theCuts, theCutsElectron, theCutsGamma, theCutsPositron, theEnergyOfCrossSectionMax, theLambdaTable, theLambdaTablePrim, theParameters, G4EmParameters::Verbose(), G4VProcess::verboseLevel, and G4EmParameters::WorkerVerbose().

+ Here is the call graph for this function:

void G4VEmProcess::PrintInfoProcess ( const G4ParticleDefinition part)
private

Definition at line 546 of file G4VEmProcess.cc.

References applyCuts, biasFactor, buildLambdaTable, G4EmModelManager::DumpModelList(), emax, G4PhysicsVector::Energy(), G4BestUnit, G4cout, G4endl, G4lrint(), G4PhysicsVector::GetMaxEnergy(), G4ParticleDefinition::GetParticleName(), G4VProcess::GetProcessName(), G4VProcess::GetProcessSubType(), G4PhysicsVector::GetVectorLength(), integral, G4PhysicsTable::length(), maxKinEnergy, minKinEnergy, minKinEnergyPrim, modelManager, particle, PrintInfo(), splineFlag, theLambdaTable, theLambdaTablePrim, and G4VProcess::verboseLevel.

Referenced by BuildPhysicsTable().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::PrintWarning ( G4String  tit,
G4double  val 
)
private

Definition at line 1240 of file G4VEmProcess.cc.

References G4Exception(), G4VProcess::GetProcessName(), GeV, JustWarning, keV, G4EmParameters::MaxKinEnergy(), G4EmParameters::MinKinEnergy(), G4EmParameters::NumberOfBins(), and theParameters.

Referenced by SetLambdaBinning(), SetMaxKinEnergy(), SetMinKinEnergy(), and SetMinKinEnergyPrim().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::ProcessDescription ( std::ostream &  outFile) const
virtual

Definition at line 1254 of file G4VEmProcess.cc.

References G4endl, and G4VProcess::GetProcessName().

+ Here is the call graph for this function:

G4double G4VEmProcess::RecalculateLambda ( G4double  kinEnergy,
const G4MaterialCutsCouple couple 
)
inlineprotected

Definition at line 530 of file G4VEmProcess.hh.

References ComputeCurrentLambda(), currentCoupleIndex, DefineMaterial(), fFactor, and SelectModel().

+ Here is the call graph for this function:

G4bool G4VEmProcess::RetrievePhysicsTable ( const G4ParticleDefinition part,
const G4String directory,
G4bool  ascii 
)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 924 of file G4VEmProcess.cc.

References buildLambdaTable, G4cout, G4endl, G4ParticleDefinition::GetParticleName(), G4VProcess::GetPhysicsTableFileName(), G4VProcess::GetProcessName(), G4PhysicsTable::length(), maxKinEnergy, minKinEnergyPrim, n, particle, G4PhysicsTableHelper::RetrievePhysicsTable(), G4EmParameters::Spline(), theLambdaTable, theLambdaTablePrim, theParameters, and G4VProcess::verboseLevel.

+ Here is the call graph for this function:

const G4ParticleDefinition * G4VEmProcess::SecondaryParticle ( ) const
inline

Definition at line 620 of file G4VEmProcess.hh.

References secondaryParticle.

G4VEmModel * G4VEmProcess::SelectModel ( G4double kinEnergy,
size_t  index 
)
inlineprotected

Definition at line 465 of file G4VEmProcess.hh.

References currentCouple, currentModel, modelManager, numberOfModels, G4EmModelManager::SelectModel(), and G4VEmModel::SetCurrentCouple().

Referenced by G4NuclearStopping::AlongStepDoIt(), ComputeCrossSectionPerAtom(), CrossSectionPerVolume(), GetLambda(), PostStepDoIt(), PostStepGetPhysicalInteractionLength(), and RecalculateLambda().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

G4VEmModel * G4VEmProcess::SelectModelForMaterial ( G4double  kinEnergy,
size_t &  idxRegion 
) const
inline

Definition at line 477 of file G4VEmProcess.hh.

References modelManager, and G4EmModelManager::SelectModel().

Referenced by G4EmCalculator::FindEmModel().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::SetBuildTableFlag ( G4bool  val)
inline

Definition at line 641 of file G4VEmProcess.hh.

References buildLambdaTable.

Referenced by ExExChPhysListEmStandardSS::ConstructProcess(), PhysListEmStandardSSM::ConstructProcess(), PhysListEmStandardSS::ConstructProcess(), G4ComptonScattering::G4ComptonScattering(), G4CoulombScattering::G4CoulombScattering(), G4eeToHadrons::G4eeToHadrons(), G4eplusAnnihilation::G4eplusAnnihilation(), G4GammaConversion::G4GammaConversion(), G4NuclearStopping::G4NuclearStopping(), G4PhotoElectricEffect::G4PhotoElectricEffect(), G4PolarizedCompton::G4PolarizedCompton(), G4PolarizedGammaConversion::G4PolarizedGammaConversion(), G4PolarizedPhotoElectricEffect::G4PolarizedPhotoElectricEffect(), G4RayleighScattering::G4RayleighScattering(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4MuElecElastic::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4MuElecInelastic::InitialiseProcess(), and G4DNAElectronSolvation::InitialiseProcess().

+ Here is the caller graph for this function:

void G4VEmProcess::SetCrossSectionBiasingFactor ( G4double  f,
G4bool  flag = true 
)

Definition at line 1131 of file G4VEmProcess.cc.

References biasFactor, G4cout, G4endl, G4ParticleDefinition::GetParticleName(), G4VProcess::GetProcessName(), particle, G4VProcess::verboseLevel, and weightFlag.

Referenced by G4EmParameters::DefineRegParamForEM().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::SetEmModel ( G4VEmModel p,
G4int  index = 1 
)

Definition at line 213 of file G4VEmProcess.cc.

References emModels, and n.

Referenced by PhysicsList::ConstructEM(), DMXPhysicsList::ConstructEM(), G4EmDNAPhysics_option3::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmLivermorePolarizedPhysics::ConstructProcess(), G4EmLivermorePhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmDNAPhysics::ConstructProcess(), G4EmDNAPhysics_option7::ConstructProcess(), G4EmDNAPhysics_option2::ConstructProcess(), G4EmDNAPhysics_option4::ConstructProcess(), G4EmDNAPhysics_option5::ConstructProcess(), ExExChPhysListEmStandardSS::ConstructProcess(), G4EmLEPTSPhysics::ConstructProcess(), PhysListEmStandardNR::ConstructProcess(), PhysListEmStandard_WVI::ConstructProcess(), PhysListEmStandard_GS::ConstructProcess(), PhysListEmStandard_option3::ConstructProcess(), PhysListEmStandard_SS::ConstructProcess(), PhysListEmStandard_option0::ConstructProcess(), G4EmStandardPhysicsSS::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysicsGS::ConstructProcess(), GammaRayTelEMlowePhysics::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), G4EmStandardPhysics_option1::ConstructProcess(), G4EmStandardPhysics_option2::ConstructProcess(), G4EmModelActivator::FindOrAddProcess(), G4eplusPolarizedAnnihilation::G4eplusPolarizedAnnihilation(), G4DNADissociation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4MuElecElastic::InitialiseProcess(), G4RayleighScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4MuElecInelastic::InitialiseProcess(), G4DNAElectronSolvation::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4ComptonScattering::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4NuclearStopping::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), and G4PolarizedPhotoElectricEffect::InitialiseProcess().

void G4VEmProcess::SetIntegral ( G4bool  val)
inline

Definition at line 627 of file G4VEmProcess.hh.

References integral.

Referenced by G4CoulombScattering::G4CoulombScattering(), G4eeToHadrons::G4eeToHadrons(), and G4eplusAnnihilation::G4eplusAnnihilation().

+ Here is the caller graph for this function:

void G4VEmProcess::SetLambdaBinning ( G4int  nbins)

Definition at line 1194 of file G4VEmProcess.cc.

References actBinning, n, nLambdaBins, and PrintWarning().

Referenced by G4GammaConversion::G4GammaConversion(), and G4PolarizedGammaConversion::G4PolarizedGammaConversion().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::SetMaxKinEnergy ( G4double  e)

Definition at line 1219 of file G4VEmProcess.cc.

References actMaxKinEnergy, G4Log(), G4lrint(), maxKinEnergy, minKinEnergy, nLambdaBins, PrintWarning(), and TeV.

Referenced by G4EmLowEPPhysics::ConstructProcess(), G4EmLivermorePolarizedPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmLivermorePhysics::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), and G4EmStandardPhysics_option4::ConstructProcess().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::SetMinKinEnergy ( G4double  e)
void G4VEmProcess::SetMinKinEnergyPrim ( G4double  e)

Definition at line 1231 of file G4VEmProcess.cc.

References G4EmParameters::MaxKinEnergy(), G4EmParameters::MinKinEnergy(), minKinEnergyPrim, PrintWarning(), and theParameters.

Referenced by G4ComptonScattering::G4ComptonScattering(), G4PhotoElectricEffect::G4PhotoElectricEffect(), G4PolarizedCompton::G4PolarizedCompton(), and G4RayleighScattering::G4RayleighScattering().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

void G4VEmProcess::SetParticle ( const G4ParticleDefinition p)
inlineprotected

Definition at line 655 of file G4VEmProcess.hh.

References currentParticle, and particle.

Referenced by G4eeToHadrons::InitialiseProcess(), and PreparePhysicsTable().

+ Here is the caller graph for this function:

void G4VEmProcess::SetSplineFlag ( G4bool  val)
inlineprotected

Definition at line 677 of file G4VEmProcess.hh.

References actSpline, and splineFlag.

Referenced by G4ComptonScattering::G4ComptonScattering(), G4PolarizedCompton::G4PolarizedCompton(), and G4RayleighScattering::G4RayleighScattering().

+ Here is the caller graph for this function:

void G4VEmProcess::SetStartFromNullFlag ( G4bool  val)
inlineprotected

Definition at line 670 of file G4VEmProcess.hh.

References startFromNull.

Referenced by G4ComptonScattering::G4ComptonScattering(), G4CoulombScattering::G4CoulombScattering(), G4eplusAnnihilation::G4eplusAnnihilation(), G4GammaConversion::G4GammaConversion(), G4PolarizedCompton::G4PolarizedCompton(), G4RayleighScattering::G4RayleighScattering(), and G4CoulombScattering::InitialiseProcess().

+ Here is the caller graph for this function:

void G4VEmProcess::StartTracking ( G4Track track)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 619 of file G4VEmProcess.cc.

References biasFlag, biasManager, currentParticle, DBL_MAX, G4Track::GetParentID(), G4Track::GetParticleDefinition(), mfpKinEnergy, G4EmBiasingManager::ResetForcedInteraction(), and G4VProcess::theNumberOfInteractionLengthLeft.

+ Here is the call graph for this function:

G4bool G4VEmProcess::StorePhysicsTable ( const G4ParticleDefinition part,
const G4String directory,
G4bool  ascii = false 
)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 873 of file G4VEmProcess.cc.

References G4cout, G4endl, G4VProcess::GetMasterProcess(), G4ParticleDefinition::GetParticleName(), G4VProcess::GetPhysicsTableFileName(), G4VProcess::GetProcessName(), G4InuclParticleNames::name(), particle, G4PhysicsTable::StorePhysicsTable(), theLambdaTable, and theLambdaTablePrim.

+ Here is the call graph for this function:

void G4VEmProcess::UpdateEmModel ( const G4String nam,
G4double  emin,
G4double  emax 
)

Definition at line 233 of file G4VEmProcess.cc.

References modelManager, and G4EmModelManager::UpdateEmModel().

+ Here is the call graph for this function:

Member Data Documentation

G4bool G4VEmProcess::actBinning
private

Definition at line 385 of file G4VEmProcess.hh.

Referenced by BuildLambdaTable(), G4VEmProcess(), and SetLambdaBinning().

G4bool G4VEmProcess::actMaxKinEnergy
private

Definition at line 384 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PreparePhysicsTable(), and SetMaxKinEnergy().

G4bool G4VEmProcess::actMinKinEnergy
private

Definition at line 383 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PreparePhysicsTable(), and SetMinKinEnergy().

G4bool G4VEmProcess::actSpline
private

Definition at line 386 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PreparePhysicsTable(), and SetSplineFlag().

G4bool G4VEmProcess::applyCuts
private

Definition at line 380 of file G4VEmProcess.hh.

Referenced by PostStepDoIt(), PreparePhysicsTable(), and PrintInfoProcess().

G4int G4VEmProcess::augerID
private

Definition at line 420 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PostStepDoIt(), and PreparePhysicsTable().

size_t G4VEmProcess::basedCoupleIndex
private
const G4Material* G4VEmProcess::baseMaterial
private

Definition at line 404 of file G4VEmProcess.hh.

Referenced by ComputeCurrentLambda(), DefineMaterial(), and G4VEmProcess().

G4bool G4VEmProcess::biasFlag
private
G4int G4VEmProcess::biasID
private

Definition at line 421 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PostStepDoIt(), and PreparePhysicsTable().

const G4MaterialCutsCouple* G4VEmProcess::currentCouple
private

Definition at line 406 of file G4VEmProcess.hh.

Referenced by Clear(), DefineMaterial(), PostStepDoIt(), and SelectModel().

const G4Material* G4VEmProcess::currentMaterial
private

Definition at line 405 of file G4VEmProcess.hh.

Referenced by CrossSectionPerVolume(), DefineMaterial(), and G4VEmProcess().

const G4ParticleDefinition* G4VEmProcess::currentParticle
private
std::vector<G4VEmModel*> G4VEmProcess::emModels
private

Definition at line 352 of file G4VEmProcess.hh.

Referenced by EmModel(), and SetEmModel().

G4int G4VEmProcess::fluoID
private

Definition at line 419 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PostStepDoIt(), and PreparePhysicsTable().

G4ParticleChangeForGamma G4VEmProcess::fParticleChange
protected
size_t G4VEmProcess::idxLambda
private

Definition at line 361 of file G4VEmProcess.hh.

Referenced by Clear(), DefineMaterial(), G4VEmProcess(), and GetLambdaFromTable().

size_t G4VEmProcess::idxLambdaPrim
private

Definition at line 362 of file G4VEmProcess.hh.

Referenced by Clear(), DefineMaterial(), G4VEmProcess(), and GetLambdaFromTablePrim().

G4bool G4VEmProcess::integral
private
G4double G4VEmProcess::lambdaFactor
private

Definition at line 376 of file G4VEmProcess.hh.

Referenced by ComputeIntegralLambda(), G4VEmProcess(), and PreparePhysicsTable().

G4LossTableManager* G4VEmProcess::lManager
private
G4int G4VEmProcess::mainSecondaries
private

Definition at line 417 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), and PostStepDoIt().

G4int G4VEmProcess::nLambdaBins
private
G4int G4VEmProcess::numberOfModels
private

Definition at line 353 of file G4VEmProcess.hh.

Referenced by BuildPhysicsTable(), PreparePhysicsTable(), and SelectModel().

G4double G4VEmProcess::preStepKinEnergy
private

Definition at line 411 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), and PostStepGetPhysicalInteractionLength().

G4double G4VEmProcess::preStepLambda
private
G4int G4VEmProcess::secID
private

Definition at line 418 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PostStepDoIt(), and PreparePhysicsTable().

const G4ParticleDefinition* G4VEmProcess::secondaryParticle
private
std::vector<G4DynamicParticle*> G4VEmProcess::secParticles
private

Definition at line 396 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), and PostStepDoIt().

G4bool G4VEmProcess::splineFlag
private
G4bool G4VEmProcess::startFromNull
private

Definition at line 381 of file G4VEmProcess.hh.

Referenced by BuildLambdaTable(), and SetStartFromNullFlag().

std::vector<G4double> G4VEmProcess::theCrossSectionMax
private

Definition at line 359 of file G4VEmProcess.hh.

Referenced by ComputeIntegralLambda(), FindLambdaMax(), and PreparePhysicsTable().

const std::vector<G4double>* G4VEmProcess::theCuts
private
const std::vector<G4double>* G4VEmProcess::theCutsElectron
private
const std::vector<G4double>* G4VEmProcess::theCutsGamma
private
const std::vector<G4double>* G4VEmProcess::theCutsPositron
private

Definition at line 367 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), PostStepDoIt(), and PreparePhysicsTable().

const std::vector<G4double>* G4VEmProcess::theDensityFactor
private

Definition at line 368 of file G4VEmProcess.hh.

Referenced by BuildPhysicsTable().

const std::vector<G4int>* G4VEmProcess::theDensityIdx
private

Definition at line 369 of file G4VEmProcess.hh.

Referenced by BuildPhysicsTable().

const G4ParticleDefinition* G4VEmProcess::theElectron
private

Definition at line 344 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), and PostStepDoIt().

std::vector<G4double> G4VEmProcess::theEnergyOfCrossSectionMax
private

Definition at line 358 of file G4VEmProcess.hh.

Referenced by ComputeIntegralLambda(), FindLambdaMax(), and PreparePhysicsTable().

const G4ParticleDefinition* G4VEmProcess::theGamma
private

Definition at line 343 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), and PostStepDoIt().

const G4ParticleDefinition* G4VEmProcess::thePositron
private

Definition at line 345 of file G4VEmProcess.hh.

Referenced by G4VEmProcess(), and PostStepDoIt().

G4bool G4VEmProcess::weightFlag
private

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