Geant4 11.3.0
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4VEmProcess Class Referenceabstract

#include <G4VEmProcess.hh>

+ Inheritance diagram for G4VEmProcess:

Public Member Functions

 G4VEmProcess (const G4String &name, G4ProcessType type=fElectromagnetic)
 
 ~G4VEmProcess () override
 
void ProcessDescription (std::ostream &outFile) const override
 
void PreparePhysicsTable (const G4ParticleDefinition &) override
 
void BuildPhysicsTable (const G4ParticleDefinition &) override
 
void StartTracking (G4Track *) override
 
G4double PostStepGetPhysicalInteractionLength (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
 
G4VParticleChangePostStepDoIt (const G4Track &, const G4Step &) override
 
G4bool StorePhysicsTable (const G4ParticleDefinition *, const G4String &directory, G4bool ascii=false) override
 
G4bool RetrievePhysicsTable (const G4ParticleDefinition *, const G4String &directory, G4bool ascii) override
 
virtual G4VEmProcessGetEmProcess (const G4String &name)
 
G4double GetLambda (G4double kinEnergy, const G4MaterialCutsCouple *couple, G4double logKinEnergy)
 
G4double GetCrossSection (const G4double kinEnergy, const G4MaterialCutsCouple *couple) override
 
G4double ComputeCrossSectionPerAtom (G4double kineticEnergy, G4double Z, G4double A=0., G4double cut=0.0)
 
G4double MeanFreePath (const G4Track &track)
 
void SetLambdaBinning (G4int nbins)
 
void SetMinKinEnergy (G4double e)
 
void SetMinKinEnergyPrim (G4double e)
 
void SetMaxKinEnergy (G4double e)
 
G4PhysicsTableLambdaTable () const
 
G4PhysicsTableLambdaTablePrim () const
 
void SetLambdaTable (G4PhysicsTable *)
 
void SetLambdaTablePrim (G4PhysicsTable *)
 
std::vector< G4double > * EnergyOfCrossSectionMax () const
 
void SetEnergyOfCrossSectionMax (std::vector< G4double > *)
 
G4CrossSectionType CrossSectionType () const
 
void SetCrossSectionType (G4CrossSectionType val)
 
const G4ParticleDefinitionParticle () const
 
const G4ParticleDefinitionSecondaryParticle () const
 
G4VEmModelSelectModelForMaterial (G4double kinEnergy, std::size_t idxCouple) const
 
void AddEmModel (G4int, G4VEmModel *, const G4Region *region=nullptr)
 
void SetEmModel (G4VEmModel *, G4int index=0)
 
G4int NumberOfModels () const
 
G4VEmModelEmModel (std::size_t index=0) const
 
const G4VEmModelGetCurrentModel () const
 
G4VEmModelGetModelByIndex (G4int idx=0, G4bool ver=false) 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 SetEmMasterProcess (const G4VEmProcess *)
 
void SetBuildTableFlag (G4bool val)
 
void CurrentSetup (const G4MaterialCutsCouple *, G4double energy)
 
G4bool UseBaseMaterial () const
 
void BuildLambdaTable ()
 
void StreamInfo (std::ostream &outFile, const G4ParticleDefinition &, G4bool rst=false) const
 
 G4VEmProcess (G4VEmProcess &)=delete
 
G4VEmProcessoperator= (const G4VEmProcess &right)=delete
 
- Public Member Functions inherited from G4VDiscreteProcess
 G4VDiscreteProcess (const G4String &aName, G4ProcessType aType=fNotDefined)
 
 G4VDiscreteProcess (G4VDiscreteProcess &)
 
virtual ~G4VDiscreteProcess ()
 
G4VDiscreteProcessoperator= (const G4VDiscreteProcess &)=delete
 
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 &)
 
virtual G4double MinPrimaryEnergy (const G4ParticleDefinition *, const G4Material *)
 
- Public Member Functions inherited from G4VProcess
 G4VProcess (const G4String &aName="NoName", G4ProcessType aType=fNotDefined)
 
 G4VProcess (const G4VProcess &right)
 
virtual ~G4VProcess ()
 
G4VProcessoperator= (const G4VProcess &)=delete
 
G4bool operator== (const G4VProcess &right) const
 
G4bool 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)
 
virtual G4bool IsApplicable (const G4ParticleDefinition &)
 
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 const G4VProcessGetCreatorProcess () const
 
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 StreamProcessInfo (std::ostream &) const
 
virtual void InitialiseProcess (const G4ParticleDefinition *)=0
 
G4VEmModelSelectModel (G4double kinEnergy, std::size_t)
 
G4double GetMeanFreePath (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
 
G4PhysicsVectorLambdaPhysicsVector (const G4MaterialCutsCouple *)
 
void DefineMaterial (const G4MaterialCutsCouple *couple)
 
G4int LambdaBinning () const
 
G4double MinKinEnergy () const
 
G4double MaxKinEnergy () const
 
G4double PolarAngleLimit () const
 
G4ParticleChangeForGammaGetParticleChange ()
 
void SetParticle (const G4ParticleDefinition *p)
 
void SetSecondaryParticle (const G4ParticleDefinition *p)
 
std::size_t CurrentMaterialCutsCoupleIndex () const
 
const G4MaterialCutsCoupleMaterialCutsCouple () const
 
G4bool ApplyCuts () const
 
G4double GetGammaEnergyCut ()
 
G4double GetElectronEnergyCut ()
 
void SetStartFromNullFlag (G4bool val)
 
void SetSplineFlag (G4bool val)
 
const G4ElementGetTargetElement () const
 
const G4IsotopeGetTargetIsotope () const
 
G4int DensityIndex (G4int idx) const
 
G4double DensityFactor (G4int idx) const
 
- Protected Member Functions inherited from G4VProcess
void SubtractNumberOfInteractionLengthLeft (G4double prevStepSize)
 
void ClearNumberOfInteractionLengthLeft ()
 

Protected Attributes

const G4MaterialCutsCouplecurrentCouple = nullptr
 
const G4MaterialcurrentMaterial = nullptr
 
G4EmBiasingManagerbiasManager = nullptr
 
std::vector< G4double > * theEnergyOfCrossSectionMax = nullptr
 
G4double mfpKinEnergy = DBL_MAX
 
G4double preStepKinEnergy = 0.0
 
G4double preStepLambda = 0.0
 
G4int mainSecondaries = 1
 
G4int secID = _EM
 
G4int fluoID = _Fluorescence
 
G4int augerID = _AugerElectron
 
G4int biasID = _EM
 
G4int tripletID = _TripletElectron
 
std::size_t currentCoupleIndex = 0
 
std::size_t basedCoupleIndex = 0
 
std::size_t coupleIdxLambda = 0
 
std::size_t idxLambda = 0
 
G4bool isTheMaster = false
 
G4bool baseMat = false
 
std::vector< G4DynamicParticle * > secParticles
 
G4ParticleChangeForGamma fParticleChange
 
- Protected Attributes inherited from G4VProcess
const G4ProcessManageraProcessManager = nullptr
 
G4VParticleChangepParticleChange = nullptr
 
G4ParticleChange aParticleChange
 
G4double theNumberOfInteractionLengthLeft = -1.0
 
G4double currentInteractionLength = -1.0
 
G4double theInitialNumberOfInteractionLength = -1.0
 
G4String theProcessName
 
G4String thePhysicsTableFileName
 
G4ProcessType theProcessType = fNotDefined
 
G4int theProcessSubType = -1
 
G4double thePILfactor = 1.0
 
G4int verboseLevel = 0
 
G4bool enableAtRestDoIt = true
 
G4bool enableAlongStepDoIt = true
 
G4bool enablePostStepDoIt = true
 

Additional Inherited Members

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

Detailed Description

Definition at line 76 of file G4VEmProcess.hh.

Constructor & Destructor Documentation

◆ G4VEmProcess() [1/2]

G4VEmProcess::G4VEmProcess ( const G4String & name,
G4ProcessType type = fElectromagnetic )

Definition at line 79 of file G4VEmProcess.cc.

79 :
80 G4VDiscreteProcess(name, type)
81{
82 theParameters = G4EmParameters::Instance();
84
85 // Size of tables
86 minKinEnergy = 0.1*CLHEP::keV;
87 maxKinEnergy = 100.0*CLHEP::TeV;
88
89 // default lambda factor
90 invLambdaFactor = 1.0/lambdaFactor;
91
92 // particle types
93 theGamma = G4Gamma::Gamma();
94 theElectron = G4Electron::Electron();
95 thePositron = G4Positron::Positron();
96
98 fParticleChange.SetSecondaryWeightByProcess(true);
99 secParticles.reserve(5);
100
101 modelManager = new G4EmModelManager();
102 lManager = G4LossTableManager::Instance();
103 lManager->Register(this);
104 isTheMaster = lManager->IsMaster();
105 G4LossTableBuilder* bld = lManager->GetTableBuilder();
106 theDensityFactor = bld->GetDensityFactors();
107 theDensityIdx = bld->GetCoupleIndexes();
108}
static G4Electron * Electron()
Definition G4Electron.cc:91
static G4EmParameters * Instance()
static G4Gamma * Gamma()
Definition G4Gamma.cc:81
static const std::vector< G4double > * GetDensityFactors()
static const std::vector< G4int > * GetCoupleIndexes()
static G4LossTableManager * Instance()
static G4Positron * Positron()
Definition G4Positron.cc:90
G4VDiscreteProcess(const G4String &aName, G4ProcessType aType=fNotDefined)
std::vector< G4DynamicParticle * > secParticles
G4ParticleChangeForGamma fParticleChange
void SetVerboseLevel(G4int value)
G4VParticleChange * pParticleChange

Referenced by G4GammaGeneralProcess::AddEmProcess(), BuildPhysicsTable(), G4ComptonScattering::G4ComptonScattering(), G4CoulombScattering::G4CoulombScattering(), G4DNAAttachment::G4DNAAttachment(), G4DNAChargeDecrease::G4DNAChargeDecrease(), G4DNAChargeIncrease::G4DNAChargeIncrease(), G4DNADissociation::G4DNADissociation(), G4DNADoubleIonisation::G4DNADoubleIonisation(), G4DNAElastic::G4DNAElastic(), G4DNAElectronSolvation::G4DNAElectronSolvation(), G4DNAExcitation::G4DNAExcitation(), G4DNAIonisation::G4DNAIonisation(), G4DNAPlasmonExcitation::G4DNAPlasmonExcitation(), G4DNAPositronium::G4DNAPositronium(), G4DNAQuadrupleIonisation::G4DNAQuadrupleIonisation(), G4DNARotExcitation::G4DNARotExcitation(), G4DNATripleIonisation::G4DNATripleIonisation(), G4DNAVibExcitation::G4DNAVibExcitation(), G4eeToHadrons::G4eeToHadrons(), G4eplusAnnihilation::G4eplusAnnihilation(), G4GammaConversion::G4GammaConversion(), G4GammaGeneralProcess::G4GammaGeneralProcess(), G4JAEAElasticScattering::G4JAEAElasticScattering(), G4MicroElecElastic::G4MicroElecElastic(), G4MicroElecInelastic::G4MicroElecInelastic(), G4MicroElecLOPhononScattering::G4MicroElecLOPhononScattering(), G4NuclearStopping::G4NuclearStopping(), G4PhotoElectricEffect::G4PhotoElectricEffect(), G4PolarizedCompton::G4PolarizedCompton(), G4PolarizedGammaConversion::G4PolarizedGammaConversion(), G4PolarizedPhotoElectric::G4PolarizedPhotoElectric(), G4RayleighScattering::G4RayleighScattering(), G4VEmProcess(), G4GammaGeneralProcess::GetEmProcess(), GetEmProcess(), InitialiseProcess(), G4GammaGeneralProcess::operator=(), operator=(), G4GammaGeneralProcess::SelectEmProcess(), and SetEmMasterProcess().

◆ ~G4VEmProcess()

G4VEmProcess::~G4VEmProcess ( )
override

Definition at line 112 of file G4VEmProcess.cc.

113{
114 if(isTheMaster) {
115 delete theData;
117 }
118 delete modelManager;
119 delete biasManager;
120 lManager->DeRegister(this);
121}
G4EmBiasingManager * biasManager
std::vector< G4double > * theEnergyOfCrossSectionMax

◆ G4VEmProcess() [2/2]

G4VEmProcess::G4VEmProcess ( G4VEmProcess & )
delete

Member Function Documentation

◆ ActivateForcedInteraction()

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

Definition at line 770 of file G4VEmProcess.cc.

772{
773 if(nullptr == biasManager) { biasManager = new G4EmBiasingManager(); }
774 if(1 < verboseLevel) {
775 G4cout << "### ActivateForcedInteraction: for "
776 << particle->GetParticleName()
777 << " and process " << GetProcessName()
778 << " length(mm)= " << length/mm
779 << " in G4Region <" << r
780 << "> weightFlag= " << flag
781 << G4endl;
782 }
783 weightFlag = flag;
784 biasManager->ActivateForcedInteraction(length, r);
785}
#define G4endl
Definition G4ios.hh:67
G4GLOB_DLL std::ostream G4cout
G4int verboseLevel
const G4String & GetProcessName() const

Referenced by G4EmExtraParameters::DefineRegParamForEM().

◆ ActivateSecondaryBiasing()

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

Definition at line 790 of file G4VEmProcess.cc.

793{
794 if (0.0 <= factor) {
795
796 // Range cut can be applied only for e-
797 if(0.0 == factor && secondaryParticle != G4Electron::Electron())
798 { return; }
799
800 if(!biasManager) { biasManager = new G4EmBiasingManager(); }
801 biasManager->ActivateSecondaryBiasing(region, factor, energyLimit);
802 if(1 < verboseLevel) {
803 G4cout << "### ActivateSecondaryBiasing: for "
804 << " process " << GetProcessName()
805 << " factor= " << factor
806 << " in G4Region <" << region
807 << "> energyLimit(MeV)= " << energyLimit/MeV
808 << G4endl;
809 }
810 }
811}

Referenced by G4EmExtraParameters::DefineRegParamForEM().

◆ AddEmModel()

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

Definition at line 125 of file G4VEmProcess.cc.

127{
128 if(nullptr == ptr) { return; }
129 G4VEmFluctuationModel* fm = nullptr;
130 modelManager->AddEmModel(order, ptr, fm, region);
132}
void SetParticleChange(G4VParticleChange *, G4VEmFluctuationModel *f=nullptr)

Referenced by G4EmDNABuilder::ConstructDNAElectronPhysics(), LBE::ConstructEM(), G4EmLivermorePhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4ComptonScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNADoubleIonisation::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAElectronSolvation::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAPlasmonExcitation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNAQuadrupleIonisation::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNATripleIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4eeToHadrons::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4JAEAElasticScattering::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4MicroElecLOPhononScattering::InitialiseProcess(), G4NuclearStopping::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4PolarizedPhotoElectric::InitialiseProcess(), G4RayleighScattering::InitialiseProcess(), and G4EmConfigurator::PrepareModels().

◆ ApplyCuts()

G4bool G4VEmProcess::ApplyCuts ( ) const
inlineprotected

Definition at line 613 of file G4VEmProcess.hh.

614{
615 return applyCuts;
616}

◆ BuildLambdaTable()

void G4VEmProcess::BuildLambdaTable ( )

Definition at line 246 of file G4VEmProcess.cc.

247{
248 G4double scale = theParameters->MaxKinEnergy()/theParameters->MinKinEnergy();
249 G4int nbin =
250 theParameters->NumberOfBinsPerDecade()*G4lrint(std::log10(scale));
251 if(actBinning) { nbin = std::max(nbin, nLambdaBins); }
252 scale = nbin/G4Log(scale);
253
254 G4LossTableBuilder* bld = lManager->GetTableBuilder();
255 G4EmTableUtil::BuildLambdaTable(this, particle, modelManager,
256 bld, theLambdaTable, theLambdaTablePrim,
257 minKinEnergy, minKinEnergyPrim,
258 maxKinEnergy, scale, verboseLevel,
259 startFromNull, splineFlag);
260}
G4double G4Log(G4double x)
Definition G4Log.hh:227
double G4double
Definition G4Types.hh:83
int G4int
Definition G4Types.hh:85
static void BuildLambdaTable(G4VEmProcess *proc, const G4ParticleDefinition *part, G4EmModelManager *modelManager, G4LossTableBuilder *bld, G4PhysicsTable *theLambdaTable, G4PhysicsTable *theLambdaTablePrim, const G4double minKinEnergy, const G4double minKinEnergyPrim, const G4double maxKinEnergy, const G4double scale, const G4int verbose, const G4bool startFromNull, const G4bool splineFlag)
int G4lrint(double ad)
Definition templates.hh:134

Referenced by G4EmTableUtil::BuildEmProcess().

◆ BuildPhysicsTable()

void G4VEmProcess::BuildPhysicsTable ( const G4ParticleDefinition & part)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 229 of file G4VEmProcess.cc.

230{
231 if(nullptr == masterProc) {
232 if(isTheMaster) { masterProc = this; }
233 else { masterProc = static_cast<const G4VEmProcess*>(GetMasterProcess());}
234 }
235 G4int nModels = modelManager->NumberOfModels();
236 G4bool isLocked = theParameters->IsPrintLocked();
237 G4bool toBuild = (buildLambdaTable || minKinEnergyPrim < maxKinEnergy);
238
239 G4EmTableUtil::BuildEmProcess(this, masterProc, particle, &part,
240 nModels, verboseLevel, isTheMaster,
241 isLocked, toBuild, baseMat);
242}
bool G4bool
Definition G4Types.hh:86
static void BuildEmProcess(G4VEmProcess *proc, const G4VEmProcess *masterProc, const G4ParticleDefinition *firstPart, const G4ParticleDefinition *part, const G4int nModels, const G4int verb, const G4bool master, const G4bool isLocked, const G4bool toBuild, G4bool &baseMat)
G4VEmProcess(const G4String &name, G4ProcessType type=fElectromagnetic)
const G4VProcess * GetMasterProcess() const

Referenced by G4PolarizedAnnihilation::BuildPhysicsTable(), and G4PolarizedCompton::BuildPhysicsTable().

◆ ComputeCrossSectionPerAtom()

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

Definition at line 706 of file G4VEmProcess.cc.

708{
710 return (currentModel) ?
711 currentModel->ComputeCrossSectionPerAtom(currentParticle, kinEnergy,
712 Z, A, cut) : 0.0;
713}
const G4double A[17]
std::size_t currentCoupleIndex
G4VEmModel * SelectModel(G4double kinEnergy, std::size_t)

◆ CrossSectionBiasingFactor()

G4double G4VEmProcess::CrossSectionBiasingFactor ( ) const
inline

Definition at line 641 of file G4VEmProcess.hh.

642{
643 return biasFactor;
644}

◆ CrossSectionType()

G4CrossSectionType G4VEmProcess::CrossSectionType ( ) const
inline

Definition at line 712 of file G4VEmProcess.hh.

713{
714 return fXSType;
715}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ CurrentMaterialCutsCoupleIndex()

std::size_t G4VEmProcess::CurrentMaterialCutsCoupleIndex ( ) const
inlineprotected

Definition at line 443 of file G4VEmProcess.hh.

444{
445 return currentCoupleIndex;
446}

◆ CurrentSetup()

void G4VEmProcess::CurrentSetup ( const G4MaterialCutsCouple * couple,
G4double energy )
inline

Definition at line 584 of file G4VEmProcess.hh.

585{
586 DefineMaterial(couple);
587 SelectModel(energy*massRatio, currentCoupleIndex);
588}
void DefineMaterial(const G4MaterialCutsCouple *couple)

Referenced by GetCrossSection(), GetLambda(), MeanFreePath(), and G4GammaGeneralProcess::SelectEmProcess().

◆ DefineMaterial()

void G4VEmProcess::DefineMaterial ( const G4MaterialCutsCouple * couple)
inlineprotected

Definition at line 471 of file G4VEmProcess.hh.

472{
473 if (couple != currentCouple) {
474 currentCouple = couple;
475 baseMaterial = currentMaterial = couple->GetMaterial();
477 fFactor = biasFactor;
479 if (baseMat) {
480 basedCoupleIndex = (*theDensityIdx)[currentCoupleIndex];
481 if (nullptr != currentMaterial->GetBaseMaterial())
482 baseMaterial = currentMaterial->GetBaseMaterial();
483 fFactor *= (*theDensityFactor)[currentCoupleIndex];
484 }
485 }
486}
const G4Material * GetMaterial() const
G4double mfpKinEnergy
std::size_t basedCoupleIndex
const G4MaterialCutsCouple * currentCouple
const G4Material * currentMaterial
#define DBL_MAX
Definition templates.hh:62

Referenced by G4eplusAnnihilation::AtRestDoIt(), CurrentSetup(), LambdaPhysicsVector(), and PostStepGetPhysicalInteractionLength().

◆ DensityFactor()

G4double G4VEmProcess::DensityFactor ( G4int idx) const
inlineprotected

Definition at line 769 of file G4VEmProcess.hh.

770{
771 return (*theDensityFactor)[idx];
772}

Referenced by G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength().

◆ DensityIndex()

G4int G4VEmProcess::DensityIndex ( G4int idx) const
inlineprotected

Definition at line 762 of file G4VEmProcess.hh.

763{
764 return (*theDensityIdx)[idx];
765}

Referenced by G4GammaGeneralProcess::BuildPhysicsTable(), and G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength().

◆ EmModel()

G4VEmModel * G4VEmProcess::EmModel ( std::size_t index = 0) const
inline

Definition at line 804 of file G4VEmProcess.hh.

805{
806 return (index < emModels.size()) ? emModels[index] : nullptr;
807}

Referenced by G4eplusAnnihilation::AtRestDoIt(), G4EmCalculator::ComputeNuclearDEDX(), G4EmDNAChemistry::ConstructProcess(), G4EmDNAChemistry_option1::ConstructProcess(), G4EmDNAChemistry_option2::ConstructProcess(), G4EmDNAChemistry_option3::ConstructProcess(), G4ComptonScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNADoubleIonisation::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAElectronSolvation::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAPlasmonExcitation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNAQuadrupleIonisation::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNATripleIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4JAEAElasticScattering::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4MicroElecLOPhononScattering::InitialiseProcess(), G4NuclearStopping::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4PolarizedPhotoElectric::InitialiseProcess(), G4RayleighScattering::InitialiseProcess(), G4DNAAttachment::PrintInfo(), G4DNADissociation::PrintInfo(), G4DNADoubleIonisation::PrintInfo(), G4DNAElastic::PrintInfo(), G4DNAIonisation::PrintInfo(), G4DNAPlasmonExcitation::PrintInfo(), G4DNAPositronium::PrintInfo(), G4DNAQuadrupleIonisation::PrintInfo(), G4DNATripleIonisation::PrintInfo(), G4DNAChargeDecrease::ProcessDescription(), and G4DNAChargeIncrease::ProcessDescription().

◆ EnergyOfCrossSectionMax()

std::vector< G4double > * G4VEmProcess::EnergyOfCrossSectionMax ( ) const
inline

Definition at line 676 of file G4VEmProcess.hh.

677{
679}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ GetCrossSection()

G4double G4VEmProcess::GetCrossSection ( const G4double kinEnergy,
const G4MaterialCutsCouple * couple )
overridevirtual

Reimplemented from G4VDiscreteProcess.

Definition at line 686 of file G4VEmProcess.cc.

688{
689 CurrentSetup(couple, kinEnergy);
690 return GetCurrentLambda(kinEnergy, G4Log(kinEnergy));
691}
void CurrentSetup(const G4MaterialCutsCouple *, G4double energy)

Referenced by G4EmCalculator::GetCrossSectionPerVolume().

◆ GetCurrentElement()

const G4Element * G4VEmProcess::GetCurrentElement ( ) const

Definition at line 728 of file G4VEmProcess.cc.

729{
730 return (nullptr != currentModel) ?
731 currentModel->GetCurrentElement(currentMaterial) : nullptr;
732}

Referenced by GetTargetIsotope().

◆ GetCurrentModel()

const G4VEmModel * G4VEmProcess::GetCurrentModel ( ) const
inline

Definition at line 783 of file G4VEmProcess.hh.

784{
785 return currentModel;
786}

◆ GetElectronEnergyCut()

G4double G4VEmProcess::GetElectronEnergyCut ( )
inlineprotected

Definition at line 464 of file G4VEmProcess.hh.

465{
466 return (*theCutsElectron)[currentCoupleIndex];
467}

◆ GetEmProcess()

G4VEmProcess * G4VEmProcess::GetEmProcess ( const G4String & name)
virtual

Reimplemented in G4GammaGeneralProcess.

Definition at line 861 of file G4VEmProcess.cc.

862{
863 return (nam == GetProcessName()) ? this : nullptr;
864}

◆ GetGammaEnergyCut()

G4double G4VEmProcess::GetGammaEnergyCut ( )
inlineprotected

Definition at line 457 of file G4VEmProcess.hh.

458{
459 return (*theCutsGamma)[currentCoupleIndex];
460}

Referenced by G4eplusAnnihilation::AtRestDoIt().

◆ GetLambda()

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

Definition at line 593 of file G4VEmProcess.hh.

595{
596 CurrentSetup(couple, kinEnergy);
597 return GetCurrentLambda(kinEnergy, logKinEnergy);
598}

◆ GetMeanFreePath()

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

Implements G4VDiscreteProcess.

Definition at line 695 of file G4VEmProcess.cc.

698{
700 return G4VEmProcess::MeanFreePath(track);
701}
G4double condition(const G4ErrorSymMatrix &m)
@ NotForced
G4double MeanFreePath(const G4Track &track)

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

◆ GetModelByIndex()

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

Definition at line 811 of file G4VEmProcess.hh.

812{
813 return modelManager->GetModel(idx, ver);
814}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ GetParticleChange()

G4ParticleChangeForGamma * G4VEmProcess::GetParticleChange ( )
inlineprotected

Definition at line 726 of file G4VEmProcess.hh.

727{
728 return &fParticleChange;
729}

◆ GetTargetElement()

const G4Element * G4VEmProcess::GetTargetElement ( ) const
protected

Definition at line 736 of file G4VEmProcess.cc.

737{
738 return (nullptr != currentModel) ?
739 currentModel->GetCurrentElement(currentMaterial) : nullptr;
740}

◆ GetTargetIsotope()

const G4Isotope * G4VEmProcess::GetTargetIsotope ( ) const
protected

Definition at line 744 of file G4VEmProcess.cc.

745{
746 return (nullptr != currentModel) ?
747 currentModel->GetCurrentIsotope(GetCurrentElement()) : nullptr;
748}
const G4Element * GetCurrentElement() const

◆ InitialiseProcess()

◆ LambdaBinning()

G4int G4VEmProcess::LambdaBinning ( ) const
inlineprotected

Definition at line 620 of file G4VEmProcess.hh.

621{
622 return nLambdaBins;
623}

◆ LambdaPhysicsVector()

G4PhysicsVector * G4VEmProcess::LambdaPhysicsVector ( const G4MaterialCutsCouple * couple)
protected

Definition at line 718 of file G4VEmProcess.cc.

719{
720 DefineMaterial(couple);
721 G4PhysicsVector* newv = new G4PhysicsLogVector(minKinEnergy, maxKinEnergy,
722 nLambdaBins, splineFlag);
723 return newv;
724}

◆ LambdaTable()

G4PhysicsTable * G4VEmProcess::LambdaTable ( ) const
inline

Definition at line 648 of file G4VEmProcess.hh.

649{
650 return theLambdaTable;
651}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ LambdaTablePrim()

G4PhysicsTable * G4VEmProcess::LambdaTablePrim ( ) const
inline

Definition at line 655 of file G4VEmProcess.hh.

656{
657 return theLambdaTablePrim;
658}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ MaterialCutsCouple()

const G4MaterialCutsCouple * G4VEmProcess::MaterialCutsCouple ( ) const
inlineprotected

Definition at line 450 of file G4VEmProcess.hh.

451{
452 return currentCouple;
453}

◆ MaxKinEnergy()

G4double G4VEmProcess::MaxKinEnergy ( ) const
inlineprotected

Definition at line 634 of file G4VEmProcess.hh.

635{
636 return maxKinEnergy;
637}

Referenced by G4eplusAnnihilation::InitialiseProcess(), and SetMinKinEnergyPrim().

◆ MeanFreePath()

G4double G4VEmProcess::MeanFreePath ( const G4Track & track)
inline

Definition at line 602 of file G4VEmProcess.hh.

603{
604 const G4double kinEnergy = track.GetKineticEnergy();
605 CurrentSetup(track.GetMaterialCutsCouple(), kinEnergy);
606 const G4double xs = GetCurrentLambda(kinEnergy,
608 return (0.0 < xs) ? 1.0/xs : DBL_MAX;
609}
G4double GetLogKineticEnergy() const
const G4DynamicParticle * GetDynamicParticle() const
G4double GetKineticEnergy() const
const G4MaterialCutsCouple * GetMaterialCutsCouple() const

Referenced by G4GammaGeneralProcess::GetMeanFreePath(), and GetMeanFreePath().

◆ MinKinEnergy()

G4double G4VEmProcess::MinKinEnergy ( ) const
inlineprotected

Definition at line 627 of file G4VEmProcess.hh.

628{
629 return minKinEnergy;
630}

Referenced by G4eplusAnnihilation::InitialiseProcess().

◆ NumberOfModels()

G4int G4VEmProcess::NumberOfModels ( ) const
inline

Definition at line 797 of file G4VEmProcess.hh.

798{
799 return numberOfModels;
800}

◆ operator=()

G4VEmProcess & G4VEmProcess::operator= ( const G4VEmProcess & right)
delete

◆ Particle()

const G4ParticleDefinition * G4VEmProcess::Particle ( ) const
inline

Definition at line 691 of file G4VEmProcess.hh.

692{
693 return particle;
694}

◆ PolarAngleLimit()

G4double G4VEmProcess::PolarAngleLimit ( ) const
inlineprotected

Definition at line 868 of file G4VEmProcess.cc.

869{
870 return theParameters->MscThetaLimit();
871}

◆ PostStepDoIt()

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

Reimplemented from G4VDiscreteProcess.

Definition at line 466 of file G4VEmProcess.cc.

468{
469 // clear number of interaction lengths in any case
472
473 fParticleChange.InitializeForPostStep(track);
474
475 // Do not make anything if particle is stopped, the annihilation then
476 // should be performed by the AtRestDoIt!
477 if (track.GetTrackStatus() == fStopButAlive) { return &fParticleChange; }
478
479 const G4double finalT = track.GetKineticEnergy();
480
481 // forced process - should happen only once per track
482 if(biasFlag) {
483 if(biasManager->ForcedInteractionRegion((G4int)currentCoupleIndex)) {
484 biasFlag = false;
485 }
486 }
487
488 // check active and select model
489 const G4double scaledEnergy = finalT*massRatio;
490 SelectModel(scaledEnergy, currentCoupleIndex);
491 if(!currentModel->IsActive(scaledEnergy)) { return &fParticleChange; }
492
493 // Integral approach
494 if (fXSType != fEmNoIntegral) {
495 const G4double logFinalT =
497 const G4double lx = std::max(GetCurrentLambda(finalT, logFinalT), 0.0);
498#ifdef G4VERBOSE
499 if(preStepLambda < lx && 1 < verboseLevel) {
500 G4cout << "WARNING: for " << currentParticle->GetParticleName()
501 << " and " << GetProcessName() << " E(MeV)= " << finalT/MeV
502 << " preLambda= " << preStepLambda
503 << " < " << lx << " (postLambda) " << G4endl;
504 }
505#endif
506 // if false interaction then use new cross section value
507 // if both values are zero - no interaction
508 if(preStepLambda*G4UniformRand() >= lx) {
509 return &fParticleChange;
510 }
511 }
512
513 // define new weight for primary and secondaries
514 G4double weight = fParticleChange.GetParentWeight();
515 if(weightFlag) {
516 weight /= biasFactor;
517 fParticleChange.ProposeWeight(weight);
518 }
519
520#ifdef G4VERBOSE
521 if(1 < verboseLevel) {
522 G4cout << "G4VEmProcess::PostStepDoIt: Sample secondary; E= "
523 << finalT/MeV
524 << " MeV; model= (" << currentModel->LowEnergyLimit()
525 << ", " << currentModel->HighEnergyLimit() << ")"
526 << G4endl;
527 }
528#endif
529
530 // sample secondaries
531 secParticles.clear();
532 currentModel->SampleSecondaries(&secParticles,
534 track.GetDynamicParticle(),
535 (*theCuts)[currentCoupleIndex]);
536
537 G4int num0 = (G4int)secParticles.size();
538
539 // splitting or Russian roulette
540 if(biasManager) {
541 if(biasManager->SecondaryBiasingRegion((G4int)currentCoupleIndex)) {
542 G4double eloss = 0.0;
543 weight *= biasManager->ApplySecondaryBiasing(
544 secParticles, track, currentModel, &fParticleChange, eloss,
546 step.GetPostStepPoint()->GetSafety());
547 if(eloss > 0.0) {
548 eloss += fParticleChange.GetLocalEnergyDeposit();
549 fParticleChange.ProposeLocalEnergyDeposit(eloss);
550 }
551 }
552 }
553
554 // save secondaries
555 G4int num = (G4int)secParticles.size();
556 if(num > 0) {
557
558 fParticleChange.SetNumberOfSecondaries(num);
559 G4double edep = fParticleChange.GetLocalEnergyDeposit();
560 G4double time = track.GetGlobalTime();
561
562 G4int n1(0), n2(0);
563 if(num0 > mainSecondaries) {
564 currentModel->FillNumberOfSecondaries(n1, n2);
565 }
566
567 for (G4int i=0; i<num; ++i) {
568 G4DynamicParticle* dp = secParticles[i];
569 if (nullptr != dp) {
570 const G4ParticleDefinition* p = dp->GetParticleDefinition();
571 G4double e = dp->GetKineticEnergy();
572 G4bool good = true;
573 if(applyCuts) {
574 if (p == theGamma) {
575 if (e < (*theCutsGamma)[currentCoupleIndex]) { good = false; }
576
577 } else if (p == theElectron) {
578 if (e < (*theCutsElectron)[currentCoupleIndex]) { good = false; }
579
580 } else if (p == thePositron) {
581 if (electron_mass_c2 < (*theCutsGamma)[currentCoupleIndex] &&
582 e < (*theCutsPositron)[currentCoupleIndex]) {
583 good = false;
584 e += 2.0*electron_mass_c2;
585 }
586 }
587 // added secondary if it is good
588 }
589 if (good) {
590 G4Track* t = new G4Track(dp, time, track.GetPosition());
592 if (biasManager) {
593 t->SetWeight(weight * biasManager->GetWeight(i));
594 } else {
595 t->SetWeight(weight);
596 }
597 pParticleChange->AddSecondary(t);
598
599 // define type of secondary
600 if(i < mainSecondaries) {
602 if(GetProcessSubType() == fComptonScattering && p == theGamma) {
604 }
605 } else if(i < mainSecondaries + n1) {
607 } else if(i < mainSecondaries + n1 + n2) {
609 } else {
610 if(i < num0) {
611 if(p == theGamma) {
613 } else {
615 }
616 } else {
618 }
619 }
620 /*
621 G4cout << "Secondary(post step) has weight " << t->GetWeight()
622 << ", Ekin= " << t->GetKineticEnergy()/MeV << " MeV "
623 << GetProcessName() << " fluoID= " << fluoID
624 << " augerID= " << augerID <<G4endl;
625 */
626 } else {
627 delete dp;
628 edep += e;
629 }
630 }
631 }
632 fParticleChange.ProposeLocalEnergyDeposit(edep);
633 }
634
635 if(0.0 == fParticleChange.GetProposedKineticEnergy() &&
636 fAlive == fParticleChange.GetTrackStatus()) {
637 if(particle->GetProcessManager()->GetAtRestProcessVector()->size() > 0)
638 { fParticleChange.ProposeTrackStatus(fStopButAlive); }
639 else { fParticleChange.ProposeTrackStatus(fStopAndKill); }
640 }
641
642 return &fParticleChange;
643}
@ fComptonScattering
@ fEmNoIntegral
@ fAlive
@ fStopAndKill
@ fStopButAlive
#define G4UniformRand()
Definition Randomize.hh:52
const G4ParticleDefinition * GetParticleDefinition() const
G4double GetKineticEnergy() const
G4double GetSafety() const
G4StepPoint * GetPostStepPoint() const
G4TrackStatus GetTrackStatus() const
void SetWeight(G4double aValue)
const G4ThreeVector & GetPosition() const
void SetTouchableHandle(const G4TouchableHandle &apValue)
G4double GetGlobalTime() const
const G4TouchableHandle & GetTouchableHandle() const
void SetCreatorModelID(const G4int id)
G4int mainSecondaries
G4double preStepLambda
G4double theNumberOfInteractionLengthLeft
G4int GetProcessSubType() const

◆ PostStepGetPhysicalInteractionLength()

G4double G4VEmProcess::PostStepGetPhysicalInteractionLength ( const G4Track & track,
G4double previousStepSize,
G4ForceCondition * condition )
overridevirtual

Reimplemented from G4VDiscreteProcess.

Definition at line 360 of file G4VEmProcess.cc.

364{
366 G4double x = DBL_MAX;
367
370 const G4double scaledEnergy = preStepKinEnergy*massRatio;
371 SelectModel(scaledEnergy, currentCoupleIndex);
372 /*
373 G4cout << "PostStepGetPhysicalInteractionLength: idx= " << currentCoupleIndex
374 << " couple: " << currentCouple << G4endl;
375 */
376 if(!currentModel->IsActive(scaledEnergy)) {
380 preStepLambda = 0.0;
381 return x;
382 }
383
384 // forced biasing only for primary particles
385 if(biasManager) {
386 if(0 == track.GetParentID()) {
387 if(biasFlag &&
388 biasManager->ForcedInteractionRegion((G4int)currentCoupleIndex)) {
389 return biasManager->GetStepLimit((G4int)currentCoupleIndex, previousStepSize);
390 }
391 }
392 }
393
394 // compute mean free path
395
396 ComputeIntegralLambda(preStepKinEnergy, track);
397
398 // zero cross section
399 if(preStepLambda <= 0.0) {
402
403 } else {
404
405 // non-zero cross section
407
408 // beggining of tracking (or just after DoIt of this process)
411
412 } else {
413
415 previousStepSize/currentInteractionLength;
418 }
419
420 // new mean free path and step limit for the next step
423 }
424 return x;
425}
G4int GetParentID() const
G4double preStepKinEnergy
G4double currentInteractionLength
G4double theInitialNumberOfInteractionLength

Referenced by G4PolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), and G4PolarizedCompton::PostStepGetPhysicalInteractionLength().

◆ PreparePhysicsTable()

void G4VEmProcess::PreparePhysicsTable ( const G4ParticleDefinition & part)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 147 of file G4VEmProcess.cc.

148{
149 if(nullptr == particle) { SetParticle(&part); }
150
151 if(part.GetParticleType() == "nucleus" &&
152 part.GetParticleSubType() == "generic") {
153
154 G4String pname = part.GetParticleName();
155 if(pname != "deuteron" && pname != "triton" &&
156 pname != "He3" && pname != "alpha" && pname != "alpha+" &&
157 pname != "helium" && pname != "hydrogen") {
158
159 particle = G4GenericIon::GenericIon();
160 isIon = true;
161 }
162 }
163 if(particle != &part) { return; }
164
165 lManager->PreparePhysicsTable(&part, this);
166
167 // for new run
168 currentCouple = nullptr;
169 preStepLambda = 0.0;
170 fLambdaEnergy = 0.0;
171
172 InitialiseProcess(particle);
173
174 G4LossTableBuilder* bld = lManager->GetTableBuilder();
175 const G4ProductionCutsTable* theCoupleTable=
177 theCutsGamma = theCoupleTable->GetEnergyCutsVector(idxG4GammaCut);
178 theCutsElectron = theCoupleTable->GetEnergyCutsVector(idxG4ElectronCut);
179 theCutsPositron = theCoupleTable->GetEnergyCutsVector(idxG4PositronCut);
180
181 // initialisation of the process
182 if(!actMinKinEnergy) { minKinEnergy = theParameters->MinKinEnergy(); }
183 if(!actMaxKinEnergy) { maxKinEnergy = theParameters->MaxKinEnergy(); }
184
185 applyCuts = theParameters->ApplyCuts();
186 lambdaFactor = theParameters->LambdaFactor();
187 invLambdaFactor = 1.0/lambdaFactor;
188 theParameters->DefineRegParamForEM(this);
189
190 // integral option may be disabled
191 if(!theParameters->Integral()) { fXSType = fEmNoIntegral; }
192
193 // prepare tables
194 if(isTheMaster) {
195 if(nullptr == theData) { theData = new G4EmDataHandler(2); }
196
197 if(buildLambdaTable) {
198 theLambdaTable = theData->MakeTable(0);
199 bld->InitialiseBaseMaterials(theLambdaTable);
200 }
201 // high energy table
202 if(minKinEnergyPrim < maxKinEnergy) {
203 theLambdaTablePrim = theData->MakeTable(1);
204 bld->InitialiseBaseMaterials(theLambdaTablePrim);
205 }
206 }
207 // models
209 numberOfModels = modelManager->NumberOfModels();
210 currentModel = modelManager->GetModel(0);
211 if(nullptr != lManager->AtomDeexcitation()) {
212 modelManager->SetFluoFlag(true);
213 }
214 // forced biasing
215 if(nullptr != biasManager) {
216 biasManager->Initialise(part, GetProcessName(), verboseLevel);
217 biasFlag = false;
218 }
219
220 theCuts =
221 G4EmTableUtil::PrepareEmProcess(this, particle, secondaryParticle,
222 modelManager, maxKinEnergy,
225}
@ idxG4ElectronCut
@ idxG4GammaCut
@ idxG4PositronCut
static const G4DataVector * PrepareEmProcess(G4VEmProcess *proc, const G4ParticleDefinition *part, const G4ParticleDefinition *secPart, G4EmModelManager *modelManager, const G4double &maxKinEnergy, G4int &secID, G4int &tripletID, G4int &mainSec, const G4int &verb, const G4bool &master)
static G4GenericIon * GenericIon()
static G4bool GetBaseMaterialFlag()
void InitialiseBaseMaterials(const G4PhysicsTable *table=nullptr)
const G4String & GetParticleType() const
const G4String & GetParticleName() const
const G4String & GetParticleSubType() const
const std::vector< G4double > * GetEnergyCutsVector(std::size_t pcIdx) const
static G4ProductionCutsTable * GetProductionCutsTable()
virtual void InitialiseProcess(const G4ParticleDefinition *)=0
void SetParticle(const G4ParticleDefinition *p)

◆ ProcessDescription()

◆ RetrievePhysicsTable()

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

Reimplemented from G4VProcess.

Definition at line 665 of file G4VEmProcess.cc.

668{
669 if(!isTheMaster || part != particle) { return true; }
670 G4bool yes = true;
671 if(buildLambdaTable) {
672 yes = G4EmTableUtil::RetrieveTable(this, part, theLambdaTable, dir,
673 "Lambda", verboseLevel,
674 ascii, splineFlag);
675 }
676 if(yes && minKinEnergyPrim < maxKinEnergy) {
677 yes = G4EmTableUtil::RetrieveTable(this, part, theLambdaTablePrim, dir,
678 "LambdaPrim", verboseLevel,
679 ascii, splineFlag);
680 }
681 return yes;
682}
static G4bool RetrieveTable(G4VProcess *ptr, const G4ParticleDefinition *part, G4PhysicsTable *aTable, const G4String &dir, const G4String &tname, const G4int verb, const G4bool ascii, const G4bool spline)

◆ SecondaryParticle()

const G4ParticleDefinition * G4VEmProcess::SecondaryParticle ( ) const
inline

Definition at line 698 of file G4VEmProcess.hh.

699{
700 return secondaryParticle;
701}

◆ SelectModel()

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

Definition at line 491 of file G4VEmProcess.hh.

492{
493 if(1 < numberOfModels) {
494 currentModel = modelManager->SelectModel(kinEnergy, currentCoupleIndex);
495 }
496 currentModel->SetCurrentCouple(currentCouple);
497 return currentModel;
498}

Referenced by G4NuclearStopping::AlongStepDoIt(), ComputeCrossSectionPerAtom(), CurrentSetup(), PostStepDoIt(), and PostStepGetPhysicalInteractionLength().

◆ SelectModelForMaterial()

G4VEmModel * G4VEmProcess::SelectModelForMaterial ( G4double kinEnergy,
std::size_t idxCouple ) const
inline

Definition at line 503 of file G4VEmProcess.hh.

505{
506 return modelManager->SelectModel(kinEnergy, idxCouple);
507}

◆ SetBuildTableFlag()

void G4VEmProcess::SetBuildTableFlag ( G4bool val)
inline

◆ SetCrossSectionBiasingFactor()

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

Definition at line 752 of file G4VEmProcess.cc.

753{
754 if(f > 0.0) {
755 biasFactor = f;
756 weightFlag = flag;
757 if(1 < verboseLevel) {
758 G4cout << "### SetCrossSectionBiasingFactor: for "
759 << particle->GetParticleName()
760 << " and process " << GetProcessName()
761 << " biasFactor= " << f << " weightFlag= " << flag
762 << G4endl;
763 }
764 }
765}

Referenced by G4EmExtraParameters::DefineRegParamForEM().

◆ SetCrossSectionType()

◆ SetEmMasterProcess()

void G4VEmProcess::SetEmMasterProcess ( const G4VEmProcess * ptr)
inline

Definition at line 790 of file G4VEmProcess.hh.

791{
792 masterProc = ptr;
793}

◆ SetEmModel()

void G4VEmProcess::SetEmModel ( G4VEmModel * ptr,
G4int index = 0 )

Definition at line 136 of file G4VEmProcess.cc.

137{
138 if(nullptr == ptr) { return; }
139 if(!emModels.empty()) {
140 for(auto & em : emModels) { if(em == ptr) { return; } }
141 }
142 emModels.push_back(ptr);
143}

Referenced by G4EmBuilder::ConstructElectronSSProcess(), G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option1::ConstructProcess(), G4EmStandardPhysics_option2::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsGS::ConstructProcess(), G4EmStandardPhysicsSS::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), G4EmDNABuilder::FindOrBuildAttachment(), G4EmDNABuilder::FindOrBuildChargeDecrease(), G4EmDNABuilder::FindOrBuildChargeIncrease(), G4EmDNABuilder::FindOrBuildElastic(), G4EmDNABuilder::FindOrBuildElectronSolvation(), G4EmDNABuilder::FindOrBuildExcitation(), G4EmDNABuilder::FindOrBuildIonisation(), G4EmDNABuilder::FindOrBuildVibExcitation(), G4PolarizedAnnihilation::G4PolarizedAnnihilation(), G4ComptonScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNADoubleIonisation::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAElectronSolvation::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAPlasmonExcitation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNAQuadrupleIonisation::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNATripleIonisation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4eeToHadrons::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4JAEAElasticScattering::InitialiseProcess(), G4MicroElecElastic::InitialiseProcess(), G4MicroElecInelastic::InitialiseProcess(), G4MicroElecLOPhononScattering::InitialiseProcess(), G4NuclearStopping::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4PolarizedPhotoElectric::InitialiseProcess(), G4RayleighScattering::InitialiseProcess(), and G4EmTableUtil::PrepareEmProcess().

◆ SetEnergyOfCrossSectionMax()

void G4VEmProcess::SetEnergyOfCrossSectionMax ( std::vector< G4double > * ptr)
inline

Definition at line 684 of file G4VEmProcess.hh.

685{
687}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ SetLambdaBinning()

void G4VEmProcess::SetLambdaBinning ( G4int nbins)

Definition at line 815 of file G4VEmProcess.cc.

816{
817 if(5 < n && n < 10000000) {
818 nLambdaBins = n;
819 actBinning = true;
820 } else {
821 G4double e = (G4double)n;
822 PrintWarning("SetLambdaBinning", e);
823 }
824}

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

◆ SetLambdaTable()

void G4VEmProcess::SetLambdaTable ( G4PhysicsTable * ptr)
inline

Definition at line 662 of file G4VEmProcess.hh.

663{
664 theLambdaTable = ptr;
665}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ SetLambdaTablePrim()

void G4VEmProcess::SetLambdaTablePrim ( G4PhysicsTable * ptr)
inline

Definition at line 669 of file G4VEmProcess.hh.

670{
671 theLambdaTablePrim = ptr;
672}

Referenced by G4EmTableUtil::BuildEmProcess().

◆ SetMaxKinEnergy()

void G4VEmProcess::SetMaxKinEnergy ( G4double e)

Definition at line 840 of file G4VEmProcess.cc.

841{
842 if(minKinEnergy < e && e < 1.e+6*TeV) {
843 nLambdaBins = G4lrint(nLambdaBins*G4Log(e/minKinEnergy)
844 /G4Log(maxKinEnergy/minKinEnergy));
845 maxKinEnergy = e;
846 actMaxKinEnergy = true;
847 } else { PrintWarning("SetMaxKinEnergy", e); }
848}

Referenced by G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), and G4EmDNABuilder::FindOrBuildNuclearStopping().

◆ SetMinKinEnergy()

◆ SetMinKinEnergyPrim()

void G4VEmProcess::SetMinKinEnergyPrim ( G4double e)

Definition at line 852 of file G4VEmProcess.cc.

853{
854 if(theParameters->MinKinEnergy() <= e &&
855 e <= theParameters->MaxKinEnergy()) { minKinEnergyPrim = e; }
856 else { PrintWarning("SetMinKinEnergyPrim", e); }
857}
G4double MaxKinEnergy() const

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

◆ SetParticle()

void G4VEmProcess::SetParticle ( const G4ParticleDefinition * p)
inlineprotected

Definition at line 733 of file G4VEmProcess.hh.

734{
735 particle = p;
736 currentParticle = p;
737}

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

◆ SetSecondaryParticle()

◆ SetSplineFlag()

◆ SetStartFromNullFlag()

◆ StartTracking()

void G4VEmProcess::StartTracking ( G4Track * track)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 338 of file G4VEmProcess.cc.

339{
340 // reset parameters for the new track
341 currentParticle = track->GetParticleDefinition();
344 preStepLambda = 0.0;
345
346 if(isIon) { massRatio = proton_mass_c2/currentParticle->GetPDGMass(); }
347
348 // forced biasing only for primary particles
349 if(biasManager) {
350 if(0 == track->GetParentID()) {
351 // primary particle
352 biasFlag = true;
353 biasManager->ResetForcedInteraction();
354 }
355 }
356}
const G4ParticleDefinition * GetParticleDefinition() const

◆ StorePhysicsTable()

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

Reimplemented from G4VProcess.

Definition at line 647 of file G4VEmProcess.cc.

650{
651 if(!isTheMaster || part != particle) { return true; }
652 if(G4EmTableUtil::StoreTable(this, part, theLambdaTable,
653 directory, "Lambda",
654 verboseLevel, ascii) &&
655 G4EmTableUtil::StoreTable(this, part, theLambdaTablePrim,
656 directory, "LambdaPrim",
657 verboseLevel, ascii)) {
658 return true;
659 }
660 return false;
661}
static G4bool StoreTable(G4VProcess *, const G4ParticleDefinition *, G4PhysicsTable *, const G4String &dir, const G4String &tname, G4int verb, G4bool ascii)

◆ StreamInfo()

void G4VEmProcess::StreamInfo ( std::ostream & outFile,
const G4ParticleDefinition & part,
G4bool rst = false ) const

Definition at line 264 of file G4VEmProcess.cc.

266{
267 G4String indent = (rst ? " " : "");
268 out << std::setprecision(6);
269 out << G4endl << indent << GetProcessName() << ": ";
270 if (!rst) {
271 out << " for " << part.GetParticleName();
272 }
273 if(fXSType != fEmNoIntegral) { out << " XStype:" << fXSType; }
274 if(applyCuts) { out << " applyCuts:1 "; }
275 G4int subtype = GetProcessSubType();
276 out << " SubType=" << subtype;
277 if (subtype == fAnnihilation) {
278 G4int mod = theParameters->PositronAtRestModelType();
279 const G4String namp[2] = {"Simple", "Allison"};
280 out << " AtRestModel:" << namp[mod];
281 }
282 if(biasFactor != 1.0) { out << " BiasingFactor=" << biasFactor; }
283 out << " BuildTable=" << buildLambdaTable << G4endl;
284 if(buildLambdaTable) {
285 if(particle == &part) {
286 for(auto & v : *theLambdaTable) {
287 if(nullptr != v) {
288 out << " Lambda table from ";
289 G4double emin = v->Energy(0);
290 G4double emax = v->GetMaxEnergy();
291 G4int nbin = G4int(v->GetVectorLength() - 1);
292 if(emin > minKinEnergy) { out << "threshold "; }
293 else { out << G4BestUnit(emin,"Energy"); }
294 out << " to "
295 << G4BestUnit(emax,"Energy")
296 << ", " << G4lrint(nbin/std::log10(emax/emin))
297 << " bins/decade, spline: "
298 << splineFlag << G4endl;
299 break;
300 }
301 }
302 } else {
303 out << " Used Lambda table of "
304 << particle->GetParticleName() << G4endl;
305 }
306 }
307 if(minKinEnergyPrim < maxKinEnergy) {
308 if(particle == &part) {
309 for(auto & v : *theLambdaTablePrim) {
310 if(nullptr != v) {
311 out << " LambdaPrime table from "
312 << G4BestUnit(v->Energy(0),"Energy")
313 << " to "
314 << G4BestUnit(v->GetMaxEnergy(),"Energy")
315 << " in " << v->GetVectorLength()-1
316 << " bins " << G4endl;
317 break;
318 }
319 }
320 } else {
321 out << " Used LambdaPrime table of "
322 << particle->GetParticleName() << G4endl;
323 }
324 }
326 modelManager->DumpModelList(out, verboseLevel);
327
328 if(verboseLevel > 2 && buildLambdaTable) {
329 out << " LambdaTable address= " << theLambdaTable << G4endl;
330 if(theLambdaTable && particle == &part) {
331 out << (*theLambdaTable) << G4endl;
332 }
333 }
334}
@ fAnnihilation
#define G4BestUnit(a, b)
virtual void StreamProcessInfo(std::ostream &) const

Referenced by G4EmTableUtil::BuildEmProcess(), and ProcessDescription().

◆ StreamProcessInfo()

virtual void G4VEmProcess::StreamProcessInfo ( std::ostream & ) const
inlineprotectedvirtual

Reimplemented in G4CoulombScattering, G4eeToHadrons, and G4eplusAnnihilation.

Definition at line 92 of file G4VEmProcess.hh.

92{};

Referenced by StreamInfo().

◆ UseBaseMaterial()

G4bool G4VEmProcess::UseBaseMaterial ( ) const
inline

Definition at line 776 of file G4VEmProcess.hh.

777{
778 return baseMat;
779}

Referenced by G4EmTableUtil::BuildEmProcess().

Member Data Documentation

◆ augerID

G4int G4VEmProcess::augerID = _AugerElectron
protected

Definition at line 402 of file G4VEmProcess.hh.

Referenced by PostStepDoIt().

◆ basedCoupleIndex

◆ baseMat

◆ biasID

G4int G4VEmProcess::biasID = _EM
protected

Definition at line 403 of file G4VEmProcess.hh.

Referenced by G4eplusAnnihilation::AtRestDoIt(), and PostStepDoIt().

◆ biasManager

◆ coupleIdxLambda

std::size_t G4VEmProcess::coupleIdxLambda = 0
protected

Definition at line 407 of file G4VEmProcess.hh.

◆ currentCouple

◆ currentCoupleIndex

◆ currentMaterial

◆ fluoID

G4int G4VEmProcess::fluoID = _Fluorescence
protected

Definition at line 401 of file G4VEmProcess.hh.

Referenced by PostStepDoIt().

◆ fParticleChange

◆ idxLambda

std::size_t G4VEmProcess::idxLambda = 0
protected

Definition at line 408 of file G4VEmProcess.hh.

◆ isTheMaster

◆ mainSecondaries

G4int G4VEmProcess::mainSecondaries = 1
protected

◆ mfpKinEnergy

G4double G4VEmProcess::mfpKinEnergy = DBL_MAX
protected

◆ preStepKinEnergy

◆ preStepLambda

◆ secID

G4int G4VEmProcess::secID = _EM
protected

◆ secParticles

std::vector<G4DynamicParticle*> G4VEmProcess::secParticles
protected

Definition at line 429 of file G4VEmProcess.hh.

Referenced by G4eplusAnnihilation::AtRestDoIt(), G4VEmProcess(), and PostStepDoIt().

◆ theEnergyOfCrossSectionMax

std::vector<G4double>* G4VEmProcess::theEnergyOfCrossSectionMax = nullptr
protected

◆ tripletID

G4int G4VEmProcess::tripletID = _TripletElectron
protected

Definition at line 404 of file G4VEmProcess.hh.

Referenced by PostStepDoIt(), and PreparePhysicsTable().


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