ECCE @ EIC Software
Reference for
ECCE @ EIC
simulation and reconstruction software on GitHub
|
#include <iostream>
#include "G4SystemOfUnits.hh"
#include "G4PhysicalConstants.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 =G4Log(mel) |
static const G4int | nE =336 |
static const G4int | mLL =nE-1 |
static const G4double | EMi =2.0612 |
static const G4double | EMa =50000. |
static const G4double | EMa2 =EMa*EMa |
static const G4double | lEMi =G4Log(EMi) |
static const G4double | lEMa =G4Log(EMa) |
static const G4double | lEMa2 =lEMa*lEMa |
static const G4double | dlnE =(lEMa-lEMi)/mLL |
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 =G4Exp(-reg*lEMa) |
static const G4double | ele1 =G4Exp(d1*lEMa) |
static const G4double | ele2 =G4Exp(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 =G4Log(185.) |
static const G4double | bp =0.85 |
static const G4double | clK0 =G4Log(1390.) |
static const G4double | cp =3. |
static const G4int | nN =14 |
static const G4int | LL [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.
View newest version in sPHENIX GitHub at line 115 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetFunctions(), and lgam().
Definition at line 87 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 87 of file G4ElectroNuclearCrossSection.cc
Referenced by G4InuclCollider::collide(), G4eplusTo3GammaOKVIModel::ComputeF(), G4eplusTo3GammaOKVIModel::ComputeF0(), Acts::GenericCuboidVolumeBounds::construct(), Acts::TGeoDetectorElement::construct(), Acts::ConvexPolygonBoundsBase::convex_impl(), G4GenericPolycone::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), Acts::GenericCuboidVolumeBounds::decomposeToSurfaces(), G4EmMessenger::G4EmMessenger(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4ElectroNuclearCrossSection::HighEnergyJ2(), G4CascadeColliderBase::inelasticInteractionPossible(), G4NucleiModel::initializeCascad(), kdfinder::Helix< T >::pathLengths(), pygfxx(), pygrvd(), pygrvl(), pygrvm(), pyhggm(), pypole(), pyrvch(), pyrvgl(), pyrvgw(), pyrvi1(), pyrvi2(), pyrvi3(), pyrvne(), pysfdc(), HepGeom::Reflect3D::Reflect3D(), G4AlphaBuilder::RegisterMe(), G4VEmModel::SelectIsotopeNumber(), G4ElementSelector::SelectZandA(), and G4IntraNucleiCascader::setupCascade().
|
static |
Definition at line 81 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 81 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection().
Definition at line 106 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 106 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetVirtualFactor().
|
static |
Definition at line 107 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 107 of file G4ElectroNuclearCrossSection.cc
Referenced by CLHEP::HepLorentzVector::boost(), G4INCL::Particle::boost(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4Abla::direct(), G4Abla::evap_postsaddle(), G4Abla::evapora(), G4ElectroNuclearCrossSection::GetVirtualFactor(), pyhixtot(), pyxtot(), rcdaqEventiterator::read_next_buffer(), rcdaqEventiterator::setup(), HelixHough::splitIntoBins(), and rcdaqEventiterator::~rcdaqEventiterator().
Definition at line 90 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 90 of file G4ElectroNuclearCrossSection.cc
Referenced by G4BoundingEnvelope::CalculateExtent(), G4PolyconeSide::Extent(), G4UImanager::Foreach(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4UImanager::Loop(), G4DataInterpolation::PolynomInterpolation(), pygrvd(), pygrvl(), pygrvm(), G4DataInterpolation::RationalPolInterpolation(), HepGeom::Reflect3D::Reflect3D(), CLHEP::Hep3Vector::rotate(), G4IonisParamMat::SetDensityEffectParameters(), and HepTool::Evaluator::setSystemOfUnits().
Definition at line 91 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 91 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 92 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 92 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
Definition at line 108 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 108 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetVirtualFactor().
|
static |
Definition at line 109 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 109 of file G4ElectroNuclearCrossSection.cc
Referenced by Acts::Test::BOOST_AUTO_TEST_CASE(), G4DNAScreenedRutherfordElasticModel::BrennerZaiderRandomizeCosTheta(), G4DNAUeharaScreenedRutherfordElasticModel::BrennerZaiderRandomizeCosTheta(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4TheRayTracer::CreateBitMap(), G4RTPrimaryGeneratorAction::GeneratePrimaries(), G4ElectroNuclearCrossSection::GetVirtualFactor(), DetectorConstruction::LoadChromosome(), lux4jt(), makePacketV1Hdr(), pyx4jt(), oncsEventiterator::read_next_buffer(), fileEventiterator::read_next_buffer(), FW::Options::readTGeoLayerBuilderConfigs(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeIonisationModel::SampleFinalStatePositron(), G4DNAScreenedRutherfordElasticModel::ScreenedRutherfordRandomizeCosTheta(), G4DNAUeharaScreenedRutherfordElasticModel::ScreenedRutherfordRandomizeCosTheta(), ogzBuffer::writeout(), olzoBuffer::writeout(), ospBuffer::writeout(), ophBuffer::writeout(), and FW::Obj::writeVTN().
Definition at line 88 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 88 of file G4ElectroNuclearCrossSection.cc
Definition at line 89 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 89 of file G4ElectroNuclearCrossSection.cc
Referenced by kdfinder::angle_between_vectors(), GPUTPCTrackParam::BetheBlochGeant(), G4RDLinLogLogInterpolation::Calculate(), G4DNACPA100LogLogInterpolation::Calculate(), G4RDLinLogInterpolation::Calculate(), G4LinInterpolator::Calculate(), G4LogLogInterpolator::Calculate(), G4RDLinInterpolation::Calculate(), G4RDLogLogInterpolation::Calculate(), G4RDSemiLogInterpolation::Calculate(), G4LinLogLogInterpolation::Calculate(), G4LinLogInterpolation::Calculate(), G4LinInterpolation::Calculate(), G4SemiLogInterpolation::Calculate(), G4LogLogInterpolation::Calculate(), CML2ExpVoxels::calculateNormalizedEd(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), G4PolyhedraSide::ClosestPhiSegment(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), G4PhysicalVolumeModel::DescribeAndDescend(), G4PolyconeSide::DistanceAway(), G4Sphere::DistanceToIn(), G4CutTubs::DistanceToOut(), G4Tubs::DistanceToOut(), G4Sphere::DistanceToOut(), G4ReplicaNavigation::DistanceToOutRad(), Acts::Frustum< value_t, DIM, SIDES >::draw(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), G4PolyhedraSide::G4PolyhedraSide(), G4ComponentAntiNuclNuclearXS::GetAntiHadronNucleonElCrSc(), G4ComponentAntiNuclNuclearXS::GetAntiHadronNucleonTotCrSc(), G4VXTRenergyLoss::GetComptonPerAtom(), G4MesonAbsorption::GetFinalState(), ActsFatras::detail::GeneralMixture::getGaussmix(), G4QGSMFragmentation::GetLightConeZ(), G4CascadParticle::getPathToTheNextZone(), G4ElectroNuclearCrossSection::HighEnergyJ3(), hijsft(), G4DNABornIonisationModel2::Interpolate(), G4DNABornIonisationModel1::Interpolate(), G4MicroElecInelasticModel::Interpolate(), G4DNAEmfietzoglouIonisationModel::Interpolate(), G4DNACPA100IonisationModel::Interpolate(), intersect_circles(), CylindricalHough::intersect_circles(), G4VTwistSurface::IsSameBoundary(), PHSimpleKFProp::KDPointCloud< T >::kdtree_distance(), kdfinder::KDPointCloud< double >::kdtree_distance(), G4MicroElecElasticModel::LinLinInterpolate(), G4DNAChampionElasticModel::LinLinInterpolate(), G4DNAELSEPAElasticModel::LinLinInterpolate(), G4DNACPA100ElasticModel::LinLinInterpolate(), G4DNAIonElasticModel::LinLinInterpolate(), G4DNAPTBElasticModel::LinLinInterpolate(), G4ecpssrBaseKxsModel::LinLogInterpolate(), G4ecpssrBaseLixsModel::LinLogInterpolate(), G4MuElecElasticModel::LinLogInterpolate(), G4MicroElecElasticModel::LinLogInterpolate(), G4DNAIonElasticModel::LinLogInterpolate(), G4DNACPA100ElasticModel::LinLogInterpolate(), G4DNAChampionElasticModel::LinLogInterpolate(), G4DNAELSEPAElasticModel::LinLogInterpolate(), G4DNAPTBElasticModel::LinLogInterpolate(), G4DNAPTBIonisationModel::LogLogInterpolate(), G4UImanager::LoopS(), G4Trap::MakePlane(), MCGIDI_sampling_sampleX_from_pdfOfX(), ptwX_sort_ascending(), ptwXY_mergeCompareFunction(), pytbdy(), G4AnalyticalPolSolver::QuadRoots(), G4QuasiElRatios::RelDecayIn2(), G4VisCommandViewerColourByDensity::SetNewValue(), Acts::AtlasStepper< bfield_t >::State::State(), Acts::AtlasStepper< ConstantBField >::step(), Acts::Frustum< value_t, DIM, SIDES >::svg(), CLHEP::RandLandau::transform(), Acts::AtlasStepper< ConstantBField >::update(), and G4NucleiModel::zoneIntegralWoodsSaxon().
Definition at line 80 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 80 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), and G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy().
|
static |
Definition at line 103 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub 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.
View newest version in sPHENIX GitHub at line 93 of file G4ElectroNuclearCrossSection.cc
Referenced by G4MPIscorerMerger::CalculatePackSize(), G4tgbGeometryDumper::DumpElement(), EICG4dRICHGas::EICG4dRICHGas(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4MPIscorerMerger::Pack(), and pyG4Element::Print().
Definition at line 94 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 94 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 95 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 95 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 75 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 75 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2(), and G4ElectroNuclearCrossSection::SolveTheEquation().
Definition at line 76 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 76 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 74 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 74 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection().
|
static |
Definition at line 99 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 99 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::SolveTheEquation().
Definition at line 85 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 85 of file G4ElectroNuclearCrossSection.cc
Referenced by HelixKalman::addHit(), HelixKalmanFilter::addHit(), CylinderKalman::calculateProjections(), HelixKalmanFilter::calculateProjections(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4ElectroNuclearCrossSection::HighEnergyJ3(), luboei(), ludecy(), luprep(), pybesq(), pydecy(), pydisg(), pyhiresd(), pyprep(), pyremn(), pyresd(), HelixKalman::subtractProjections(), CylinderKalman::subtractProjections(), and HelixKalmanFilter::subtractProjections().
Definition at line 86 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 86 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
|
static |
Definition at line 98 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 98 of file G4ElectroNuclearCrossSection.cc
Referenced by G4NistMaterialBuilder::AddElementByWeightFraction(), atrobo(), attrad(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4FermiBreakUpVI::BreakFragment(), G4GoudsmitSaundersonTable::ComputeScatteringPowerCorrection(), CLHEP::correctPsiPhi(), G4NistMaterialBuilder::DumpMix(), PHCASeeding::FollowBiLinks(), hirobo(), G4ParticleHPFFFissionFS::Init(), luclus(), luedit(), lulist(), lurobo(), G4MuPairProductionModel::MakeSamplingTables(), MCGIDI_misc_binarySearch(), G4NistElementBuilder::PrintElement(), PHG4ConsistencyCheck::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), pyclus(), pycomp(), pyedit(), pyhimaxi(), pyhiovly(), pyhiresd(), pyldcm(), pylist(), pymaxi(), pymirm(), pyovly(), pypile(), pyptis(), pyresd(), pyrobo(), pyscat(), pysgqc(), and G4ElectroNuclearCrossSection::SolveTheEquation().
|
static |
Definition at line 101 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 101 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::ThresholdEnergy().
Definition at line 82 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 82 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ2().
Definition at line 83 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 83 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ3().
Definition at line 78 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 78 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), G4ElectroNuclearCrossSection::HighEnergyJ1(), and G4ElectroNuclearCrossSection::SolveTheEquation().
Definition at line 79 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 79 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::HighEnergyJ1().
Definition at line 77 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 77 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), and G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy().
Definition at line 113 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 113 of file G4ElectroNuclearCrossSection.cc
Referenced by G4Generator2BN::Calculatedsdkdt(), G4PDGCodeChecker::CheckForNuclei(), G4eeToHadronsModel::ComputeCMCrossSectionPerElectron(), G4IonTable::Contains(), G4ParticleHPThermalScattering::find_LH(), G4IonTable::FindIon(), G4IonTable::FindIonInMaster(), G4eeToHadronsModel::GenerateCMPhoton(), EICPIDParticlev1::get_SumLogLikelyhood(), G4ElectroNuclearCrossSection::GetFunctions(), G4IonTable::GetIon(), G4IonTable::GetIonName(), G4IonTable::GetNucleusByEncoding(), EICPIDParticlev1::identify(), G4IonTable::Insert(), G4IonTable::InsertWorker(), G4LevelReader::NormalizedICCProbability(), G4IonTable::Remove(), and PHNodeIOManager::setFile().
Definition at line 70 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 70 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::DFun(), G4ElectroNuclearCrossSection::GetElementCrossSection(), G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy(), and G4ElectroNuclearCrossSection::SolveTheEquation().
|
static |
Definition at line 68 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 68 of file G4ElectroNuclearCrossSection.cc
Definition at line 69 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 69 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetEquivalentPhotonQ2().
Definition at line 73 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub 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.
View newest version in sPHENIX GitHub at line 72 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetElementCrossSection(), G4ElectroNuclearCrossSection::GetEquivalentPhotonEnergy(), G4ElectroNuclearCrossSection::GetFunctions(), and GIDI_settings_flux_order::print().
|
static |
Definition at line 111 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 111 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetFunctions().
Definition at line 2175 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 2175 of file G4ElectroNuclearCrossSection.cc
Referenced by TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4ElectroNuclearCrossSection::GetFunctions(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4INCL::NKbToNKbChannel::KaonMomentum(), G4INCL::NKbToLpiChannel::KaonMomentum(), G4INCL::NKbElasticChannel::KaonMomentum(), G4INCL::NpiToLKChannel::KaonMomentum(), and G4INCL::NpiToSKChannel::KaonMomentum().
Definition at line 117 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 117 of file G4ElectroNuclearCrossSection.cc
Definition at line 264 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 264 of file G4ElectroNuclearCrossSection.cc
Definition at line 1587 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1587 of file G4ElectroNuclearCrossSection.cc
Definition at line 1734 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1734 of file G4ElectroNuclearCrossSection.cc
Definition at line 1881 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1881 of file G4ElectroNuclearCrossSection.cc
Definition at line 2028 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 2028 of file G4ElectroNuclearCrossSection.cc
Definition at line 411 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 411 of file G4ElectroNuclearCrossSection.cc
Definition at line 558 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 558 of file G4ElectroNuclearCrossSection.cc
Definition at line 705 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 705 of file G4ElectroNuclearCrossSection.cc
Definition at line 852 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 852 of file G4ElectroNuclearCrossSection.cc
Definition at line 999 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 999 of file G4ElectroNuclearCrossSection.cc
Definition at line 1146 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1146 of file G4ElectroNuclearCrossSection.cc
Definition at line 1293 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1293 of file G4ElectroNuclearCrossSection.cc
Definition at line 1440 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1440 of file G4ElectroNuclearCrossSection.cc
Definition at line 2176 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 2176 of file G4ElectroNuclearCrossSection.cc
Referenced by G4PreCompoundModel::DeExcite(), G4StatMFChannel::FragmentsMomenta(), G4PartonPair::G4PartonPair(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfProjectile(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfTarget(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4ElectroNuclearCrossSection::GetFunctions(), G4Bessel::I0(), G4Bessel::I1(), G4Bessel::K0(), G4Bessel::K1(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4INCL::NKbToNKbChannel::KaonMomentum(), G4INCL::NpiToLKChannel::KaonMomentum(), G4INCL::NKbElasticChannel::KaonMomentum(), G4INCL::NKbToLpiChannel::KaonMomentum(), G4INCL::NpiToSKChannel::KaonMomentum(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 166 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 166 of file G4ElectroNuclearCrossSection.cc
Referenced by PHG4Reco::DefineMaterials(), G4RKFieldIntegrator::Erf(), G4INCL::NKbElasticChannel::KaonMomentum(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 313 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 313 of file G4ElectroNuclearCrossSection.cc
Referenced by G4RKFieldIntegrator::Erf(), and G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 1636 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1636 of file G4ElectroNuclearCrossSection.cc
Definition at line 1783 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1783 of file G4ElectroNuclearCrossSection.cc
Definition at line 1930 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1930 of file G4ElectroNuclearCrossSection.cc
Definition at line 2077 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 2077 of file G4ElectroNuclearCrossSection.cc
Definition at line 460 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 460 of file G4ElectroNuclearCrossSection.cc
Definition at line 607 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 607 of file G4ElectroNuclearCrossSection.cc
Definition at line 754 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 754 of file G4ElectroNuclearCrossSection.cc
Definition at line 901 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 901 of file G4ElectroNuclearCrossSection.cc
Definition at line 1048 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1048 of file G4ElectroNuclearCrossSection.cc
Definition at line 1195 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1195 of file G4ElectroNuclearCrossSection.cc
Definition at line 1342 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1342 of file G4ElectroNuclearCrossSection.cc
Definition at line 1489 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1489 of file G4ElectroNuclearCrossSection.cc
Definition at line 2177 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 2177 of file G4ElectroNuclearCrossSection.cc
Referenced by G4PreCompoundModel::DeExcite(), G4RKFieldIntegrator::Erf(), G4StatMFChannel::FragmentsMomenta(), G4PartonPair::G4PartonPair(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4ElectroNuclearCrossSection::GetFunctions(), G4Bessel::I0(), G4Bessel::I1(), G4Bessel::K0(), G4Bessel::K1(), G4INCL::NpiToLKChannel::KaonMomentum(), G4INCL::NpiToSKChannel::KaonMomentum(), G4INCL::NKbToNKbChannel::KaonMomentum(), G4INCL::NKbElasticChannel::KaonMomentum(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4INCL::NKbToLpiChannel::KaonMomentum(), G4FermiPhaseSpaceDecay::PtwoBody(), G4PenelopeBremsstrahlungAngular::SampleDirection(), and G4BoldyshevTripletModel::SampleSecondaries().
Definition at line 215 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 215 of file G4ElectroNuclearCrossSection.cc
Referenced by G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 362 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 362 of file G4ElectroNuclearCrossSection.cc
Referenced by G4PenelopeBremsstrahlungAngular::SampleDirection().
Definition at line 1685 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1685 of file G4ElectroNuclearCrossSection.cc
Definition at line 1832 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1832 of file G4ElectroNuclearCrossSection.cc
Definition at line 1979 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1979 of file G4ElectroNuclearCrossSection.cc
Definition at line 2126 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 2126 of file G4ElectroNuclearCrossSection.cc
Definition at line 509 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 509 of file G4ElectroNuclearCrossSection.cc
Definition at line 656 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 656 of file G4ElectroNuclearCrossSection.cc
Definition at line 803 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 803 of file G4ElectroNuclearCrossSection.cc
Definition at line 950 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 950 of file G4ElectroNuclearCrossSection.cc
Definition at line 1097 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1097 of file G4ElectroNuclearCrossSection.cc
Definition at line 1244 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1244 of file G4ElectroNuclearCrossSection.cc
Definition at line 1391 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1391 of file G4ElectroNuclearCrossSection.cc
Definition at line 1538 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 1538 of file G4ElectroNuclearCrossSection.cc
Definition at line 97 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 97 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::SolveTheEquation().
|
static |
Definition at line 65 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 65 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::DFun(), and G4ElectroNuclearCrossSection::HighEnergyJ2().
|
static |
Definition at line 66 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 66 of file G4ElectroNuclearCrossSection.cc
|
static |
Definition at line 104 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 104 of file G4ElectroNuclearCrossSection.cc
Definition at line 105 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 105 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::GetVirtualFactor().
|
static |
Definition at line 67 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 67 of file G4ElectroNuclearCrossSection.cc
Referenced by G4EmModelActivator::ActivateEmOptions(), G4EmBiasingManager::ActivateForcedInteraction(), G4EmModelActivator::ActivateMicroElec(), G4EmBiasingManager::ActivateSecondaryBiasing(), G4VEnergyLossProcess::ActivateSubCutoff(), G4EmConfigurator::AddModels(), ExTGRCRegionCutsMgr::BuildProductionCuts(), ExTGRCRegionCutsMgr::BuildRegions(), G4EmLowEParameters::CheckRegion(), G4EmExtraParameters::CheckRegion(), G4EmDNAPhysicsActivator::ConstructProcess(), G4EmExtraParameters::DefineRegParamForLoss(), G4ElectroNuclearCrossSection::DFun(), G4EmModelManager::DumpModelList(), G4EmModelManager::FillDEDXVector(), G4EmModelManager::FillLambdaVector(), G4EmConfigurator::FindRegion(), G4AntiNuclElastic::G4AntiNuclElastic(), G4RegionModels::G4RegionModels(), G4ElectroNuclearCrossSection::HighEnergyJ1(), G4PAIPhotModel::Initialise(), G4PAIModel::Initialise(), G4EmModelManager::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4MSSteppingAction::Initialize(), RE06SteppingVerbose::NewStep(), G4EmConfigurator::PrepareModels(), G4VEnergyLossProcess::PreparePhysicsTable(), G4VTransitionRadiation::SetRegion(), and G4WorkerThread::UpdateGeometryAndPhysicsVectorFromMaster().
|
static |
Definition at line 64 of file G4ElectroNuclearCrossSection.cc.
View newest version in sPHENIX GitHub at line 64 of file G4ElectroNuclearCrossSection.cc
Referenced by G4ElectroNuclearCrossSection::DFun().