Geant4
10.00.p01
|
#include <iostream>
#include "G4SystemOfUnits.hh"
#include "G4HadTmpUtil.hh"
#include "G4ElectroNuclearCrossSection.hh"
#include "G4CrossSectionFactory.hh"
Go to the source code of this file.
Functions | |
G4_DECLARE_XS_FACTORY (G4ElectroNuclearCrossSection) | |
Variables | |
static const G4double | shd =1.0734 |
static const G4double | poc =0.0375 |
static const G4double | pos =16.5 |
static const G4double | reg =.11 |
static const G4double | mel =0.5109989 |
static const G4double | mel2 =mel*mel |
static const G4double | lmel =std::log(mel) |
static const G4int | nE =336 |
static const G4int | mL =nE-1 |
static const G4double | EMi =2.0612 |
static const G4double | EMa =50000. |
static const G4double | EMa2 =EMa*EMa |
static const G4double | lEMi =std::log(EMi) |
static const G4double | lEMa =std::log(EMa) |
static const G4double | lEMa2 =lEMa*lEMa |
static const G4double | dlnE =(lEMa-lEMi)/mL |
static const G4double | alop =1./137.036/3.14159265 |
static const G4double | le1 =(lEMa-1.)*EMa |
static const G4double | leh =(lEMa-.5)*EMa2 |
static const G4double | ha =poc*.5 |
static const G4double | hab =ha*pos |
static const G4double | ab =poc*pos |
static const G4double | d1 = 1 - reg |
static const G4double | d2 = 2 - reg |
static const G4double | cd =shd/reg |
static const G4double | cd1 =shd/d1 |
static const G4double | cd2 =shd/d2 |
static const G4double | ele =std::exp(-reg*lEMa) |
static const G4double | ele1 =std::exp(d1*lEMa) |
static const G4double | ele2 =std::exp(d2*lEMa) |
static const G4double | phte =poc*(lEMa-pos)+shd*ele |
static const G4int | imax =27 |
static const G4double | eps =0.001 |
static const G4double | infEn = 9.e27 |
static const G4double | dM =938.27+939.57 |
static const G4double | Q0 =843. |
static const G4double | Q02 =Q0*Q0 |
static const G4double | blK0 =std::log(185.) |
static const G4double | bp =0.85 |
static const G4double | clK0 =std::log(1390.) |
static const G4double | cp =3. |
static const G4int | nN =14 |
static const G4int | L [nN] ={138, 2, 32, 75, 26, 41, 0, 67, 58, 46, 41, 38, 39, 36} |
static const G4double | A [nN] ={1.,2.,3.,4.,6.,7.,9.,12.,16.,27.,63.546,118.71,207.2,238.472} |
static const G4double | P00 [nE] |
static const G4double | P10 [nE] |
static const G4double | P20 [nE] |
static const G4double | P01 [nE] |
static const G4double | P11 [nE] |
static const G4double | P21 [nE] |
static const G4double | P02 [nE] |
static const G4double | P12 [nE] |
static const G4double | P22 [nE] |
static const G4double | P03 [nE] |
static const G4double | P13 [nE] |
static const G4double | P23 [nE] |
static const G4double | P04 [nE] |
static const G4double | P14 [nE] |
static const G4double | P24 [nE] |
static const G4double | P05 [nE] |
static const G4double | P15 [nE] |
static const G4double | P25 [nE] |
static const G4double | P06 [nE] |
static const G4double | P16 [nE] |
static const G4double | P26 [nE] |
static const G4double | P07 [nE] |
static const G4double | P17 [nE] |
static const G4double | P27 [nE] |
static const G4double | P08 [nE] |
static const G4double | P18 [nE] |
static const G4double | P28 [nE] |
static const G4double | P09 [nE] |
static const G4double | P19 [nE] |
static const G4double | P29 [nE] |
static const G4double | P010 [nE] |
static const G4double | P110 [nE] |
static const G4double | P210 [nE] |
static const G4double | P011 [nE] |
static const G4double | P111 [nE] |
static const G4double | P211 [nE] |
static const G4double | P012 [nE] |
static const G4double | P112 [nE] |
static const G4double | P212 [nE] |
static const G4double | P013 [nE] |
static const G4double | P113 [nE] |
static const G4double | P213 [nE] |
static const G4double * | P0 [nN] ={P00,P01,P02,P03,P04,P05,P06,P07,P08,P09,P010,P011,P012,P013} |
static const G4double * | P1 [nN] ={P10,P11,P12,P13,P14,P15,P16,P17,P18,P19,P110,P111,P112,P113} |
static const G4double * | P2 [nN] ={P20,P21,P22,P23,P24,P25,P26,P27,P28,P29,P210,P211,P212,P213} |
G4_DECLARE_XS_FACTORY | ( | G4ElectroNuclearCrossSection | ) |
Definition at line 115 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4Pow::A13(), G4RadioactiveDecay::AddDecayRateTable(), G4INCL::NuclearDensityFactory::addDensityToCache(), G4NistElementBuilder::AddElement(), exrdmAnalysisManager::AddEnergy(), G4INCL::NuclearDensityFactory::addRPCorrelationToCache(), G4NuclearLevelStore::AddUserEvaporationDataFile(), G4ParaFissionModel::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LEpp::ApplyYourself(), G4LEnp::ApplyYourself(), G4PreCompoundModel::ApplyYourself(), G4MuMinusCapturePrecompound::ApplyYourself(), G4EmCaptureCascade::ApplyYourself(), G4MuonMinusBoundDecay::ApplyYourself(), G4INCLXXInterface::ApplyYourself(), G4NeutronHPChannel::ApplyYourself(), G4FissionBarrier::BarashenkovFissionBarrier(), RunAction::BeginOfRunAction(), G4InuclSpecialFunctions::bindingEnergyAsymptotic(), G4InuclEvaporation::BreakItUp(), G4Evaporation::BreakItUp(), G4ExcitationHandler::BreakItUp(), G4WilsonAblationModel::BreakItUp(), G4CompetitiveFission::BreakUp(), G4UnstableFragmentBreakUp::BreakUpFragment(), G4EmCorrections::BuildCorrectionVector(), G4AdjointCSManager::BuildCrossSectionMatrices(), G4NeutronHPJENDLHEData::BuildPhysicsTable(), G4BGGPionElasticXS::BuildPhysicsTable(), G4BGGNucleonInelasticXS::BuildPhysicsTable(), G4BGGNucleonElasticXS::BuildPhysicsTable(), G4BGGPionInelasticXS::BuildPhysicsTable(), G4GEMCoulombBarrier::CalcCompoundRadius(), G4StatMFMicroCanonical::CalcEntropyOfCompoundNucleus(), G4StatMFMicroCanonical::CalcFreeInternalEnergy(), G4GEMProbability::CalcProbability(), G4ChipsKaonPlusInelasticXS::CalculateCrossSection(), G4GNASHTransitions::CalculateProbability(), G4PreCompoundTransitions::CalculateProbability(), G4StatMFMacroCanonical::CalculateTemperature(), G4PDGCodeChecker::CheckForNuclei(), G4StatMFChannel::CheckFragments(), G4BinaryCascade::CheckPauliPrinciple(), G4QuasiElRatios::ChExElCoef(), G4StatMFMacroCanonical::ChooseA(), G4StatMFMacroCanonical::ChooseAandZ(), G4StatMFMacroCanonical::ChooseZ(), G4INCL::Cluster::Cluster(), G4INCL::ClusteringModelIntercomparison::ClusteringModelIntercomparison(), G4VCrossSectionDataSet::ComputeCrossSection(), Construct(), Materials::Construct(), QMaterials::Construct(), MyMaterials::Construct(), B03DetectorConstruction::Construct(), B01DetectorConstruction::Construct(), B02DetectorConstruction::Construct(), CML2Ph_BoxInBox::Construct(), G4RDGenerator2BN::ConstructMajorantSurface(), G4Generator2BN::ConstructMajorantSurface(), G4IonTable::Contains(), G4BGGPionInelasticXS::CoulombFactor(), G4INCL::NuclearDensityFactory::createDensity(), G4INCL::NuclearDensityFactory::createPCDFTable(), G4UGenericPolycone::CreatePolyhedron(), G4GenericPolycone::CreatePolyhedron(), G4UPolyhedra::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), G4INCL::NuclearDensityFactory::createRCDFTable(), G4INCL::NuclearDensityFactory::createRPCorrelationTable(), G4ContinuumGammaDeexcitation::CreateTransition(), G4DiscreteGammaDeexcitation::CreateTransition(), G4VTwistSurface::DebugPrint(), G4Fissioner::deExcite(), G4PreCompoundModel::DeExcite(), G4HumanPhantomMaterial::DefineMaterials(), BrachyMaterial::DefineMaterials(), G4ElasticData::DefineNucleusParameters(), G4Ellipsoid::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), G4ScreenedCoulombClassicalKinematics::DoCollisionStep(), G4ProjectileFragmentCrossSection::doit(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), G4VIsotopeTable::DumpTable(), G4FissionProbability::EmissionProbability(), G4FPYSamplingOps::EvaluateWattConstants(), G4Pow::expA(), G4AdjointInterpolator::ExponentialInterpolation(), PerspectiveVisAction::ExtendedDraw(), G4LivermorePolarizedGammaConversionModel::Fdlor(), G4InuclSpecialFunctions::FermiEnergy(), HadrontherapyMatrix::Fill(), IORTMatrix::Fill(), G4NuclearDecayChannel::FillDaughterNucleus(), HadrontherapyLet::FillEnergySpectrum(), G4IonTable::FindIon(), G4IonTable::FindIonInMaster(), G4StatMF::FindTemperatureOfBreakingChannel(), G4LivermorePolarizedGammaConversionModel::Fintlor(), G4CompetitiveFission::FissionCharge(), G4NistManager::G4NistManager(), G4fissionEvent::G4SmpNugDist(), G4RDGenerator2BN::Generate2BN(), G4NuclearLevelStore::GenerateFileName(), G4NuclearLevelStore::GenerateKey(), B3PrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4AblaVirtualData::getAlpha(), G4SigmaPlusField::GetBarrier(), G4SigmaMinusField::GetBarrier(), G4AntiProtonField::GetBarrier(), G4KaonMinusField::GetBarrier(), G4KaonPlusField::GetBarrier(), G4PionPlusField::GetBarrier(), G4PionMinusField::GetBarrier(), G4QuasiElRatios::GetChExFactor(), G4FermiFragmentsPool::GetConfigurationList(), G4NeutronHPJENDLHEData::GetCrossSection(), G4NuclNuclDiffuseElastic::GetDiffuseElasticSumXsc(), G4DiffuseElastic::GetDiffuseElasticSumXsc(), G4NuclNuclDiffuseElastic::GetDiffuseElasticXsc(), G4DiffuseElastic::GetDiffuseElasticXsc(), G4AblaVirtualData::getEcnz(), G3EleTable::GetEle(), G4NeutronInelasticCrossSection::GetElementCrossSection(), G4HadronInelasticDataSet::GetElementCrossSection(), G4HadronElasticDataSet::GetElementCrossSection(), G4IonsShenCrossSection::GetElementCrossSection(), G4GGNuclNuclCrossSection::GetElementCrossSection(), G4ChargeExchangeProcess::GetElementCrossSection(), G4ComponentGGNuclNuclXsc::GetElementCrossSection(), G4QuasiElRatios::GetElTot(), G4PromptPhotonEvaporation::GetEmissionProbability(), G4BinaryCascade::GetExcitationEnergy(), G4INCL::ParticleTable::getFermiMomentumConstantLight(), G4SigmaPlusField::GetField(), G4KaonZeroField::GetField(), G4SigmaMinusField::GetField(), G4SigmaZeroField::GetField(), G4AntiProtonField::GetField(), G4PionZeroField::GetField(), G4KaonMinusField::GetField(), G4PionPlusField::GetField(), G4KaonPlusField::GetField(), G4PionMinusField::GetField(), G4FermiFragmentsPool::GetFragment(), G4ElectroNuclearCrossSection::GetFunctions(), G4IonTable::GetIon(), G4IonTable::GetIonName(), G4BGGNucleonInelasticXS::GetIsoCrossSection(), G4BGGPionElasticXS::GetIsoCrossSection(), G4BGGNucleonElasticXS::GetIsoCrossSection(), G4BGGPionInelasticXS::GetIsoCrossSection(), G4IsotopeMagneticMomentTable::GetIsotope(), G4NuclideTable::GetIsotope(), G4IsotopeMagneticMomentTable::GetIsotopeByIsoLvl(), G4NuclearLevelStore::GetLevelManager(), G4IonTable::GetLifeTime(), G4NuclearLevelStore::GetManager(), G4QMDNucleus::GetMassNumber(), G4PhononDownconversion::GetMeanFreePath(), G4RIsotopeTable::GetMeanLifeTime(), G4MuonMinusBoundDecay::GetMuonCaptureRate(), G4NeutronHPNames::GetName(), G4INCL::ParticleTable::getName(), G4QMDNucleus::GetNuclearMass(), G4INCL::ParticleTable::getNuclearRadius(), G4IonTable::GetNucleusMass(), G4AblaVirtualData::getPace2(), G4FissionProductYieldDist::GetParticleDefinition(), G4Paraboloid::GetPointOnSurface(), G4QuasiElRatios::GetQF2IN_Ratio(), G4INCL::ParticleTable::getRadiusParameter(), G4INCL::ParticleTable::getSeparationEnergyReal(), G4INCL::ParticleTable::getShortName(), G4PhononDownconversion::GetTTDecayProb(), G4AblaVirtualData::getVgsld(), G4EMDissociationCrossSection::GetWilsonProbabilityForProtonDissociation(), G4NeutronHPMadlandNixSpectrum::GIntegral(), G4LivermorePolarizedGammaConversionModel::Glor(), G4NeutronHPPInelasticFS::Init(), G4NeutronHPNInelasticFS::Init(), G4NeutronHPCaptureFS::Init(), G4NeutronHPElementData::Init(), G4NeutronHPIsoData::Init(), G4FissionLibrary::Init(), G4FermiFragmentsPool::Initialise(), G4NeutronCaptureXS::Initialise(), G4NeutronInelasticXS::Initialise(), G4NuclNuclDiffuseElastic::InitialiseOnFly(), G4DiffuseElastic::InitialiseOnFly(), G4StatMFMicroCanonical::Initialize(), G4StatMFMacroCanonical::Initialize(), G4StatMFMicroManager::Initialize(), G4WendtFissionFragmentGenerator::InitializeANucleus(), G4PenelopeBremsstrahlungFS::InitializeEnergySampling(), G4NuclNuclDiffuseElastic::InitParameters(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4IonTable::Insert(), G4IonTable::InsertWorker(), G4Paraboloid::Inside(), G4NuclNuclDiffuseElastic::IntegralElasticProb(), G4DiffuseElastic::IntegralElasticProb(), G4HETCFragment::IntegrateEmissionProbability(), G4PiNuclearCrossSection::Interpolate(), G4NucleonNuclearCrossSection::Interpolate(), G4ComponentBarNucleonNucleusXsc::Interpolate(), G4RDVeLowEnergyLoss::InvertRangeVector(), G4hRDEnergyLoss::InvertRangeVector(), G4HadronNucleonXsc::IsApplicable(), G4RadioactiveDecay::IsApplicable(), G4FermiFragmentsPool::IsExist(), G4INCL::ClusterDecay::isStable(), G4EvaporationLevelDensityParameter::LevelDensityParameter(), G4RadioactiveDecay::LoadDecayTable(), G4INCL::Store::loadParticles(), G4AdjointInterpolator::LogarithmicInterpolation(), main(), G4FissionProductYieldDist::MakeIsotopeName(), G4CascadeCoalescence::makeLightIon(), G4NucleiPropertiesTableAME03::MaxZ(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4RPGReaction::NuclearReaction(), G4ReactionDynamics::NuclearReaction(), CML2Acc1::otherMaterials(), G3EleTable::parse(), G4PreCompoundTransitions::PerformTransition(), G4GammaConversionToMuons::PostStepDoIt(), G4IonTable::PreloadNuclide(), G4INCL::INCL::prepareReaction(), G4INCL::Store::printParticleConfiguration(), G4PreCompoundIon::ProbabilityDistributionFunction(), HadrontherapyDetectorSD::ProcessHits(), G4CompetitiveFission::Ratio(), G4AblaDataFile::readData(), CCalMaterialFactory::readElements(), G4NeutronHPJENDLHEData::registAPhysicsVector(), G4NeutronHPChannel::Register(), G4IonTable::Remove(), PerspectiveVisAction::RoomAndChair(), G4NeutronHPIsotropic::Sample(), G4NeutronHPContAngularPar::Sample(), G4NeutronHPNBodyPhaseSpace::Sample(), G4NeutronHPLabAngularEnergy::Sample(), G4NeutronHPDiscreteTwoBody::Sample(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4Generator2BN::SampleDirection(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4PenelopeComptonModel::SampleSecondaries(), G4GoudsmitSaundersonTable::SampleTheta(), G4NuclNuclDiffuseElastic::SampleThetaCMS(), G4DiffuseElastic::SampleThetaCMS(), G4QuasiElasticChannel::Scatter(), G4NeutronCaptureXS::SelectIsotope(), G4NeutronInelasticXS::SelectIsotope(), G4WilsonAblationModel::SelectSecondariesByDefault(), G4ElementSelector::SelectZandA(), G4INCL::Cluster::setA(), G4AblaVirtualData::setAlpha(), G4IsotopeProperty::SetAtomicMass(), G4AblaVirtualData::setEcnz(), G4KM_OpticalEqRhs::SetFactor(), G4VPolarizedCrossSection::SetMaterial(), G4RadioactiveDecaymessenger::SetNewValue(), G4NuclearLevelManager::SetNucleus(), G4AblaVirtualData::setPace2(), G4Nucleus::SetParameters(), G4NeutronHPReactionWhiteBoard::SetTargA(), G4INCL::Config::setTargetA(), G4ScreeningMottCrossSection::SetupKinematic(), G4AblaVirtualData::setVgsld(), G4RPGNeutronInelastic::SlowNeutron(), G4RPGProtonInelastic::SlowProton(), G4NystromRK4::Stepper(), HadrontherapyLet::StoreLetRoot(), G4Paraboloid::SurfaceNormal(), G4NuclNuclDiffuseElastic::TestAngleTable(), G4DiffuseElastic::TestAngleTable(), G4PhotoNuclearCrossSection::ThresholdEnergy(), tpia_particle_getInternalID(), G4NeutronHPInelasticCompFS::two_body_reaction(), exrdmSteppingAction::UserSteppingAction(), HadrontherapySteppingAction::UserSteppingAction(), and IORTSteppingAction::UserSteppingAction().
Definition at line 87 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4MuonMinusCaptureAtRest::AtRestDoIt(), G4InuclCollider::collide(), G4UGenericPolycone::CreatePolyhedron(), G4GenericPolycone::CreatePolyhedron(), G4UPolyhedra::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), G4EmMessenger::G4EmMessenger(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4ElectroNuclearCrossSection::HighEnergyJ2(), G4CascadeColliderBase::inelasticInteractionPossible(), G4NucleiModel::initializeCascad(), G4VEmModel::SelectIsotopeNumber(), G4ElementSelector::SelectZandA(), and G4IntraNucleiCascader::setupCascade().
|
static |
Definition at line 81 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection().
|
static |
Definition at line 106 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetVirtualFactor().
|
static |
Definition at line 107 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4INCL::Particle::boost(), G4Abla::direct(), G4Abla::evapora(), and G4ElectroNuclearCrossSection::GetVirtualFactor().
Definition at line 90 of file G4ElectroNuclearCrossSection.cc.
Referenced by UPolyconeSide::Extent(), G4PolyconeSide::Extent(), G4UImanager::Foreach(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4UImanager::Loop(), G4DataInterpolation::PolynomInterpolation(), and G4DataInterpolation::RationalPolInterpolation().
Definition at line 91 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 92 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 108 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetVirtualFactor().
|
static |
Definition at line 109 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4TheRayTracer::CreateBitMap(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4ElectroNuclearCrossSection::GetVirtualFactor(), DetectorConstruction::LoadChromosome(), mmap_resize(), G4PenelopeIonisationModel::SampleFinalStateElectron(), and G4PenelopeIonisationModel::SampleFinalStatePositron().
Definition at line 88 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 89 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
Definition at line 80 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), and G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy().
|
static |
Definition at line 103 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroVDNuclearModel::ApplyYourself(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4ElectroNuclearCrossSection::GetVirtualFactor(), and G4LENDUsedTarget::searchTarget().
Definition at line 93 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4tgbGeometryDumper::DumpElement(), G4ElectroNuclearCrossSection::HighEnergyJ1(), and pyG4Element::Print().
Definition at line 94 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 95 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 75 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2(), and G4ElectroNuclearCrossSection::SolveTheEquation().
Definition at line 76 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 74 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection().
|
static |
Definition at line 99 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4MagInt_Driver::AccurateAdvance(), G4NeutronHPCaptureFS::ApplyYourself(), G4NeutronHPInelasticBaseFS::BaseApply(), G4StatMFMicroCanonical::CalcEntropyOfCompoundNucleus(), G4StatMFMicroPartition::CalcPartitionTemperature(), G4NeutronHPInelasticCompFS::CompositeApply(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeDXSectionPerAtom(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4ScreenedCoulombClassicalKinematics::DoCollisionStep(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), G4ecpssrBaseKxsModel::ExpIntFunction(), G4ecpssrBaseLixsModel::ExpIntFunction(), G4RKPropagation::FieldTransport(), G4StatMF::FindTemperatureOfBreakingChannel(), G4MuonRadiativeDecayChannelWithSpin::fron(), MyGamma::GamCf(), MyGamma::GamSer(), G4NeutronHPFissionData::GetCrossSection(), G4NeutronHPCaptureData::GetCrossSection(), G4NeutronHPInelasticData::GetCrossSection(), G4NeutronHPElasticData::GetCrossSection(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4HyperNucleiProperties::GetNuclearMass(), G4NeutronHPThermalBoost::GetThermalEnergy(), G4NeutronHPInelasticBaseFS::InitGammas(), G4PolarizedAnnihilationCrossSection::Initialize(), G4PolarizedComptonCrossSection::Initialize(), G4NativeScreenedCoulombCrossSection::LoadData(), G4LindhardRobinsonPartition::PartitionNIEL(), G4eBremsstrahlungRelModel::Psi1M2(), G4MagInt_Driver::QuickAdvance(), G4InuclSpecialFunctions::randomGauss(), G4PenelopeGammaConversionModel::SampleSecondaries(), VUSolid::SetAngTolerance(), VUSolid::SetCarTolerance(), G4DNATransformElectronModel::SetEpsilonEnergy(), F04GlobalField::SetEpsMax(), F04GlobalField::SetEpsMin(), VUSolid::SetRadTolerance(), G4ElectroNuclearCrossSection::SolveTheEquation(), CLHEP::transformSmall(), and G4MagInt_Driver::WarnEndPointTooFar().
Definition at line 85 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ1(), and G4ElectroNuclearCrossSection::HighEnergyJ3().
Definition at line 86 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 98 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4NistMaterialBuilder::AddElementByWeightFraction(), CLHEP::correctPsiPhi(), G4NistMaterialBuilder::DumpMix(), G4NeutronHPFFFissionFS::Init(), G4MuPairProductionModel::MakeSamplingTables(), G4NistElementBuilder::PrintElement(), G4ElectroNuclearCrossSection::SolveTheEquation(), and tpia_misc_binarySearch().
|
static |
Definition at line 101 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::ThresholdEnergy().
Definition at line 113 of file G4ElectroNuclearCrossSection.cc.
Referenced by _tr_align(), _tr_init(), _tr_stored_block(), _tr_tally(), adler32(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4PDGCodeChecker::CheckForNuclei(), G4eeToHadronsModel::ComputeCMCrossSectionPerElectron(), G4IonTable::Contains(), deflate(), deflate_stored(), deflateInit2_(), deflateResetKeep(), deflateSetDictionary(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TemplateRNGHelper< T >::Fill(), G4NeutronHPThermalScattering::find_LH(), G4IonTable::FindIon(), G4IonTable::FindIonInMaster(), G4eeToHadronsModel::GenerateCMPhoton(), G4ElectroNuclearCrossSection::GetFunctions(), G4IonTable::GetIon(), G4IonTable::GetIonName(), G4IonTable::GetNucleusByEncoding(), G4RadioactiveDecay::GetTaoTime(), inflate(), inflateMark(), inflatePrime(), inflateSetDictionary(), init_block(), G4IonTable::Insert(), G4IonTable::InsertWorker(), lm_init(), G4TemplateRNGHelper< T >::Refill(), G4IonTable::Remove(), CLHEP::StirlingCorrection(), and zlibCompileFlags().
Definition at line 82 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 83 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
Definition at line 78 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), G4ElectroNuclearCrossSection::HighEnergyJ1(), and G4ElectroNuclearCrossSection::SolveTheEquation().
Definition at line 79 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ1().
Definition at line 77 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), and G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy().
|
static |
Definition at line 68 of file G4ElectroNuclearCrossSection.cc.
Definition at line 69 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetEquivalentPhotonQ2().
Definition at line 73 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy(), and G4HyperNucleiProperties::GetNuclearMass().
|
static |
Definition at line 72 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy(), and G4ElectroNuclearCrossSection::GetFunctions().
|
static |
Definition at line 111 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetFunctions().
Definition at line 2175 of file G4ElectroNuclearCrossSection.cc.
Referenced by TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), and G4ElectroNuclearCrossSection::GetFunctions().
Definition at line 117 of file G4ElectroNuclearCrossSection.cc.
Definition at line 264 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1587 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1734 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1881 of file G4ElectroNuclearCrossSection.cc.
Definition at line 2028 of file G4ElectroNuclearCrossSection.cc.
Definition at line 411 of file G4ElectroNuclearCrossSection.cc.
Definition at line 558 of file G4ElectroNuclearCrossSection.cc.
Definition at line 705 of file G4ElectroNuclearCrossSection.cc.
Definition at line 852 of file G4ElectroNuclearCrossSection.cc.
Definition at line 999 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1146 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1293 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1440 of file G4ElectroNuclearCrossSection.cc.
Definition at line 2176 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4PreCompoundModel::DeExcite(), G4CompetitiveFission::FissionKineticEnergy(), G4StatMFChannel::FragmentsMomenta(), G4PartonPair::G4PartonPair(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfProjectile(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfTarget(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4ElectroNuclearCrossSection::GetFunctions(), G4Bessel::I0(), G4Bessel::I1(), G4Bessel::K0(), G4Bessel::K1(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 166 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4RKFieldIntegrator::Erf(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 313 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4RKFieldIntegrator::Erf(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 1636 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1783 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1930 of file G4ElectroNuclearCrossSection.cc.
Definition at line 2077 of file G4ElectroNuclearCrossSection.cc.
Definition at line 460 of file G4ElectroNuclearCrossSection.cc.
Referenced by tpia_misc_sampleEqualProbableBin().
Definition at line 607 of file G4ElectroNuclearCrossSection.cc.
Definition at line 754 of file G4ElectroNuclearCrossSection.cc.
Definition at line 901 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1048 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1195 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1342 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1489 of file G4ElectroNuclearCrossSection.cc.
Definition at line 2177 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4PreCompoundModel::DeExcite(), G4RKFieldIntegrator::Erf(), G4CompetitiveFission::FissionKineticEnergy(), G4StatMFChannel::FragmentsMomenta(), G4PartonPair::G4PartonPair(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4ElectroNuclearCrossSection::GetFunctions(), G4Bessel::I0(), G4Bessel::I1(), G4Bessel::K0(), G4Bessel::K1(), G4FermiPhaseSpaceDecay::PtwoBody(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 215 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 362 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 1685 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1832 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1979 of file G4ElectroNuclearCrossSection.cc.
Definition at line 2126 of file G4ElectroNuclearCrossSection.cc.
Definition at line 509 of file G4ElectroNuclearCrossSection.cc.
Definition at line 656 of file G4ElectroNuclearCrossSection.cc.
Referenced by tpia_misc_sampleEqualProbableBin().
Definition at line 803 of file G4ElectroNuclearCrossSection.cc.
Definition at line 950 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1097 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1244 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1391 of file G4ElectroNuclearCrossSection.cc.
Definition at line 1538 of file G4ElectroNuclearCrossSection.cc.
Definition at line 97 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::SolveTheEquation().
|
static |
Definition at line 65 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::DFun(), and G4ElectroNuclearCrossSection::HighEnergyJ2().
|
static |
Definition at line 66 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4KDTree::__NearestInRange(), CML2ExpVoxels::add(), G4AdjointCrossSurfChecker::AddaSphericalSurface(), G4HepRepSceneHandler::addAttVals(), G4TessellatedSolid::AddFacet(), HistoManager::AddLeakingParticle(), G4Region::AddRootLogicalVolume(), HistoManager::AddTargetStep(), XrayTelAnalysis::analyseStepping(), G4RDAugerTransition::AugerOriginatingShellId(), G4AugerTransition::AugerOriginatingShellId(), G4RDAugerTransition::AugerTransitionEnergy(), G4AugerTransition::AugerTransitionEnergy(), G4RDAugerTransition::AugerTransitionProbability(), G4AugerTransition::AugerTransitionProbability(), G4ShellData::BindingEnergy(), G4RDShellData::BindingEnergy(), G03ColorWriter::BookAttribute(), G4GDMLWriteSolids::BooleanWrite(), G4NucleiModel::boundaryTransition(), G4INCL::InteractionAvatar::bringParticleInside(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4SurfaceVoxelizer::BuildReduceVoxels(), UVoxelizer::BuildReduceVoxels(), G4BinaryCascade::BuildTargetList(), G4PVParameterised::CheckOverlaps(), G4BinaryCascade::CheckPauliPrinciple(), G4RunManagerKernel::CheckRegularGeometry(), G4NucleiModel::choosePointAlongTraj(), DMXStackingAction::ClassifyNewTrack(), G4FieldManagerStore::Clean(), G4LogicalVolumeStore::Clean(), G4PhysicalVolumeStore::Clean(), G4SolidStore::Clean(), G4RegionStore::Clean(), G4SurfaceProperty::CleanSurfacePropertyTable(), G4LogicalSkinSurface::CleanSurfaceTable(), G4LogicalBorderSurface::CleanSurfaceTable(), G4RDVCrossSectionHandler::Clear(), G4VCrossSectionHandler::Clear(), G4PixeCrossSectionHandler::Clear(), G4INCL::ClusteringModelIntercomparison::clusterCanEscape(), DetectorConstruction::ConstructDetector(), G3Division::CreateEnvelope(), G4TessellatedSolid::CreateVertexList(), G4ChipsProtonInelasticXS::CrossSectionLin(), G4ChipsNeutronInelasticXS::CrossSectionLin(), G4DNAChampionElasticModel::CrossSectionPerVolume(), G4DNABornExcitationModel::CrossSectionPerVolume(), G4DNAMeltonAttachmentModel::CrossSectionPerVolume(), G4DNARuddIonisationExtendedModel::CrossSectionPerVolume(), G4DNARuddIonisationModel::CrossSectionPerVolume(), G4DNABornIonisationModel::CrossSectionPerVolume(), G4MicroElecElasticModel::CrossSectionPerVolume(), G4MuElecElasticModel::CrossSectionPerVolume(), G4MicroElecInelasticModel::CrossSectionPerVolume(), G4MuElecInelasticModel::CrossSectionPerVolume(), G4MagneticFieldModel::DescribeYourselfTo(), G4ElectroNuclearCrossSection::DFun(), G4ScoringBox::Draw(), G4ScoringBox::DrawColumn(), LXeTrajectory::DrawTrajectory(), RE01Trajectory::DrawTrajectory(), WLSTrajectory::DrawTrajectory(), G4tgbGeometryDumper::DumpBooleanVolume(), G4tgbGeometryDumper::DumpPVPlacement(), GFlashShowerModel::ElectronDoIt(), CCalEndOfEventAction::EndOfEventAction(), G4BlineEventAction::EndOfEventAction(), engine(), G4KM_OpticalEqRhs::EvaluateRhsGivenB(), G4KM_NucleonEqRhs::EvaluateRhsGivenB(), G4eIonisationParameters::Excitation(), G4RDeIonisationParameters::Excitation(), G4GDMLReadStructure::FileRead(), G4CascadParticle::fill(), G4Absorber::FindAbsorbers(), G4GDMLWriteStructure::FindOpticalSurface(), G4MCTSimEvent::FindParticle(), G4RDVCrossSectionHandler::FindValue(), G4PixeCrossSectionHandler::FindValue(), G4VCrossSectionHandler::FindValue(), G4AugerData::G4AugerData(), G4GenericMessenger::G4GenericMessenger(), G4RDAugerData::G4RDAugerData(), G4SmoothTrajectoryPoint::G4SmoothTrajectoryPoint(), G4TrajectoryPoint::G4TrajectoryPoint(), G4AdjointPrimaryGenerator::GenerateAdjointPrimaryVertex(), G4RDAtomicDeexcitation::GenerateAuger(), G4AtomicDeexcitation::GenerateAuger(), G4UAtomicDeexcitation::GenerateAuger(), G4AdjointPrimaryGenerator::GenerateFwdPrimaryVertex(), G4GDMLReadStructure::GetAssembly(), RE01TrackerHit::GetAttDefs(), RE01CalorimeterHit::GetAttDefs(), RE04TrajectoryPoint::GetAttDefs(), G4GDMLWriteStructure::GetBorderSurface(), G4LossTableManager::GetEnergyLossProcess(), pyG4MagneticField::CB_PyG4MagneticField::GetFieldValue(), G4MCTEvent::GetGenParticle(), XrayFluoSiLiDetectorType::GetInfData(), XrayFluoHPGeDetectorType::GetInfData(), G4KDTreeResult::GetItem(), G4ScoringBox::GetReplicaPosition(), G4MCTEvent::GetSimParticle(), G4GDMLWriteStructure::GetSkinSurface(), XrayFluoHPGeDetectorType::GetSupData(), XrayFluoSiLiDetectorType::GetSupData(), G4MesonAbsorption::GetTimeToAbsorption(), G4Scatterer::GetTimeToInteraction(), G03ColorReader::GetVisAttribute(), G4GDMLReadStructure::GetVolumeAuxiliaryInformation(), HadrontherapyDetectorROGeometry::Initialize(), G4NucleiModel::initializeCascad(), __1DSortOut::Insert(), G4KDMap::Insert(), UPolycone::Inside(), G4BinaryLightIonReaction::Interact(), internal_memalign(), CML2ExpVoxels::loadData(), G4KDTree::Nearest(), UPolycone::Normal(), G4RDVCrossSectionHandler::NumberOfComponents(), G4VCrossSectionHandler::NumberOfComponents(), G4PixeCrossSectionHandler::NumberOfComponents(), G4AtomicTransitionManager::NumberOfReachableShells(), G4RDAtomicTransitionManager::NumberOfReachableShells(), G4AtomicTransitionManager::NumberOfShells(), G4RDAtomicTransitionManager::NumberOfShells(), operand(), G4eIonisationParameters::Parameter(), G4BremsstrahlungParameters::Parameter(), G4RDeIonisationParameters::Parameter(), G4RDBremsstrahlungParameters::Parameter(), G4DNARuddIonisationExtendedModel::PartialCrossSection(), G4DNARuddIonisationModel::PartialCrossSection(), G4STRead::PhysvolRead(), G4GDMLWriteStructure::PhysvolWrite(), __1DSortOut::PopOutMiddle(), G4BremsstrahlungParameters::PrintData(), G4eIonisationParameters::PrintData(), G4RDBremsstrahlungParameters::PrintData(), G4RDeIonisationParameters::PrintData(), G4RDVCrossSectionHandler::PrintData(), G4VCrossSectionHandler::PrintData(), G4PixeCrossSectionHandler::PrintData(), G4BinaryCascade::PrintKTVector(), ExN04MuonSD::ProcessHits(), RE05MuonSD::ProcessHits(), LXeScintSD::ProcessHits(), G4DopplerProfile::Profiles(), G4RDDopplerProfile::Profiles(), G4BinaryCascade::Propagate1H1(), G4DNABornExcitationModel::RandomSelect(), G4MuElecInelasticModel::RandomSelect(), G4MicroElecInelasticModel::RandomSelect(), G4DNARuddIonisationExtendedModel::RandomSelect(), G4DNABornIonisationModel::RandomSelect(), G4DNARuddIonisationModel::RandomSelect(), G4AtomicTransitionManager::ReachableShell(), G4RDAtomicTransitionManager::ReachableShell(), G4CollisionOutput::removeOutgoingNucleus(), G4CollisionOutput::removeOutgoingParticle(), G4Region::RemoveRootLogicalVolume(), G4OpenInventorXtExaminerViewer::renameViewPt(), G4ExtDEDXTable::RetrievePhysicsTable(), Histo::ScoreNewTrack(), HistoManager::ScoreNewTrack(), G4RDVCrossSectionHandler::SelectRandomShell(), G4PixeCrossSectionHandler::SelectRandomShell(), G4VCrossSectionHandler::SelectRandomShell(), G4TessellatedSolid::SetAllUsingStack(), G4SafetyHelper::SetCurrentSafety(), G4ErrorTrajState::SetData(), WLSUserTrackInformation::SetExitPosition(), ExN04PrimaryGeneratorAction::SetGenerator(), H02PrimaryGeneratorAction::SetGenerator(), DicomIntersectVolume::SetNewValue(), G4ErrorSurfaceTrajState::SetParameters(), G4ErrorFreeTrajState::SetParameters(), HadrontherapyDetectorConstruction::SetPhantomPosition(), IORTDetectorConstruction::SetPhantomPosition(), eRositaTrackerHit::SetPos(), G4ErrorTrajState::SetPosition(), G4VUserParallelWorld::SetSensitiveDetector(), G4VUserDetectorConstruction::SetSensitiveDetector(), MedicalBeam::SetSourcePosition(), G4AtomicTransitionManager::Shell(), G4RDAtomicTransitionManager::Shell(), G4ShellData::ShellId(), G4RDShellData::ShellId(), G4ShellData::ShellIdVector(), G4RDShellData::ShellIdVector(), G4ShellData::ShellOccupancyProbability(), G4RDShellData::ShellOccupancyProbability(), G4ShellData::ShellVector(), G4RDShellData::ShellVector(), G4TrajectoryDrawerUtils::SliceLine(), G4FluoData::StartShellEnergy(), G4RDFluoData::StartShellEnergy(), G4RDFluoData::StartShellId(), G4FluoData::StartShellId(), G4FluoData::StartShellProb(), G4RDFluoData::StartShellProb(), G4GDMLWriteStructure::SurfacesWrite(), Tokenize(), G4AtomicTransitionManager::TotalNonRadiativeTransitionProbability(), G4RDAtomicTransitionManager::TotalNonRadiativeTransitionProbability(), G4AtomicTransitionManager::TotalRadiativeTransitionProbability(), G4RDAtomicTransitionManager::TotalRadiativeTransitionProbability(), G4CascadParticle::updatePosition(), G4ErrorTrajState::UpdatePosMom(), G4FluoData::VacancyId(), G4RDFluoData::VacancyId(), G03ColorReader::~G03ColorReader(), G4AtomicTransitionManager::~G4AtomicTransitionManager(), G4BremsstrahlungParameters::~G4BremsstrahlungParameters(), G4ChipsAntiBaryonElasticXS::~G4ChipsAntiBaryonElasticXS(), G4ChipsHyperonElasticXS::~G4ChipsHyperonElasticXS(), G4ChipsKaonMinusElasticXS::~G4ChipsKaonMinusElasticXS(), G4ChipsKaonPlusElasticXS::~G4ChipsKaonPlusElasticXS(), G4ChipsNeutronElasticXS::~G4ChipsNeutronElasticXS(), G4ChipsPionMinusElasticXS::~G4ChipsPionMinusElasticXS(), G4ChipsPionPlusElasticXS::~G4ChipsPionPlusElasticXS(), G4ChipsProtonElasticXS::~G4ChipsProtonElasticXS(), G4DNABornExcitationModel::~G4DNABornExcitationModel(), G4DNABornIonisationModel::~G4DNABornIonisationModel(), G4DNAChampionElasticModel::~G4DNAChampionElasticModel(), G4DNAMeltonAttachmentModel::~G4DNAMeltonAttachmentModel(), G4DNARuddIonisationExtendedModel::~G4DNARuddIonisationExtendedModel(), G4DNARuddIonisationModel::~G4DNARuddIonisationModel(), G4DopplerProfile::~G4DopplerProfile(), G4eIonisationParameters::~G4eIonisationParameters(), G4FluoData::~G4FluoData(), G4MicroElecElasticModel::~G4MicroElecElasticModel(), G4MicroElecInelasticModel::~G4MicroElecInelasticModel(), G4MuElecElasticModel::~G4MuElecElasticModel(), G4MuElecInelasticModel::~G4MuElecInelasticModel(), G4PixeCrossSectionHandler::~G4PixeCrossSectionHandler(), G4QuasiElRatios::~G4QuasiElRatios(), G4RDAtomicTransitionManager::~G4RDAtomicTransitionManager(), G4RDBremsstrahlungParameters::~G4RDBremsstrahlungParameters(), G4RDDopplerProfile::~G4RDDopplerProfile(), G4RDeIonisationParameters::~G4RDeIonisationParameters(), G4RDFluoData::~G4RDFluoData(), G4RDShellData::~G4RDShellData(), G4RDVCrossSectionHandler::~G4RDVCrossSectionHandler(), G4ShellData::~G4ShellData(), G4VCrossSectionHandler::~G4VCrossSectionHandler(), XrayFluoHPGeDetectorType::~XrayFluoHPGeDetectorType(), and XrayFluoSiLiDetectorType::~XrayFluoSiLiDetectorType().
|
static |
Definition at line 104 of file G4ElectroNuclearCrossSection.cc.
Definition at line 105 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::GetVirtualFactor().
|
static |
Definition at line 67 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4EmBiasingManager::ActivateForcedInteraction(), G4EmBiasingManager::ActivateSecondaryBiasing(), G4VEnergyLossProcess::ActivateSubCutoff(), G4EmConfigurator::AddModels(), ExTGRCRegionCutsMgr::BuildProductionCuts(), ExTGRCRegionCutsMgr::BuildRegions(), G4ElectroNuclearCrossSection::DFun(), G4EmModelManager::DumpModelList(), G4EmModelManager::FillDEDXVector(), G4EmModelManager::FillLambdaVector(), G4EmConfigurator::FindRegion(), G4RegionModels::G4RegionModels(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4PAIPhotModel::Initialise(), G4PAIPhotonModel::Initialise(), G4PAIModel::Initialise(), G4EmModelManager::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4MSSteppingAction::Initialize(), RE06SteppingVerbose::NewStep(), G4EmConfigurator::PrepareModels(), G4VEnergyLossProcess::PreparePhysicsTable(), RE06PhysicsList::SetCuts(), G4VTransitionRadiation::SetRegion(), GammaRayTelPhysicsList::SetRegionCut(), and G4WorkerThread::UpdateGeometryAndPhysicsVectorFromMaster().
|
static |
Definition at line 64 of file G4ElectroNuclearCrossSection.cc.
Referenced by G4ElectroNuclearCrossSection::DFun().