Geant4 11.1.1
Toolkit for the simulation of the passage of particles through matter
Loading...
Searching...
No Matches
G4DNAElectronHoleRecombination.cc File Reference

Go to the source code of this file.

Functions

G4double Y (G4double density)
 
G4double A (G4double temperature)
 
G4double B (G4double temperature)
 
G4double S (G4double temp)
 
G4double C (G4double temp)
 
G4double D (G4double temp)
 
G4double epsilon (G4double density, G4double temperature)
 

Function Documentation

◆ A()

G4double A ( G4double  temperature)

Definition at line 59 of file G4DNAElectronHoleRecombination.cc.

60{
61 G4double temp_inverse = 1 / temperature;
62 return 0.7017
63 + 642.0 * temp_inverse
64 - 1.167e5 * temp_inverse * temp_inverse
65 + 9.190e6 * temp_inverse * temp_inverse * temp_inverse;
66}
double G4double
Definition: G4Types.hh:83

◆ B()

G4double B ( G4double  temperature)

Definition at line 68 of file G4DNAElectronHoleRecombination.cc.

69{
70 G4double temp_inverse = 1 / temperature;
71 return -2.71
72 + 275.4 * temp_inverse
73 + 0.3245e5 * temp_inverse * temp_inverse;
74}

Referenced by G4LMsdGenerator::ApplyYourself(), G4DecayWithSpin::AtRestDoIt(), B(), C(), G4hhElastic::CalculateBQ(), G4hhElastic::CalculateBqQ123(), G4Reggeons::CalculateXs(), G4Reggeons::Chi_pomeron(), G4Reggeons::Chi_reggeon(), G4GeomTools::ClosestPointOnSegment(), G4GeomTools::ClosestPointOnTriangle(), G4NeutrinoNucleusModel::CoherentPion(), G4GammaConversionToMuons::ComputeCrossSectionPerAtom(), G4DNABornIonisationModel1::CrossSectionPerVolume(), G4DNABornIonisationModel2::CrossSectionPerVolume(), D(), G4VTwistSurface::DebugPrint(), CLHEP::HepLorentzRotation::decompose(), G4NonEquilibriumEvaporator::deExcite(), G4GeomTools::DistancePointSegment(), G4Ellipsoid::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4Paraboloid::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), G4ErrorMag_UsualEqRhs::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), G4Mag_UsualEqRhs::EvaluateRhsGivenB(), G4AdjointInterpolator::ExponentialInterpolation(), G4NeutrinoNucleusModel::FinalBarion(), G4NeutrinoNucleusModel::FinalMomentum(), G4IntersectingCone::G4IntersectingCone(), G4RandomPointOnEllipse(), G4RandomPointOnEllipsoid(), G4ComponentAntiNuclNuclearXS::GetAntiHadronNucleonTotCrSc(), G4TUniformMagneticField::GetConstantFieldValue(), G4UniformMagField::GetConstantFieldValue(), G4ConstRK4::GetConstField(), G4GenericTrap::GetCubicVolume(), G4TQuadrupoleMagField::GetFieldValue(), G4TUniformMagneticField::GetFieldValue(), G4UniformMagField::GetFieldValue(), G4DELPHIMagField::GetFieldValue(), G4HarmonicPolMagField::GetFieldValue(), G4LineCurrentMagField::GetFieldValue(), G4QuadrupoleMagField::GetFieldValue(), G4SextupoleMagField::GetFieldValue(), G4IonsShenCrossSection::GetIsoCrossSection(), G4FTFParticipants::GetList(), G4PhononScattering::GetMeanFreePath(), G4Ellipsoid::GetPointOnSurface(), G4GenericTrap::GetPointOnSurface(), G4Reggeons::GetProbabilities(), G4GenericTrap::GetSurfaceArea(), HepPolyhedronHyperbolicMirror::HepPolyhedronHyperbolicMirror(), G4AdjointInterpolator::LogarithmicInterpolation(), G4GeomTools::PointInTriangle(), G4GammaConversionToMuons::PostStepDoIt(), G4GeomTools::QuadArea(), G4GeomTools::QuadAreaNormal(), G4NeutrinoElectronCcModel::SampleCosCMS(), G4NeutrinoElectronNcModel::SampleElectronTkin(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4MicroElecLOPhononModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), CLHEP::HepLorentzRotation::set(), G4RKG3_Stepper::StepNoErr(), G4RKG3_Stepper::Stepper(), G4TMagFieldEquation< T_Field >::TEvaluateRhsGivenB(), G4GeomTools::TriangleArea(), G4GeomTools::TriangleAreaNormal(), G4MuonToMuonPairProductionModel::U_func(), G4BorisScheme::UpdateVelocity(), and G4Abla::width().

◆ C()

G4double C ( G4double  temp)

Definition at line 85 of file G4DNAElectronHoleRecombination.cc.

86{
87 return A(temp) - B(temp) - 3;
88}
G4double B(G4double temperature)
const G4double A[17]

◆ D()

G4double D ( G4double  temp)

Definition at line 90 of file G4DNAElectronHoleRecombination.cc.

91{
92 return B(temp) + 3;
93}

Referenced by G4MicroElecElasticModel_new::AcousticCrossSectionPerVolume(), G4hhElastic::CalculateBQ(), G4DNASmoluchowskiDiffusion::ComputeDistance(), G4DNASmoluchowskiDiffusion::ComputeS(), G4DNASmoluchowskiDiffusion::ComputeTime(), G4VTwistSurface::DebugPrint(), G4NonEquilibriumEvaporator::deExcite(), G4TriangularFacet::Distance(), G4Orb::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4Orb::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4TwistTubsHypeSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), epsilon(), G4DNASmoluchowskiDiffusion::EstimateCrossingTime(), G4DNASmoluchowskiReactionModel::FindReaction(), G3DetTableEntry::G3DetTableEntry(), G4GenericTrap::GetCubicVolume(), G4DNASmoluchowskiDiffusion::GetDensityProbability(), G4Abla::gethyperbinding(), G4DNAIRT::GetIndependentReactionTime(), G4GenericTrap::GetPointOnSurface(), G4DNASmoluchowskiDiffusion::GetRandomDistance(), G4DNASmoluchowskiDiffusion::GetRandomTime(), G4TransparentRegXTRadiator::GetStackFactor(), G4XTRTransparentRegRadModel::GetStackFactor(), G4GenericTrap::GetSurfaceArea(), G4DiffusionControlledReactionModel::GetTimeToEncounter(), G4TriangularFacet::Intersect(), G4GDMLReadMaterials::MaterialRead(), G3DetTable::Put(), G4GeomTools::QuadArea(), G4GeomTools::QuadAreaNormal(), G4AnalyticalPolSolver::QuarticRoots(), G4NeutrinoElectronCcModel::SampleCosCMS(), G4NeutrinoElectronNcModel::SampleElectronTkin(), and G4LivermorePolarizedComptonModel::SampleSecondaries().

◆ epsilon()

G4double epsilon ( G4double  density,
G4double  temperature 
)

Definition at line 95 of file G4DNAElectronHoleRecombination.cc.

96{
97 return 1 + G4Exp(std::log(10.) *
98 (Y(density) *
99 (C(temperature) + (S(temperature) - 1) * std::log(density) / std::log(10.))
100 + D(temperature) + std::log(density) / std::log(10.)));
101}
G4double S(G4double temp)
G4double D(G4double temp)
G4double Y(G4double density)
G4double G4Exp(G4double initial_x)
Exponential Function double precision.
Definition: G4Exp.hh:180

Referenced by G4BorisDriver::AccurateAdvance(), G4Generator2BN::Calculatedsdkdt(), G4KokoulinMuonNuclearXS::ComputeDDMicroscopicCrossSection(), G4eBremsstrahlungRelModel::ComputeDXSectionPerAtom(), G4PropagatorInField::ComputeStep(), G4XPDGTotal::CrossSection(), G4AdjointComptonModel::DiffCrossSectionPerAtomPrimToScatPrim(), G4VSolid::EstimateCubicVolume(), G4QuadrangularFacet::G4QuadrangularFacet(), G4NuclNuclDiffuseElastic::GetLegendrePol(), G4hhElastic::GetTransfer(), G4NeutronElectronElModel::GetTransfer(), G4ParticleHPDeExGammas::Init(), G4ErrorSymMatrix::invertBunchKaufman(), CLHEP::HepAxisAngle::isNear(), CLHEP::HepEulerAngles::isNear(), CLHEP::Hep2Vector::isNear(), CLHEP::Hep3Vector::isNear(), CLHEP::HepLorentzRotation::isNear(), CLHEP::HepRotation::isNear(), CLHEP::HepLorentzVector::isNear(), CLHEP::HepBoost::isNear(), CLHEP::HepBoostX::isNear(), CLHEP::HepBoostY::isNear(), CLHEP::HepBoostZ::isNear(), CLHEP::HepRotationX::isNear(), CLHEP::HepRotationY::isNear(), CLHEP::HepRotationZ::isNear(), CLHEP::HepLorentzVector::isNearCM(), CLHEP::Hep2Vector::isOrthogonal(), CLHEP::Hep3Vector::isOrthogonal(), CLHEP::Hep2Vector::isParallel(), CLHEP::Hep3Vector::isParallel(), CLHEP::HepLorentzVector::isParallel(), ptwX_close(), ptwXY_mergeClosePoints(), ptwXY_tweakDomainsToMutualify(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PolarizedComptonModel::SampleSecondaries(), G4KleinNishinaCompton::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4Solver< Function >::SetTolerance(), G4DiffuseElastic::TestAngleTable(), G4NuclNuclDiffuseElastic::TestAngleTable(), G4NucleiModel::zoneIntegralGaussian(), and G4NucleiModel::zoneIntegralWoodsSaxon().

◆ S()

G4double S ( G4double  temp)

Definition at line 76 of file G4DNAElectronHoleRecombination.cc.

77{
78 G4double temp_inverse = 1 / temp;
79
80 return 1.667
81 - 11.41 * temp_inverse
82 - 35260.0 * temp_inverse * temp_inverse;
83}

Referenced by G4INCLXXInterface::ApplyYourself(), G4INCL::Cluster::Cluster(), G4INCL::Nucleus::computeSeparationEnergyBalance(), G4AngularDistribution::CosTheta(), G4AngularDistributionNP::CosTheta(), G4AngularDistributionPP::CosTheta(), G4INCL::NuclearDensityFactory::createDensity(), G4XAnnihilationChannel::CrossSection(), G4XPDGTotal::CrossSection(), G4EquilibriumEvaporator::deExcite(), G4VXResonance::DetailedBalance(), G4QGSParticipants::DeterminePartonMomenta(), G4AngularDistribution::DifferentialCrossSection(), G4ElasticHNScattering::ElasticScattering(), epsilon(), G4QuarkExchange::ExciteParticipants(), G4SingleDiffractiveExcitation::ExciteParticipants(), G4QGSDiffractiveExcitation::ExciteParticipants(), G4VElasticCollision::FinalState(), G4VScatteringCollision::FinalState(), G4GIDI_Misc_Z_A_m_ToName(), G4ComponentAntiNuclNuclearXS::GetAntiHadronNucleonElCrSc(), G4INCL::ParticleTable::getINCLMass(), G4INCL::ParticleTable::getName(), G4INCL::ParticleTable::getRealMass(), G4FTFParameters::InitForInteraction(), G4INCL::INCL::initializeTarget(), G4INCL::CDPP::isBlocked(), MCGIDI_reaction_getENDL_CSNumbers(), G4INCL::INCL::prepareReaction(), G4CrossSectionBuffer::push_back(), G4InuclSpecialFunctions::randomInuclPowers(), G4AntiNuclElastic::SampleInvariantT(), G4BoldyshevTripletModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4QGSParticipants::SelectInteractions(), G4FTFParameters::SethNcmsEnergy(), G4INCL::Cluster::setS(), G4Reggeons::SetS(), HepTool::Evaluator::setSystemOfUnits(), and G4INCL::Config::setTargetS().

◆ Y()