Geant4-11
Namespaces | Functions | Variables
G4INCL::Math Namespace Reference

Namespaces

namespace  anonymous_namespace{G4INCLGlobals.cc}
 

Functions

G4double arcCos (const G4double x)
 Calculates arccos with some tolerance on illegal arguments. More...
 
G4double arcSin (const G4double x)
 Calculates arcsin with some tolerance on illegal arguments. More...
 
G4double aSinH (G4double x)
 
G4double gaussianCDF (const G4double x)
 Cumulative distribution function for Gaussian. More...
 
G4double gaussianCDF (const G4double x, const G4double x0, const G4double sigma)
 Generic cumulative distribution function for Gaussian. More...
 
G4int heaviside (G4int n)
 
G4double inverseGaussianCDF (const G4double x)
 Inverse cumulative distribution function for Gaussian. More...
 
template<typename T >
max (const T t1, const T t2)
 brief Return the largest of the two arguments More...
 
template<typename T >
min (const T t1, const T t2)
 brief Return the smallest of the two arguments More...
 
G4double pow13 (G4double x)
 
G4double pow23 (G4double x)
 
G4double powMinus13 (G4double x)
 
template<typename T >
G4int sign (const T t)
 
G4double toDegrees (G4double radians)
 

Variables

const G4double oneOverSqrtThree = 1./std::sqrt((G4double)3.)
 
const G4double oneOverSqrtTwo = 1./std::sqrt((G4double)2.)
 
const G4double oneThird = 1./3.
 
const G4double pi = 3.14159265358979323846264338328
 
const G4double piOverTwo = 0.5 * pi
 
const G4double sqrtFiveThirds = std::sqrt(5./3.)
 
const G4double sqrtThreeFifths = std::sqrt(3./5.)
 
const G4double tenPi = 10.0 * pi
 
const G4double twoPi = 2.0 * pi
 
const G4double twoThirds = 2./3.
 

Function Documentation

◆ arcCos()

G4double G4INCL::Math::arcCos ( const G4double  x)

Calculates arccos with some tolerance on illegal arguments.

Definition at line 103 of file G4INCLGlobals.cc.

103 {
104// assert(x>-1.000001 && x<1.000001);
105 return ((x > 1.) ? 0. : ((x<-1.) ? pi : std::acos(x)));
106 }
static constexpr double pi
Definition: G4SIunits.hh:55

References pi.

Referenced by G4INCL::anonymous_namespace{G4INCLPhaseSpaceGenerator.cc}::bias(), G4INCL::CoulombNonRelativistic::coulombDeviation(), G4INCL::CoulombNonRelativistic::distortOut(), G4INCL::EventInfo::fillInverseKinematics(), G4INCL::SurfaceAvatar::getTransmissionProbability(), and G4INCL::EventInfo::remnantToParticle().

◆ arcSin()

G4double G4INCL::Math::arcSin ( const G4double  x)

Calculates arcsin with some tolerance on illegal arguments.

Definition at line 98 of file G4INCLGlobals.cc.

98 {
99// assert(x>-1.000001 && x<1.000001);
100 return ((x > 1.) ? 0. : ((x<-1.) ? pi : std::asin(x)));
101 }

References pi.

◆ aSinH()

G4double G4INCL::Math::aSinH ( G4double  x)
inline

Definition at line 100 of file G4INCLGlobals.hh.

100 {
101 return std::log(x + std::sqrt(x*x+1.));
102 }

◆ gaussianCDF() [1/2]

G4double G4INCL::Math::gaussianCDF ( const G4double  x)

Cumulative distribution function for Gaussian.

A public-domain approximation taken from Abramowitz and Stegun. Applies to a Gaussian with mean=0 and sigma=1.

Parameters
xa Gaussian variable

Definition at line 74 of file G4INCLGlobals.cc.

75 {
76 // Save the sign of x
77 const G4double sgn = sign(x);
78 const G4double z = std::fabs(x) * oneOverSqrtTwo;
79
80 // A&S formula 7.1.26
81 G4double t = 1.0/(1.0 + gcdfp*z);
82 G4double y = 1.0 - (((((gcdfa5*t + gcdfa4)*t) + gcdfa3)*t + gcdfa2)*t + gcdfa1)*t*std::exp(-z*z);
83
84 return 0.5*(1.0 + sgn*y);
85 }
double G4double
Definition: G4Types.hh:83
const G4double oneOverSqrtTwo
G4int sign(const T t)

References G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::gcdfa1, G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::gcdfa2, G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::gcdfa3, G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::gcdfa4, G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::gcdfa5, G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::gcdfp, oneOverSqrtTwo, and sign().

Referenced by G4INCL::Random::correlatedUniform(), and gaussianCDF().

◆ gaussianCDF() [2/2]

G4double G4INCL::Math::gaussianCDF ( const G4double  x,
const G4double  x0,
const G4double  sigma 
)

Generic cumulative distribution function for Gaussian.

A public-domain approximation taken from Abramowitz and Stegun. Applies to a generic Gaussian.

Parameters
xa Gaussian variable
x0mean of the Gaussian
sigmastandard deviation of the Gaussian

Definition at line 87 of file G4INCLGlobals.cc.

87 {
88 return gaussianCDF((x-x0)/sigma);
89 }
G4double gaussianCDF(const G4double x)
Cumulative distribution function for Gaussian.

References gaussianCDF().

◆ heaviside()

G4int G4INCL::Math::heaviside ( G4int  n)
inline

Definition at line 83 of file G4INCLGlobals.hh.

83 {
84 if(n < 0) return 0;
85 else return 1;
86 }

References CLHEP::detail::n.

Referenced by G4INCL::Nucleus::insertParticle().

◆ inverseGaussianCDF()

G4double G4INCL::Math::inverseGaussianCDF ( const G4double  x)

Inverse cumulative distribution function for Gaussian.

A public-domain approximation taken from Abramowitz and Stegun. Applies to a Gaussian with mean=0 and sigma=1.

Parameters
xa uniform variate
Returns
a Gaussian variate

Definition at line 91 of file G4INCLGlobals.cc.

91 {
92 if (x < 0.5)
93 return -inverseGaussianCDFRational( std::sqrt(-2.0*std::log(x)) );
94 else
95 return inverseGaussianCDFRational( std::sqrt(-2.0*std::log(1.-x)) );
96 }

References G4INCL::Math::anonymous_namespace{G4INCLGlobals.cc}::inverseGaussianCDFRational().

◆ max()

template<typename T >
T G4INCL::Math::max ( const T  t1,
const T  t2 
)
inline

brief Return the largest of the two arguments

Definition at line 112 of file G4INCLGlobals.hh.

112 {
113 return t1 > t2 ? t1 : t2;
114 }

Referenced by field_utils::absoluteError(), G4PenelopeCrossSection::AddCrossSectionPoint(), G4UPiNuclearCrossSection::AddDataSet(), G4INCL::ProjectileRemnant::addMostDynamicalSpectators(), G4PenelopeCrossSection::AddShellCrossSectionPoint(), G4SolidExtentList::AddSurface(), G4ParticleHPFinalState::adjust_final_state(), G4NavigationLogger::AlongComputeStepLog(), G4VEnergyLossProcess::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4Transportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4PreCompoundEmission::AngularDistribution(), G4Nucleus::AnnihilationEvaporationEffects(), G4ParticleHPCapture::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4PreCompoundModel::ApplyYourself(), G4TheoFSGenerator::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4ExtrudedSolid::ApproxSurfaceNormal(), G4eIonisationSpectrum::AverageEnergy(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), G4eIonisationSpectrum::AverageValue(), G4HadronBuilder::Barion(), G4ClippablePolygon::BehindOf(), G4AtimaEnergyLossModel::Bethek_dedx_e(), G4NucleiModel::boundaryTransition(), G4IntersectionSolid::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4Cons::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Para::BoundingLimits(), G4Sphere::BoundingLimits(), G4Trd::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4TwistedTubs::BoundingLimits(), G4WilsonAblationModel::BreakItUp(), G4UnstableFragmentBreakUp::BreakUpChain(), G4Voxelizer::BuildBitmasks(), G4Voxelizer::BuildBoundaries(), G4Voxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsModelAndElement(), G4AdjointCSManager::BuildCrossSectionsModelAndMaterial(), G4PenelopeIonisationXSHandler::BuildDeltaTable(), G4Voxelizer::BuildEmpty(), G4VEmProcess::BuildLambdaTable(), G4VEnergyLossProcess::BuildLambdaTable(), G4GammaNuclearXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4hImpactIonisation::BuildPhysicsTable(), G4Voxelizer::BuildReduceVoxels(), G4Voxelizer::BuildReduceVoxels2(), G4SBBremTable::BuildSamplingTables(), G4LossTableBuilder::BuildTableForModel(), G4Voxelizer::BuildVoxelLimits(), G4BulirschStoer::calc_h_opt(), G4ConvergenceTester::calc_slope_fit(), G4StatMFMicroCanonical::CalcEntropyOfCompoundNucleus(), G4StatMFMacroMultiNucleon::CalcMeanMultiplicity(), G4StatMFMicroPartition::CalcPartitionProbability(), G4StatMFMicroPartition::CalcPartitionTemperature(), G4StatMFMacroTemperature::CalcTemperature(), G4WeightWindowAlgorithm::Calculate(), G4IntersectionSolid::CalculateExtent(), G4UnionSolid::CalculateExtent(), G4VCSGfaceted::CalculateExtent(), G4PreCompoundTransitions::CalculateProbability(), G4ITStepProcessor::CalculateSafety(), G4SteppingManager::CalculateSafety(), G4StatMFMacroCanonical::CalculateTemperature(), G4BoundingEnvelope::CheckBoundingPolygons(), G4MolecularDissociationTable::CheckDataConsistency(), G4PVPlacement::CheckOverlaps(), G4Ellipsoid::CheckParameters(), G4GeomTools::CheckSnip(), HepPolyhedron::CheckSnip(), G4DiffractiveSplitableHadron::ChooseStringEnds(), G4Nucleus::Cinema(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), G4ParticleHPInelasticCompFS::CompositeApply(), compress2(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), G4eBremsstrahlungRelModel::ComputeBremLoss(), G4KalbachCrossSection::ComputeCrossSection(), G4ChatterjeeCrossSection::ComputeCrossSection(), G4eDPWACoulombScatteringModel::ComputeCrossSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4LivermorePhotoElectricModel::ComputeCrossSectionPerAtom(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4BoldyshevTripletModel::ComputeCrossSectionPerAtom(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4PairProductionRelModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversion5DModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversionModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4EmCalculator::ComputeCrossSectionPerAtom(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4BraggIonModel::ComputeCrossSectionPerElectron(), G4BraggModel::ComputeCrossSectionPerElectron(), G4ICRU73QOModel::ComputeCrossSectionPerElectron(), G4PenelopeAnnihilationModel::ComputeCrossSectionPerElectron(), G4eeToTwoGammaModel::ComputeCrossSectionPerElectron(), G4eplusTo2GammaOKVIModel::ComputeCrossSectionPerElectron(), G4eplusTo3GammaOKVIModel::ComputeCrossSectionPerElectron(), G4EmCalculator::ComputeCrossSectionPerShell(), G4EmCalculator::ComputeCrossSectionPerVolume(), G4ComponentBarNucleonNucleusXsc::ComputeCrossSections(), G4ComponentGGHadronNucleusXsc::ComputeCrossSections(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4eDPWAElasticDCS::ComputeCSPerAtom(), G4mplIonisationWithDeltaModel::ComputeDEDXAhlen(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4MuBetheBlochModel::ComputeDEDXPerVolume(), G4MuPairProductionModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4BraggIonModel::ComputeDEDXPerVolume(), G4BraggModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4AtimaEnergyLossModel::ComputeDEDXPerVolume(), G4ICRU73QOModel::ComputeDEDXPerVolume(), G4hBremsstrahlungModel::ComputeDMicroscopicCrossSection(), G4PairProductionRelModel::ComputeDXSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeDXSectionPerAtom(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4MicroElecInelasticModel_new::ComputeElasticQmax(), G4WentzelOKandVIxSection::ComputeElectronCrossSection(), G4eplusTo3GammaOKVIModel::ComputeF(), G4eplusTo3GammaOKVIModel::ComputeFS(), G4UrbanAdjointMscModel::ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), G4UrbanMscModel::ComputeGeomPathLength(), G4VEmProcess::ComputeIntegralLambda(), G4VEnergyLossProcess::ComputeLambdaForScaledEnergy(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), G4KokoulinMuonNuclearXS::ComputeMicroscopicCrossSection(), G4MuPairProductionModel::ComputeMicroscopicCrossSection(), G4eBremParametrizedModel::ComputeParametrizedDXSectionPerAtom(), G4GEMProbabilityVI::ComputeProbability(), G4ComponentGGHadronNucleusXsc::ComputeQuasiElasticRatio(), G4PairProductionRelModel::ComputeRelDXSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeRelDXSectionPerAtom(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4PathFinder::ComputeStep(), G4PropagatorInField::ComputeStep(), G4UrbanMscModel::ComputeTlimitmin(), G4GEMProbabilityVI::ComputeTotalProbability(), G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4eBremsstrahlungRelModel::ComputeXSectionPerAtom(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), G4EmExtraPhysics::ConstructProcess(), G4HadronDElasticPhysics::ConstructProcess(), G4HadronElasticPhysics::ConstructProcess(), G4HadronHElasticPhysics::ConstructProcess(), G4VRangeToEnergyConverter::Convert(), G4ConversionUtils::Convert(), G4BinaryCascade::CorrectFinalPandE(), G4BraggIonModel::CorrectionsAlongStep(), G4BetheBlochModel::CorrectionsAlongStep(), G4LindhardSorensenIonModel::CorrectionsAlongStep(), G4VLongitudinalStringDecay::CreatePartonPair(), G4TwistedTubs::CreatePolyhedron(), G4TessellatedSolid::CreateVertexList(), G4XPDGElastic::CrossSection(), G4PEEffectFluoModel::CrossSectionPerVolume(), G4GoudsmitSaundersonMscModel::CrossSectionPerVolume(), G4VEmProcess::CrossSectionPerVolume(), G4VEnergyLossProcess::CrossSectionPerVolume(), G4PAIModelData::CrossSectionPerVolume(), G4FermiPhaseSpaceDecay::Decay(), G4ICRU73QOModel::DEDXPerElement(), G4PAIModelData::DEDXPerVolume(), G4BinaryLightIonReaction::DeExciteSpectatorNucleus(), G4FissionParameters::DefineParameters(), G4hImpactIonisation::DeltaRaysEnergy(), G4INCL::DeuteronDensity::derivWavefunctionR(), G4VFieldModel::DescribeYourselfTo(), G4PenelopeComptonModel::DifferentialCrossSection(), G4ScreeningMottCrossSection::DifferentialXSection(), G4QGSMSplitableHadron::DiffractiveSplitUp(), G4PAIySection::DifPAIySection(), G4DiffractiveSplitableHadron::Diquark(), G4LundStringFragmentation::DiQuarkSplitup(), G4QGSMFragmentation::DiQuarkSplitup(), G4GeomTools::DiskExtent(), G4AtimaFluctuations::Dispersion(), G4PolyconeSide::DistanceAway(), G4CutTubs::DistanceToIn(), G4Para::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Box::DistanceToIn(), G4Torus::DistanceToIn(), G4Trap::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4Tet::DistanceToIn(), G4UnionSolid::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), G4Trd::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ITStepProcessor::DoStepping(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), G4FermiFragmentsPoolVI::Dump(), G4HadronicProcessStore::Dump(), G4EmModelManager::DumpModelList(), G4ionEffectiveCharge::EffectiveCharge(), G4PiData::ElasticXSection(), GFlashShowerModel::ElectronDoIt(), G4hImpactIonisation::ElectronicLossFluctuation(), G4BraggIonModel::ElectronicStoppingPower(), G4BraggModel::ElectronicStoppingPower(), G4GeomTools::EllipsePerimeter(), G4GeomTools::EllipticConeLateralArea(), G4GEMChannelVI::EmittedFragment(), G4EvaporationChannel::EmittedFragment(), G4BinaryLightIonReaction::EnergyAndMomentumCorrector(), G4AtimaFluctuations::EnergyTable_interpolate(), G4AtimaEnergyLossModel::EnergyTable_interpolate(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), G4PolyPhiFace::Extent(), G4MultiUnion::Extent(), G4VCrossSectionSource::FcrossX(), G4EmModelManager::FillDEDXVector(), G4INCL::ElasticChannel::fillFinalState(), G4INCL::NNToMissingStrangenessChannel::fillFinalState(), G4INCL::NpiToMissingStrangenessChannel::fillFinalState(), G4INCL::EventInfo::fillInverseKinematics(), G4EmModelManager::FillLambdaVector(), G4HadronicProcess::FillResult(), G4eDPWAElasticDCS::FindCumValue(), G4VEmProcess::FindLambdaMax(), G4NuclearLevelData::FindLevel(), G4Physics2DVector::FindLinearX(), G4VEmissionProbability::FindRecoilExcitation(), G4JTPolynomialSolver::FindRoots(), G4BoundingEnvelope::FindScaleFactor(), G4StatMF::FindTemperatureOfBreakingChannel(), CLHEP::RandBreitWigner::fireM2(), G4CompetitiveFission::FissionAtomicNumber(), G4CompetitiveFission::FissionKineticEnergy(), G4ArrowModel::G4ArrowModel(), G4BogackiShampine45::G4BogackiShampine45(), G4CashKarpRKF45::G4CashKarpRKF45(), G4ClassicalRK4::G4ClassicalRK4(), G4DensityEffectCalculator::G4DensityEffectCalculator(), G4DormandPrinceRK56::G4DormandPrinceRK56(), G4DormandPrinceRK78::G4DormandPrinceRK78(), G4FSALBogackiShampine45::G4FSALBogackiShampine45(), G4GDecay3::G4GDecay3(), G4ImplicitEuler::G4ImplicitEuler(), G4IntersectingCone::G4IntersectingCone(), G4MuPairProductionModel::G4MuPairProductionModel(), G4Nucleus::G4Nucleus(), G4OpenGL2PSAction::G4OpenGL2PSAction(), G4OpenGLXmSliderBar::G4OpenGLXmSliderBar(), G4PAIModelData::G4PAIModelData(), G4PAIPhotData::G4PAIPhotData(), G4Para::G4Para(), G4ParticleHPPartial::G4ParticleHPPartial(), G4ParticleHPVector::G4ParticleHPVector(), G4PropagatorInField::G4PropagatorInField(), G4QuadrangularFacet::G4QuadrangularFacet(), G4RandomPointOnEllipse(), G4RandomPointOnEllipsoid(), G4SimpleRunge::G4SimpleRunge(), G4Sphere::G4Sphere(), G4TriangularFacet::G4TriangularFacet(), G4TsitourasRK45::G4TsitourasRK45(), G4INCL::PhaseSpaceRauboldLynch::generate(), G4eeToHadronsModel::GenerateCMPhoton(), GFlashSamplingShowerParameterisation::GenerateEnergyProfile(), G4Clebsch::GenerateIso3(), GFlashSamplingShowerParameterisation::GenerateNSpotProfile(), G4BCLateParticle::GetCollisions(), G4VXTRenergyLoss::GetComptonPerAtom(), G4ErrorEnergyLoss::GetContinuousStepLimit(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4ParticleHPCaptureData::GetCrossSection(), G4ParticleHPElasticData::GetCrossSection(), G4ParticleHPFissionData::GetCrossSection(), G4ParticleHPInelasticData::GetCrossSection(), G4PhotoNuclearCrossSection::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4HadronicProcess::GetElementCrossSection(), G4EvaporationChannel::GetEmissionProbability(), G4GEMChannelVI::GetEmissionProbability(), G4PhotonEvaporation::GetEmissionProbability(), G4ClippablePolygon::GetExtent(), G4SolidExtentList::GetExtent(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXsc(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXscVU(), G4INCL::ParticleTable::getLargestNuclearRadius(), G4ClippablePolygon::GetMaxPoint(), G4Accumulables::GetMergeFunction(), G4FTFParameters::GetMinMass(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4MuonMinusBoundDecay::GetMuonZeff(), G4PairingCorrection::GetPairingCorrection(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorIn(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorTot(), G4VMscModel::GetParticleChangeForMSC(), G4ClippablePolygon::GetPlanerExtent(), G4Ellipsoid::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4TrajectoryDrawerUtils::GetPointsAndTimes(), G4ITNavigator2::GetRandomInCurrentVolume(), G4ComponentGGHadronNucleusXsc::GetRatioQE(), G4DeexPrecoParameters::GetVerbose(), G4ParticleHPChannelList::GetXsec(), G4ParticleHPFissionBaseFS::GetXsec(), G4ParticleHPInelasticBaseFS::GetXsec(), G4ParticleHPInelasticCompFS::GetXsec(), G4ParticleHPChannel::GetXsec(), G4ParticleHPIsoData::GetXsec(), gz_comp(), gz_load(), G4HadronNucleonXsc::HadronNucleonXscNS(), G4ParticleHPChannel::Harmonise(), G4ParticleHPElementData::Harmonise(), G4BraggIonModel::HeEffChargeSquare(), G4VhElectronicStoppingPower::HeEffChargeSquare(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronHyperbolicMirror::HepPolyhedronHyperbolicMirror(), inflate_table(), G4Fancy3DNucleus::Init(), G4ParticleHPContAngularPar::Init(), G4LivermoreGammaConversion5DModel::Initialise(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4MuPairProductionModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4WentzelVIModel::Initialise(), G4EmModelManager::Initialise(), G4HadronXSDataTable::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4VEmModel::InitialiseElementSelectors(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4ePairProduction::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), G4hIonisation::InitialiseEnergyLossProcess(), G4GammaGeneralProcess::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4CoulombScattering::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4Orb::Initialize(), G4INCL::NuclearPotential::NuclearPotentialIsospin::initialize(), G4VPreCompoundFragment::Initialize(), G4Tet::Initialize(), G4RTXScanner::Initialize(), G4PenelopeBremsstrahlungFS::InitializeEnergySampling(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4PenelopeRayleighModelMI::InitializeSamplingAlgorithm(), G4INCL::INCL::initMaxInteractionDistance(), G4SBBremTable::InitSamplingTables(), G4GoudsmitSaundersonTable::InitSCPCorrection(), G4eDPWAElasticDCS::InitSCPCorrection(), G4INCL::INCL::initUniverseRadius(), G4UnionSolid::Inside(), G4Box::Inside(), G4Para::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4Trd::Inside(), G4Ellipsoid::Inside(), G4EllipticalCone::Inside(), G4EllipticalTube::Inside(), G4ExtrudedSolid::Inside(), G4Tet::Inside(), G4KineticTrack::IntegrandFunction1(), G4KineticTrack::IntegrandFunction2(), G4INCL::IFunction1D::integrate(), G4HETCFragment::IntegrateEmissionProbability(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4VEmissionProbability::IntegrateProbability(), G4INCL::CrossSections::interactionDistanceKbarN(), G4INCL::CrossSections::interactionDistanceKN(), G4INCL::CrossSections::interactionDistanceNN(), G4INCL::CrossSections::interactionDistancePiN(), G4INCL::CrossSections::interactionDistanceYN(), G4UPiNuclearCrossSection::Interpolate(), G4UCNMicroRoughnessHelper::IntIminus(), G4UCNMicroRoughnessHelper::IntIplus(), G4eIonisationSpectrum::IntSpectrum(), G4hIonEffChargeSquare::IonEffChargeSquare(), G4ExtrudedSolid::IsSameLineSegment(), G4HETCAlpha::K(), G4HETCDeuteron::K(), G4HETCHe3::K(), G4HETCNeutron::K(), G4HETCProton::K(), G4HETCTriton::K(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4INCL::NpiToSKChannel::KaonMomentum(), G4HadronNucleonXsc::KaonNucleonXscNS(), G4HadronNucleonXsc::KaonNucleonXscVG(), G4LevelReader::LevelManager(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4SBBremTable::LoadSamplingTables(), G4SBBremTable::LoadSTGrid(), EmPlot::make_plot(), G4Trap::MakePlane(), G4INCL::Random::Adapter::max(), MCGIDI_particle_getInternalID(), MCGIDI_POPs_findParticleIndex(), G4eBremsstrahlungRelModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4MuBremsstrahlungModel::MinPrimaryEnergy(), G4MuPairProductionModel::MinPrimaryEnergy(), G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), G4MagInt_Driver::OneGoodStep(), G4OldMagIntDriver::OneGoodStep(), G4INCL::NuclearDensityFunctions::ModifiedHarmonicOscillatorRP::operator()(), anonymous_namespace{G4AttValueFilterT.hh}::InInterval< T >::operator()(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), G4DNABoundingBox::overlap(), G4PAIySection::PAIdNdxPlasmon(), G4eIonisationParameters::Parameter(), G4INCL::ParticleEntryChannel::particleEnters(), G4PreCompoundEmission::PerformEmission(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGetMajorantSurfaceAandCParameters(), G4Vee2hadrons::PhysicsVector(), G4DipBustGenerator::PolarAngle(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4HadronElasticProcess::PostStepDoIt(), G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength(), G4PolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4PolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4eIonisationSpectrum::Probability(), G4PreCompoundIon::ProbabilityDistributionFunction(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), G4MicroElecInelasticModel_new::RandomizeEjectedElectronEnergy(), G4UrbanMscModel::Randomizetlimit(), G4PiData::ReactionXSection(), field_utils::relativeError2(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4GeomTools::RemoveRedundantVertices(), G4LocatorChangeLogger::ReportEndChanges(), G4LocatorChangeRecord::ReportEndChanges(), G4NavigationLogger::ReportOutsideMother(), G4StatDouble::rms(), G4VoxelSafety::SafetyForVoxelHeader(), G4ParticleHPVector::Sample(), G4ParticleHPFissionSpectrum::Sample(), G4ParticleHPKallbachMannSyst::Sample(), G4ParticleHPSimpleEvapSpectrum::Sample(), G4ParticleHPWattSpectrum::Sample(), G4ParticleHPIsotropic::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPContAngularPar::Sample(), G4ParticleHPLegendreStore::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4UrbanMscModel::SampleCosineTheta(), G4eDPWAElasticDCS::SampleCosineTheta(), G4eDPWAElasticDCS::SampleCosineThetaRestricted(), G4DipBustGenerator::SampleCosTheta(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4ParticleHPLegendreStore::SampleDiscreteTwoBody(), G4ParticleHPLegendreStore::SampleElastic(), G4eIonisationSpectrum::SampleEnergy(), G4SBBremTable::SampleEnergyTransfer(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeIonisationModel::SampleFinalStatePositron(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4HETCChargedFragment::SampleKineticEnergy(), G4HETCNeutron::SampleKineticEnergy(), G4EvaporationProbability::SampleKineticEnergy(), G4SampleResonance::SampleMass(), G4ParticleHPLegendreStore::SampleMax(), G4DNAIRT::SamplePDC(), G4DNAIRT_geometries::SamplePDC(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4LEPTSIonisationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4GammaTransition::SampleTransition(), G4GoudsmitSaundersonTable::Sampling(), G4FTFModel::SamplingNucleonKinematics(), G4VPartonStringModel::Scatter(), G4ParticleHPInelasticCompFS::SelectExitChannel(), G4Torus::SetAllParameters(), G4TessellatedSolid::SetAllUsingStack(), G4RadioactiveDecay::SetDecayHalfAngle(), G4FieldManager::SetDetectorField(), G4GeomTestVolume::SetErrorsThreshold(), G4EmConfigurator::SetExtraEmModel(), G4EmParameters::SetMaxEnergy(), G4DNAEventScheduler::SetMaxNbSteps(), G4BuffercoutDestination::SetMaxSize(), G4TessellatedSolid::SetMaxVoxels(), G4Voxelizer::SetMaxVoxels(), G4VLongitudinalStringDecay::SetMinMasses(), G4KDTree::HyperRect::SetMinMax(), G4Fragment::SetNumberOfLambdas(), G4ExcitationHandler::SetParameters(), G4Nucleus::SetParameters(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G3Division::SetRangeAndAxis(), G4RadioactiveDecay::SetThresholdForVeryLongDecayTime(), G4TransportationLogger::SetThresholdTrials(), G4WentzelOKandVIxSection::SetupKinematic(), G4WentzelVIRelXSection::SetupKinematic(), G4AtimaEnergyLossModel::sezi_dedx_e(), CLHEP::RandBreitWigner::shootM2(), G4LatticeReader::SkipComments(), G4TrajectoryDrawerUtils::SliceLine(), G4GeomTools::SphereExtent(), G4MesonSplitter::SplitMeson(), G4SteppingManager::Stepping(), G4BraggIonModel::StoppingPower(), G4BraggModel::StoppingPower(), G4QGSDiffractiveExcitation::String(), G4Torus::SurfaceNormal(), G4PiData::TotalXSection(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BulirschStoer::try_step(), uncompress2(), G4DiffractiveExcitation::UnpackMeson(), G4EmConfigurator::UpdateModelEnergyRange(), G4Physics2DVector::Value(), G4EmSaturation::VisibleEnergyDeposition(), G4INCL::DeuteronDensity::wavefunctionR(), and G4Clebsch::Weight().

◆ min()

template<typename T >
T G4INCL::Math::min ( const T  t1,
const T  t2 
)
inline

brief Return the smallest of the two arguments

Definition at line 117 of file G4INCLGlobals.hh.

117 {
118 return t1 < t2 ? t1 : t2;
119 }

Referenced by G4ParticleHPKallbachMannSyst::A(), G4AdjointCSMatrix::AddData(), G4EmDNAPhysicsActivator::AddElectronModels0(), G4EmDNAPhysicsActivator::AddElectronModels2(), G4EmDNAPhysicsActivator::AddElectronModels4(), G4EmDNAPhysicsActivator::AddElectronModels4a(), G4EmDNAPhysicsActivator::AddElectronModels6(), G4EmDNAPhysicsActivator::AddElectronModels6a(), G4EmDNAPhysicsActivator::AddElectronModels7(), G4EmDNAPhysicsActivator::AddGenericIonModels0(), G4EmDNAPhysicsActivator::AddProtonModels0(), G4SolidExtentList::AddSurface(), G4AdjointPhotoElectricModel::AdjointCrossSection(), G4BFieldIntegrationDriver::AdvanceChordLimited(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4VMultipleScattering::AlongStepDoIt(), G4NuclearStopping::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4Nucleus::AnnihilationEvaporationEffects(), G4EmCaptureCascade::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4eIonisationSpectrum::AverageEnergy(), G4HadronBuilder::Barion(), G4AtimaEnergyLossModel::Bethek_dedx_e(), G4IntersectionSolid::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4Cons::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Para::BoundingLimits(), G4Sphere::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4TwistedTubs::BoundingLimits(), G4WilsonAblationModel::BreakItUp(), G4Voxelizer::BuildBitmasks(), G4Voxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsModelAndElement(), G4AdjointCSManager::BuildCrossSectionsModelAndMaterial(), G4VEmProcess::BuildLambdaTable(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4GammaNuclearXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4SBBremTable::BuildSamplingTables(), G4tgbVolume::BuildSolidForDivision(), G4Voxelizer::BuildVoxelLimits(), G4BulirschStoer::calc_h_opt(), G4ConvergenceTester::calc_slope_fit(), G4IntersectionSolid::CalculateExtent(), G4UnionSolid::CalculateExtent(), G4VCSGfaceted::CalculateExtent(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4PVPlacement::CheckOverlaps(), G4Ellipsoid::CheckParameters(), G4EllipticalTube::CheckParameters(), G4GeomTools::CheckSnip(), HepPolyhedron::CheckSnip(), G4Fancy3DNucleus::ChoosePositions(), G4Nucleus::Cinema(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForSecond(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForSecond(), G4KalbachCrossSection::ComputeCrossSection(), G4ChatterjeeCrossSection::ComputeCrossSection(), G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4BoldyshevTripletModel::ComputeCrossSectionPerAtom(), G4PairProductionRelModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversion5DModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversionModel::ComputeCrossSectionPerAtom(), G4MuBremsstrahlungModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4eBremParametrizedModel::ComputeCrossSectionPerAtom(), G4IonParametrisedLossModel::ComputeCrossSectionPerAtom(), G4UrbanMscModel::ComputeCrossSectionPerAtom(), G4PolarizedIonisationModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4AtimaEnergyLossModel::ComputeCrossSectionPerElectron(), G4BetheBlochModel::ComputeCrossSectionPerElectron(), G4BraggIonModel::ComputeCrossSectionPerElectron(), G4BraggModel::ComputeCrossSectionPerElectron(), G4ICRU73QOModel::ComputeCrossSectionPerElectron(), G4LindhardSorensenIonModel::ComputeCrossSectionPerElectron(), G4MollerBhabhaModel::ComputeCrossSectionPerElectron(), G4ComponentBarNucleonNucleusXsc::ComputeCrossSections(), G4ComponentGGHadronNucleusXsc::ComputeCrossSections(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4eDPWAElasticDCS::ComputeCSPerAtom(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4PAIModel::ComputeDEDXPerVolume(), G4PAIPhotModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4MuBetheBlochModel::ComputeDEDXPerVolume(), G4MuBremsstrahlungModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4eBremParametrizedModel::ComputeDEDXPerVolume(), G4LindhardSorensenIonModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4AtimaEnergyLossModel::ComputeDEDXPerVolume(), G4PairProductionRelModel::ComputeDXSectionPerAtom(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4eplusTo3GammaOKVIModel::ComputeF(), G4UrbanAdjointMscModel::ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), G4UrbanMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), G4WentzelOKandVIxSection::ComputeMaxElectronScattering(), G4NIELCalculator::ComputeNIEL(), G4PairProductionRelModel::ComputeRelDXSectionPerAtom(), G4ErrorPropagationNavigator::ComputeSafety(), G4VoxelSafety::ComputeSafety(), G4PathFinder::ComputeStep(), G4ITPathFinder::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ErrorPropagationNavigator::ComputeStep(), G4Navigator::ComputeStep(), G4ITNavigator2::ComputeStep(), G4PropagatorInField::ComputeStep(), G4RegularNavigation::ComputeStepSkippingEqualMaterials(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTrueStepLength(), G4VoxelNavigation::ComputeVoxelSafety(), G4ParameterisedNavigation::ComputeVoxelSafety(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), G4VRangeToEnergyConverter::Convert(), G4ConversionUtils::Convert(), G4VLongitudinalStringDecay::CreatePartonPair(), G4PenelopeIonisationCrossSection::CrossSection(), G4LivermoreIonisationCrossSection::CrossSection(), G4PAIModel::CrossSectionPerVolume(), G4PAIPhotModel::CrossSectionPerVolume(), G4DNAMolecularDissociation::DecayIt(), G4ICRU73QOModel::DEDXPerElement(), G4FissionParameters::DefineParameters(), G4OpBoundaryProcess::DielectricLUTDAVIS(), G4DiffractiveSplitableHadron::Diquark(), G4LundStringFragmentation::DiQuarkSplitup(), G4QGSMFragmentation::DiQuarkSplitup(), G4GeomTools::DiskExtent(), G4AtimaFluctuations::Dispersion(), G4IntersectionSolid::DistanceToIn(), G4UnionSolid::DistanceToIn(), G4Box::DistanceToIn(), G4Trap::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalTube::DistanceToIn(), G4Tet::DistanceToIn(), G4SubtractionSolid::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Sphere::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Tet::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4Box::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4EllipticalTube::DistanceToOut(), G4PathFinder::DoNextCurvedStep(), G4ITPathFinder::DoNextCurvedStep(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), G4EmModelManager::DumpModelList(), GFlashShowerModel::ElectronDoIt(), G4BraggIonModel::ElectronicStoppingPower(), G4BraggModel::ElectronicStoppingPower(), G4GeomTools::EllipsePerimeter(), G4GeomTools::EllipticConeLateralArea(), G4AtimaFluctuations::EnergyTable_interpolate(), G4AtimaEnergyLossModel::EnergyTable_interpolate(), G4VSolid::EstimateSurfaceArea(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), PTL::ThreadPool::execute_on_all_threads(), G4MultiUnion::Extent(), G4INCL::NNToMissingStrangenessChannel::fillFinalState(), G4INCL::NpiToMissingStrangenessChannel::fillFinalState(), G4ElasticHadrNucleusHE::FillFq2(), G4MesonAbsorption::FindAndFillCluster(), G4eDPWAElasticDCS::FindCumValue(), G4Physics2DVector::FindLinearX(), G4JTPolynomialSolver::FindRoots(), G3CalcParamsFn(), G4ArrowModel::G4ArrowModel(), G4IntersectingCone::G4IntersectingCone(), G4OpenGLXmSliderBar::G4OpenGLXmSliderBar(), CLHEP::RandBinomial::genBinomial(), G4eeToHadronsModel::GenerateCMPhoton(), G4Clebsch::GenerateIso3(), GFlashHomoShowerParameterisation::GenerateRadius(), GFlashSamplingShowerParameterisation::GenerateRadius(), G4ParticleHPVector::Get15percentBorder(), DNA::Penetration::Terrisol1990::Get3DStdDeviation(), G4INCL::ClusteringModelIntercomparison::getCluster(), G4hImpactIonisation::GetConstraints(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PenelopeIonisationCrossSection::GetCrossSection(), G4LivermoreIonisationCrossSection::GetCrossSection(), G4VEnergyLossProcess::GetDEDXDispersion(), G4LindhardSorensenData::GetDeltaL(), G4NeutronCaptureXS::GetElementCrossSection(), G4BGGNucleonElasticXS::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4BGGNucleonInelasticXS::GetElementCrossSection(), G4PhotonEvaporation::GetEmissionProbability(), G4ClippablePolygon::GetExtent(), G4SolidExtentList::GetExtent(), G4OpBoundaryProcess::GetFacetNormal(), G4Accumulables::GetMergeFunction(), G4SampleResonance::GetMinimumMass(), G4FTFParameters::GetMinMass(), G4ClippablePolygon::GetMinPoint(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4MuonMinusBoundDecay::GetMuonZeff(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorIn(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorTot(), G4VMscModel::GetParticleChangeForMSC(), G4ClippablePolygon::GetPlanerExtent(), G4ITNavigator2::GetRandomInCurrentVolume(), G4VEmAdjointModel::GetSecondAdjEnergyMaxForScatProjToProj(), G4AdjointComptonModel::GetSecondAdjEnergyMaxForScatProjToProj(), G4ParticleHPVector::GetXsec(), G4ParticleHPPartial::GetY(), G4HadronNucleonXsc::HadronNucleonXscNS(), G4HadronNucleonXsc::HadronNucleonXscVU(), G4ElasticHadrNucleusHE::HadronNucleusQ2_2(), inflate_table(), G4ClippablePolygon::InFrontOf(), G4ParticleHPDeExGammas::Init(), G4ParticleHPContAngularPar::Init(), G4FermiFragmentsPoolVI::Initialise(), G4BoldyshevTripletModel::Initialise(), G4eeToHadronsModel::Initialise(), G4LivermoreComptonModel::Initialise(), G4LivermoreGammaConversion5DModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermorePhotoElectricModel::Initialise(), G4LivermorePolarizedRayleighModel::Initialise(), G4LivermoreRayleighModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4WentzelVIModel::Initialise(), G4EmModelManager::Initialise(), G4BetheHeitlerModel::InitialiseElementData(), G4eBremsstrahlungRelModel::InitialiseElementData(), G4PairProductionRelModel::InitialiseElementData(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4hIonisation::InitialiseEnergyLossProcess(), G4ElasticHadrNucleusHE::InitialiseModel(), G4CoulombScattering::InitialiseProcess(), G4DNAIRT_geometries::Initialize(), G4Tet::Initialize(), G4hImpactIonisation::InitializeParametrisation(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4PenelopeRayleighModelMI::InitializeSamplingAlgorithm(), G4GoudsmitSaundersonTable::InitSCPCorrection(), G4eDPWAElasticDCS::InitSCPCorrection(), G4INCL::IFunction1D::integrate(), G4UPiNuclearCrossSection::Interpolate(), G4INCL::IFunction1D::inverseCDFTable(), G4NeutronCaptureXS::IsoCrossSection(), G4ExtrudedSolid::IsSameLineSegment(), G4INCL::NpiToSKChannel::KaonMomentum(), G4HadronNucleonXsc::KaonNucleonXscVG(), G4LevelReader::LevelManager(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4SBBremTable::LoadSamplingTables(), G4SBBremTable::LoadSTGrid(), G4EmCorrections::LShellCorrection(), EmPlot::make_plot(), G4AtimaEnergyLossModel::MaxSecondaryEnergy(), MCGIDI_particle_getInternalID(), MCGIDI_POPs_findParticleIndex(), G4INCL::Random::Adapter::min(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4LevelManager::NearestLevelIndex(), G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), anonymous_namespace{G4AttValueFilterT.hh}::InInterval< T >::operator()(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), G4DNABoundingBox::overlap(), G4eIonisationParameters::Parameter(), G4DipBustGenerator::PolarAngle(), G4VMultipleScattering::PreparePhysicsTable(), G4INCL::INCL::prepareReaction(), G4eIonisationSpectrum::Probability(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), G4NuclearRadii::RadiusCB(), G4ITNavigator2::RecheckDistanceToCurrentBoundary(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), G4ParticleHPContAngularPar::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4PAIModelData::SampleAlongStepTransfer(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4UrbanMscModel::SampleCosineTheta(), G4eDPWAElasticDCS::SampleCosineTheta(), G4eDPWAElasticDCS::SampleCosineThetaRestricted(), G4DipBustGenerator::SampleCosTheta(), G4ModifiedMephi::SampleCosTheta(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4UrbanAdjointMscModel::SampleDisplacement(), G4eIonisationSpectrum::SampleEnergy(), G4SBBremTable::SampleEnergyTransfer(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4UniversalFluctuation::SampleFluctuations(), G4ElasticHadrNucleusHE::SampleInvariantT(), G4HadronElastic::SampleInvariantT(), G4SampleResonance::SampleMass(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4eBremParametrizedModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4PenelopeRayleighModelMI::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4PolarizedIonisationModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4LEPTSDissociationModel::SampleSecondaries(), G4LEPTSExcitationModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4FTFModel::SamplingNucleonKinematics(), G4RadioactiveDecay::SetDecayHalfAngle(), G4VRangeToEnergyConverter::SetEnergyRange(), G4EmConfigurator::SetExtraEmModel(), G4VLongitudinalStringDecay::SetMinimalStringMass(), G4VLongitudinalStringDecay::SetMinMasses(), G4KDTree::HyperRect::SetMinMax(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G3Division::SetRangeAndAxis(), G4OpenInventorQtExaminerViewer::setStartingPtForAnimation(), G4OpenInventorXtExaminerViewer::setStartingPtForAnimation(), G4VEnergyLossProcess::SetStepFunction(), G4ScreeningMottCrossSection::SetupKinematic(), G4EnergyLossForExtrapolator::SetupKinematics(), G4WentzelOKandVIxSection::SetupTarget(), G4EmParameters::SetVerbose(), G4AtimaEnergyLossModel::sezi_dedx_e(), G4EmCorrections::ShellCorrection(), G4GeomTools::SphereExtent(), G4VMultipleScattering::StorePhysicsTable(), G4Scheduler::SynchronizeTracks(), G4EvaporationProbability::TotalProbability(), G4MultiUnion::TransformLimits(), G4Voxelizer::TransformLimits(), G4BulirschStoer::try_step(), G4EmConfigurator::UpdateModelEnergyRange(), G4Physics2DVector::Value(), and G4Clebsch::Weight().

◆ pow13()

G4double G4INCL::Math::pow13 ( G4double  x)
inline

◆ pow23()

G4double G4INCL::Math::pow23 ( G4double  x)
inline

◆ powMinus13()

G4double G4INCL::Math::powMinus13 ( G4double  x)
inline

Definition at line 92 of file G4INCLGlobals.hh.

92 {
93 return std::pow(x, -oneThird);
94 }

References oneThird.

◆ sign()

template<typename T >
G4int G4INCL::Math::sign ( const T  t)
inline

◆ toDegrees()

G4double G4INCL::Math::toDegrees ( G4double  radians)
inline

Definition at line 79 of file G4INCLGlobals.hh.

79 {
80 return radians * (180.0 / pi);
81 }

References pi.

Referenced by G4INCL::Nucleus::fillEventInfo(), G4INCL::EventInfo::fillInverseKinematics(), and G4INCL::EventInfo::remnantToParticle().

Variable Documentation

◆ oneOverSqrtThree

const G4double G4INCL::Math::oneOverSqrtThree = 1./std::sqrt((G4double)3.)

◆ oneOverSqrtTwo

const G4double G4INCL::Math::oneOverSqrtTwo = 1./std::sqrt((G4double)2.)

Definition at line 72 of file G4INCLGlobals.hh.

Referenced by gaussianCDF().

◆ oneThird

const G4double G4INCL::Math::oneThird = 1./3.

Definition at line 74 of file G4INCLGlobals.hh.

Referenced by pow13(), and powMinus13().

◆ pi

const G4double G4INCL::Math::pi = 3.14159265358979323846264338328

◆ piOverTwo

const G4double G4INCL::Math::piOverTwo = 0.5 * pi

◆ sqrtFiveThirds

const G4double G4INCL::Math::sqrtFiveThirds = std::sqrt(5./3.)

◆ sqrtThreeFifths

const G4double G4INCL::Math::sqrtThreeFifths = std::sqrt(3./5.)

Definition at line 77 of file G4INCLGlobals.hh.

Referenced by G4INCL::ParticleTable::getMomentumRMS().

◆ tenPi

const G4double G4INCL::Math::tenPi = 10.0 * pi

◆ twoPi

const G4double G4INCL::Math::twoPi = 2.0 * pi

◆ twoThirds

const G4double G4INCL::Math::twoThirds = 2./3.

Definition at line 75 of file G4INCLGlobals.hh.

Referenced by G4INCL::InteractionAvatar::postInteraction(), and pow23().