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

#include <G4VEnergyLossProcess.hh>

+ Inheritance diagram for G4VEnergyLossProcess:

Public Member Functions

 G4VEnergyLossProcess (const G4String &name="EnergyLoss", G4ProcessType type=fElectromagnetic)
 
 ~G4VEnergyLossProcess () override
 
virtual G4double MinPrimaryEnergy (const G4ParticleDefinition *, const G4Material *, G4double cut)
 
void ProcessDescription (std::ostream &outFile) const override
 
void PreparePhysicsTable (const G4ParticleDefinition &) override
 
void BuildPhysicsTable (const G4ParticleDefinition &) override
 
G4PhysicsTableBuildDEDXTable (G4EmTableType tType=fRestricted)
 
G4PhysicsTableBuildLambdaTable (G4EmTableType tType=fRestricted)
 
void StartTracking (G4Track *) override
 
G4double AlongStepGetPhysicalInteractionLength (const G4Track &, G4double previousStepSize, G4double currentMinimumStep, G4double &currentSafety, G4GPILSelection *selection) override
 
G4double PostStepGetPhysicalInteractionLength (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
 
G4VParticleChangeAlongStepDoIt (const G4Track &, const G4Step &) 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
 
G4double GetDEDXDispersion (const G4MaterialCutsCouple *couple, const G4DynamicParticle *dp, G4double length)
 
G4double CrossSectionPerVolume (G4double kineticEnergy, const G4MaterialCutsCouple *couple)
 
G4double CrossSectionPerVolume (G4double kineticEnergy, const G4MaterialCutsCouple *couple, G4double logKineticEnergy)
 
G4double MeanFreePath (const G4Track &track)
 
G4double ContinuousStepLimit (const G4Track &track, G4double previousStepSize, G4double currentMinimumStep, G4double &currentSafety)
 
G4VEmModelSelectModelForMaterial (G4double kinEnergy, std::size_t &idxCouple) const
 
void AddEmModel (G4int, G4VEmModel *, G4VEmFluctuationModel *fluc=nullptr, const G4Region *region=nullptr)
 
void SetEmModel (G4VEmModel *, G4int index=0)
 
std::size_t NumberOfModels () const
 
G4VEmModelEmModel (std::size_t index=0) const
 
G4VEmModelGetModelByIndex (std::size_t idx=0, G4bool ver=false) const
 
void SetFluctModel (G4VEmFluctuationModel *)
 
G4VEmFluctuationModelFluctModel () const
 
void SetBaseParticle (const G4ParticleDefinition *p)
 
const G4ParticleDefinitionParticle () const
 
const G4ParticleDefinitionBaseParticle () const
 
const G4ParticleDefinitionSecondaryParticle () const
 
 G4VEnergyLossProcess (G4VEnergyLossProcess &)=delete
 
G4VEnergyLossProcessoperator= (const G4VEnergyLossProcess &right)=delete
 
void ActivateSubCutoff (const G4Region *region)
 
void SetCrossSectionBiasingFactor (G4double f, G4bool flag=true)
 
void ActivateForcedInteraction (G4double length, const G4String &region, G4bool flag=true)
 
void ActivateSecondaryBiasing (const G4String &region, G4double factor, G4double energyLimit)
 
void SetLossFluctuations (G4bool val)
 
void SetSpline (G4bool val)
 
void SetCrossSectionType (G4CrossSectionType val)
 
G4CrossSectionType CrossSectionType () const
 
void SetIonisation (G4bool val)
 
G4bool IsIonisationProcess () const
 
void SetLinearLossLimit (G4double val)
 
void SetStepFunction (G4double v1, G4double v2)
 
void SetLowestEnergyLimit (G4double)
 
G4int NumberOfSubCutoffRegions () const
 
void SetDEDXTable (G4PhysicsTable *p, G4EmTableType tType)
 
void SetCSDARangeTable (G4PhysicsTable *pRange)
 
void SetRangeTableForLoss (G4PhysicsTable *p)
 
void SetInverseRangeTable (G4PhysicsTable *p)
 
void SetLambdaTable (G4PhysicsTable *p)
 
void SetTwoPeaksXS (std::vector< G4TwoPeaksXS * > *)
 
void SetEnergyOfCrossSectionMax (std::vector< G4double > *)
 
void SetDEDXBinning (G4int nbins)
 
void SetMinKinEnergy (G4double e)
 
G4double MinKinEnergy () const
 
void SetMaxKinEnergy (G4double e)
 
G4double MaxKinEnergy () const
 
G4double CrossSectionBiasingFactor () const
 
G4double GetDEDX (G4double kineticEnergy, const G4MaterialCutsCouple *)
 
G4double GetCSDADEDX (G4double kineticEnergy, const G4MaterialCutsCouple *)
 
G4double GetDEDX (G4double kineticEnergy, const G4MaterialCutsCouple *, G4double logKineticEnergy)
 
G4double GetRange (G4double kineticEnergy, const G4MaterialCutsCouple *)
 
G4double GetRange (G4double kineticEnergy, const G4MaterialCutsCouple *, G4double logKineticEnergy)
 
G4double GetCSDARange (G4double kineticEnergy, const G4MaterialCutsCouple *)
 
G4double GetKineticEnergy (G4double range, const G4MaterialCutsCouple *)
 
G4double GetLambda (G4double kineticEnergy, const G4MaterialCutsCouple *)
 
G4double GetLambda (G4double kineticEnergy, const G4MaterialCutsCouple *, G4double logKineticEnergy)
 
G4bool TablesAreBuilt () const
 
G4PhysicsTableDEDXTable () const
 
G4PhysicsTableDEDXunRestrictedTable () const
 
G4PhysicsTableIonisationTable () const
 
G4PhysicsTableCSDARangeTable () const
 
G4PhysicsTableRangeTableForLoss () const
 
G4PhysicsTableInverseRangeTable () const
 
G4PhysicsTableLambdaTable () const
 
std::vector< G4TwoPeaksXS * > * TwoPeaksXS () const
 
std::vector< G4double > * EnergyOfCrossSectionMax () const
 
G4bool UseBaseMaterial () const
 
const G4ElementGetCurrentElement () const
 
void SetDynamicMassCharge (G4double massratio, G4double charge2ratio)
 
- Public Member Functions inherited from G4VContinuousDiscreteProcess
 G4VContinuousDiscreteProcess (const G4String &, G4ProcessType aType=fNotDefined)
 
 G4VContinuousDiscreteProcess (G4VContinuousDiscreteProcess &)
 
virtual ~G4VContinuousDiscreteProcess ()
 
G4VContinuousDiscreteProcessoperator= (const G4VContinuousDiscreteProcess &)=delete
 
virtual G4double AtRestGetPhysicalInteractionLength (const G4Track &, G4ForceCondition *)
 
virtual G4VParticleChangeAtRestDoIt (const G4Track &, const G4Step &)
 
- 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 InitialiseEnergyLossProcess (const G4ParticleDefinition *, const G4ParticleDefinition *)=0
 
G4double GetMeanFreePath (const G4Track &track, G4double previousStepSize, G4ForceCondition *condition) override
 
G4double GetContinuousStepLimit (const G4Track &track, G4double previousStepSize, G4double currentMinimumStep, G4double &currentSafety) override
 
G4PhysicsVectorLambdaPhysicsVector (const G4MaterialCutsCouple *, G4double cut)
 
std::size_t CurrentMaterialCutsCoupleIndex () const
 
void SelectModel (G4double kinEnergy)
 
void SetParticle (const G4ParticleDefinition *p)
 
void SetSecondaryParticle (const G4ParticleDefinition *p)
 
- Protected Member Functions inherited from G4VContinuousDiscreteProcess
void SetGPILSelection (G4GPILSelection selection)
 
G4GPILSelection GetGPILSelection () const
 
- Protected Member Functions inherited from G4VProcess
void SubtractNumberOfInteractionLengthLeft (G4double prevStepSize)
 
void ClearNumberOfInteractionLengthLeft ()
 

Protected Attributes

G4ParticleChangeForLoss fParticleChange
 
const G4MaterialcurrentMaterial = nullptr
 
const G4MaterialCutsCouplecurrentCouple = nullptr
 
G4double preStepLambda = 0.0
 
G4double preStepKinEnergy = 0.0
 
G4double preStepScaledEnergy = 0.0
 
G4double mfpKinEnergy = 0.0
 
std::size_t currentCoupleIndex = 0
 
- 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 82 of file G4VEnergyLossProcess.hh.

Constructor & Destructor Documentation

◆ G4VEnergyLossProcess() [1/2]

G4VEnergyLossProcess::G4VEnergyLossProcess ( const G4String & name = "EnergyLoss",
G4ProcessType type = fElectromagnetic )

Definition at line 93 of file G4VEnergyLossProcess.cc.

94 :
96{
97 theParameters = G4EmParameters::Instance();
99
100 // low energy limit
101 lowestKinEnergy = theParameters->LowestElectronEnergy();
102
103 // Size of tables
104 minKinEnergy = 0.1*CLHEP::keV;
105 maxKinEnergy = 100.0*CLHEP::TeV;
106 maxKinEnergyCSDA = 1.0*CLHEP::GeV;
107 nBins = 84;
108 nBinsCSDA = 35;
109
110 invLambdaFactor = 1.0/lambdaFactor;
111
112 // default linear loss limit
113 finalRange = 1.*CLHEP::mm;
114
115 // run time objects
117 fParticleChange.SetSecondaryWeightByProcess(true);
118 modelManager = new G4EmModelManager();
120 ->GetSafetyHelper();
121 aGPILSelection = CandidateForSelection;
122
123 // initialise model
124 lManager = G4LossTableManager::Instance();
125 lManager->Register(this);
126 isMaster = lManager->IsMaster();
127
128 G4LossTableBuilder* bld = lManager->GetTableBuilder();
129 theDensityFactor = bld->GetDensityFactors();
130 theDensityIdx = bld->GetCoupleIndexes();
131
132 scTracks.reserve(10);
133 secParticles.reserve(12);
134 emModels = new std::vector<G4VEmModel*>;
135}
@ CandidateForSelection
static G4EmParameters * Instance()
static const std::vector< G4double > * GetDensityFactors()
static const std::vector< G4int > * GetCoupleIndexes()
static G4LossTableManager * Instance()
static G4TransportationManager * GetTransportationManager()
G4SafetyHelper * GetSafetyHelper() const
G4VContinuousDiscreteProcess(const G4String &, G4ProcessType aType=fNotDefined)
G4ParticleChangeForLoss fParticleChange
void SetVerboseLevel(G4int value)
G4VParticleChange * pParticleChange

Referenced by BuildPhysicsTable(), G4eBremsstrahlung::G4eBremsstrahlung(), G4eIonisation::G4eIonisation(), G4ePairProduction::G4ePairProduction(), G4hhIonisation::G4hhIonisation(), G4hIonisation::G4hIonisation(), G4ionIonisation::G4ionIonisation(), G4mplIonisation::G4mplIonisation(), G4MuBremsstrahlung::G4MuBremsstrahlung(), G4MuIonisation::G4MuIonisation(), G4MuPairProduction::G4MuPairProduction(), G4PolarizedIonisation::G4PolarizedIonisation(), G4VEnergyLossProcess(), and operator=().

◆ ~G4VEnergyLossProcess()

G4VEnergyLossProcess::~G4VEnergyLossProcess ( )
override

Definition at line 139 of file G4VEnergyLossProcess.cc.

140{
141 if (isMaster) {
142 if(nullptr == baseParticle) { delete theData; }
143 delete theEnergyOfCrossSectionMax;
144 if(nullptr != fXSpeaks) {
145 for(auto const & v : *fXSpeaks) { delete v; }
146 delete fXSpeaks;
147 }
148 }
149 delete modelManager;
150 delete biasManager;
151 delete scoffRegions;
152 delete emModels;
153 lManager->DeRegister(this);
154}

◆ G4VEnergyLossProcess() [2/2]

G4VEnergyLossProcess::G4VEnergyLossProcess ( G4VEnergyLossProcess & )
delete

Member Function Documentation

◆ ActivateForcedInteraction()

void G4VEnergyLossProcess::ActivateForcedInteraction ( G4double length,
const G4String & region,
G4bool flag = true )

Definition at line 1374 of file G4VEnergyLossProcess.cc.

1377{
1378 if(nullptr == biasManager) { biasManager = new G4EmBiasingManager(); }
1379 if(1 < verboseLevel) {
1380 G4cout << "### ActivateForcedInteraction: for "
1381 << " process " << GetProcessName()
1382 << " length(mm)= " << length/mm
1383 << " in G4Region <" << region
1384 << "> weightFlag= " << flag
1385 << G4endl;
1386 }
1387 weightFlag = flag;
1388 biasManager->ActivateForcedInteraction(length, region);
1389}
#define G4endl
Definition G4ios.hh:67
G4GLOB_DLL std::ostream G4cout
G4int verboseLevel
const G4String & GetProcessName() const

Referenced by G4EmExtraParameters::DefineRegParamForLoss().

◆ ActivateSecondaryBiasing()

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

Definition at line 1394 of file G4VEnergyLossProcess.cc.

1397{
1398 if (0.0 <= factor) {
1399 // Range cut can be applied only for e-
1400 if(0.0 == factor && secondaryParticle != G4Electron::Electron())
1401 { return; }
1402
1403 if(nullptr == biasManager) { biasManager = new G4EmBiasingManager(); }
1404 biasManager->ActivateSecondaryBiasing(region, factor, energyLimit);
1405 if(1 < verboseLevel) {
1406 G4cout << "### ActivateSecondaryBiasing: for "
1407 << " process " << GetProcessName()
1408 << " factor= " << factor
1409 << " in G4Region <" << region
1410 << "> energyLimit(MeV)= " << energyLimit/MeV
1411 << G4endl;
1412 }
1413 }
1414}
static G4Electron * Electron()
Definition G4Electron.cc:91

Referenced by G4EmExtraParameters::DefineRegParamForLoss().

◆ ActivateSubCutoff()

void G4VEnergyLossProcess::ActivateSubCutoff ( const G4Region * region)

Definition at line 515 of file G4VEnergyLossProcess.cc.

516{
517 if(nullptr == scoffRegions) {
518 scoffRegions = new std::vector<const G4Region*>;
519 }
520 // the region is in the list
521 if(!scoffRegions->empty()) {
522 for (auto & reg : *scoffRegions) {
523 if (reg == r) { return; }
524 }
525 }
526 // new region
527 scoffRegions->push_back(r);
528 ++nSCoffRegions;
529}

Referenced by G4EmExtraParameters::DefineRegParamForLoss().

◆ AddEmModel()

◆ AlongStepDoIt()

G4VParticleChange * G4VEnergyLossProcess::AlongStepDoIt ( const G4Track & track,
const G4Step & step )
overridevirtual

Reimplemented from G4VContinuousDiscreteProcess.

Definition at line 773 of file G4VEnergyLossProcess.cc.

775{
776 fParticleChange.InitializeForAlongStep(track);
777 // The process has range table - calculate energy loss
778 if(!isIonisation || !currentModel->IsActive(preStepScaledEnergy)) {
779 return &fParticleChange;
780 }
781
782 G4double length = step.GetStepLength();
783 G4double eloss = 0.0;
784
785 /*
786 if(-1 < verboseLevel) {
787 const G4ParticleDefinition* d = track.GetParticleDefinition();
788 G4cout << "AlongStepDoIt for "
789 << GetProcessName() << " and particle " << d->GetParticleName()
790 << " eScaled(MeV)=" << preStepScaledEnergy/MeV
791 << " range(mm)=" << fRange/mm << " s(mm)=" << length/mm
792 << " rf=" << reduceFactor << " q^2=" << chargeSqRatio
793 << " md=" << d->GetPDGMass() << " status=" << track.GetTrackStatus()
794 << " " << track.GetMaterial()->GetName() << G4endl;
795 }
796 */
797 const G4DynamicParticle* dynParticle = track.GetDynamicParticle();
798
799 // define new weight for primary and secondaries
800 G4double weight = fParticleChange.GetParentWeight();
801 if(weightFlag) {
802 weight /= biasFactor;
803 fParticleChange.ProposeWeight(weight);
804 }
805
806 // stopping, check actual range and kinetic energy
807 if (length >= fRange || preStepKinEnergy <= lowestKinEnergy) {
808 eloss = preStepKinEnergy;
809 if (useDeexcitation) {
810 atomDeexcitation->AlongStepDeexcitation(scTracks, step,
811 eloss, (G4int)currentCoupleIndex);
812 if(scTracks.size() > 0) { FillSecondariesAlongStep(weight); }
813 eloss = std::max(eloss, 0.0);
814 }
815 fParticleChange.SetProposedKineticEnergy(0.0);
816 fParticleChange.ProposeLocalEnergyDeposit(eloss);
817 return &fParticleChange;
818 }
819 // zero step length with non-zero range
820 if(length <= 0.0) { return &fParticleChange; }
821
822 // Short step
823 eloss = length*GetDEDXForScaledEnergy(preStepScaledEnergy,
824 LogScaledEkin(track));
825 /*
826 G4cout << "##### Short STEP: eloss= " << eloss
827 << " Escaled=" << preStepScaledEnergy
828 << " R=" << fRange
829 << " L=" << length
830 << " fFactor=" << fFactor << " minE=" << minKinEnergy
831 << " idxBase=" << basedCoupleIndex << G4endl;
832 */
833 // Long step
834 if(eloss > preStepKinEnergy*linLossLimit) {
835
836 const G4double x = (fRange - length)/reduceFactor;
837 const G4double de = preStepKinEnergy - ScaledKinEnergyForLoss(x)/massRatio;
838 if(de > 0.0) { eloss = de; }
839 /*
840 if(-1 < verboseLevel)
841 G4cout << " Long STEP: rPre(mm)="
842 << GetScaledRangeForScaledEnergy(preStepScaledEnergy)/mm
843 << " x(mm)=" << x/mm
844 << " eloss(MeV)=" << eloss/MeV
845 << " rFactor=" << reduceFactor
846 << " massRatio=" << massRatio
847 << G4endl;
848 */
849 }
850
851 /*
852 if(-1 < verboseLevel ) {
853 G4cout << "Before fluct: eloss(MeV)= " << eloss/MeV
854 << " e-eloss= " << preStepKinEnergy-eloss
855 << " step(mm)= " << length/mm << " range(mm)= " << fRange/mm
856 << " fluct= " << lossFluctuationFlag << G4endl;
857 }
858 */
859
860 const G4double cut = (*theCuts)[currentCoupleIndex];
861 G4double esec = 0.0;
862
863 // Corrections, which cannot be tabulated
864 if(isIon) {
865 currentModel->CorrectionsAlongStep(currentCouple, dynParticle,
866 length, eloss);
867 eloss = std::max(eloss, 0.0);
868 }
869
870 // Sample fluctuations if not full energy loss
871 if(eloss >= preStepKinEnergy) {
872 eloss = preStepKinEnergy;
873
874 } else if (lossFluctuationFlag) {
875 const G4double tmax = currentModel->MaxSecondaryKinEnergy(dynParticle);
876 const G4double tcut = std::min(cut, tmax);
877 G4VEmFluctuationModel* fluc = currentModel->GetModelOfFluctuations();
878 eloss = fluc->SampleFluctuations(currentCouple,dynParticle,
879 tcut, tmax, length, eloss);
880 /*
881 if(-1 < verboseLevel)
882 G4cout << "After fluct: eloss(MeV)= " << eloss/MeV
883 << " fluc= " << (eloss-eloss0)/MeV
884 << " ChargeSqRatio= " << chargeSqRatio
885 << " massRatio= " << massRatio << " tmax= " << tmax << G4endl;
886 */
887 }
888
889 // deexcitation
890 if (useDeexcitation) {
891 G4double esecfluo = preStepKinEnergy;
892 G4double de = esecfluo;
893 atomDeexcitation->AlongStepDeexcitation(scTracks, step,
895
896 // sum of de-excitation energies
897 esecfluo -= de;
898
899 // subtracted from energy loss
900 if(eloss >= esecfluo) {
901 esec += esecfluo;
902 eloss -= esecfluo;
903 } else {
904 esec += esecfluo;
905 eloss = 0.0;
906 }
907 }
908 if(nullptr != subcutProducer && IsRegionForCubcutProcessor(track)) {
909 subcutProducer->SampleSecondaries(step, scTracks, eloss, cut);
910 }
911 // secondaries from atomic de-excitation and subcut
912 if(!scTracks.empty()) { FillSecondariesAlongStep(weight); }
913
914 // Energy balance
915 G4double finalT = preStepKinEnergy - eloss - esec;
916 if (finalT <= lowestKinEnergy) {
917 eloss += finalT;
918 finalT = 0.0;
919 } else if(isIon) {
920 fParticleChange.SetProposedCharge(
921 currentModel->GetParticleCharge(track.GetParticleDefinition(),
922 currentMaterial,finalT));
923 }
924 eloss = std::max(eloss, 0.0);
925
926 fParticleChange.SetProposedKineticEnergy(finalT);
927 fParticleChange.ProposeLocalEnergyDeposit(eloss);
928 /*
929 if(-1 < verboseLevel) {
930 G4double del = finalT + eloss + esec - preStepKinEnergy;
931 G4cout << "Final value eloss(MeV)= " << eloss/MeV
932 << " preStepKinEnergy= " << preStepKinEnergy
933 << " postStepKinEnergy= " << finalT
934 << " de(keV)= " << del/keV
935 << " lossFlag= " << lossFluctuationFlag
936 << " status= " << track.GetTrackStatus()
937 << G4endl;
938 }
939 */
940 return &fParticleChange;
941}
double G4double
Definition G4Types.hh:83
int G4int
Definition G4Types.hh:85
G4double GetStepLength() const
const G4ParticleDefinition * GetParticleDefinition() const
const G4DynamicParticle * GetDynamicParticle() const
virtual G4double SampleFluctuations(const G4MaterialCutsCouple *, const G4DynamicParticle *, const G4double tcut, const G4double tmax, const G4double length, const G4double meanLoss)=0
const G4MaterialCutsCouple * currentCouple
const G4Material * currentMaterial

◆ AlongStepGetPhysicalInteractionLength()

G4double G4VEnergyLossProcess::AlongStepGetPhysicalInteractionLength ( const G4Track & track,
G4double previousStepSize,
G4double currentMinimumStep,
G4double & currentSafety,
G4GPILSelection * selection )
overridevirtual

Reimplemented from G4VContinuousDiscreteProcess.

Definition at line 571 of file G4VEnergyLossProcess.cc.

574{
575 G4double x = DBL_MAX;
576 *selection = aGPILSelection;
577 if(isIonisation && currentModel->IsActive(preStepScaledEnergy)) {
578 GetScaledRangeForScaledEnergy(preStepScaledEnergy, LogScaledEkin(track));
579 x = (useCutAsFinalRange) ? std::min(finalRange,
580 currentCouple->GetProductionCuts()->GetProductionCut(1)) : finalRange;
581 x = (fRange > x) ? fRange*dRoverRange + x*(1.0 - dRoverRange)*(2.0 - x/fRange)
582 : fRange;
583 /*
584 G4cout<<"AlongStepGPIL: " << GetProcessName()<<": e="<<preStepKinEnergy
585 << " fRange=" << fRange << " finR=" << finR <<" stepLimit="<<x<<G4endl;
586 */
587 }
588 return x;
589}
#define DBL_MAX
Definition templates.hh:62

Referenced by ContinuousStepLimit().

◆ BaseParticle()

const G4ParticleDefinition * G4VEnergyLossProcess::BaseParticle ( ) const
inline

◆ BuildDEDXTable()

G4PhysicsTable * G4VEnergyLossProcess::BuildDEDXTable ( G4EmTableType tType = fRestricted)

Definition at line 415 of file G4VEnergyLossProcess.cc.

416{
417 G4PhysicsTable* table = nullptr;
418 G4double emax = maxKinEnergy;
419 G4int bin = nBins;
420
421 if(fTotal == tType) {
422 emax = maxKinEnergyCSDA;
423 bin = nBinsCSDA;
424 table = theDEDXunRestrictedTable;
425 } else if(fRestricted == tType) {
426 table = theDEDXTable;
427 } else {
428 G4cout << "G4VEnergyLossProcess::BuildDEDXTable WARNING: wrong type "
429 << tType << G4endl;
430 }
431 if(1 < verboseLevel) {
432 G4cout << "G4VEnergyLossProcess::BuildDEDXTable() of type " << tType
433 << " for " << GetProcessName()
434 << " and " << particle->GetParticleName()
435 << "spline=" << spline << G4endl;
436 }
437 if(nullptr == table) { return table; }
438
439 G4LossTableBuilder* bld = lManager->GetTableBuilder();
440 G4EmTableUtil::BuildDEDXTable(this, particle, modelManager, bld,
441 table, minKinEnergy, emax, bin,
442 verboseLevel, tType, spline);
443 return table;
444}
@ fTotal
@ fRestricted
static void BuildDEDXTable(G4VEnergyLossProcess *proc, const G4ParticleDefinition *part, G4EmModelManager *modelManager, G4LossTableBuilder *bld, G4PhysicsTable *table, const G4double minKinEnergy, const G4double maxKinEnergy, const G4int nbins, const G4int verbose, const G4EmTableType tType, const G4bool splineFlag)

◆ BuildLambdaTable()

G4PhysicsTable * G4VEnergyLossProcess::BuildLambdaTable ( G4EmTableType tType = fRestricted)

Definition at line 448 of file G4VEnergyLossProcess.cc.

449{
450 if(nullptr == theLambdaTable) { return theLambdaTable; }
451
452 G4double scale = theParameters->MaxKinEnergy()/theParameters->MinKinEnergy();
453 G4int nbin =
454 theParameters->NumberOfBinsPerDecade()*G4lrint(std::log10(scale));
455 scale = nbin/G4Log(scale);
456
457 G4LossTableBuilder* bld = lManager->GetTableBuilder();
458 G4EmTableUtil::BuildLambdaTable(this, particle, modelManager,
459 bld, theLambdaTable, theCuts,
460 minKinEnergy, maxKinEnergy, scale,
461 verboseLevel, spline);
462 return theLambdaTable;
463}
G4double G4Log(G4double x)
Definition G4Log.hh:227
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

◆ BuildPhysicsTable()

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

Reimplemented from G4VProcess.

Definition at line 346 of file G4VEnergyLossProcess.cc.

347{
348 if(1 < verboseLevel) {
349 G4cout << "### G4VEnergyLossProcess::BuildPhysicsTable() for "
350 << GetProcessName()
351 << " and particle " << part.GetParticleName()
352 << "; the first particle " << particle->GetParticleName();
353 if(baseParticle) {
354 G4cout << "; base: " << baseParticle->GetParticleName();
355 }
356 G4cout << G4endl;
357 G4cout << " TablesAreBuilt= " << tablesAreBuilt << " isIon= " << isIon
358 << " spline=" << spline << " ptr: " << this << G4endl;
359 }
360
361 if(&part == particle) {
362 if(isMaster) {
363 lManager->BuildPhysicsTable(particle, this);
364
365 } else {
366 const auto masterProcess =
367 static_cast<const G4VEnergyLossProcess*>(GetMasterProcess());
368
369 numberOfModels = modelManager->NumberOfModels();
370 G4EmTableUtil::BuildLocalElossProcess(this, masterProcess,
371 particle, numberOfModels);
372 tablesAreBuilt = true;
373 baseMat = masterProcess->UseBaseMaterial();
374 lManager->LocalPhysicsTables(particle, this);
375 }
376
377 // needs to be done only once
378 safetyHelper->InitialiseHelper();
379 }
380 // Added tracking cut to avoid tracking artifacts
381 // and identified deexcitation flag
382 if(isIonisation) {
383 atomDeexcitation = lManager->AtomDeexcitation();
384 if(nullptr != atomDeexcitation) {
385 if(atomDeexcitation->IsPIXEActive()) { useDeexcitation = true; }
386 }
387 }
388
389 // protection against double printout
390 if(theParameters->IsPrintLocked()) { return; }
391
392 // explicitly defined printout by particle name
393 G4String num = part.GetParticleName();
394 if(1 < verboseLevel ||
395 (0 < verboseLevel && (num == "e-" ||
396 num == "e+" || num == "mu+" ||
397 num == "mu-" || num == "proton"||
398 num == "pi+" || num == "pi-" ||
399 num == "kaon+" || num == "kaon-" ||
400 num == "alpha" || num == "anti_proton" ||
401 num == "GenericIon"|| num == "alpha+" ))) {
402 StreamInfo(G4cout, part);
403 }
404 if(1 < verboseLevel) {
405 G4cout << "### G4VEnergyLossProcess::BuildPhysicsTable() done for "
406 << GetProcessName()
407 << " and particle " << part.GetParticleName();
408 if(isIonisation) { G4cout << " isIonisation flag=1"; }
409 G4cout << " baseMat=" << baseMat << G4endl;
410 }
411}
static void BuildLocalElossProcess(G4VEnergyLossProcess *proc, const G4VEnergyLossProcess *masterProc, const G4ParticleDefinition *part, const G4int nModels)
const G4String & GetParticleName() const
G4VEnergyLossProcess(const G4String &name="EnergyLoss", G4ProcessType type=fElectromagnetic)
const G4VProcess * GetMasterProcess() const

Referenced by G4PolarizedIonisation::BuildPhysicsTable().

◆ ContinuousStepLimit()

G4double G4VEnergyLossProcess::ContinuousStepLimit ( const G4Track & track,
G4double previousStepSize,
G4double currentMinimumStep,
G4double & currentSafety )

Definition at line 1215 of file G4VEnergyLossProcess.cc.

1218{
1219 return AlongStepGetPhysicalInteractionLength(track, x, y, z, &aGPILSelection);
1220}
G4double AlongStepGetPhysicalInteractionLength(const G4Track &, G4double previousStepSize, G4double currentMinimumStep, G4double &currentSafety, G4GPILSelection *selection) override

◆ CrossSectionBiasingFactor()

G4double G4VEnergyLossProcess::CrossSectionBiasingFactor ( ) const
inline

Definition at line 919 of file G4VEnergyLossProcess.hh.

920{
921 return biasFactor;
922}

◆ CrossSectionPerVolume() [1/2]

G4double G4VEnergyLossProcess::CrossSectionPerVolume ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple )

◆ CrossSectionPerVolume() [2/2]

G4double G4VEnergyLossProcess::CrossSectionPerVolume ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple,
G4double logKineticEnergy )

Definition at line 1182 of file G4VEnergyLossProcess.cc.

1185{
1186 // Cross section per volume is calculated
1187 DefineMaterial(couple);
1188 G4double cross = 0.0;
1189 if (nullptr != theLambdaTable) {
1190 cross = GetLambdaForScaledEnergy(kineticEnergy * massRatio,
1191 logKineticEnergy + logMassRatio);
1192 } else {
1193 SelectModel(kineticEnergy*massRatio);
1194 cross = (!baseMat) ? biasFactor : biasFactor*(*theDensityFactor)[currentCoupleIndex];
1195 cross *= (currentModel->CrossSectionPerVolume(currentMaterial, particle, kineticEnergy,
1196 (*theCuts)[currentCoupleIndex]));
1197 }
1198 return std::max(cross, 0.0);
1199}
void SelectModel(G4double kinEnergy)

◆ CrossSectionType()

G4CrossSectionType G4VEnergyLossProcess::CrossSectionType ( ) const
inline

Definition at line 884 of file G4VEnergyLossProcess.hh.

885{
886 return fXSType;
887}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ CSDARangeTable()

G4PhysicsTable * G4VEnergyLossProcess::CSDARangeTable ( ) const
inline

Definition at line 954 of file G4VEnergyLossProcess.hh.

955{
956 return theCSDARangeTable;
957}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ CurrentMaterialCutsCoupleIndex()

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

Definition at line 532 of file G4VEnergyLossProcess.hh.

533{
534 return currentCoupleIndex;
535}

◆ DEDXTable()

G4PhysicsTable * G4VEnergyLossProcess::DEDXTable ( ) const
inline

◆ DEDXunRestrictedTable()

G4PhysicsTable * G4VEnergyLossProcess::DEDXunRestrictedTable ( ) const
inline

Definition at line 940 of file G4VEnergyLossProcess.hh.

941{
942 return theDEDXunRestrictedTable;
943}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ EmModel()

◆ EnergyOfCrossSectionMax()

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

Definition at line 990 of file G4VEnergyLossProcess.hh.

991{
992 return theEnergyOfCrossSectionMax;
993}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ FluctModel()

◆ GetContinuousStepLimit()

G4double G4VEnergyLossProcess::GetContinuousStepLimit ( const G4Track & track,
G4double previousStepSize,
G4double currentMinimumStep,
G4double & currentSafety )
overrideprotectedvirtual

Implements G4VContinuousDiscreteProcess.

Definition at line 1236 of file G4VEnergyLossProcess.cc.

1239{
1240 return DBL_MAX;
1241}

◆ GetCSDADEDX()

G4double G4VEnergyLossProcess::GetCSDADEDX ( G4double kineticEnergy,
const G4MaterialCutsCouple *  )
inline

◆ GetCSDARange()

G4double G4VEnergyLossProcess::GetCSDARange ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple )
inline

Definition at line 759 of file G4VEnergyLossProcess.hh.

761{
762 DefineMaterial(couple);
763 return (nullptr == theCSDARangeTable) ? DBL_MAX :
764 GetLimitScaledRangeForScaledEnergy(kineticEnergy*massRatio)*reduceFactor;
765}

◆ GetCurrentElement()

const G4Element * G4VEnergyLossProcess::GetCurrentElement ( ) const

Definition at line 1349 of file G4VEnergyLossProcess.cc.

1350{
1351 return (nullptr != currentModel)
1352 ? currentModel->GetCurrentElement(currentMaterial) : nullptr;
1353}

◆ GetDEDX() [1/2]

G4double G4VEnergyLossProcess::GetDEDX ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple )
inline

Definition at line 717 of file G4VEnergyLossProcess.hh.

719{
720 DefineMaterial(couple);
721 return GetDEDXForScaledEnergy(kinEnergy*massRatio);
722}

◆ GetDEDX() [2/2]

G4double G4VEnergyLossProcess::GetDEDX ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple,
G4double logKineticEnergy )
inline

Definition at line 727 of file G4VEnergyLossProcess.hh.

730{
731 DefineMaterial(couple);
732 return GetDEDXForScaledEnergy(kinEnergy*massRatio, logKinEnergy+logMassRatio);
733}

◆ GetDEDXDispersion()

G4double G4VEnergyLossProcess::GetDEDXDispersion ( const G4MaterialCutsCouple * couple,
const G4DynamicParticle * dp,
G4double length )

Definition at line 1163 of file G4VEnergyLossProcess.cc.

1167{
1168 DefineMaterial(couple);
1169 G4double ekin = dp->GetKineticEnergy();
1170 SelectModel(ekin*massRatio);
1171 G4double tmax = currentModel->MaxSecondaryKinEnergy(dp);
1172 G4double tcut = std::min(tmax,(*theCuts)[currentCoupleIndex]);
1173 G4double d = 0.0;
1174 G4VEmFluctuationModel* fm = currentModel->GetModelOfFluctuations();
1175 if(nullptr != fm) { d = fm->Dispersion(currentMaterial,dp,tcut,tmax,length); }
1176 return d;
1177}
G4double GetKineticEnergy() const
virtual G4double Dispersion(const G4Material *, const G4DynamicParticle *, const G4double tcut, const G4double tmax, const G4double length)=0

◆ GetKineticEnergy()

G4double G4VEnergyLossProcess::GetKineticEnergy ( G4double range,
const G4MaterialCutsCouple * couple )
inline

Definition at line 770 of file G4VEnergyLossProcess.hh.

772{
773 DefineMaterial(couple);
774 return ScaledKinEnergyForLoss(range/reduceFactor)/massRatio;
775}

◆ GetLambda() [1/2]

G4double G4VEnergyLossProcess::GetLambda ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple )
inline

Definition at line 780 of file G4VEnergyLossProcess.hh.

782{
783 DefineMaterial(couple);
784 return (nullptr != theLambdaTable) ?
785 GetLambdaForScaledEnergy(kinEnergy*massRatio) : 0.0;
786}

◆ GetLambda() [2/2]

G4double G4VEnergyLossProcess::GetLambda ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple,
G4double logKineticEnergy )
inline

Definition at line 791 of file G4VEnergyLossProcess.hh.

794{
795 DefineMaterial(couple);
796 return (nullptr != theLambdaTable) ?
797 GetLambdaForScaledEnergy(kinEnergy*massRatio, logKinEnergy+logMassRatio)
798 : 0.0;
799}

◆ GetMeanFreePath()

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

Implements G4VContinuousDiscreteProcess.

Definition at line 1224 of file G4VEnergyLossProcess.cc.

1229{
1231 return MeanFreePath(track);
1232}
G4double condition(const G4ErrorSymMatrix &m)
@ NotForced
G4double MeanFreePath(const G4Track &track)

Referenced by G4PolarizedIonisation::GetMeanFreePath().

◆ GetModelByIndex()

G4VEmModel * G4VEnergyLossProcess::GetModelByIndex ( std::size_t idx = 0,
G4bool ver = false ) const
inline

Definition at line 1019 of file G4VEnergyLossProcess.hh.

1020{
1021 return modelManager->GetModel((G4int)idx, ver);
1022}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ GetRange() [1/2]

G4double G4VEnergyLossProcess::GetRange ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple )
inline

Definition at line 738 of file G4VEnergyLossProcess.hh.

740{
741 DefineMaterial(couple);
742 return GetScaledRangeForScaledEnergy(kinEnergy*massRatio);
743}

◆ GetRange() [2/2]

G4double G4VEnergyLossProcess::GetRange ( G4double kineticEnergy,
const G4MaterialCutsCouple * couple,
G4double logKineticEnergy )
inline

Definition at line 748 of file G4VEnergyLossProcess.hh.

751{
752 DefineMaterial(couple);
753 return GetScaledRangeForScaledEnergy(kinEnergy*massRatio, logKinEnergy+logMassRatio);
754}

◆ InitialiseEnergyLossProcess()

◆ InverseRangeTable()

G4PhysicsTable * G4VEnergyLossProcess::InverseRangeTable ( ) const
inline

Definition at line 968 of file G4VEnergyLossProcess.hh.

969{
970 return theInverseRangeTable;
971}

Referenced by G4EmTableUtil::BuildLocalElossProcess(), G4LossTableManager::LocalPhysicsTables(), and G4EmCalculator::PrintInverseRangeTable().

◆ IonisationTable()

G4PhysicsTable * G4VEnergyLossProcess::IonisationTable ( ) const
inline

Definition at line 947 of file G4VEnergyLossProcess.hh.

948{
949 return theIonisationTable;
950}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ IsIonisationProcess()

G4bool G4VEnergyLossProcess::IsIonisationProcess ( ) const
inline

◆ LambdaPhysicsVector()

G4PhysicsVector * G4VEnergyLossProcess::LambdaPhysicsVector ( const G4MaterialCutsCouple * couple,
G4double cut )
protected

Definition at line 1246 of file G4VEnergyLossProcess.cc.

1248{
1249 DefineMaterial(couple);
1250 G4PhysicsVector* v = (*theLambdaTable)[basedCoupleIndex];
1251 return new G4PhysicsVector(*v);
1252}

◆ LambdaTable()

G4PhysicsTable * G4VEnergyLossProcess::LambdaTable ( ) const
inline

Definition at line 975 of file G4VEnergyLossProcess.hh.

976{
977 return theLambdaTable;
978}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ MaxKinEnergy()

G4double G4VEnergyLossProcess::MaxKinEnergy ( ) const
inline

Definition at line 912 of file G4VEnergyLossProcess.hh.

913{
914 return maxKinEnergy;
915}

◆ MeanFreePath()

G4double G4VEnergyLossProcess::MeanFreePath ( const G4Track & track)

Definition at line 1203 of file G4VEnergyLossProcess.cc.

1204{
1205 DefineMaterial(track.GetMaterialCutsCouple());
1206 const G4double kinEnergy = track.GetKineticEnergy();
1207 const G4double logKinEnergy = track.GetDynamicParticle()->GetLogKineticEnergy();
1208 const G4double cs = GetLambdaForScaledEnergy(kinEnergy * massRatio,
1209 logKinEnergy + logMassRatio);
1210 return (0.0 < cs) ? 1.0/cs : DBL_MAX;
1211}
G4double GetLogKineticEnergy() const
G4double GetKineticEnergy() const
const G4MaterialCutsCouple * GetMaterialCutsCouple() const

Referenced by GetMeanFreePath().

◆ MinKinEnergy()

G4double G4VEnergyLossProcess::MinKinEnergy ( ) const
inline

Definition at line 905 of file G4VEnergyLossProcess.hh.

906{
907 return minKinEnergy;
908}

◆ MinPrimaryEnergy()

G4double G4VEnergyLossProcess::MinPrimaryEnergy ( const G4ParticleDefinition * ,
const G4Material * ,
G4double cut )
virtual

◆ NumberOfModels()

std::size_t G4VEnergyLossProcess::NumberOfModels ( ) const
inline

Definition at line 1004 of file G4VEnergyLossProcess.hh.

1005{
1006 return numberOfModels;
1007}

◆ NumberOfSubCutoffRegions()

G4int G4VEnergyLossProcess::NumberOfSubCutoffRegions ( ) const
inline

Definition at line 898 of file G4VEnergyLossProcess.hh.

899{
900 return nSCoffRegions;
901}

◆ operator=()

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

◆ Particle()

const G4ParticleDefinition * G4VEnergyLossProcess::Particle ( ) const
inline

Definition at line 840 of file G4VEnergyLossProcess.hh.

841{
842 return particle;
843}

Referenced by G4LossTableManager::BuildPhysicsTable(), and G4LossTableManager::LocalPhysicsTables().

◆ PostStepDoIt()

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

Reimplemented from G4VContinuousDiscreteProcess.

Definition at line 985 of file G4VEnergyLossProcess.cc.

987{
988 // clear number of interaction lengths in any case
991
992 fParticleChange.InitializeForPostStep(track);
993 const G4double finalT = track.GetKineticEnergy();
994
995 const G4double postStepScaledEnergy = finalT*massRatio;
996 SelectModel(postStepScaledEnergy);
997
998 if(!currentModel->IsActive(postStepScaledEnergy)) {
999 return &fParticleChange;
1000 }
1001 /*
1002 if(1 < verboseLevel) {
1003 G4cout<<GetProcessName()<<" PostStepDoIt: E(MeV)= "<< finalT/MeV<< G4endl;
1004 }
1005 */
1006 // forced process - should happen only once per track
1007 if(biasFlag) {
1008 if(biasManager->ForcedInteractionRegion((G4int)currentCoupleIndex)) {
1009 biasFlag = false;
1010 }
1011 }
1012 const G4DynamicParticle* dp = track.GetDynamicParticle();
1013
1014 // Integral approach
1015 if (fXSType != fEmNoIntegral) {
1016 const G4double logFinalT = dp->GetLogKineticEnergy();
1017 G4double lx = GetLambdaForScaledEnergy(postStepScaledEnergy,
1018 logFinalT + logMassRatio);
1019 lx = std::max(lx, 0.0);
1020
1021 // if both lg and lx are zero then no interaction
1022 if(preStepLambda*G4UniformRand() >= lx) {
1023 return &fParticleChange;
1024 }
1025 }
1026
1027 // define new weight for primary and secondaries
1028 G4double weight = fParticleChange.GetParentWeight();
1029 if(weightFlag) {
1030 weight /= biasFactor;
1031 fParticleChange.ProposeWeight(weight);
1032 }
1033
1034 const G4double tcut = (*theCuts)[currentCoupleIndex];
1035
1036 // sample secondaries
1037 secParticles.clear();
1038 currentModel->SampleSecondaries(&secParticles, currentCouple, dp, tcut);
1039
1040 const G4int num0 = (G4int)secParticles.size();
1041
1042 // bremsstrahlung splitting or Russian roulette
1043 if(biasManager) {
1044 if(biasManager->SecondaryBiasingRegion((G4int)currentCoupleIndex)) {
1045 G4double eloss = 0.0;
1046 weight *= biasManager->ApplySecondaryBiasing(
1047 secParticles,
1048 track, currentModel,
1049 &fParticleChange, eloss,
1050 (G4int)currentCoupleIndex, tcut,
1051 step.GetPostStepPoint()->GetSafety());
1052 if(eloss > 0.0) {
1053 eloss += fParticleChange.GetLocalEnergyDeposit();
1054 fParticleChange.ProposeLocalEnergyDeposit(eloss);
1055 }
1056 }
1057 }
1058
1059 // save secondaries
1060 const G4int num = (G4int)secParticles.size();
1061 if(num > 0) {
1062
1063 fParticleChange.SetNumberOfSecondaries(num);
1064 G4double time = track.GetGlobalTime();
1065
1066 G4int n1(0), n2(0);
1067 if(num0 > mainSecondaries) {
1068 currentModel->FillNumberOfSecondaries(n1, n2);
1069 }
1070
1071 for (G4int i=0; i<num; ++i) {
1072 if(nullptr != secParticles[i]) {
1073 G4Track* t = new G4Track(secParticles[i], time, track.GetPosition());
1075 if (biasManager) {
1076 t->SetWeight(weight * biasManager->GetWeight(i));
1077 } else {
1078 t->SetWeight(weight);
1079 }
1080 if(i < num0) {
1081 t->SetCreatorModelID(secID);
1082 } else if(i < num0 + n1) {
1083 t->SetCreatorModelID(tripletID);
1084 } else {
1085 t->SetCreatorModelID(biasID);
1086 }
1087
1088 //G4cout << "Secondary(post step) has weight " << t->GetWeight()
1089 // << ", kenergy " << t->GetKineticEnergy()/MeV << " MeV"
1090 // << " time= " << time/ns << " ns " << G4endl;
1091 pParticleChange->AddSecondary(t);
1092 }
1093 }
1094 }
1095
1096 if(0.0 == fParticleChange.GetProposedKineticEnergy() &&
1097 fAlive == fParticleChange.GetTrackStatus()) {
1098 if(particle->GetProcessManager()->GetAtRestProcessVector()->size() > 0)
1099 { fParticleChange.ProposeTrackStatus(fStopButAlive); }
1100 else { fParticleChange.ProposeTrackStatus(fStopAndKill); }
1101 }
1102
1103 /*
1104 if(-1 < verboseLevel) {
1105 G4cout << "::PostStepDoIt: Sample secondary; Efin= "
1106 << fParticleChange.GetProposedKineticEnergy()/MeV
1107 << " MeV; model= (" << currentModel->LowEnergyLimit()
1108 << ", " << currentModel->HighEnergyLimit() << ")"
1109 << " preStepLambda= " << preStepLambda
1110 << " dir= " << track.GetMomentumDirection()
1111 << " status= " << track.GetTrackStatus()
1112 << G4endl;
1113 }
1114 */
1115 return &fParticleChange;
1116}
@ fEmNoIntegral
@ fAlive
@ fStopAndKill
@ fStopButAlive
#define G4UniformRand()
Definition Randomize.hh:52
G4double GetSafety() const
G4StepPoint * GetPostStepPoint() 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)
G4double theNumberOfInteractionLengthLeft

◆ PostStepGetPhysicalInteractionLength()

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

Reimplemented from G4VContinuousDiscreteProcess.

Definition at line 593 of file G4VEnergyLossProcess.cc.

597{
598 // condition is set to "Not Forced"
600 G4double x = DBL_MAX;
601
602 // initialisation of material, mass, charge, model
603 // at the beginning of the step
604 DefineMaterial(track.GetMaterialCutsCouple());
608
609 if(!currentModel->IsActive(preStepScaledEnergy)) {
612 preStepLambda = 0.0;
614 return x;
615 }
616
617 // change effective charge of a charged particle on fly
618 if(isIon) {
619 const G4double q2 = currentModel->ChargeSquareRatio(track);
620 fFactor = q2*biasFactor;
621 if(baseMat) { fFactor *= (*theDensityFactor)[currentCoupleIndex]; }
622 reduceFactor = 1.0/(fFactor*massRatio);
623 if (lossFluctuationFlag) {
624 auto fluc = currentModel->GetModelOfFluctuations();
625 fluc->SetParticleAndCharge(track.GetDefinition(), q2);
626 }
627 }
628
629 // forced biasing only for primary particles
630 if(biasManager) {
631 if(0 == track.GetParentID() && biasFlag &&
632 biasManager->ForcedInteractionRegion((G4int)currentCoupleIndex)) {
633 return biasManager->GetStepLimit((G4int)currentCoupleIndex, previousStepSize);
634 }
635 }
636
637 ComputeLambdaForScaledEnergy(preStepScaledEnergy, track);
638
639 // zero cross section
640 if(preStepLambda <= 0.0) {
643 } else {
644
645 // non-zero cross section
647
648 // beggining of tracking (or just after DoIt of this process)
651
652 } else if(currentInteractionLength < DBL_MAX) {
653
654 // subtract NumberOfInteractionLengthLeft using previous step
656 previousStepSize/currentInteractionLength;
657
660 }
661
662 // new mean free path and step limit
665 }
666#ifdef G4VERBOSE
667 if (verboseLevel>2) {
668 G4cout << "G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength ";
669 G4cout << "[ " << GetProcessName() << "]" << G4endl;
670 G4cout << " for " << track.GetDefinition()->GetParticleName()
671 << " in Material " << currentMaterial->GetName()
672 << " Ekin(MeV)= " << preStepKinEnergy/MeV
673 << " track material: " << track.GetMaterial()->GetName()
674 <<G4endl;
675 G4cout << "MeanFreePath = " << currentInteractionLength/cm << "[cm]"
676 << "InteractionLength= " << x/cm <<"[cm] " <<G4endl;
677 }
678#endif
679 return x;
680}
const G4String & GetName() const
G4Material * GetMaterial() const
G4ParticleDefinition * GetDefinition() const
G4int GetParentID() const
G4double currentInteractionLength
G4double theInitialNumberOfInteractionLength

Referenced by G4PolarizedIonisation::PostStepGetPhysicalInteractionLength().

◆ PreparePhysicsTable()

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

Reimplemented from G4VProcess.

Definition at line 204 of file G4VEnergyLossProcess.cc.

205{
206 particle = G4EmTableUtil::CheckIon(this, &part, particle,
207 verboseLevel, isIon);
208
209 if( particle != &part ) {
210 if(!isIon) { lManager->RegisterExtraParticle(&part, this); }
211 if(1 < verboseLevel) {
212 G4cout << "### G4VEnergyLossProcess::PreparePhysicsTable()"
213 << " interrupted for " << GetProcessName() << " and "
214 << part.GetParticleName() << " isIon=" << isIon
215 << " spline=" << spline << G4endl;
216 }
217 return;
218 }
219
220 tablesAreBuilt = false;
221 if (GetProcessSubType() == fIonisation) { SetIonisation(true); }
222
223 G4LossTableBuilder* bld = lManager->GetTableBuilder();
224 lManager->PreparePhysicsTable(&part, this);
225
226 // Base particle and set of models can be defined here
227 InitialiseEnergyLossProcess(particle, baseParticle);
228
229 // parameters of the process
230 if(!actLossFluc) { lossFluctuationFlag = theParameters->LossFluctuation(); }
231 useCutAsFinalRange = theParameters->UseCutAsFinalRange();
232 if(!actMinKinEnergy) { minKinEnergy = theParameters->MinKinEnergy(); }
233 if(!actMaxKinEnergy) { maxKinEnergy = theParameters->MaxKinEnergy(); }
234 if(!actBinning) { nBins = theParameters->NumberOfBins(); }
235 maxKinEnergyCSDA = theParameters->MaxEnergyForCSDARange();
236 nBinsCSDA = theParameters->NumberOfBinsPerDecade()
237 *G4lrint(std::log10(maxKinEnergyCSDA/minKinEnergy));
238 if(!actLinLossLimit) { linLossLimit = theParameters->LinearLossLimit(); }
239 lambdaFactor = theParameters->LambdaFactor();
240 invLambdaFactor = 1.0/lambdaFactor;
241 if(isMaster) { SetVerboseLevel(theParameters->Verbose()); }
242 else { SetVerboseLevel(theParameters->WorkerVerbose()); }
243 // integral option may be disabled
244 if(!theParameters->Integral()) { fXSType = fEmNoIntegral; }
245
246 theParameters->DefineRegParamForLoss(this);
247
248 fRangeEnergy = 0.0;
249
250 G4double initialCharge = particle->GetPDGCharge();
251 G4double initialMass = particle->GetPDGMass();
252
253 theParameters->FillStepFunction(particle, this);
254
255 // parameters for scaling from the base particle
256 if (nullptr != baseParticle) {
257 massRatio = (baseParticle->GetPDGMass())/initialMass;
258 logMassRatio = G4Log(massRatio);
259 G4double q = initialCharge/baseParticle->GetPDGCharge();
260 chargeSqRatio = q*q;
261 if(chargeSqRatio > 0.0) { reduceFactor = 1.0/(chargeSqRatio*massRatio); }
262 }
263 lowestKinEnergy = (initialMass < CLHEP::MeV)
264 ? theParameters->LowestElectronEnergy()
265 : theParameters->LowestMuHadEnergy();
266
267 // Tables preparation
268 if (isMaster && nullptr == baseParticle) {
269 if(nullptr == theData) { theData = new G4EmDataHandler(7); }
270
271 if(nullptr != theDEDXTable && isIonisation) {
272 if(nullptr != theIonisationTable && theDEDXTable != theIonisationTable) {
273 theData->CleanTable(0);
274 theDEDXTable = theIonisationTable;
275 theIonisationTable = nullptr;
276 }
277 }
278
279 theDEDXTable = theData->MakeTable(theDEDXTable, 0);
280 bld->InitialiseBaseMaterials(theDEDXTable);
281 theData->UpdateTable(theIonisationTable, 1);
282
283 if (theParameters->BuildCSDARange()) {
284 theDEDXunRestrictedTable = theData->MakeTable(2);
285 if(isIonisation) { theCSDARangeTable = theData->MakeTable(3); }
286 }
287
288 theLambdaTable = theData->MakeTable(4);
289 if(isIonisation) {
290 theRangeTableForLoss = theData->MakeTable(5);
291 theInverseRangeTable = theData->MakeTable(6);
292 }
293 }
294
295 // forced biasing
296 if(nullptr != biasManager) {
297 biasManager->Initialise(part,GetProcessName(),verboseLevel);
298 biasFlag = false;
299 }
300 baseMat = bld->GetBaseMaterialFlag();
301 numberOfModels = modelManager->NumberOfModels();
302 currentModel = modelManager->GetModel(0);
303 G4EmTableUtil::UpdateModels(this, modelManager, maxKinEnergy,
304 numberOfModels, secID, biasID,
305 mainSecondaries, baseMat, isMaster,
306 theParameters->UseAngularGeneratorForIonisation());
307 theCuts = modelManager->Initialise(particle, secondaryParticle,
309 // subcut processor
310 if(isIonisation) {
311 subcutProducer = lManager->SubCutProducer();
312 }
313 if(1 == nSCoffRegions) {
314 if((*scoffRegions)[0]->GetName() == "DefaultRegionForTheWorld") {
315 delete scoffRegions;
316 scoffRegions = nullptr;
317 nSCoffRegions = 0;
318 }
319 }
320
321 if(1 < verboseLevel) {
322 G4cout << "G4VEnergyLossProcess::PrepearPhysicsTable() is done "
323 << " for " << GetProcessName() << " and " << particle->GetParticleName()
324 << " isIon= " << isIon << " spline=" << spline;
325 if(baseParticle) {
326 G4cout << "; base: " << baseParticle->GetParticleName();
327 }
328 G4cout << G4endl;
329 G4cout << " chargeSqRatio= " << chargeSqRatio
330 << " massRatio= " << massRatio
331 << " reduceFactor= " << reduceFactor << G4endl;
332 if (nSCoffRegions > 0) {
333 G4cout << " SubCut secondary production is ON for regions: " << G4endl;
334 for (G4int i=0; i<nSCoffRegions; ++i) {
335 const G4Region* r = (*scoffRegions)[i];
336 G4cout << " " << r->GetName() << G4endl;
337 }
338 } else if(nullptr != subcutProducer) {
339 G4cout << " SubCut secondary production is ON for all regions" << G4endl;
340 }
341 }
342}
@ fIonisation
static void UpdateModels(G4VEnergyLossProcess *proc, G4EmModelManager *modelManager, const G4double maxKinEnergy, const G4int nModels, G4int &secID, G4int &biasID, G4int &mainSecondaries, const G4bool baseMat, const G4bool isMaster, const G4bool useAGen)
static const G4ParticleDefinition * CheckIon(G4VEnergyLossProcess *proc, const G4ParticleDefinition *part, const G4ParticleDefinition *particle, const G4int verboseLevel, G4bool &isIon)
static G4bool GetBaseMaterialFlag()
void InitialiseBaseMaterials(const G4PhysicsTable *table=nullptr)
const G4String & GetName() const
virtual void InitialiseEnergyLossProcess(const G4ParticleDefinition *, const G4ParticleDefinition *)=0
G4int GetProcessSubType() const

◆ ProcessDescription()

◆ RangeTableForLoss()

G4PhysicsTable * G4VEnergyLossProcess::RangeTableForLoss ( ) const
inline

Definition at line 961 of file G4VEnergyLossProcess.hh.

962{
963 return theRangeTableForLoss;
964}

Referenced by G4EmTableUtil::BuildLocalElossProcess(), G4LossTableManager::LocalPhysicsTables(), and G4EmCalculator::PrintRangeTable().

◆ RetrievePhysicsTable()

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

Reimplemented from G4VProcess.

Definition at line 1146 of file G4VEnergyLossProcess.cc.

1148{
1149 if (!isMaster || nullptr != baseParticle || part != particle ) return true;
1150 for(std::size_t i=0; i<7; ++i) {
1151 // ionisation table only for ionisation process
1152 if (!isIonisation && 1 == i) { continue; }
1153 if(!G4EmTableUtil::RetrieveTable(this, part, theData->Table(i), dir, tnames[i],
1154 verboseLevel, ascii, spline)) {
1155 return false;
1156 }
1157 }
1158 return true;
1159}
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 * G4VEnergyLossProcess::SecondaryParticle ( ) const
inline

Definition at line 855 of file G4VEnergyLossProcess.hh.

856{
857 return secondaryParticle;
858}

◆ SelectModel()

void G4VEnergyLossProcess::SelectModel ( G4double kinEnergy)
inlineprotected

Definition at line 539 of file G4VEnergyLossProcess.hh.

540{
541 currentModel = modelManager->SelectModel(kinEnergy, currentCoupleIndex);
542 currentModel->SetCurrentCouple(currentCouple);
543}

Referenced by CrossSectionPerVolume(), GetDEDXDispersion(), PostStepDoIt(), and PostStepGetPhysicalInteractionLength().

◆ SelectModelForMaterial()

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

Definition at line 547 of file G4VEnergyLossProcess.hh.

549{
550 return modelManager->SelectModel(kinEnergy, idx);
551}

◆ SetBaseParticle()

void G4VEnergyLossProcess::SetBaseParticle ( const G4ParticleDefinition * p)
inline

Definition at line 833 of file G4VEnergyLossProcess.hh.

834{
835 baseParticle = p;
836}

Referenced by G4hIonisation::InitialiseEnergyLossProcess(), and G4ionIonisation::InitialiseEnergyLossProcess().

◆ SetCrossSectionBiasingFactor()

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

Definition at line 1357 of file G4VEnergyLossProcess.cc.

1359{
1360 if(f > 0.0) {
1361 biasFactor = f;
1362 weightFlag = flag;
1363 if(1 < verboseLevel) {
1364 G4cout << "### SetCrossSectionBiasingFactor: for "
1365 << " process " << GetProcessName()
1366 << " biasFactor= " << f << " weightFlag= " << flag
1367 << G4endl;
1368 }
1369 }
1370}

Referenced by G4EmExtraParameters::DefineRegParamForLoss().

◆ SetCrossSectionType()

void G4VEnergyLossProcess::SetCrossSectionType ( G4CrossSectionType val)
inline

Definition at line 877 of file G4VEnergyLossProcess.hh.

878{
879 fXSType = val;
880}

Referenced by G4EmTableUtil::BuildLocalElossProcess(), and G4eBremsstrahlung::G4eBremsstrahlung().

◆ SetCSDARangeTable()

void G4VEnergyLossProcess::SetCSDARangeTable ( G4PhysicsTable * pRange)

Definition at line 1283 of file G4VEnergyLossProcess.cc.

1284{
1285 theCSDARangeTable = p;
1286}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ SetDEDXBinning()

void G4VEnergyLossProcess::SetDEDXBinning ( G4int nbins)

Definition at line 1457 of file G4VEnergyLossProcess.cc.

1458{
1459 if(2 < n && n < 1000000000) {
1460 nBins = n;
1461 actBinning = true;
1462 } else {
1463 G4double e = (G4double)n;
1464 PrintWarning("SetDEDXBinning", e);
1465 }
1466}

Referenced by G4hhIonisation::InitialiseEnergyLossProcess(), and G4mplIonisation::InitialiseEnergyLossProcess().

◆ SetDEDXTable()

void G4VEnergyLossProcess::SetDEDXTable ( G4PhysicsTable * p,
G4EmTableType tType )

Definition at line 1257 of file G4VEnergyLossProcess.cc.

1258{
1259 if(1 < verboseLevel) {
1260 G4cout << "### Set DEDX table " << p << " " << theDEDXTable
1261 << " " << theDEDXunRestrictedTable << " " << theIonisationTable
1262 << " for " << particle->GetParticleName()
1263 << " and process " << GetProcessName()
1264 << " type=" << tType << " isIonisation:" << isIonisation << G4endl;
1265 }
1266 if(fTotal == tType) {
1267 theDEDXunRestrictedTable = p;
1268 } else if(fRestricted == tType) {
1269 theDEDXTable = p;
1270 if(isMaster && nullptr == baseParticle) {
1271 theData->UpdateTable(theDEDXTable, 0);
1272 }
1273 } else if(fIsIonisation == tType) {
1274 theIonisationTable = p;
1275 if(isMaster && nullptr == baseParticle) {
1276 theData->UpdateTable(theIonisationTable, 1);
1277 }
1278 }
1279}
@ fIsIonisation

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ SetDynamicMassCharge()

void G4VEnergyLossProcess::SetDynamicMassCharge ( G4double massratio,
G4double charge2ratio )

Definition at line 190 of file G4VEnergyLossProcess.cc.

192{
193 massRatio = massratio;
194 logMassRatio = G4Log(massRatio);
195 fFactor = charge2ratio*biasFactor;
196 if(baseMat) { fFactor *= (*theDensityFactor)[currentCoupleIndex]; }
197 chargeSqRatio = charge2ratio;
198 reduceFactor = 1.0/(fFactor*massRatio);
199}

◆ SetEmModel()

◆ SetEnergyOfCrossSectionMax()

void G4VEnergyLossProcess::SetEnergyOfCrossSectionMax ( std::vector< G4double > * p)

Definition at line 1335 of file G4VEnergyLossProcess.cc.

1336{
1337 theEnergyOfCrossSectionMax = p;
1338}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ SetFluctModel()

◆ SetInverseRangeTable()

void G4VEnergyLossProcess::SetInverseRangeTable ( G4PhysicsTable * p)

Definition at line 1297 of file G4VEnergyLossProcess.cc.

1298{
1299 theInverseRangeTable = p;
1300}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ SetIonisation()

◆ SetLambdaTable()

void G4VEnergyLossProcess::SetLambdaTable ( G4PhysicsTable * p)

Definition at line 1304 of file G4VEnergyLossProcess.cc.

1305{
1306 if(1 < verboseLevel) {
1307 G4cout << "### Set Lambda table " << p << " " << theLambdaTable
1308 << " for " << particle->GetParticleName()
1309 << " and process " << GetProcessName() << G4endl;
1310 }
1311 theLambdaTable = p;
1312 tablesAreBuilt = true;
1313
1314 if(isMaster && nullptr != p) {
1315 delete theEnergyOfCrossSectionMax;
1316 theEnergyOfCrossSectionMax = nullptr;
1317 if(fEmTwoPeaks == fXSType) {
1318 if(nullptr != fXSpeaks) {
1319 for(auto & ptr : *fXSpeaks) { delete ptr; }
1320 delete fXSpeaks;
1321 }
1322 G4LossTableBuilder* bld = lManager->GetTableBuilder();
1323 fXSpeaks = G4EmUtility::FillPeaksStructure(p, bld);
1324 if(nullptr == fXSpeaks) { fXSType = fEmOnePeak; }
1325 }
1326 if(fXSType == fEmOnePeak) {
1327 theEnergyOfCrossSectionMax = G4EmUtility::FindCrossSectionMax(p);
1328 if(nullptr == theEnergyOfCrossSectionMax) { fXSType = fEmIncreasing; }
1329 }
1330 }
1331}
@ fEmOnePeak
@ fEmTwoPeaks
@ fEmIncreasing
static std::vector< G4TwoPeaksXS * > * FillPeaksStructure(G4PhysicsTable *, G4LossTableBuilder *)
static std::vector< G4double > * FindCrossSectionMax(G4PhysicsTable *)

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ SetLinearLossLimit()

void G4VEnergyLossProcess::SetLinearLossLimit ( G4double val)

Definition at line 1426 of file G4VEnergyLossProcess.cc.

1427{
1428 if(0.0 < val && val < 1.0) {
1429 linLossLimit = val;
1430 actLinLossLimit = true;
1431 } else { PrintWarning("SetLinearLossLimit", val); }
1432}

Referenced by G4ionIonisation::G4ionIonisation().

◆ SetLossFluctuations()

void G4VEnergyLossProcess::SetLossFluctuations ( G4bool val)
inline

Definition at line 862 of file G4VEnergyLossProcess.hh.

863{
864 lossFluctuationFlag = val;
865 actLossFluc = true;
866}

◆ SetLowestEnergyLimit()

void G4VEnergyLossProcess::SetLowestEnergyLimit ( G4double val)

Definition at line 1449 of file G4VEnergyLossProcess.cc.

1450{
1451 if(1.e-18 < val && val < 1.e+50) { lowestKinEnergy = val; }
1452 else { PrintWarning("SetLowestEnergyLimit", val); }
1453}

◆ SetMaxKinEnergy()

void G4VEnergyLossProcess::SetMaxKinEnergy ( G4double e)

Definition at line 1480 of file G4VEnergyLossProcess.cc.

1481{
1482 if(minKinEnergy < e && e < 1.e+50) {
1483 maxKinEnergy = e;
1484 actMaxKinEnergy = true;
1485 if(e < maxKinEnergyCSDA) { maxKinEnergyCSDA = e; }
1486 } else { PrintWarning("SetMaxKinEnergy", e); }
1487}

Referenced by G4hhIonisation::InitialiseEnergyLossProcess(), and G4mplIonisation::InitialiseEnergyLossProcess().

◆ SetMinKinEnergy()

void G4VEnergyLossProcess::SetMinKinEnergy ( G4double e)

Definition at line 1470 of file G4VEnergyLossProcess.cc.

1471{
1472 if(1.e-18 < e && e < maxKinEnergy) {
1473 minKinEnergy = e;
1474 actMinKinEnergy = true;
1475 } else { PrintWarning("SetMinKinEnergy", e); }
1476}

Referenced by G4hhIonisation::InitialiseEnergyLossProcess(), and G4mplIonisation::InitialiseEnergyLossProcess().

◆ SetParticle()

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

Definition at line 817 of file G4VEnergyLossProcess.hh.

818{
819 particle = p;
820}

◆ SetRangeTableForLoss()

void G4VEnergyLossProcess::SetRangeTableForLoss ( G4PhysicsTable * p)

Definition at line 1290 of file G4VEnergyLossProcess.cc.

1291{
1292 theRangeTableForLoss = p;
1293}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ SetSecondaryParticle()

◆ SetSpline()

void G4VEnergyLossProcess::SetSpline ( G4bool val)
inline

Definition at line 870 of file G4VEnergyLossProcess.hh.

871{
872 spline = val;
873}

Referenced by G4ePairProduction::G4ePairProduction().

◆ SetStepFunction()

void G4VEnergyLossProcess::SetStepFunction ( G4double v1,
G4double v2 )

Definition at line 1436 of file G4VEnergyLossProcess.cc.

1437{
1438 if(0.0 < v1 && 0.0 < v2) {
1439 dRoverRange = std::min(1.0, v1);
1440 finalRange = std::min(v2, 1.e+50);
1441 } else {
1442 PrintWarning("SetStepFunctionV1", v1);
1443 PrintWarning("SetStepFunctionV2", v2);
1444 }
1445}

Referenced by LBE::ConstructEM(), and G4EmExtraParameters::FillStepFunction().

◆ SetTwoPeaksXS()

void G4VEnergyLossProcess::SetTwoPeaksXS ( std::vector< G4TwoPeaksXS * > * ptr)

Definition at line 1342 of file G4VEnergyLossProcess.cc.

1343{
1344 fXSpeaks = ptr;
1345}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ StartTracking()

void G4VEnergyLossProcess::StartTracking ( G4Track * track)
overridevirtual

Reimplemented from G4VProcess.

Definition at line 545 of file G4VEnergyLossProcess.cc.

546{
547 // reset parameters for the new track
550 preStepLambda = 0.0;
551 currentCouple = nullptr;
552
553 // reset ion
554 if(isIon) {
555 const G4double newmass = track->GetDefinition()->GetPDGMass();
556 massRatio = (nullptr == baseParticle) ? CLHEP::proton_mass_c2/newmass
557 : baseParticle->GetPDGMass()/newmass;
558 logMassRatio = G4Log(massRatio);
559 }
560 // forced biasing only for primary particles
561 if(nullptr != biasManager) {
562 if(0 == track->GetParentID()) {
563 biasFlag = true;
564 biasManager->ResetForcedInteraction();
565 }
566 }
567}

◆ StorePhysicsTable()

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

Reimplemented from G4VProcess.

Definition at line 1120 of file G4VEnergyLossProcess.cc.

1122{
1123 if (!isMaster || nullptr != baseParticle || part != particle ) return true;
1124 for(std::size_t i=0; i<7; ++i) {
1125 // ionisation table only for ionisation process
1126 if (nullptr == theData->Table(i) || (!isIonisation && 1 == i)) {
1127 continue;
1128 }
1129 if (-1 < verboseLevel) {
1130 G4cout << "G4VEnergyLossProcess::StorePhysicsTable i=" << i
1131 << " " << particle->GetParticleName()
1132 << " " << GetProcessName()
1133 << " " << tnames[i] << " " << theData->Table(i) << G4endl;
1134 }
1135 if (!G4EmTableUtil::StoreTable(this, part, theData->Table(i),
1136 dir, tnames[i], verboseLevel, ascii)) {
1137 return false;
1138 }
1139 }
1140 return true;
1141}
static G4bool StoreTable(G4VProcess *, const G4ParticleDefinition *, G4PhysicsTable *, const G4String &dir, const G4String &tname, G4int verb, G4bool ascii)

◆ StreamProcessInfo()

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

Reimplemented in G4eBremsstrahlung, G4ePairProduction, and G4MuPairProduction.

Definition at line 98 of file G4VEnergyLossProcess.hh.

98{};

◆ TablesAreBuilt()

G4bool G4VEnergyLossProcess::TablesAreBuilt ( ) const
inline

Definition at line 926 of file G4VEnergyLossProcess.hh.

927{
928 return tablesAreBuilt;
929}

◆ TwoPeaksXS()

std::vector< G4TwoPeaksXS * > * G4VEnergyLossProcess::TwoPeaksXS ( ) const
inline

Definition at line 997 of file G4VEnergyLossProcess.hh.

998{
999 return fXSpeaks;
1000}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

◆ UseBaseMaterial()

G4bool G4VEnergyLossProcess::UseBaseMaterial ( ) const
inline

Definition at line 982 of file G4VEnergyLossProcess.hh.

983{
984 return baseMat;
985}

Referenced by G4EmTableUtil::BuildLocalElossProcess().

Member Data Documentation

◆ currentCouple

const G4MaterialCutsCouple* G4VEnergyLossProcess::currentCouple = nullptr
protected

◆ currentCoupleIndex

◆ currentMaterial

const G4Material* G4VEnergyLossProcess::currentMaterial = nullptr
protected

◆ fParticleChange

G4ParticleChangeForLoss G4VEnergyLossProcess::fParticleChange
protected

Definition at line 415 of file G4VEnergyLossProcess.hh.

Referenced by AlongStepDoIt(), G4VEnergyLossProcess(), and PostStepDoIt().

◆ mfpKinEnergy

G4double G4VEnergyLossProcess::mfpKinEnergy = 0.0
protected

◆ preStepKinEnergy

G4double G4VEnergyLossProcess::preStepKinEnergy = 0.0
protected

Definition at line 476 of file G4VEnergyLossProcess.hh.

Referenced by AlongStepDoIt(), and PostStepGetPhysicalInteractionLength().

◆ preStepLambda

G4double G4VEnergyLossProcess::preStepLambda = 0.0
protected

◆ preStepScaledEnergy

G4double G4VEnergyLossProcess::preStepScaledEnergy = 0.0
protected

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