Geant4-11
|
#include <G4UrbanAdjointMscModel.hh>
Protected Member Functions | |
G4double | ConvertTrueToGeom (G4double &tLength, G4double &gLength) |
const G4MaterialCutsCouple * | CurrentCouple () const |
G4ParticleChangeForGamma * | GetParticleChangeForGamma () |
G4ParticleChangeForLoss * | GetParticleChangeForLoss () |
G4ParticleChangeForMSC * | GetParticleChangeForMSC (const G4ParticleDefinition *p=nullptr) |
virtual G4double | MaxSecondaryEnergy (const G4ParticleDefinition *, G4double kineticEnergy) |
void | SetCurrentElement (const G4Element *) |
Protected Attributes | |
size_t | basedCoupleIndex = 0 |
size_t | currentCoupleIndex = 0 |
G4double | dtrl = 0.05 |
G4double | facgeom = 2.5 |
G4double | facrange = 0.04 |
G4double | facsafety = 0.6 |
G4ThreeVector | fDisplacement |
G4ElementData * | fElementData = nullptr |
G4double | geomMax |
G4double | geomMin |
G4double | inveplus |
G4bool | latDisplasment = true |
G4bool | lossFlucFlag = true |
const G4Material * | pBaseMaterial = nullptr |
G4double | pFactor = 1.0 |
G4VParticleChange * | pParticleChange = nullptr |
G4bool | samplez = false |
G4double | skin = 1.0 |
G4MscStepLimitType | steppingAlgorithm |
const std::vector< G4double > * | theDensityFactor = nullptr |
const std::vector< G4int > * | theDensityIdx = nullptr |
G4PhysicsTable * | xSectionTable = nullptr |
Private Member Functions | |
G4double | Randomizetlimit () |
G4double | SampleCosineTheta (G4double trueStepLength, G4double KineticEnergy) |
void | SampleDisplacement (G4double sinTheta, G4double phi) |
void | SampleDisplacementNew (G4double sinTheta, G4double phi) |
void | SetParticle (const G4ParticleDefinition *) |
G4double | SimpleScattering (G4double xmeanth, G4double x2meanth) |
void | UpdateCache () |
Definition at line 52 of file G4UrbanAdjointMscModel.hh.
|
explicit |
Definition at line 63 of file G4UrbanAdjointMscModel.cc.
References charge, ChargeSquare, coeffc1, coeffc2, coeffc3, coeffc4, coeffth1, coeffth2, couple, currentKinEnergy, currentMaterialIndex, currentRadLength, currentRange, currentTau, displacementFlag, drr, G4VMscModel::facsafety, finalr, firstStep, fParticleChange, fr, geombig, geomlimit, geommin, insideskin, G4LossTableManager::Instance(), lambda0, lambdaeff, lambdalimit, latDisplasmentbackup, lnZ, mass, masslimite, MeV, mm, nm, par1, par2, par3, particle, G4Positron::Positron(), positron, presafety, source.hepunit::proton_mass_c2, rangecut, rangeinit, rndmEngineMod, G4VMscModel::skin, skindepth, smallstep, stepmin, taubig, taulim, tausmall, tgeom, theManager, tlimit, tlimitmin, tlimitminfix, tlimitminfix2, tPathLength, um, Z2, Z23, Zeff, Zold, and zPathLength.
|
override |
Definition at line 128 of file G4UrbanAdjointMscModel.cc.
|
delete |
Reimplemented in G4BraggIonGasModel, and G4BetheBlochIonGasModel.
Definition at line 374 of file G4VEmModel.cc.
References G4VEmModel::GetChargeSquareRatio(), G4Track::GetKineticEnergy(), G4Track::GetMaterial(), and G4Track::GetParticleDefinition().
Referenced by G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength().
|
inlineinherited |
Definition at line 566 of file G4VEmModel.hh.
References G4VEmModel::ComputeCrossSectionPerAtom(), G4Element::GetN(), G4Element::GetZ(), and G4VEmModel::SetCurrentElement().
|
overridevirtual |
Reimplemented from G4VEmModel.
Definition at line 148 of file G4UrbanAdjointMscModel.cc.
References CLHEP::barn, CLHEP::Bohr_radius, charge, ChargeSquare, CLHEP::classic_electr_radius, source.hepunit::electron_mass_c2, CLHEP::electron_mass_c2, eps, CLHEP::eV, G4Log(), G4lrint(), G4Pow::GetInstance(), CLHEP::hbarc, CLHEP::keV, mass, CLHEP::MeV, SetParticle(), CLHEP::twopi, G4Pow::Z23(), and Z23.
|
virtualinherited |
Definition at line 351 of file G4VEmModel.cc.
Referenced by G4EmCalculator::ComputeCrossSectionPerShell().
|
inlineinherited |
Definition at line 528 of file G4VEmModel.hh.
References G4VEmModel::ComputeDEDXPerVolume(), G4VEmModel::pBaseMaterial, G4VEmModel::pFactor, and G4VEmModel::SetCurrentCouple().
|
virtualinherited |
Reimplemented in G4eBremsstrahlungRelModel, G4PAIModel, G4PAIPhotModel, G4EmMultiModel, G4BetheBlochNoDeltaModel, G4BraggNoDeltaModel, G4ICRU73NoDeltaModel, G4mplIonisationModel, G4mplIonisationWithDeltaModel, G4LivermoreIonisationModel, G4PenelopeBremsstrahlungModel, G4PenelopeIonisationModel, G4MuBetheBlochModel, G4MuBremsstrahlungModel, G4MuPairProductionModel, G4BetheBlochModel, G4BraggIonModel, G4BraggModel, G4eBremParametrizedModel, G4LindhardSorensenIonModel, G4MollerBhabhaModel, G4ICRU49NuclearStoppingModel, G4AtimaEnergyLossModel, G4ICRU73QOModel, and G4IonParametrisedLossModel.
Definition at line 228 of file G4VEmModel.cc.
Referenced by G4NuclearStopping::AlongStepDoIt(), G4EmCorrections::BuildCorrectionVector(), G4VEmModel::ComputeDEDX(), G4EmCalculator::ComputeDEDX(), G4NIELCalculator::ComputeNIEL(), and G4EmCalculator::ComputeNuclearDEDX().
|
inlineinherited |
Definition at line 290 of file G4VMscModel.hh.
References G4SafetyHelper::CheckNextStep(), G4Track::GetMomentumDirection(), G4StepPoint::GetPosition(), G4Step::GetPreStepPoint(), G4Track::GetStep(), and G4VMscModel::safetyHelper.
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), and G4WentzelVIModel::ComputeTruePathLengthLimit().
Implements G4VMscModel.
Definition at line 731 of file G4UrbanAdjointMscModel.cc.
References couple, currentKinEnergy, currentRange, G4VMscModel::dtrl, G4Exp(), G4Log(), G4VMscModel::GetEnergy(), G4VMscModel::GetTransportMeanFreePath(), insideskin, lambda0, lambdaeff, mass, G4INCL::Math::max(), G4INCL::Math::min(), par1, par2, par3, particle, taulim, tausmall, tlimitminfix2, tPathLength, and zPathLength.
|
inlineinherited |
Definition at line 553 of file G4VEmModel.hh.
References G4VEmModel::CrossSectionPerVolume(), DBL_MAX, emax, and eplot::material.
|
inlineinherited |
Definition at line 272 of file G4VMscModel.hh.
References G4SafetyHelper::ComputeSafety(), and G4VMscModel::safetyHelper.
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), and G4WentzelVIModel::ComputeTruePathLengthLimit().
Definition at line 1070 of file G4UrbanAdjointMscModel.cc.
References charge, coeffth1, coeffth2, currentKinEnergy, currentRadLength, G4Exp(), G4Log(), mass, CLHEP::MeV, particle, positron, anonymous_namespace{G4PionRadiativeDecayChannel.cc}::xl, anonymous_namespace{G4PionRadiativeDecayChannel.cc}::yl, and Zeff.
Referenced by SampleCosineTheta().
|
overridevirtual |
Implements G4VMscModel.
Definition at line 424 of file G4UrbanAdjointMscModel.cc.
References charge, G4VMscModel::ComputeGeomLimit(), G4VMscModel::ComputeSafety(), G4VMscModel::ConvertTrueToGeom(), couple, currentKinEnergy, currentMaterialIndex, currentRange, drr, G4VMscModel::facgeom, G4VMscModel::facrange, G4VMscModel::facsafety, fGeomBoundary, finalr, firstStep, fr, fUseDistanceToBoundary, fUseSafety, fUseSafetyPlus, G4Log(), geombig, geomlimit, geommin, G4Track::GetDynamicParticle(), G4MaterialCutsCouple::GetIndex(), G4Material::GetIonisation(), G4DynamicParticle::GetKineticEnergy(), G4MaterialCutsCouple::GetMaterial(), G4Track::GetMaterialCutsCouple(), G4Step::GetPreStepPoint(), G4ProductionCuts::GetProductionCut(), G4MaterialCutsCouple::GetProductionCuts(), G4VMscModel::GetRange(), G4Track::GetStep(), G4VMscModel::GetTransportMeanFreePath(), G4IonisParamMat::GetZeffective(), insideskin, lambda0, lambdalimit, G4VMscModel::latDisplasment, latDisplasmentbackup, mass, masslimite, G4INCL::Math::max(), CLHEP::MeV, G4INCL::Math::min(), particle, presafety, Randomizetlimit(), rangecut, rangeinit, G4VEmModel::SetCurrentCouple(), G4VMscModel::skin, skindepth, smallstep, G4InuclParticleNames::sp, stepmin, G4VMscModel::steppingAlgorithm, tgeom, tlimit, tlimitmin, tlimitminfix, tPathLength, UpdateCache(), Zeff, and Zold.
Implements G4VMscModel.
Definition at line 794 of file G4UrbanAdjointMscModel.cc.
References currentRange, G4Exp(), G4Log(), insideskin, lambda0, par1, par3, tausmall, tlimitminfix2, tPathLength, and zPathLength.
|
inlineprotectedinherited |
Definition at line 280 of file G4VMscModel.hh.
References G4VMscModel::ComputeGeomPathLength().
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), and G4WentzelVIModel::ComputeTruePathLengthLimit().
|
virtualinherited |
Reimplemented in G4IonParametrisedLossModel, G4AtimaEnergyLossModel, G4BraggIonModel, G4ICRU73QOModel, G4BetheBlochModel, and G4LindhardSorensenIonModel.
Definition at line 399 of file G4VEmModel.cc.
Referenced by G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4EmCalculator::ComputeDEDX(), and G4EmCalculator::GetDEDX().
|
inlineinherited |
Definition at line 539 of file G4VEmModel.hh.
References G4VEmModel::CrossSectionPerVolume(), G4VEmModel::pBaseMaterial, G4VEmModel::pFactor, and G4VEmModel::SetCurrentCouple().
Referenced by G4PolarizedAnnihilation::ComputeAsymmetry(), G4PolarizedIonisation::ComputeAsymmetry(), G4PolarizedCompton::ComputeAsymmetry(), G4EmModelManager::FillLambdaVector(), and G4EmMultiModel::SampleSecondaries().
|
virtualinherited |
Reimplemented in G4LivermorePhotoElectricModel, G4PAIModel, G4PAIPhotModel, G4BetheBlochNoDeltaModel, G4BraggNoDeltaModel, G4eeToHadronsModel, G4eeToHadronsMultiModel, G4ICRU73NoDeltaModel, G4MuBetheBlochModel, G4AtimaEnergyLossModel, G4BetheBlochModel, G4BraggIonModel, G4BraggModel, G4ICRU73QOModel, G4LindhardSorensenIonModel, G4MollerBhabhaModel, G4PEEffectFluoModel, G4PenelopeRayleighModelMI, G4LEPTSAttachmentModel, G4LEPTSDissociationModel, G4LEPTSElasticModel, G4LEPTSExcitationModel, G4LEPTSIonisationModel, G4LEPTSPositroniumModel, G4LEPTSRotExcitationModel, G4LEPTSVibExcitationModel, G4eplusTo2GammaOKVIModel, G4eplusTo3GammaOKVIModel, G4PenelopeComptonModel, G4eeToTwoGammaModel, G4GoudsmitSaundersonMscModel, G4IonParametrisedLossModel, G4DNABornExcitationModel1, G4DNABornExcitationModel2, G4DNABornIonisationModel1, G4DNABornIonisationModel2, G4DNAChampionElasticModel, G4DNACPA100ElasticModel, G4DNACPA100ExcitationModel, G4DNACPA100IonisationModel, G4DNADingfelderChargeDecreaseModel, G4DNADingfelderChargeIncreaseModel, G4DNADiracRMatrixExcitationModel, G4DNAEmfietzoglouExcitationModel, G4DNAEmfietzoglouIonisationModel, G4DNAIonElasticModel, G4DNAMeltonAttachmentModel, G4DNAMillerGreenExcitationModel, G4DNAModelInterface, G4TDNAOneStepThermalizationModel< MODEL >, G4DNAQuinnPlasmonExcitationModel, G4DNARelativisticIonisationModel, G4DNARuddIonisationExtendedModel, G4DNARuddIonisationModel, G4DNASancheExcitationModel, G4DNAScreenedRutherfordElasticModel, G4DNATransformElectronModel, G4DNAUeharaScreenedRutherfordElasticModel, G4MicroElecElasticModel, G4MicroElecElasticModel_new, G4MicroElecInelasticModel, G4MicroElecInelasticModel_new, G4MicroElecLOPhononModel, G4DNAELSEPAElasticModel, G4PenelopeBremsstrahlungModel, and G4PenelopeIonisationModel.
Definition at line 237 of file G4VEmModel.cc.
References G4VEmModel::ComputeCrossSectionPerAtom(), emax, G4Material::GetElement(), G4Material::GetNumberOfElements(), G4Material::GetVecNbOfAtomsPerVolume(), G4VEmModel::nsec, G4VEmModel::SetupForMaterial(), and G4VEmModel::xsec.
Referenced by G4AdjointBremsstrahlungModel::AdjointCrossSection(), G4EmCalculator::ComputeCrossSectionPerVolume(), G4VEmProcess::ComputeCurrentLambda(), G4VEmModel::ComputeMeanFreePath(), G4TablesForExtrapolator::ComputeTrasportXS(), G4VEmModel::CrossSection(), G4LivermorePhotoElectricModel::CrossSectionPerVolume(), G4PenelopeRayleighModelMI::CrossSectionPerVolume(), G4DNADummyModel::CrossSectionPerVolume(), G4VEnergyLossProcess::CrossSectionPerVolume(), G4VEmAdjointModel::DiffCrossSectionPerVolumePrimToSecond(), G4VMscModel::GetTransportMeanFreePath(), G4VEmModel::SelectRandomAtom(), and G4VEmModel::Value().
|
inlineprotectedinherited |
Definition at line 490 of file G4VEmModel.hh.
References G4VEmModel::fCurrentCouple.
Referenced by G4eDPWACoulombScatteringModel::ComputeCrossSectionPerAtom(), G4eSingleCoulombScatteringModel::ComputeCrossSectionPerAtom(), G4IonCoulombScatteringModel::ComputeCrossSectionPerAtom(), G4eCoulombScatteringModel::ComputeCrossSectionPerAtom(), G4hCoulombScatteringModel::ComputeCrossSectionPerAtom(), G4PEEffectFluoModel::ComputeCrossSectionPerAtom(), G4EmMultiModel::ComputeCrossSectionPerAtom(), G4WentzelVIModel::ComputeCrossSectionPerAtom(), G4WentzelVIRelModel::ComputeCrossSectionPerAtom(), G4PAIModel::ComputeDEDXPerVolume(), G4PAIPhotModel::ComputeDEDXPerVolume(), G4mplIonisationModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4PAIModel::CrossSectionPerVolume(), G4PAIPhotModel::CrossSectionPerVolume(), G4eCoulombScatteringModel::MinPrimaryEnergy(), and G4hCoulombScatteringModel::MinPrimaryEnergy().
|
inlineinherited |
Definition at line 704 of file G4VEmModel.hh.
References G4VEmModel::flagDeexcitation.
Referenced by G4EmModelManager::DumpModelList().
|
virtualinherited |
Reimplemented in G4PAIModel, and G4PAIPhotModel.
Definition at line 360 of file G4VEmModel.cc.
Referenced by G4EmModelManager::AddEmModel().
|
inherited |
Definition at line 137 of file G4VMscModel.cc.
References G4VMscModel::facgeom, G4VMscModel::facrange, G4VMscModel::facsafety, fMinimal, fUseDistanceToBoundary, fUseSafetyPlus, G4endl, G4VMscModel::lambdalimit, G4VMscModel::latDisplasment, CLHEP::mm, G4VMscModel::skin, and G4VMscModel::steppingAlgorithm.
Referenced by G4EmModelManager::DumpModelList().
|
virtualinherited |
Definition at line 365 of file G4VEmModel.cc.
Referenced by G4VEmProcess::PostStepDoIt(), and G4VEnergyLossProcess::PostStepDoIt().
|
inlineinherited |
Definition at line 711 of file G4VEmModel.hh.
References G4VEmModel::flagForceBuildTable.
Referenced by G4VMscModel::GetParticleChangeForMSC().
|
inlineinherited |
Definition at line 621 of file G4VEmModel.hh.
References G4VEmModel::anglModel.
Referenced by G4EmModelManager::DumpModelList(), G4AtimaEnergyLossModel::Initialise(), G4BetheBlochModel::Initialise(), G4BraggIonModel::Initialise(), G4BraggModel::Initialise(), G4ICRU73QOModel::Initialise(), G4LindhardSorensenIonModel::Initialise(), G4MollerBhabhaModel::Initialise(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4eBremParametrizedModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNARuddIonisationExtendedModel::SampleSecondaries(), G4DNARuddIonisationModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4LivermorePhotoElectricModel::SampleSecondaries(), G4LivermoreRayleighModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel_new::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4PEEffectFluoModel::SampleSecondaries(), and G4IonParametrisedLossModel::SampleSecondaries().
|
virtualinherited |
Reimplemented in G4BraggIonModel, G4BraggModel, G4IonParametrisedLossModel, G4AtimaEnergyLossModel, G4BetheBlochModel, and G4LindhardSorensenIonModel.
Definition at line 382 of file G4VEmModel.cc.
References G4ParticleDefinition::GetPDGCharge(), and G4VEmModel::inveplus.
Referenced by G4ContinuousGainOfEnergy::AlongStepDoIt(), G4AdjointCSManager::BuildTotalSigmaTables(), G4VEmModel::ChargeSquareRatio(), G4EmCalculator::ComputeDEDX(), G4AdjointIonIonisationModel::CorrectPostStepWeight(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), and G4EmCalculator::GetDEDX().
|
inlineinherited |
Definition at line 870 of file G4VEmModel.hh.
References G4VEmModel::xSectionTable.
Referenced by G4VMultipleScattering::BuildPhysicsTable(), G4EmModelManager::DumpModelList(), G4EmCalculator::FindLambdaTable(), G4WentzelVIModel::Initialise(), and G4VMultipleScattering::StorePhysicsTable().
|
inlineinherited |
Definition at line 505 of file G4VEmModel.hh.
References G4VEmModel::fCurrentElement.
Referenced by G4VEmProcess::GetCurrentElement(), G4VEnergyLossProcess::GetCurrentElement(), G4VEmProcess::GetTargetElement(), G4PolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedPhotoElectricModel::SampleSecondaries(), G4PolarizedBremsstrahlungModel::SelectedAtom(), G4PolarizedGammaConversionModel::SelectedAtom(), and G4eBremParametrizedModel::SetCurrentElement().
|
inlineinherited |
Definition at line 512 of file G4VEmModel.hh.
References G4VEmModel::fCurrentIsotope.
Referenced by G4VEmProcess::GetTargetIsotope().
|
inherited |
Definition at line 159 of file G4VMscModel.cc.
References G4VMscModel::dedx, G4VEnergyLossProcess::GetDEDX(), G4ParticleDefinition::GetPDGCharge(), G4VEmModel::inveplus, and G4VMscModel::ionisation.
Referenced by SampleScattering(), and G4UrbanMscModel::SampleScattering().
|
inherited |
Definition at line 174 of file G4VMscModel.cc.
References G4VMscModel::dedx, G4VEnergyLossProcess::GetDEDX(), G4ParticleDefinition::GetPDGCharge(), G4VEmModel::inveplus, and G4VMscModel::ionisation.
|
inlineinherited |
Definition at line 863 of file G4VEmModel.hh.
References G4VEmModel::fElementData.
Referenced by G4MuPairProductionModel::InitialiseLocal(), G4ePairProduction::StreamProcessInfo(), and G4MuPairProduction::StreamProcessInfo().
|
inlineinherited |
Definition at line 844 of file G4VEmModel.hh.
References G4VEmModel::elmSelectors.
Referenced by G4eDPWACoulombScatteringModel::InitialiseLocal(), G4eSingleCoulombScatteringModel::InitialiseLocal(), G4PAIModel::InitialiseLocal(), G4PAIPhotModel::InitialiseLocal(), G4JAEAElasticScatteringModel::InitialiseLocal(), G4JAEAPolarizedElasticScatteringModel::InitialiseLocal(), G4LivermoreComptonModel::InitialiseLocal(), G4LivermoreNuclearGammaConversionModel::InitialiseLocal(), G4LivermorePolarizedComptonModel::InitialiseLocal(), G4LivermorePolarizedGammaConversionModel::InitialiseLocal(), G4LivermorePolarizedRayleighModel::InitialiseLocal(), G4LivermoreRayleighModel::InitialiseLocal(), G4LowEPComptonModel::InitialiseLocal(), G4LowEPPolarizedComptonModel::InitialiseLocal(), G4PenelopePhotoElectricModel::InitialiseLocal(), G4MuBremsstrahlungModel::InitialiseLocal(), G4MuPairProductionModel::InitialiseLocal(), G4BetheHeitlerModel::InitialiseLocal(), G4eBremParametrizedModel::InitialiseLocal(), G4eBremsstrahlungRelModel::InitialiseLocal(), G4eCoulombScatteringModel::InitialiseLocal(), G4hCoulombScatteringModel::InitialiseLocal(), G4KleinNishinaCompton::InitialiseLocal(), G4KleinNishinaModel::InitialiseLocal(), and G4PairProductionRelModel::InitialiseLocal().
|
inherited |
Definition at line 224 of file G4VMscModel.cc.
References G4VMscModel::dedx, G4Material::GetDensity(), G4VEnergyLossProcess::GetKineticEnergy(), G4MaterialCutsCouple::GetMaterial(), G4ParticleDefinition::GetPDGCharge(), G4VEmModel::inveplus, G4VMscModel::ionisation, G4VMscModel::localrange, and G4VMscModel::localtkin.
Referenced by ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), G4UrbanMscModel::ComputeGeomPathLength(), G4WentzelVIModel::ComputeGeomPathLength(), G4WentzelVIModel::ComputeTrueStepLength(), G4GoudsmitSaundersonMscModel::SampleMSC(), SampleScattering(), and G4UrbanMscModel::SampleScattering().
|
inlineinherited |
Definition at line 302 of file G4VMscModel.hh.
References G4VMscModel::ionisation.
|
inlineinherited |
Definition at line 614 of file G4VEmModel.hh.
References G4VEmModel::flucModel.
Referenced by G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4IonParametrisedLossModel::CorrectionsAlongStep(), G4AtimaEnergyLossModel::CorrectionsAlongStep(), G4BraggIonModel::CorrectionsAlongStep(), G4BetheBlochModel::CorrectionsAlongStep(), G4LindhardSorensenIonModel::CorrectionsAlongStep(), G4BraggModel::GetChargeSquareRatio(), G4VEnergyLossProcess::GetDEDXDispersion(), and G4EmMultiModel::Initialise().
|
inlineinherited |
Definition at line 837 of file G4VEmModel.hh.
References G4VEmModel::name.
Referenced by G4NIELCalculator::AddEmModel(), G4VLEPTSModel::BuildMeanFreePathTable(), G4VLEPTSModel::BuildPhysicsTable(), G4EmCalculator::ComputeDEDX(), G4MuPairProductionModel::DataCorrupted(), G4EmElementSelector::Dump(), G4EmModelManager::DumpModelList(), G4EmCalculator::FindEmModel(), G4NIELCalculator::G4NIELCalculator(), G4EmMultiModel::Initialise(), G4IonParametrisedLossModel::Initialise(), G4EmModelManager::Initialise(), G4IonParametrisedLossModel::PrintDEDXTable(), G4DNAAttachment::PrintInfo(), G4DNAChargeDecrease::PrintInfo(), G4DNAChargeIncrease::PrintInfo(), G4DNADissociation::PrintInfo(), G4DNAElastic::PrintInfo(), G4DNAExcitation::PrintInfo(), G4DNAIonisation::PrintInfo(), G4DNAPlasmonExcitation::PrintInfo(), G4DNAPositronium::PrintInfo(), G4DNARotExcitation::PrintInfo(), G4DNAVibExcitation::PrintInfo(), G4VLEPTSModel::ReadIXS(), G4LossTableManager::Register(), G4DNAModelInterface::RegisterModel(), G4IonParametrisedLossModel::RemoveDEDXTable(), G4VLEPTSModel::SampleEnergyLoss(), G4EmConfigurator::SetExtraEmModel(), G4EmConfigurator::SetModelForRegion(), and G4EmConfigurator::UpdateModelEnergyRange().
|
virtualinherited |
Reimplemented in G4DNABornExcitationModel1, G4DNABornExcitationModel2, G4DNABornIonisationModel1, G4DNABornIonisationModel2, G4DNAMillerGreenExcitationModel, and G4DNARelativisticIonisationModel.
Definition at line 261 of file G4VEmModel.cc.
|
protectedinherited |
Definition at line 123 of file G4VEmModel.cc.
References G4VEmModel::fTripletModel, G4VEmModel::pParticleChange, and G4VEmModel::SetParticleChange().
Referenced by G4MicroElecLOPhononModel::G4MicroElecLOPhononModel(), G4DNAChampionElasticModel::Initialise(), G4DNACPA100ElasticModel::Initialise(), G4DNADingfelderChargeDecreaseModel::Initialise(), G4DNADingfelderChargeIncreaseModel::Initialise(), G4DNAMeltonAttachmentModel::Initialise(), G4DNAMillerGreenExcitationModel::Initialise(), G4DNARuddIonisationExtendedModel::Initialise(), G4DNARuddIonisationModel::Initialise(), G4DNASancheExcitationModel::Initialise(), G4DNAScreenedRutherfordElasticModel::Initialise(), G4DNATransformElectronModel::Initialise(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4LEPTSAttachmentModel::Initialise(), G4LEPTSDissociationModel::Initialise(), G4LEPTSElasticModel::Initialise(), G4LEPTSExcitationModel::Initialise(), G4LEPTSIonisationModel::Initialise(), G4LEPTSPositroniumModel::Initialise(), G4LEPTSRotExcitationModel::Initialise(), G4LEPTSVibExcitationModel::Initialise(), G4BoldyshevTripletModel::Initialise(), G4eplusTo3GammaOKVIModel::Initialise(), G4eSingleCoulombScatteringModel::Initialise(), G4IonCoulombScatteringModel::Initialise(), G4eeToHadronsMultiModel::Initialise(), G4JAEAElasticScatteringModel::Initialise(), G4JAEAPolarizedElasticScatteringModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermoreGammaConversion5DModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4LivermorePhotoElectricModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermorePolarizedRayleighModel::Initialise(), G4LivermoreRayleighModel::Initialise(), G4LowEPComptonModel::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4MicroElecElasticModel::Initialise(), G4MicroElecElasticModel_new::Initialise(), G4MicroElecInelasticModel::Initialise(), G4MicroElecInelasticModel_new::Initialise(), G4MicroElecLOPhononModel::Initialise(), G4PenelopeAnnihilationModel::Initialise(), G4PenelopeComptonModel::Initialise(), G4PenelopeGammaConversionModel::Initialise(), G4PenelopePhotoElectricModel::Initialise(), G4PenelopeRayleighModel::Initialise(), G4PenelopeRayleighModelMI::Initialise(), G4PolarizedAnnihilationModel::Initialise(), G4BetheHeitlerModel::Initialise(), G4eCoulombScatteringModel::Initialise(), G4eDPWACoulombScatteringModel::Initialise(), G4eeToTwoGammaModel::Initialise(), G4eplusTo2GammaOKVIModel::Initialise(), G4hCoulombScatteringModel::Initialise(), G4KleinNishinaCompton::Initialise(), G4KleinNishinaModel::Initialise(), G4PairProductionRelModel::Initialise(), G4PEEffectFluoModel::Initialise(), G4XrayRayleighModel::Initialise(), G4DNABornExcitationModel1::Initialise(), G4DNABornExcitationModel2::Initialise(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4DNACPA100ExcitationModel::Initialise(), G4DNACPA100IonisationModel::Initialise(), G4DNADiracRMatrixExcitationModel::Initialise(), G4DNAEmfietzoglouExcitationModel::Initialise(), G4DNAEmfietzoglouIonisationModel::Initialise(), G4DNAQuinnPlasmonExcitationModel::Initialise(), G4DNARelativisticIonisationModel::Initialise(), G4DNAELSEPAElasticModel::Initialise(), G4DNAModelInterface::Initialise(), and G4DNAIonElasticModel::Initialise().
|
protectedinherited |
Definition at line 108 of file G4VEmModel.cc.
References G4VEmModel::fTripletModel, G4VEmModel::pParticleChange, and G4VEmModel::SetParticleChange().
Referenced by G4PAIModel::Initialise(), G4PAIPhotModel::Initialise(), G4mplIonisationModel::Initialise(), G4mplIonisationWithDeltaModel::Initialise(), G4IonParametrisedLossModel::Initialise(), G4LivermoreIonisationModel::Initialise(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4MuBetheBlochModel::Initialise(), G4MuBremsstrahlungModel::Initialise(), G4MuPairProductionModel::Initialise(), G4AtimaEnergyLossModel::Initialise(), G4BetheBlochModel::Initialise(), G4BraggIonModel::Initialise(), G4BraggModel::Initialise(), G4eBremParametrizedModel::Initialise(), G4eBremsstrahlungRelModel::Initialise(), G4ICRU73QOModel::Initialise(), G4LindhardSorensenIonModel::Initialise(), G4MollerBhabhaModel::Initialise(), and G4SeltzerBergerModel::Initialise().
|
protectedinherited |
Definition at line 78 of file G4VMscModel.cc.
References G4LossTableBuilder::BuildTableForModel(), emax, G4VEmModel::ForceBuildTableFlag(), G4ParticleDefinition::GetParticleName(), G4ParticleDefinition::GetPDGMass(), G4TransportationManager::GetSafetyHelper(), G4LossTableManager::GetTableBuilder(), G4TransportationManager::GetTransportationManager(), CLHEP::GeV, G4VEmModel::HighEnergyActivationLimit(), G4VEmModel::HighEnergyLimit(), G4SafetyHelper::InitialiseHelper(), G4EmParameters::Instance(), G4LossTableManager::Instance(), G4VEmModel::IsMaster(), G4VEmModel::LowEnergyActivationLimit(), G4VEmModel::LowEnergyLimit(), G4INCL::Math::max(), G4EmParameters::MaxKinEnergy(), G4INCL::Math::min(), G4EmParameters::MinKinEnergy(), G4VEmModel::pParticleChange, G4VMscModel::safetyHelper, and G4VEmModel::xSectionTable.
Referenced by Initialise(), G4GoudsmitSaundersonMscModel::Initialise(), G4UrbanMscModel::Initialise(), and G4WentzelVIModel::Initialise().
|
virtualinherited |
Reimplemented in G4IonParametrisedLossModel, G4BraggIonGasModel, G4BetheBlochIonGasModel, G4AtimaEnergyLossModel, G4BetheBlochModel, G4BraggIonModel, G4BraggModel, and G4LindhardSorensenIonModel.
Definition at line 391 of file G4VEmModel.cc.
References G4ParticleDefinition::GetPDGCharge().
Referenced by G4VEnergyLossProcess::AlongStepDoIt().
|
inherited |
Definition at line 189 of file G4VMscModel.cc.
References G4VMscModel::dedx, G4Material::GetDensity(), G4MaterialCutsCouple::GetMaterial(), G4ParticleDefinition::GetPDGCharge(), G4VEnergyLossProcess::GetRange(), G4VEmModel::inveplus, G4VMscModel::ionisation, G4VMscModel::localrange, and G4VMscModel::localtkin.
Referenced by G4VMultipleScattering::AlongStepDoIt(), ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), and G4WentzelVIModel::ComputeTruePathLengthLimit().
|
inherited |
Definition at line 206 of file G4VMscModel.cc.
References G4VMscModel::dedx, G4Material::GetDensity(), G4MaterialCutsCouple::GetMaterial(), G4ParticleDefinition::GetPDGCharge(), G4VEnergyLossProcess::GetRange(), G4VEmModel::inveplus, G4VMscModel::ionisation, G4VMscModel::localrange, and G4VMscModel::localtkin.
|
inlineinherited |
Definition at line 319 of file G4VMscModel.hh.
References G4VEmModel::basedCoupleIndex, G4VEmModel::CrossSectionPerVolume(), DBL_MAX, G4VEmModel::pBaseMaterial, G4VEmModel::pFactor, and G4VEmModel::xSectionTable.
Referenced by ComputeGeomPathLength(), G4UrbanMscModel::ComputeGeomPathLength(), G4WentzelVIModel::ComputeGeomPathLength(), ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTrueStepLength(), G4EmCalculator::GetCrossSectionPerVolume(), SampleCosineTheta(), and G4UrbanMscModel::SampleCosineTheta().
|
inlineinherited |
Definition at line 332 of file G4VMscModel.hh.
References G4VEmModel::basedCoupleIndex, G4VEmModel::CrossSectionPerVolume(), DBL_MAX, G4VEmModel::pBaseMaterial, G4VEmModel::pFactor, and G4VEmModel::xSectionTable.
|
inlineinherited |
Definition at line 638 of file G4VEmModel.hh.
References G4VEmModel::fTripletModel.
Referenced by G4eBremsstrahlungRelModel::Initialise(), G4SeltzerBergerModel::Initialise(), and G4eBremsstrahlungRelModel::SampleSecondaries().
|
inlineinherited |
Definition at line 669 of file G4VEmModel.hh.
References G4VEmModel::eMaxActive.
Referenced by G4EmModelManager::DumpModelList(), G4VMscModel::GetParticleChangeForMSC(), G4WentzelVIModel::Initialise(), and G4EmModelManager::Initialise().
|
inlineinherited |
Definition at line 655 of file G4VEmModel.hh.
References G4VEmModel::highLimit.
Referenced by G4DNAChampionElasticModel::CrossSectionPerVolume(), G4DNACPA100ElasticModel::CrossSectionPerVolume(), G4DNACPA100ExcitationModel::CrossSectionPerVolume(), G4DNACPA100IonisationModel::CrossSectionPerVolume(), G4DNAEmfietzoglouExcitationModel::CrossSectionPerVolume(), G4DNAEmfietzoglouIonisationModel::CrossSectionPerVolume(), G4DNAMeltonAttachmentModel::CrossSectionPerVolume(), G4DNASancheExcitationModel::CrossSectionPerVolume(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNATransformElectronModel::CrossSectionPerVolume(), G4DNAELSEPAElasticModel::CrossSectionPerVolume(), G4DNAChampionElasticModel::G4DNAChampionElasticModel(), G4DNACPA100ElasticModel::G4DNACPA100ElasticModel(), G4DNAMeltonAttachmentModel::G4DNAMeltonAttachmentModel(), G4DNASancheExcitationModel::G4DNASancheExcitationModel(), G4DNAUeharaScreenedRutherfordElasticModel::G4DNAUeharaScreenedRutherfordElasticModel(), G4eeToHadronsModel::G4eeToHadronsModel(), G4IonParametrisedLossModel::G4IonParametrisedLossModel(), G4LivermorePolarizedRayleighModel::G4LivermorePolarizedRayleighModel(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PenelopeBremsstrahlungModel::GetCrossSectionTableForCouple(), G4VMscModel::GetParticleChangeForMSC(), G4DNAChampionElasticModel::Initialise(), G4DNACPA100ElasticModel::Initialise(), G4DNADingfelderChargeDecreaseModel::Initialise(), G4DNADingfelderChargeIncreaseModel::Initialise(), G4DNAMeltonAttachmentModel::Initialise(), G4DNAMillerGreenExcitationModel::Initialise(), G4DNARuddIonisationExtendedModel::Initialise(), G4DNARuddIonisationModel::Initialise(), G4DNASancheExcitationModel::Initialise(), G4DNAScreenedRutherfordElasticModel::Initialise(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4BoldyshevTripletModel::Initialise(), G4PAIModel::Initialise(), G4PAIPhotModel::Initialise(), G4JAEAElasticScatteringModel::Initialise(), G4JAEAPolarizedElasticScatteringModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermoreGammaConversion5DModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermoreIonisationModel::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermoreRayleighModel::Initialise(), G4LowEPComptonModel::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4MicroElecElasticModel::Initialise(), G4MicroElecElasticModel_new::Initialise(), G4MicroElecInelasticModel::Initialise(), G4MicroElecInelasticModel_new::Initialise(), G4PenelopeAnnihilationModel::Initialise(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeComptonModel::Initialise(), G4PenelopeGammaConversionModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4PenelopePhotoElectricModel::Initialise(), G4PenelopeRayleighModel::Initialise(), G4PenelopeRayleighModelMI::Initialise(), G4MuBremsstrahlungModel::Initialise(), G4MuPairProductionModel::Initialise(), G4eBremsstrahlungRelModel::Initialise(), G4eDPWACoulombScatteringModel::Initialise(), G4GoudsmitSaundersonMscModel::Initialise(), G4PairProductionRelModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4WentzelVIModel::Initialise(), G4DNABornExcitationModel1::Initialise(), G4DNABornExcitationModel2::Initialise(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4DNACPA100ExcitationModel::Initialise(), G4DNACPA100IonisationModel::Initialise(), G4DNADiracRMatrixExcitationModel::Initialise(), G4DNAEmfietzoglouExcitationModel::Initialise(), G4DNAEmfietzoglouIonisationModel::Initialise(), G4DNAQuinnPlasmonExcitationModel::Initialise(), G4DNARelativisticIonisationModel::Initialise(), G4EmModelManager::Initialise(), G4DNAELSEPAElasticModel::Initialise(), G4DNADummyModel::Initialise(), G4DNAIonElasticModel::Initialise(), G4mplIonisation::InitialiseEnergyLossProcess(), G4ionIonisation::InitialiseEnergyLossProcess(), G4MuBremsstrahlungModel::InitialiseLocal(), G4MuPairProductionModel::InitialiseLocal(), G4eBremsstrahlungRelModel::InitialiseLocal(), G4PairProductionRelModel::InitialiseLocal(), G4CoulombScattering::InitialiseProcess(), G4VEmProcess::PostStepDoIt(), G4VEmProcess::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), G4VMultipleScattering::PreparePhysicsTable(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNASancheExcitationModel::SampleSecondaries(), G4EmConfigurator::SetExtraEmModel(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G4eBremsstrahlung::StreamProcessInfo(), and G4EmConfigurator::UpdateModelEnergyRange().
|
overridevirtual |
Implements G4VEmModel.
Definition at line 131 of file G4UrbanAdjointMscModel.cc.
References G4Electron::Electron(), fParticleChange, G4VMscModel::GetParticleChangeForMSC(), G4ParticleDefinition::GetParticleName(), G4VMscModel::latDisplasment, latDisplasmentbackup, and SetParticle().
|
inherited |
Definition at line 138 of file G4VEmModel.cc.
References DBL_MAX, G4VEmModel::elmSelectors, emax, G4Log(), G4ProductionCutsTable::GetMaterialCutsCouple(), G4ProductionCutsTable::GetProductionCutsTable(), G4ProductionCutsTable::GetTableSize(), G4VEmModel::highLimit, G4VEmModel::Initialise(), G4EmParameters::Instance(), G4VEmModel::lowLimit, eplot::material, G4INCL::Math::max(), G4VEmModel::MinPrimaryEnergy(), G4VEmModel::nSelectors, G4EmParameters::NumberOfBinsPerDecade(), and G4VEmModel::SetCurrentCouple().
Referenced by G4eSingleCoulombScatteringModel::Initialise(), G4PAIModel::Initialise(), G4PAIPhotModel::Initialise(), G4JAEAElasticScatteringModel::Initialise(), G4JAEAPolarizedElasticScatteringModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermoreGammaConversion5DModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermorePolarizedRayleighModel::Initialise(), G4LivermoreRayleighModel::Initialise(), G4LowEPComptonModel::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4PenelopePhotoElectricModel::Initialise(), G4MuBremsstrahlungModel::Initialise(), G4MuPairProductionModel::Initialise(), G4BetheHeitlerModel::Initialise(), G4eBremParametrizedModel::Initialise(), G4eBremsstrahlungRelModel::Initialise(), G4eCoulombScatteringModel::Initialise(), G4eDPWACoulombScatteringModel::Initialise(), G4hCoulombScatteringModel::Initialise(), G4KleinNishinaCompton::Initialise(), G4KleinNishinaModel::Initialise(), G4PairProductionRelModel::Initialise(), G4SeltzerBergerModel::Initialise(), and G4XrayRayleighModel::Initialise().
|
virtualinherited |
Reimplemented in G4BoldyshevTripletModel, G4JAEAElasticScatteringModel, G4JAEAPolarizedElasticScatteringModel, G4LivermoreBremsstrahlungModel, G4LivermoreComptonModel, G4LivermoreGammaConversion5DModel, G4LivermoreGammaConversionModel, G4LivermoreNuclearGammaConversionModel, G4LivermorePhotoElectricModel, G4LivermorePolarizedComptonModel, G4LivermorePolarizedGammaConversionModel, G4LivermorePolarizedRayleighModel, G4LivermoreRayleighModel, G4LowEPComptonModel, and G4LowEPPolarizedComptonModel.
Definition at line 223 of file G4VEmModel.cc.
Referenced by G4EmCalculator::ComputeCrossSectionPerAtom(), G4EmCalculator::ComputeCrossSectionPerShell(), and G4VEmModel::InitialiseForMaterial().
|
virtualinherited |
Definition at line 209 of file G4VEmModel.cc.
References G4VEmModel::InitialiseForElement(), eplot::material, CLHEP::detail::n, and Z.
Referenced by G4EmCalculator::FindEmModel().
|
virtualinherited |
Reimplemented in G4PenelopeAnnihilationModel, G4PenelopeBremsstrahlungModel, G4PenelopeGammaConversionModel, G4PenelopeIonisationModel, G4eDPWACoulombScatteringModel, G4eSingleCoulombScatteringModel, G4PAIModel, G4PAIPhotModel, G4JAEAElasticScatteringModel, G4JAEAPolarizedElasticScatteringModel, G4LivermoreComptonModel, G4LivermoreNuclearGammaConversionModel, G4LivermorePolarizedComptonModel, G4LivermorePolarizedGammaConversionModel, G4LivermorePolarizedRayleighModel, G4LivermoreRayleighModel, G4LowEPComptonModel, G4LowEPPolarizedComptonModel, G4PenelopeComptonModel, G4PenelopePhotoElectricModel, G4PenelopeRayleighModel, G4PenelopeRayleighModelMI, G4MuBremsstrahlungModel, G4MuPairProductionModel, G4BetheHeitlerModel, G4eBremParametrizedModel, G4eBremsstrahlungRelModel, G4eCoulombScatteringModel, G4hCoulombScatteringModel, G4KleinNishinaCompton, G4KleinNishinaModel, G4PairProductionRelModel, G4WentzelVIModel, and G4GoudsmitSaundersonMscModel.
Definition at line 204 of file G4VEmModel.cc.
Referenced by G4VEmProcess::BuildPhysicsTable(), G4VEnergyLossProcess::BuildPhysicsTable(), and G4VMultipleScattering::BuildPhysicsTable().
|
inherited |
Definition at line 116 of file G4VMscModel.cc.
References G4VMscModel::facgeom, G4VMscModel::facrange, G4VMscModel::facsafety, G4ParticleDefinition::GetPDGEncoding(), G4EmParameters::Instance(), G4VEmModel::IsLocked(), G4VMscModel::lambdalimit, G4VMscModel::latDisplasment, G4EmParameters::LateralDisplacement(), G4EmParameters::MscGeomFactor(), G4EmParameters::MscLambdaLimit(), G4EmParameters::MscMuHadRangeFactor(), G4EmParameters::MscMuHadStepLimitType(), G4EmParameters::MscRangeFactor(), G4EmParameters::MscSafetyFactor(), G4EmParameters::MscSkin(), G4EmParameters::MscStepLimitType(), G4EmParameters::MuHadLateralDisplacement(), G4VMscModel::skin, and G4VMscModel::steppingAlgorithm.
Referenced by G4GoudsmitSaundersonMscModel::Initialise(), G4UrbanMscModel::Initialise(), and G4WentzelVIModel::Initialise().
Definition at line 795 of file G4VEmModel.hh.
References G4VEmModel::eMaxActive, and G4VEmModel::eMinActive.
Referenced by G4VEnergyLossProcess::AlongStepDoIt(), G4NuclearStopping::AlongStepDoIt(), G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::AlongStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), and G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength().
|
inlineinherited |
Definition at line 877 of file G4VEmModel.hh.
References G4VEmModel::isLocked.
Referenced by G4VMscModel::InitialiseParameters(), G4VMscModel::SetGeomFactor(), G4VMscModel::SetLambdaLimit(), G4VMscModel::SetLateralDisplasmentFlag(), G4VMscModel::SetRangeFactor(), G4VMscModel::SetSafetyFactor(), G4VMscModel::SetSampleZ(), G4VMscModel::SetSkin(), and G4VMscModel::SetStepLimitType().
|
inlineinherited |
Definition at line 746 of file G4VEmModel.hh.
References G4VEmModel::isMaster.
Referenced by G4PenelopeBremsstrahlungModel::BuildXSTable(), G4PenelopeBremsstrahlungModel::ClearTables(), G4MuPairProductionModel::DataCorrupted(), G4PenelopePhotoElectricModel::GetNumberOfShellXS(), G4VMscModel::GetParticleChangeForMSC(), G4BoldyshevTripletModel::Initialise(), G4eSingleCoulombScatteringModel::Initialise(), G4PAIModel::Initialise(), G4PAIPhotModel::Initialise(), G4EmMultiModel::Initialise(), G4mplIonisationModel::Initialise(), G4mplIonisationWithDeltaModel::Initialise(), G4JAEAElasticScatteringModel::Initialise(), G4JAEAPolarizedElasticScatteringModel::Initialise(), G4LivermoreBremsstrahlungModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermoreGammaConversion5DModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4LivermorePhotoElectricModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermorePolarizedRayleighModel::Initialise(), G4LivermoreRayleighModel::Initialise(), G4LowEPComptonModel::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4PenelopeAnnihilationModel::Initialise(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeComptonModel::Initialise(), G4PenelopeGammaConversionModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4PenelopePhotoElectricModel::Initialise(), G4PenelopeRayleighModel::Initialise(), G4PenelopeRayleighModelMI::Initialise(), G4MuBremsstrahlungModel::Initialise(), G4MuPairProductionModel::Initialise(), G4BetheBlochModel::Initialise(), G4BetheHeitlerModel::Initialise(), G4BraggIonModel::Initialise(), G4BraggModel::Initialise(), G4eBremParametrizedModel::Initialise(), G4eBremsstrahlungRelModel::Initialise(), G4eCoulombScatteringModel::Initialise(), G4eDPWACoulombScatteringModel::Initialise(), G4eeToTwoGammaModel::Initialise(), G4eplusTo2GammaOKVIModel::Initialise(), G4GoudsmitSaundersonMscModel::Initialise(), G4hCoulombScatteringModel::Initialise(), G4KleinNishinaCompton::Initialise(), G4KleinNishinaModel::Initialise(), G4LindhardSorensenIonModel::Initialise(), G4PairProductionRelModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4WentzelVIModel::Initialise(), G4PenelopeBremsstrahlungModel::InitialiseLocal(), G4PenelopeGammaConversionModel::ReadDataFile(), G4PenelopePhotoElectricModel::ReadDataFile(), G4BetheHeitlerModel::~G4BetheHeitlerModel(), G4BoldyshevTripletModel::~G4BoldyshevTripletModel(), G4BraggIonModel::~G4BraggIonModel(), G4BraggModel::~G4BraggModel(), G4eBremsstrahlungRelModel::~G4eBremsstrahlungRelModel(), G4eDPWACoulombScatteringModel::~G4eDPWACoulombScatteringModel(), G4GoudsmitSaundersonMscModel::~G4GoudsmitSaundersonMscModel(), G4JAEAElasticScatteringModel::~G4JAEAElasticScatteringModel(), G4JAEAPolarizedElasticScatteringModel::~G4JAEAPolarizedElasticScatteringModel(), G4LivermoreBremsstrahlungModel::~G4LivermoreBremsstrahlungModel(), G4LivermoreComptonModel::~G4LivermoreComptonModel(), G4LivermoreGammaConversion5DModel::~G4LivermoreGammaConversion5DModel(), G4LivermoreGammaConversionModel::~G4LivermoreGammaConversionModel(), G4LivermoreNuclearGammaConversionModel::~G4LivermoreNuclearGammaConversionModel(), G4LivermorePhotoElectricModel::~G4LivermorePhotoElectricModel(), G4LivermorePolarizedComptonModel::~G4LivermorePolarizedComptonModel(), G4LivermorePolarizedGammaConversionModel::~G4LivermorePolarizedGammaConversionModel(), G4LivermorePolarizedRayleighModel::~G4LivermorePolarizedRayleighModel(), G4LivermoreRayleighModel::~G4LivermoreRayleighModel(), G4LowEPComptonModel::~G4LowEPComptonModel(), G4LowEPPolarizedComptonModel::~G4LowEPPolarizedComptonModel(), G4mplIonisationModel::~G4mplIonisationModel(), G4mplIonisationWithDeltaModel::~G4mplIonisationWithDeltaModel(), G4PAIModel::~G4PAIModel(), G4PAIPhotModel::~G4PAIPhotModel(), G4PairProductionRelModel::~G4PairProductionRelModel(), G4PenelopeBremsstrahlungModel::~G4PenelopeBremsstrahlungModel(), G4PenelopeGammaConversionModel::~G4PenelopeGammaConversionModel(), G4PenelopeIonisationModel::~G4PenelopeIonisationModel(), G4PenelopePhotoElectricModel::~G4PenelopePhotoElectricModel(), G4PenelopeRayleighModel::~G4PenelopeRayleighModel(), G4PenelopeRayleighModelMI::~G4PenelopeRayleighModelMI(), G4SeltzerBergerModel::~G4SeltzerBergerModel(), and G4WentzelVIModel::~G4WentzelVIModel().
|
inlineinherited |
Definition at line 676 of file G4VEmModel.hh.
References G4VEmModel::eMinActive.
Referenced by G4EmModelManager::DumpModelList(), G4VMscModel::GetParticleChangeForMSC(), G4WentzelVIModel::Initialise(), and G4EmModelManager::Initialise().
|
inlineinherited |
Definition at line 662 of file G4VEmModel.hh.
References G4VEmModel::lowLimit.
Referenced by G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4LivermoreComptonModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedComptonModel::ComputeCrossSectionPerAtom(), G4LowEPComptonModel::ComputeCrossSectionPerAtom(), G4LowEPPolarizedComptonModel::ComputeCrossSectionPerAtom(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4EmCalculator::ComputeDEDX(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4IonParametrisedLossModel::ComputeDEDXPerVolume(), G4IonParametrisedLossModel::CorrectionsAlongStep(), G4PenelopeRayleighModelMI::CrossSectionPerVolume(), G4PenelopeComptonModel::CrossSectionPerVolume(), G4DNAChampionElasticModel::CrossSectionPerVolume(), G4DNACPA100ElasticModel::CrossSectionPerVolume(), G4DNACPA100ExcitationModel::CrossSectionPerVolume(), G4DNACPA100IonisationModel::CrossSectionPerVolume(), G4DNAEmfietzoglouExcitationModel::CrossSectionPerVolume(), G4DNAEmfietzoglouIonisationModel::CrossSectionPerVolume(), G4DNAMeltonAttachmentModel::CrossSectionPerVolume(), G4DNASancheExcitationModel::CrossSectionPerVolume(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNAELSEPAElasticModel::CrossSectionPerVolume(), G4EmCalculator::FindEmModel(), G4DNAChampionElasticModel::G4DNAChampionElasticModel(), G4DNACPA100ElasticModel::G4DNACPA100ElasticModel(), G4DNAMeltonAttachmentModel::G4DNAMeltonAttachmentModel(), G4DNASancheExcitationModel::G4DNASancheExcitationModel(), G4DNAUeharaScreenedRutherfordElasticModel::G4DNAUeharaScreenedRutherfordElasticModel(), G4eeToHadronsModel::G4eeToHadronsModel(), G4LivermorePolarizedRayleighModel::G4LivermorePolarizedRayleighModel(), G4PenelopeBremsstrahlungModel::GetCrossSectionTableForCouple(), G4VMscModel::GetParticleChangeForMSC(), G4DNAChampionElasticModel::Initialise(), G4DNACPA100ElasticModel::Initialise(), G4DNADingfelderChargeDecreaseModel::Initialise(), G4DNADingfelderChargeIncreaseModel::Initialise(), G4DNAMeltonAttachmentModel::Initialise(), G4DNAMillerGreenExcitationModel::Initialise(), G4DNARuddIonisationExtendedModel::Initialise(), G4DNARuddIonisationModel::Initialise(), G4DNASancheExcitationModel::Initialise(), G4DNAScreenedRutherfordElasticModel::Initialise(), G4DNAUeharaScreenedRutherfordElasticModel::Initialise(), G4BoldyshevTripletModel::Initialise(), G4PAIModel::Initialise(), G4PAIPhotModel::Initialise(), G4JAEAElasticScatteringModel::Initialise(), G4JAEAPolarizedElasticScatteringModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermoreGammaConversion5DModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermoreIonisationModel::Initialise(), G4LivermoreNuclearGammaConversionModel::Initialise(), G4LivermorePolarizedComptonModel::Initialise(), G4LivermorePolarizedGammaConversionModel::Initialise(), G4LivermoreRayleighModel::Initialise(), G4LowEPComptonModel::Initialise(), G4LowEPPolarizedComptonModel::Initialise(), G4MicroElecElasticModel::Initialise(), G4MicroElecElasticModel_new::Initialise(), G4MicroElecInelasticModel::Initialise(), G4MicroElecInelasticModel_new::Initialise(), G4PenelopeAnnihilationModel::Initialise(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeComptonModel::Initialise(), G4PenelopeGammaConversionModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4PenelopePhotoElectricModel::Initialise(), G4PenelopeRayleighModel::Initialise(), G4PenelopeRayleighModelMI::Initialise(), G4MuPairProductionModel::Initialise(), G4eBremParametrizedModel::Initialise(), G4eBremsstrahlungRelModel::Initialise(), G4eDPWACoulombScatteringModel::Initialise(), G4GoudsmitSaundersonMscModel::Initialise(), G4PairProductionRelModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4WentzelVIModel::Initialise(), G4DNABornExcitationModel1::Initialise(), G4DNABornExcitationModel2::Initialise(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4DNACPA100ExcitationModel::Initialise(), G4DNACPA100IonisationModel::Initialise(), G4DNADiracRMatrixExcitationModel::Initialise(), G4DNAEmfietzoglouExcitationModel::Initialise(), G4DNAEmfietzoglouIonisationModel::Initialise(), G4DNAQuinnPlasmonExcitationModel::Initialise(), G4DNARelativisticIonisationModel::Initialise(), G4EmModelManager::Initialise(), G4DNAELSEPAElasticModel::Initialise(), G4DNADummyModel::Initialise(), G4DNAIonElasticModel::Initialise(), G4mplIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlungRelModel::InitialiseLocal(), G4PairProductionRelModel::InitialiseLocal(), G4CoulombScattering::InitialiseProcess(), G4VEmProcess::PostStepDoIt(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4EmConfigurator::SetExtraEmModel(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), and G4EmConfigurator::UpdateModelEnergyRange().
|
inlineinherited |
Definition at line 697 of file G4VEmModel.hh.
References G4VEmModel::theLPMflag.
Referenced by G4eBremsstrahlungRelModel::Initialise(), G4eBremsstrahlungRelModel::SetupForMaterial(), G4SeltzerBergerModel::SetupForMaterial(), and G4eBremsstrahlungRelModel::~G4eBremsstrahlungRelModel().
|
protectedvirtualinherited |
Reimplemented in G4BraggIonModel, G4BraggModel, G4ICRU73QOModel, G4MollerBhabhaModel, G4PAIModel, G4PAIPhotModel, G4mplIonisationWithDeltaModel, G4MuBetheBlochModel, G4AtimaEnergyLossModel, G4BetheBlochModel, G4LindhardSorensenIonModel, and G4IonParametrisedLossModel.
Definition at line 432 of file G4VEmModel.cc.
Referenced by G4VEmModel::MaxSecondaryKinEnergy().
|
inlineinherited |
Definition at line 520 of file G4VEmModel.hh.
References G4DynamicParticle::GetKineticEnergy(), G4DynamicParticle::GetParticleDefinition(), and G4VEmModel::MaxSecondaryEnergy().
Referenced by G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4VEnergyLossProcess::GetDEDXDispersion(), G4MuBetheBlochModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), and G4IonParametrisedLossModel::SampleSecondaries().
|
virtualinherited |
Reimplemented in G4IonParametrisedLossModel, G4PenelopeBremsstrahlungModel, G4PenelopeIonisationModel, G4MuBetheBlochModel, G4MuBremsstrahlungModel, G4eBremParametrizedModel, G4PAIModel, G4PAIPhotModel, G4mplIonisationWithDeltaModel, G4AtimaEnergyLossModel, G4BetheBlochModel, G4BraggIonModel, G4BraggModel, and G4LindhardSorensenIonModel.
Definition at line 424 of file G4VEmModel.cc.
Referenced by G4EmModelManager::Initialise().
|
virtualinherited |
Reimplemented in G4eBremsstrahlungRelModel, G4BoldyshevTripletModel, G4eCoulombScatteringModel, G4hCoulombScatteringModel, G4LivermoreNuclearGammaConversionModel, G4LivermorePolarizedGammaConversionModel, G4MuBremsstrahlungModel, G4MuPairProductionModel, and G4eDPWACoulombScatteringModel.
Definition at line 415 of file G4VEmModel.cc.
Referenced by G4LossTableBuilder::BuildTableForModel(), and G4VEmModel::InitialiseElementSelectors().
|
virtualinherited |
Reimplemented in G4eeToHadronsMultiModel.
Definition at line 469 of file G4VEmModel.cc.
|
delete |
|
inlineinherited |
Definition at line 683 of file G4VEmModel.hh.
References G4VEmModel::polarAngleLimit.
Referenced by G4eCoulombScatteringModel::Initialise(), G4eDPWACoulombScatteringModel::Initialise(), G4hCoulombScatteringModel::Initialise(), and G4WentzelVIModel::Initialise().
|
inlineprivate |
Definition at line 186 of file G4UrbanAdjointMscModel.hh.
References rndmEngineMod, G4INCL::DeJongSpin::shoot(), tlimit, and tlimitmin.
Referenced by ComputeTruePathLengthLimit().
|
private |
Definition at line 904 of file G4UrbanAdjointMscModel.cc.
References coeffc1, coeffc2, coeffc3, coeffc4, ComputeTheta0(), couple, currentKinEnergy, currentRadLength, currentTau, CLHEP::HepRandomEngine::flat(), G4Exp(), G4Log(), G4MaterialCutsCouple::GetMaterial(), G4Material::GetRadlen(), G4VMscModel::GetTransportMeanFreePath(), lambda0, lambdaeff, lambdalimit, G4INCL::Math::min(), particle, CLHEP::pi, rndmEngineMod, SimpleScattering(), taubig, tausmall, and tlimitmin.
Referenced by SampleScattering().
Definition at line 1123 of file G4UrbanAdjointMscModel.cc.
References currentTau, G4VMscModel::fDisplacement, CLHEP::HepRandomEngine::flat(), G4Exp(), G4Log(), insideskin, lambdaeff, G4INCL::Math::min(), rndmEngineMod, CLHEP::Hep3Vector::set(), taubig, taulim, tausmall, anonymous_namespace{G4ChipsKaonMinusElasticXS.cc}::third, tPathLength, twopi, and zPathLength.
Referenced by SampleScattering().
Definition at line 1183 of file G4UrbanAdjointMscModel.cc.
References G4VMscModel::fDisplacement, CLHEP::HepRandomEngine::flat(), G4Exp(), G4Log(), rndmEngineMod, CLHEP::Hep3Vector::set(), G4INCL::DeJongSpin::shoot(), tPathLength, and zPathLength.
Referenced by SampleScattering().
|
overridevirtual |
Implements G4VMscModel.
Definition at line 850 of file G4UrbanAdjointMscModel.cc.
References couple, currentKinEnergy, currentRange, currentTau, displacementFlag, G4VMscModel::dtrl, eV, G4VMscModel::fDisplacement, CLHEP::HepRandomEngine::flat(), fParticleChange, G4VMscModel::GetDEDX(), G4VMscModel::GetEnergy(), lambda0, G4VMscModel::latDisplasment, particle, G4ParticleChangeForMSC::ProposeMomentumDirection(), rndmEngineMod, CLHEP::Hep3Vector::rotateUz(), SampleCosineTheta(), SampleDisplacement(), SampleDisplacementNew(), CLHEP::Hep3Vector::set(), tausmall, tlimitminfix, tPathLength, and twopi.
|
overridevirtualinherited |
|
inlineinherited |
Definition at line 690 of file G4VEmModel.hh.
References G4VEmModel::secondaryThreshold.
Referenced by G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4eBremParametrizedModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), and G4MuPairProductionModel::SampleSecondaries().
Definition at line 319 of file G4VEmModel.cc.
References ab, G4VEmModel::fCurrentIsotope, G4UniformRand, G4Element::GetIsotope(), G4Isotope::GetN(), G4Element::GetNumberOfIsotopes(), G4Element::GetRelativeAbundanceVector(), and G4VEmModel::SetCurrentElement().
Referenced by G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), and G4BetheHeitler5DModel::SampleSecondaries().
|
inherited |
Definition at line 275 of file G4VEmModel.cc.
References G4VEmModel::CrossSectionPerVolume(), G4VEmModel::fCurrentElement, G4UniformRand, G4Material::GetElement(), G4Material::GetNumberOfElements(), CLHEP::detail::n, and G4VEmModel::xsec.
|
inlineinherited |
Definition at line 580 of file G4VEmModel.hh.
References G4VEmModel::elmSelectors, G4VEmModel::fCurrentElement, G4VEmModel::fCurrentIsotope, G4MaterialCutsCouple::GetIndex(), G4VEmModel::nSelectors, G4VEmModel::pBaseMaterial, G4VEmModel::SelectRandomAtom(), and G4VEmModel::SetCurrentCouple().
Referenced by G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4JAEAPolarizedElasticScatteringModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePhotoElectricModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4LivermoreRayleighModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4PEEffectFluoModel::SampleSecondaries(), G4VEmModel::SelectRandomAtom(), and G4VEmModel::SelectTargetAtom().
|
inherited |
Definition at line 297 of file G4VEmModel.cc.
References G4VEmModel::fCurrentElement, G4UniformRand, G4Material::GetElement(), G4Material::GetNumberOfElements(), G4Material::GetTotNbOfAtomsPerVolume(), G4Material::GetVecNbOfAtomsPerVolume(), G4Element::GetZasInt(), and G4InuclParticleNames::nn.
Referenced by G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), and G4IonParametrisedLossModel::SampleSecondaries().
|
inlineinherited |
Definition at line 597 of file G4VEmModel.hh.
References G4VEmModel::elmSelectors, G4VEmModel::fCurrentElement, G4VEmModel::fCurrentIsotope, G4MaterialCutsCouple::GetIndex(), G4VEmModel::nSelectors, G4VEmModel::pBaseMaterial, G4VEmModel::SelectRandomAtom(), and G4VEmModel::SetCurrentCouple().
Referenced by G4eBremParametrizedModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PAIModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4eDPWACoulombScatteringModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), and G4BetheHeitler5DModel::SampleSecondaries().
|
inlineinherited |
Definition at line 781 of file G4VEmModel.hh.
References G4VEmModel::eMaxActive.
Referenced by G4EmModelActivator::ActivateMicroElec(), G4EmDNAPhysics_option7::ConstructProcess(), G4EmDNAPhysics_option8::ConstructProcess(), G4NuclearStopping::InitialiseProcess(), and G4EmConfigurator::SetExtraEmModel().
|
inlineinherited |
Definition at line 788 of file G4VEmModel.hh.
References G4VEmModel::eMinActive.
Referenced by G4EmModelActivator::ActivateMicroElec(), G4EmDNAPhysicsActivator::AddElectronModels0(), G4EmDNAPhysicsActivator::AddElectronModels2(), G4EmDNAPhysicsActivator::AddElectronModels4(), G4EmDNAPhysicsActivator::AddElectronModels4a(), G4EmDNAPhysicsActivator::AddElectronModels6(), G4EmDNAPhysicsActivator::AddElectronModels6a(), G4EmDNAPhysicsActivator::AddElectronModels7(), G4EmDNAPhysicsActivator::AddGenericIonModels0(), G4EmDNAPhysicsActivator::AddHeliumModels0(), G4EmDNAPhysicsActivator::AddProtonModels0(), G4EmModelActivator::AddStandardScattering(), G4EmDNAPhysics_option7::ConstructProcess(), G4EmDNAPhysics_option8::ConstructProcess(), G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option1::ConstructProcess(), G4EmStandardPhysics_option2::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsGS::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), and G4EmDNAPhysicsActivator::DeactivateNuclearStopping().
|
inlineinherited |
Definition at line 628 of file G4VEmModel.hh.
References G4VEmModel::anglModel.
Referenced by G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsSS::ConstructProcess(), G4BetheHeitlerModel::G4BetheHeitlerModel(), G4DNABornIonisationModel1::G4DNABornIonisationModel1(), G4DNABornIonisationModel2::G4DNABornIonisationModel2(), G4DNAEmfietzoglouIonisationModel::G4DNAEmfietzoglouIonisationModel(), G4DNARuddIonisationExtendedModel::G4DNARuddIonisationExtendedModel(), G4DNARuddIonisationModel::G4DNARuddIonisationModel(), G4eBremParametrizedModel::G4eBremParametrizedModel(), G4eBremsstrahlungRelModel::G4eBremsstrahlungRelModel(), G4IonParametrisedLossModel::G4IonParametrisedLossModel(), G4LivermoreBremsstrahlungModel::G4LivermoreBremsstrahlungModel(), G4LivermoreIonisationModel::G4LivermoreIonisationModel(), G4LivermorePhotoElectricModel::G4LivermorePhotoElectricModel(), G4LivermoreRayleighModel::G4LivermoreRayleighModel(), G4MicroElecInelasticModel::G4MicroElecInelasticModel(), G4MicroElecInelasticModel_new::G4MicroElecInelasticModel_new(), G4MuBremsstrahlungModel::G4MuBremsstrahlungModel(), G4MuPairProductionModel::G4MuPairProductionModel(), G4PAIModel::G4PAIModel(), G4PAIPhotModel::G4PAIPhotModel(), G4PairProductionRelModel::G4PairProductionRelModel(), G4PEEffectFluoModel::G4PEEffectFluoModel(), G4SeltzerBergerModel::G4SeltzerBergerModel(), G4AtimaEnergyLossModel::Initialise(), G4BetheBlochModel::Initialise(), G4BraggIonModel::Initialise(), G4BraggModel::Initialise(), G4ICRU73QOModel::Initialise(), G4LindhardSorensenIonModel::Initialise(), and G4MollerBhabhaModel::Initialise().
|
inlineinherited |
Definition at line 725 of file G4VEmModel.hh.
References G4VEmModel::useAngularGenerator.
Referenced by G4VEnergyLossProcess::PreparePhysicsTable().
|
inherited |
Definition at line 455 of file G4VEmModel.cc.
References G4PhysicsTable::clearAndDestroy(), G4VEmModel::localTable, and G4VEmModel::xSectionTable.
Referenced by G4VMultipleScattering::BuildPhysicsTable().
|
inlineinherited |
Definition at line 472 of file G4VEmModel.hh.
References G4VEmModel::basedCoupleIndex, G4VEmModel::currentCoupleIndex, G4VEmModel::fCurrentCouple, G4Material::GetBaseMaterial(), G4MaterialCutsCouple::GetIndex(), G4MaterialCutsCouple::GetMaterial(), G4VEmModel::pBaseMaterial, G4VEmModel::pFactor, and G4VEmModel::useBaseMaterials.
Referenced by G4VMultipleScattering::AlongStepGetPhysicalInteractionLength(), G4EmMultiModel::ComputeCrossSectionPerAtom(), G4VEmModel::ComputeDEDX(), G4TablesForExtrapolator::ComputeTrasportXS(), ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4VEmModel::CrossSection(), G4AdjointPhotoElectricModel::DefineCurrentMaterialAndElectronEnergy(), G4WentzelVIModel::DefineMaterial(), G4WentzelVIRelModel::DefineMaterial(), G4EmCalculator::GetCrossSectionPerVolume(), G4LivermoreGammaConversion5DModel::Initialise(), G4VEmModel::InitialiseElementSelectors(), G4PEEffectFluoModel::SampleSecondaries(), G4EmMultiModel::SampleSecondaries(), G4VEnergyLossProcess::SelectModel(), G4VEmProcess::SelectModel(), G4VEmModel::SelectRandomAtom(), G4VEmModel::SelectTargetAtom(), and G4VEmModel::Value().
|
inlineprotectedinherited |
Definition at line 497 of file G4VEmModel.hh.
References G4VEmModel::fCurrentElement, and G4VEmModel::fCurrentIsotope.
Referenced by G4VEmModel::ComputeCrossSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4eBremParametrizedModel::ComputeDEDXPerVolume(), and G4VEmModel::SelectIsotopeNumber().
|
inlineinherited |
Definition at line 823 of file G4VEmModel.hh.
References G4VEmModel::flagDeexcitation.
Referenced by G4DNABornIonisationModel1::G4DNABornIonisationModel1(), G4DNABornIonisationModel2::G4DNABornIonisationModel2(), G4DNACPA100IonisationModel::G4DNACPA100IonisationModel(), G4DNAEmfietzoglouIonisationModel::G4DNAEmfietzoglouIonisationModel(), G4DNARelativisticIonisationModel::G4DNARelativisticIonisationModel(), G4DNARuddIonisationExtendedModel::G4DNARuddIonisationExtendedModel(), G4DNARuddIonisationModel::G4DNARuddIonisationModel(), G4KleinNishinaModel::G4KleinNishinaModel(), G4LEPTSIonisationModel::G4LEPTSIonisationModel(), G4LivermoreComptonModel::G4LivermoreComptonModel(), G4LivermorePhotoElectricModel::G4LivermorePhotoElectricModel(), G4LivermorePolarizedComptonModel::G4LivermorePolarizedComptonModel(), G4LowEPComptonModel::G4LowEPComptonModel(), G4LowEPPolarizedComptonModel::G4LowEPPolarizedComptonModel(), G4MicroElecInelasticModel::G4MicroElecInelasticModel(), G4MicroElecInelasticModel_new::G4MicroElecInelasticModel_new(), G4PEEffectFluoModel::G4PEEffectFluoModel(), G4PenelopeBremsstrahlungModel::G4PenelopeBremsstrahlungModel(), G4PenelopeComptonModel::G4PenelopeComptonModel(), G4PenelopeIonisationModel::G4PenelopeIonisationModel(), G4PenelopePhotoElectricModel::G4PenelopePhotoElectricModel(), G4AtimaEnergyLossModel::Initialise(), G4BetheBlochModel::Initialise(), G4BraggIonModel::Initialise(), G4BraggModel::Initialise(), G4ICRU73QOModel::Initialise(), and G4LindhardSorensenIonModel::Initialise().
|
inlineinherited |
Definition at line 852 of file G4VEmModel.hh.
References G4VEmModel::elmSelectors, G4VEmModel::localElmSelectors, and G4VEmModel::nSelectors.
Referenced by G4eDPWACoulombScatteringModel::InitialiseLocal(), G4eSingleCoulombScatteringModel::InitialiseLocal(), G4PAIModel::InitialiseLocal(), G4PAIPhotModel::InitialiseLocal(), G4JAEAElasticScatteringModel::InitialiseLocal(), G4JAEAPolarizedElasticScatteringModel::InitialiseLocal(), G4LivermoreComptonModel::InitialiseLocal(), G4LivermoreNuclearGammaConversionModel::InitialiseLocal(), G4LivermorePolarizedComptonModel::InitialiseLocal(), G4LivermorePolarizedGammaConversionModel::InitialiseLocal(), G4LivermorePolarizedRayleighModel::InitialiseLocal(), G4LivermoreRayleighModel::InitialiseLocal(), G4LowEPComptonModel::InitialiseLocal(), G4LowEPPolarizedComptonModel::InitialiseLocal(), G4PenelopePhotoElectricModel::InitialiseLocal(), G4MuBremsstrahlungModel::InitialiseLocal(), G4MuPairProductionModel::InitialiseLocal(), G4BetheHeitlerModel::InitialiseLocal(), G4eBremParametrizedModel::InitialiseLocal(), G4eBremsstrahlungRelModel::InitialiseLocal(), G4eCoulombScatteringModel::InitialiseLocal(), G4hCoulombScatteringModel::InitialiseLocal(), G4KleinNishinaCompton::InitialiseLocal(), G4KleinNishinaModel::InitialiseLocal(), and G4PairProductionRelModel::InitialiseLocal().
|
inlineinherited |
Definition at line 732 of file G4VEmModel.hh.
References G4VEmModel::lossFlucFlag.
Referenced by G4EmCalculator::ComputeNuclearDEDX().
|
inlineinherited |
Definition at line 830 of file G4VEmModel.hh.
References G4VEmModel::flagForceBuildTable.
|
inlineinherited |
Definition at line 237 of file G4VMscModel.hh.
References G4VMscModel::facgeom, and G4VEmModel::IsLocked().
|
inlineinherited |
Definition at line 767 of file G4VEmModel.hh.
References G4VEmModel::highLimit.
Referenced by G4EmModelActivator::ActivateEmOptions(), G4EmModelActivator::ActivatePAI(), LBE::ConstructEM(), G4EmDNAPhysics_option2::ConstructProcess(), G4EmDNAPhysics_option5::ConstructProcess(), G4EmDNAPhysics_option7::ConstructProcess(), G4EmDNAPhysics_stationary::ConstructProcess(), G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option1::ConstructProcess(), G4EmStandardPhysics_option2::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsGS::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), G4BraggIonModel::G4BraggIonModel(), G4BraggModel::G4BraggModel(), G4DNAChampionElasticModel::G4DNAChampionElasticModel(), G4DNACPA100ElasticModel::G4DNACPA100ElasticModel(), G4DNACPA100ExcitationModel::G4DNACPA100ExcitationModel(), G4DNACPA100IonisationModel::G4DNACPA100IonisationModel(), G4DNAELSEPAElasticModel::G4DNAELSEPAElasticModel(), G4DNAEmfietzoglouExcitationModel::G4DNAEmfietzoglouExcitationModel(), G4DNAEmfietzoglouIonisationModel::G4DNAEmfietzoglouIonisationModel(), G4DNAIonElasticModel::G4DNAIonElasticModel(), G4DNAMeltonAttachmentModel::G4DNAMeltonAttachmentModel(), G4DNASancheExcitationModel::G4DNASancheExcitationModel(), G4DNAScreenedRutherfordElasticModel::G4DNAScreenedRutherfordElasticModel(), G4DNATransformElectronModel::G4DNATransformElectronModel(), G4DNAUeharaScreenedRutherfordElasticModel::G4DNAUeharaScreenedRutherfordElasticModel(), G4eDPWACoulombScatteringModel::G4eDPWACoulombScatteringModel(), G4ICRU73QOModel::G4ICRU73QOModel(), G4MicroElecElasticModel::G4MicroElecElasticModel(), G4MicroElecElasticModel_new::G4MicroElecElasticModel_new(), G4PenelopeAnnihilationModel::G4PenelopeAnnihilationModel(), G4PenelopeBremsstrahlungModel::G4PenelopeBremsstrahlungModel(), G4PenelopeComptonModel::G4PenelopeComptonModel(), G4PenelopeGammaConversionModel::G4PenelopeGammaConversionModel(), G4PenelopeIonisationModel::G4PenelopeIonisationModel(), G4PenelopePhotoElectricModel::G4PenelopePhotoElectricModel(), G4PenelopeRayleighModel::G4PenelopeRayleighModel(), G4PenelopeRayleighModelMI::G4PenelopeRayleighModelMI(), G4TDNAOneStepThermalizationModel< MODEL >::G4TDNAOneStepThermalizationModel(), G4XrayRayleighModel::G4XrayRayleighModel(), G4VLEPTSModel::Init(), G4DNAChampionElasticModel::Initialise(), G4DNACPA100ElasticModel::Initialise(), G4DNADingfelderChargeDecreaseModel::Initialise(), G4DNADingfelderChargeIncreaseModel::Initialise(), G4DNAMeltonAttachmentModel::Initialise(), G4DNAMillerGreenExcitationModel::Initialise(), G4DNARuddIonisationExtendedModel::Initialise(), G4DNARuddIonisationModel::Initialise(), G4DNASancheExcitationModel::Initialise(), G4MicroElecElasticModel::Initialise(), G4MicroElecInelasticModel::Initialise(), G4MicroElecInelasticModel_new::Initialise(), G4DNABornExcitationModel1::Initialise(), G4DNABornExcitationModel2::Initialise(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4DNAELSEPAElasticModel::Initialise(), G4DNAModelInterface::Initialise(), G4DNAIonElasticModel::Initialise(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4ePairProduction::InitialiseEnergyLossProcess(), G4MuBremsstrahlung::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), G4PolarizedBremsstrahlung::InitialiseEnergyLossProcess(), G4PolarizedIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4eIonisation::InitialiseEnergyLossProcess(), G4hIonisation::InitialiseEnergyLossProcess(), G4ionIonisation::InitialiseEnergyLossProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAPlasmonExcitation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4PolarizedPhotoElectric::InitialiseProcess(), G4ComptonScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4VEmProcess::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), G4VMultipleScattering::PreparePhysicsTable(), G4DNAUeharaScreenedRutherfordElasticModel::SelectHighEnergyLimit(), G4VEmAdjointModel::SetHighEnergyLimit(), G4DNAELSEPAElasticModel::SetMaximumEnergy(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), and G4EmConfigurator::UpdateModelEnergyRange().
|
inlineinherited |
Definition at line 309 of file G4VMscModel.hh.
References G4VMscModel::currentPart, and G4VMscModel::ionisation.
Referenced by G4VMultipleScattering::PreparePhysicsTable(), and G4VMultipleScattering::StartTracking().
|
inlineinherited |
Definition at line 244 of file G4VMscModel.hh.
References G4VEmModel::IsLocked(), and G4VMscModel::lambdalimit.
|
inlineinherited |
Definition at line 216 of file G4VMscModel.hh.
References G4VEmModel::IsLocked(), and G4VMscModel::latDisplasment.
Referenced by G4EmModelActivator::SetMscParameters().
|
inlineinherited |
Definition at line 884 of file G4VEmModel.hh.
References G4VEmModel::isLocked.
Referenced by G4EmModelActivator::ActivateEmOptions(), G4EmModelActivator::AddStandardScattering(), and G4EmModelActivator::SetMscParameters().
|
inlineinherited |
Definition at line 774 of file G4VEmModel.hh.
References G4VEmModel::lowLimit.
Referenced by G4EmModelActivator::ActivatePAI(), G4EmDNAPhysics_option2::ConstructProcess(), G4EmDNAPhysics_option5::ConstructProcess(), G4EmDNAPhysics_stationary::ConstructProcess(), G4EmLivermorePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmStandardPhysics_option1::ConstructProcess(), G4EmStandardPhysics_option2::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysicsGS::ConstructProcess(), G4EmStandardPhysicsWVI::ConstructProcess(), G4DNASancheExcitationModel::ExtendLowEnergyLimit(), G4AtimaEnergyLossModel::G4AtimaEnergyLossModel(), G4BetheBlochModel::G4BetheBlochModel(), G4BetheHeitler5DModel::G4BetheHeitler5DModel(), G4DNAChampionElasticModel::G4DNAChampionElasticModel(), G4DNACPA100ElasticModel::G4DNACPA100ElasticModel(), G4DNACPA100ExcitationModel::G4DNACPA100ExcitationModel(), G4DNACPA100IonisationModel::G4DNACPA100IonisationModel(), G4DNAELSEPAElasticModel::G4DNAELSEPAElasticModel(), G4DNAEmfietzoglouExcitationModel::G4DNAEmfietzoglouExcitationModel(), G4DNAEmfietzoglouIonisationModel::G4DNAEmfietzoglouIonisationModel(), G4DNAIonElasticModel::G4DNAIonElasticModel(), G4DNAMeltonAttachmentModel::G4DNAMeltonAttachmentModel(), G4DNASancheExcitationModel::G4DNASancheExcitationModel(), G4DNAScreenedRutherfordElasticModel::G4DNAScreenedRutherfordElasticModel(), G4DNATransformElectronModel::G4DNATransformElectronModel(), G4DNAUeharaScreenedRutherfordElasticModel::G4DNAUeharaScreenedRutherfordElasticModel(), G4DummyModel::G4DummyModel(), G4eBremParametrizedModel::G4eBremParametrizedModel(), G4eBremsstrahlungRelModel::G4eBremsstrahlungRelModel(), G4eDPWACoulombScatteringModel::G4eDPWACoulombScatteringModel(), G4LivermoreBremsstrahlungModel::G4LivermoreBremsstrahlungModel(), G4MicroElecElasticModel::G4MicroElecElasticModel(), G4MicroElecElasticModel_new::G4MicroElecElasticModel_new(), G4SeltzerBergerModel::G4SeltzerBergerModel(), G4TDNAOneStepThermalizationModel< MODEL >::G4TDNAOneStepThermalizationModel(), G4VLEPTSModel::Init(), G4DNAChampionElasticModel::Initialise(), G4DNACPA100ElasticModel::Initialise(), G4DNADingfelderChargeDecreaseModel::Initialise(), G4DNADingfelderChargeIncreaseModel::Initialise(), G4DNAMeltonAttachmentModel::Initialise(), G4DNAMillerGreenExcitationModel::Initialise(), G4DNARuddIonisationExtendedModel::Initialise(), G4DNARuddIonisationModel::Initialise(), G4MicroElecElasticModel::Initialise(), G4MicroElecInelasticModel::Initialise(), G4MicroElecInelasticModel_new::Initialise(), G4BetheHeitler5DModel::Initialise(), G4DNABornExcitationModel1::Initialise(), G4DNABornExcitationModel2::Initialise(), G4DNABornIonisationModel1::Initialise(), G4DNABornIonisationModel2::Initialise(), G4DNAELSEPAElasticModel::Initialise(), G4DNAModelInterface::Initialise(), G4DNAIonElasticModel::Initialise(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4ePairProduction::InitialiseEnergyLossProcess(), G4MuBremsstrahlung::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), G4PolarizedBremsstrahlung::InitialiseEnergyLossProcess(), G4PolarizedIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4eIonisation::InitialiseEnergyLossProcess(), G4hIonisation::InitialiseEnergyLossProcess(), G4ionIonisation::InitialiseEnergyLossProcess(), G4DNAAttachment::InitialiseProcess(), G4DNAChargeDecrease::InitialiseProcess(), G4DNAChargeIncrease::InitialiseProcess(), G4DNADissociation::InitialiseProcess(), G4DNAElastic::InitialiseProcess(), G4DNAExcitation::InitialiseProcess(), G4DNAIonisation::InitialiseProcess(), G4DNAPlasmonExcitation::InitialiseProcess(), G4DNAPositronium::InitialiseProcess(), G4DNARotExcitation::InitialiseProcess(), G4DNAVibExcitation::InitialiseProcess(), G4PolarizedCompton::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4PolarizedPhotoElectric::InitialiseProcess(), G4ComptonScattering::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4eplusAnnihilation::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4PhotoElectricEffect::InitialiseProcess(), G4VEmAdjointModel::SetLowEnergyLimit(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), and G4EmConfigurator::UpdateModelEnergyRange().
|
inlineinherited |
Definition at line 816 of file G4VEmModel.hh.
References G4VEmModel::theLPMflag.
Referenced by G4eBremsstrahlungRelModel::G4eBremsstrahlungRelModel(), G4LivermoreBremsstrahlungModel::G4LivermoreBremsstrahlungModel(), G4SeltzerBergerModel::G4SeltzerBergerModel(), and G4eBremsstrahlung::InitialiseEnergyLossProcess().
|
inlineinherited |
Definition at line 739 of file G4VEmModel.hh.
References G4VEmModel::isMaster.
Referenced by G4VEmProcess::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), and G4VMultipleScattering::PreparePhysicsTable().
|
inline |
Definition at line 164 of file G4UrbanAdjointMscModel.hh.
References displacementFlag.
|
inlineprivate |
Definition at line 169 of file G4UrbanAdjointMscModel.hh.
References charge, ChargeSquare, G4Electron::Electron(), CLHEP::eplus, G4ParticleDefinition::GetParticleName(), G4ParticleDefinition::GetPDGCharge(), G4ParticleDefinition::GetPDGMass(), mass, and particle.
Referenced by ComputeCrossSectionPerAtom(), Initialise(), and StartTracking().
|
inherited |
Definition at line 447 of file G4VEmModel.cc.
References G4VEmModel::flucModel, and G4VEmModel::pParticleChange.
Referenced by G4VMultipleScattering::AddEmModel(), G4VEmProcess::AddEmModel(), G4VEnergyLossProcess::AddEmModel(), G4VEmModel::GetParticleChangeForGamma(), G4VEmModel::GetParticleChangeForLoss(), G4EmMultiModel::Initialise(), G4IonParametrisedLossModel::Initialise(), G4DNADummyModel::Initialise(), and G4NuclearStopping::InitialiseProcess().
|
inlineinherited |
Definition at line 802 of file G4VEmModel.hh.
References G4VEmModel::isLocked, and G4VEmModel::polarAngleLimit.
Referenced by G4EmModelActivator::ActivateEmOptions(), G4TablesForExtrapolator::ComputeTrasportXS(), G4CoulombScattering::InitialiseProcess(), G4VEmProcess::PreparePhysicsTable(), and G4VMultipleScattering::PreparePhysicsTable().
|
inlineinherited |
Definition at line 230 of file G4VMscModel.hh.
References G4VMscModel::facrange, and G4VEmModel::IsLocked().
Referenced by G4EmModelActivator::SetMscParameters().
|
inlineinherited |
Definition at line 251 of file G4VMscModel.hh.
References G4VMscModel::facsafety, and G4VEmModel::IsLocked().
|
inlineinherited |
Definition at line 265 of file G4VMscModel.hh.
References G4VEmModel::IsLocked(), and G4VMscModel::samplez.
|
inlineinherited |
Definition at line 809 of file G4VEmModel.hh.
References G4VEmModel::secondaryThreshold.
Referenced by G4MuBremsstrahlung::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), and G4eBremsstrahlung::InitialiseEnergyLossProcess().
|
inlineinherited |
Definition at line 223 of file G4VMscModel.hh.
References G4VEmModel::IsLocked(), and G4VMscModel::skin.
Referenced by G4EmModelActivator::SetMscParameters().
|
inlineinherited |
Definition at line 258 of file G4VMscModel.hh.
References G4VEmModel::IsLocked(), and G4VMscModel::steppingAlgorithm.
Referenced by G4EmModelActivator::SetMscParameters().
|
inlineinherited |
Definition at line 645 of file G4VEmModel.hh.
References G4VEmModel::fTripletModel.
Referenced by G4eplusTo2GammaOKVIModel::G4eplusTo2GammaOKVIModel().
|
virtualinherited |
Reimplemented in G4eBremParametrizedModel, G4eBremsstrahlungRelModel, G4PairProductionRelModel, and G4SeltzerBergerModel.
Definition at line 440 of file G4VEmModel.cc.
Referenced by G4VEmModel::CrossSectionPerVolume(), G4PenelopeComptonModel::CrossSectionPerVolume(), G4PenelopeBremsstrahlungModel::CrossSectionPerVolume(), G4PenelopeIonisationModel::CrossSectionPerVolume(), G4EmCalculator::FindEmModel(), and G4EmElementSelector::Initialise().
|
inlineinherited |
Definition at line 753 of file G4VEmModel.hh.
References G4VEmModel::useBaseMaterials.
Referenced by G4VEmProcess::BuildPhysicsTable(), G4VEnergyLossProcess::BuildPhysicsTable(), G4VMultipleScattering::BuildPhysicsTable(), G4TablesForExtrapolator::ComputeElectronDEDX(), G4TablesForExtrapolator::ComputeMuonDEDX(), G4TablesForExtrapolator::ComputeProtonDEDX(), G4TablesForExtrapolator::ComputeTrasportXS(), G4VEmProcess::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), and G4VMultipleScattering::PreparePhysicsTable().
|
inlineprivate |
Definition at line 230 of file G4UrbanAdjointMscModel.hh.
References CLHEP::HepRandomEngine::flat(), G4Exp(), G4Log(), and rndmEngineMod.
Referenced by SampleCosineTheta().
|
overridevirtual |
Reimplemented from G4VEmModel.
Definition at line 410 of file G4UrbanAdjointMscModel.cc.
References G4VMscModel::facrange, firstStep, fr, geombig, G4DynamicParticle::GetDefinition(), G4Track::GetDynamicParticle(), insideskin, rangecut, rangeinit, rndmEngineMod, SetParticle(), smallstep, stepmin, tgeom, tlimit, tlimitmin, and tlimitminfix.
|
inlineprivate |
Definition at line 207 of file G4UrbanAdjointMscModel.hh.
References coeffc1, coeffc2, coeffc3, coeffc4, coeffth1, coeffth2, G4Exp(), G4Log(), lnZ, Z2, Z23, Zeff, and Zold.
Referenced by ComputeTruePathLengthLimit().
|
inlineinherited |
Definition at line 718 of file G4VEmModel.hh.
References G4VEmModel::useAngularGenerator.
Referenced by G4AtimaEnergyLossModel::Initialise(), G4BetheBlochModel::Initialise(), G4BraggIonModel::Initialise(), G4BraggModel::Initialise(), G4ICRU73QOModel::Initialise(), G4LindhardSorensenIonModel::Initialise(), G4MollerBhabhaModel::Initialise(), G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), and G4MollerBhabhaModel::SampleSecondaries().
|
inlineinherited |
Definition at line 760 of file G4VEmModel.hh.
References G4VEmModel::useBaseMaterials.
|
virtualinherited |
Definition at line 406 of file G4VEmModel.cc.
References G4VEmModel::CrossSectionPerVolume(), DBL_MAX, G4VEmModel::pBaseMaterial, G4VEmModel::pFactor, and G4VEmModel::SetCurrentCouple().
Referenced by G4IonParametrisedLossModel::BuildRangeVector(), G4LossTableBuilder::BuildTableForModel(), G4LivermorePhotoElectricModel::ComputeCrossSectionPerAtom(), G4IonParametrisedLossModel::ComputeLossForStep(), G4VLEPTSModel::GetMeanFreePath(), G4DNABornExcitationModel2::GetPartialCrossSection(), G4DNABornExcitationModel2::Initialise(), G4DNABornExcitationModel2::RandomSelect(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), and G4LivermorePhotoElectricModel::SampleSecondaries().
|
privateinherited |
Definition at line 414 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetAngularDistribution(), G4VEmModel::SetAngularDistribution(), and G4VEmModel::~G4VEmModel().
|
protectedinherited |
Definition at line 449 of file G4VEmModel.hh.
Referenced by G4VMscModel::GetTransportMeanFreePath(), and G4VEmModel::SetCurrentCouple().
|
private |
Definition at line 113 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeCrossSectionPerAtom(), ComputeTheta0(), ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and SetParticle().
|
private |
Definition at line 113 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel(), and SetParticle().
|
private |
Definition at line 149 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleCosineTheta(), and UpdateCache().
|
private |
Definition at line 149 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleCosineTheta(), and UpdateCache().
|
private |
Definition at line 149 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleCosineTheta(), and UpdateCache().
|
private |
Definition at line 149 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleCosineTheta(), and UpdateCache().
|
private |
Definition at line 148 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTheta0(), G4UrbanAdjointMscModel(), and UpdateCache().
|
private |
Definition at line 148 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTheta0(), G4UrbanAdjointMscModel(), and UpdateCache().
|
private |
Definition at line 109 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), SampleCosineTheta(), and SampleScattering().
|
protectedinherited |
Definition at line 448 of file G4VEmModel.hh.
Referenced by G4VEmModel::SetCurrentCouple().
|
private |
Definition at line 141 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTheta0(), ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), SampleCosineTheta(), and SampleScattering().
|
private |
Definition at line 154 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
privateinherited |
Definition at line 188 of file G4VMscModel.hh.
Referenced by G4VMscModel::SetIonisation().
|
private |
Definition at line 144 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTheta0(), G4UrbanAdjointMscModel(), and SampleCosineTheta().
|
private |
Definition at line 142 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTruePathLengthLimit(), ComputeTrueStepLength(), G4UrbanAdjointMscModel(), and SampleScattering().
|
private |
Definition at line 119 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleCosineTheta(), SampleDisplacement(), and SampleScattering().
|
privateinherited |
Definition at line 190 of file G4VMscModel.hh.
Referenced by G4VMscModel::G4VMscModel(), G4VMscModel::GetDEDX(), G4VMscModel::GetEnergy(), and G4VMscModel::GetRange().
|
private |
Definition at line 160 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleScattering(), and SetNewDisplacementFlag().
|
private |
Definition at line 152 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
protectedinherited |
Definition at line 200 of file G4VMscModel.hh.
Referenced by ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), G4UrbanMscModel::ComputeGeomPathLength(), SampleScattering(), and G4UrbanMscModel::SampleScattering().
|
privateinherited |
Definition at line 419 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetElementSelectors(), G4VEmModel::InitialiseElementSelectors(), G4VEmModel::SelectRandomAtom(), G4VEmModel::SelectTargetAtom(), G4VEmModel::SetElementSelectors(), and G4VEmModel::~G4VEmModel().
Definition at line 439 of file G4VEmModel.hh.
Referenced by G4VEmModel::HighEnergyActivationLimit(), G4VEmModel::IsActive(), and G4VEmModel::SetActivationHighEnergyLimit().
|
privateinherited |
Definition at line 438 of file G4VEmModel.hh.
Referenced by G4VEmModel::IsActive(), G4VEmModel::LowEnergyActivationLimit(), and G4VEmModel::SetActivationLowEnergyLimit().
|
protectedinherited |
Definition at line 197 of file G4VMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4VMscModel::DumpParameters(), G4VMscModel::InitialiseParameters(), and G4VMscModel::SetGeomFactor().
|
protectedinherited |
Definition at line 196 of file G4VMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4VMscModel::DumpParameters(), G4VMscModel::InitialiseParameters(), G4VMscModel::SetRangeFactor(), StartTracking(), and G4UrbanMscModel::StartTracking().
|
protectedinherited |
Definition at line 198 of file G4VMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4VMscModel::DumpParameters(), G4UrbanAdjointMscModel(), G4VMscModel::InitialiseParameters(), and G4VMscModel::SetSafetyFactor().
|
privateinherited |
Definition at line 416 of file G4VEmModel.hh.
Referenced by G4VEmModel::CurrentCouple(), and G4VEmModel::SetCurrentCouple().
|
privateinherited |
Definition at line 417 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetCurrentElement(), G4VEmModel::SelectRandomAtom(), G4VEmModel::SelectRandomAtomNumber(), G4VEmModel::SelectTargetAtom(), and G4VEmModel::SetCurrentElement().
|
privateinherited |
Definition at line 418 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetCurrentIsotope(), G4VEmModel::SelectIsotopeNumber(), G4VEmModel::SelectRandomAtom(), G4VEmModel::SelectTargetAtom(), and G4VEmModel::SetCurrentElement().
|
protectedinherited |
Definition at line 208 of file G4VMscModel.hh.
Referenced by SampleDisplacement(), G4UrbanMscModel::SampleDisplacement(), SampleDisplacementNew(), G4UrbanMscModel::SampleDisplacementNew(), SampleScattering(), G4UrbanMscModel::SampleScattering(), G4WentzelVIModel::SampleScattering(), and G4DummyModel::SampleScattering().
|
protectedinherited |
Definition at line 424 of file G4VEmModel.hh.
Referenced by G4MuPairProductionModel::FindScaledEnergy(), G4VEmModel::GetElementData(), G4MuPairProductionModel::Initialise(), G4MuPairProductionModel::InitialiseLocal(), G4MuPairProductionModel::MakeSamplingTables(), G4MuPairProductionModel::RetrieveTables(), G4MuPairProductionModel::StoreTables(), and G4VEmModel::~G4VEmModel().
|
privateinherited |
Definition at line 420 of file G4VEmModel.hh.
Referenced by G4VEmModel::G4VEmModel(), and G4VEmModel::~G4VEmModel().
|
private |
Definition at line 152 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 156 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
privateinherited |
Definition at line 455 of file G4VEmModel.hh.
Referenced by G4VEmModel::DeexcitationFlag(), and G4VEmModel::SetDeexcitationFlag().
|
privateinherited |
Definition at line 456 of file G4VEmModel.hh.
Referenced by G4VEmModel::ForceBuildTableFlag(), and G4VEmModel::SetForceBuildTable().
|
privateinherited |
Definition at line 413 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetModelOfFluctuations(), and G4VEmModel::SetParticleChange().
|
private |
Definition at line 107 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), Initialise(), and SampleScattering().
|
private |
Definition at line 114 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
privateinherited |
Definition at line 415 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetParticleChangeForGamma(), G4VEmModel::GetParticleChangeForLoss(), G4VEmModel::GetTripletModel(), and G4VEmModel::SetTripletModel().
|
private |
Definition at line 125 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
private |
Definition at line 127 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
protectedinherited |
Definition at line 203 of file G4VMscModel.hh.
|
private |
Definition at line 126 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
protectedinherited |
Definition at line 202 of file G4VMscModel.hh.
|
privateinherited |
Definition at line 437 of file G4VEmModel.hh.
Referenced by G4VEmModel::HighEnergyLimit(), G4VEmModel::InitialiseElementSelectors(), and G4VEmModel::SetHighEnergyLimit().
|
private |
Definition at line 157 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTruePathLengthLimit(), ComputeTrueStepLength(), G4UrbanAdjointMscModel(), SampleDisplacement(), and StartTracking().
|
protectedinherited |
Definition at line 431 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetChargeSquareRatio(), G4VMscModel::GetDEDX(), G4VMscModel::GetEnergy(), G4VMscModel::GetRange(), G4LindhardSorensenIonModel::SetupParameters(), and G4BetheBlochModel::SetupParameters().
|
privateinherited |
Definition at line 187 of file G4VMscModel.hh.
Referenced by G4VMscModel::GetDEDX(), G4VMscModel::GetEnergy(), G4VMscModel::GetIonisation(), G4VMscModel::GetRange(), and G4VMscModel::SetIonisation().
|
privateinherited |
Definition at line 463 of file G4VEmModel.hh.
Referenced by G4VEmModel::IsLocked(), G4VEmModel::SetLocked(), and G4VEmModel::SetPolarAngleLimit().
|
privateinherited |
Definition at line 457 of file G4VEmModel.hh.
Referenced by G4VEmModel::IsMaster(), G4VEmModel::SetMasterThread(), and G4VEmModel::~G4VEmModel().
|
private |
Definition at line 133 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTruePathLengthLimit(), ComputeTrueStepLength(), G4UrbanAdjointMscModel(), SampleCosineTheta(), and SampleScattering().
|
private |
Definition at line 134 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), G4UrbanAdjointMscModel(), SampleCosineTheta(), and SampleDisplacement().
|
private |
Definition at line 114 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and SampleCosineTheta().
|
protectedinherited |
Definition at line 206 of file G4VMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4VMscModel::DumpParameters(), Initialise(), G4UrbanMscModel::Initialise(), G4VMscModel::InitialiseParameters(), SampleScattering(), G4UrbanMscModel::SampleScattering(), G4WentzelVIModel::SampleScattering(), and G4VMscModel::SetLateralDisplasmentFlag().
|
private |
Definition at line 159 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and Initialise().
|
private |
Definition at line 147 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), and UpdateCache().
|
privateinherited |
Definition at line 460 of file G4VEmModel.hh.
Referenced by G4VEmModel::SetElementSelectors(), and G4VEmModel::~G4VEmModel().
Definition at line 192 of file G4VMscModel.hh.
Referenced by G4VMscModel::GetEnergy(), and G4VMscModel::GetRange().
|
privateinherited |
Definition at line 459 of file G4VEmModel.hh.
Referenced by G4VEmModel::SetCrossSectionTable(), and G4VEmModel::~G4VEmModel().
|
privateinherited |
Definition at line 191 of file G4VMscModel.hh.
Referenced by G4VMscModel::GetEnergy(), and G4VMscModel::GetRange().
|
protectedinherited |
Definition at line 450 of file G4VEmModel.hh.
Referenced by G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), and G4VEmModel::SetFluctuationFlag().
|
privateinherited |
Definition at line 436 of file G4VEmModel.hh.
Referenced by G4VEmModel::InitialiseElementSelectors(), G4VEmModel::LowEnergyLimit(), and G4VEmModel::SetLowEnergyLimit().
|
private |
Definition at line 112 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeCrossSectionPerAtom(), ComputeGeomPathLength(), ComputeTheta0(), ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and SetParticle().
|
private |
Definition at line 114 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
privateinherited |
Definition at line 465 of file G4VEmModel.hh.
Referenced by source.g4viscp.G4Scene::create_scene(), G4VEmModel::GetName(), mcscore.MCParticle::printout(), and source.g4viscp.G4Scene::update_scene().
|
privateinherited |
Definition at line 444 of file G4VEmModel.hh.
Referenced by G4VEmModel::CrossSectionPerVolume(), and G4VEmModel::G4VEmModel().
|
privateinherited |
Definition at line 443 of file G4VEmModel.hh.
Referenced by G4VEmModel::InitialiseElementSelectors(), G4VEmModel::SelectRandomAtom(), G4VEmModel::SelectTargetAtom(), G4VEmModel::SetElementSelectors(), and G4VEmModel::~G4VEmModel().
|
private |
Definition at line 137 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTrueStepLength(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 137 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 137 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTrueStepLength(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 105 of file G4UrbanAdjointMscModel.hh.
Referenced by emcalc_gui.MainWindow::cb_select_particle(), emcalc_gui.MainWindow::cb_show_plot(), ComputeGeomPathLength(), ComputeTheta0(), ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), SampleCosineTheta(), SampleScattering(), and SetParticle().
|
protectedinherited |
Definition at line 427 of file G4VEmModel.hh.
Referenced by G4VEmModel::ComputeDEDX(), G4VEmModel::CrossSection(), G4VMscModel::GetTransportMeanFreePath(), G4VEmModel::SelectRandomAtom(), G4VEmModel::SelectTargetAtom(), G4VEmModel::SetCurrentCouple(), and G4VEmModel::Value().
|
protectedinherited |
Definition at line 432 of file G4VEmModel.hh.
Referenced by G4VEmModel::ComputeDEDX(), G4VEmModel::CrossSection(), G4VMscModel::GetTransportMeanFreePath(), G4VEmModel::SetCurrentCouple(), and G4VEmModel::Value().
|
privateinherited |
Definition at line 441 of file G4VEmModel.hh.
Referenced by G4VEmModel::PolarAngleLimit(), and G4VEmModel::SetPolarAngleLimit().
|
private |
Definition at line 106 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTheta0(), and G4UrbanAdjointMscModel().
|
protectedinherited |
Definition at line 425 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetParticleChangeForGamma(), G4VEmModel::GetParticleChangeForLoss(), G4VMscModel::GetParticleChangeForMSC(), G4EmMultiModel::Initialise(), and G4VEmModel::SetParticleChange().
|
private |
Definition at line 131 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 151 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
private |
Definition at line 143 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
private |
Definition at line 103 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), Randomizetlimit(), SampleCosineTheta(), SampleDisplacement(), SampleDisplacementNew(), SampleScattering(), SimpleScattering(), and StartTracking().
|
privateinherited |
Definition at line 186 of file G4VMscModel.hh.
Referenced by G4VMscModel::ComputeGeomLimit(), G4VMscModel::ComputeSafety(), and G4VMscModel::GetParticleChangeForMSC().
|
protectedinherited |
Definition at line 205 of file G4VMscModel.hh.
Referenced by G4VMscModel::SetSampleZ().
Definition at line 440 of file G4VEmModel.hh.
Referenced by G4VEmModel::SecondaryThreshold(), and G4VEmModel::SetSecondaryThreshold().
|
protectedinherited |
Definition at line 199 of file G4VMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4VMscModel::DumpParameters(), G4UrbanAdjointMscModel(), G4UrbanMscModel::G4UrbanMscModel(), G4VMscModel::InitialiseParameters(), and G4VMscModel::SetSkin().
|
private |
Definition at line 128 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 129 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
private |
Definition at line 139 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
protectedinherited |
Definition at line 209 of file G4VMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4VMscModel::DumpParameters(), G4VMscModel::InitialiseParameters(), G4GoudsmitSaundersonMscModel::SampleScattering(), and G4VMscModel::SetStepLimitType().
|
private |
Definition at line 116 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), SampleCosineTheta(), and SampleDisplacement().
|
private |
Definition at line 118 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), G4UrbanAdjointMscModel(), and SampleDisplacement().
|
private |
Definition at line 117 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTrueStepLength(), G4UrbanAdjointMscModel(), SampleCosineTheta(), SampleDisplacement(), and SampleScattering().
|
private |
Definition at line 123 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and StartTracking().
|
protectedinherited |
Definition at line 428 of file G4VEmModel.hh.
Referenced by G4VEmModel::G4VEmModel().
|
protectedinherited |
Definition at line 429 of file G4VEmModel.hh.
Referenced by G4VEmModel::G4VEmModel().
|
privateinherited |
Definition at line 454 of file G4VEmModel.hh.
Referenced by G4VEmModel::LPMFlag(), and G4VEmModel::SetLPMFlag().
|
private |
Definition at line 110 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel().
|
private |
Definition at line 120 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), Randomizetlimit(), and StartTracking().
|
private |
Definition at line 121 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), Randomizetlimit(), SampleCosineTheta(), and StartTracking().
|
private |
Definition at line 122 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), SampleScattering(), and StartTracking().
|
private |
Definition at line 122 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTrueStepLength(), and G4UrbanAdjointMscModel().
|
private |
Definition at line 135 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTruePathLengthLimit(), ComputeTrueStepLength(), G4UrbanAdjointMscModel(), SampleDisplacement(), SampleDisplacementNew(), and SampleScattering().
|
privateinherited |
Definition at line 461 of file G4VEmModel.hh.
Referenced by G4VEmModel::SetAngularGeneratorFlag(), and G4VEmModel::UseAngularGeneratorFlag().
|
privateinherited |
Definition at line 462 of file G4VEmModel.hh.
Referenced by G4VEmModel::SetCurrentCouple(), G4VEmModel::SetUseBaseMaterials(), and G4VEmModel::UseBaseMaterials().
|
privateinherited |
Definition at line 466 of file G4VEmModel.hh.
Referenced by G4VEmModel::CrossSectionPerVolume(), G4VEmModel::G4VEmModel(), and G4VEmModel::SelectRandomAtom().
|
protectedinherited |
Definition at line 426 of file G4VEmModel.hh.
Referenced by G4VEmModel::GetCrossSectionTable(), G4VMscModel::GetParticleChangeForMSC(), G4VMscModel::GetTransportMeanFreePath(), G4VEmModel::SetCrossSectionTable(), and G4VEmModel::~G4VEmModel().
|
private |
Definition at line 147 of file G4UrbanAdjointMscModel.hh.
Referenced by G4UrbanAdjointMscModel(), and UpdateCache().
|
private |
Definition at line 147 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeCrossSectionPerAtom(), G4UrbanAdjointMscModel(), and UpdateCache().
|
private |
Definition at line 147 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTheta0(), ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and UpdateCache().
|
private |
Definition at line 146 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel(), and UpdateCache().
|
private |
Definition at line 136 of file G4UrbanAdjointMscModel.hh.
Referenced by ComputeGeomPathLength(), ComputeTrueStepLength(), G4UrbanAdjointMscModel(), SampleDisplacement(), and SampleDisplacementNew().