Geant4  10.03
G4INCL::Math Namespace Reference

Functions

G4double toDegrees (G4double radians)
 
G4int heaviside (G4int n)
 
G4double pow13 (G4double x)
 
G4double powMinus13 (G4double x)
 
G4double pow23 (G4double x)
 
G4double aSinH (G4double x)
 
template<typename T >
G4int sign (const T t)
 A simple sign function that allows us to port fortran code to c++ more easily. 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 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...
 
G4double inverseGaussianCDF (const G4double x)
 Inverse cumulative distribution function for Gaussian. More...
 
G4double arcSin (const G4double x)
 Calculates arcsin with some tolerance on illegal arguments. More...
 
G4double arcCos (const G4double x)
 Calculates arccos with some tolerance on illegal arguments. More...
 

Variables

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

Function Documentation

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

Calculates arccos with some tolerance on illegal arguments.

Definition at line 103 of file G4INCLGlobals.cc.

References pi.

Referenced by G4INCL::CoulombNonRelativistic::coulombDeviation(), G4INCL::CoulombNonRelativistic::distortOut(), G4INCL::EventInfo::fillInverseKinematics(), G4INCL::SurfaceAvatar::getTransmissionProbability(), and G4INCL::EventInfo::remnantToParticle().

+ Here is the caller graph for this function:

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

Calculates arcsin with some tolerance on illegal arguments.

Definition at line 98 of file G4INCLGlobals.cc.

References pi.

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

Definition at line 100 of file G4INCLGlobals.hh.

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.

References oneOverSqrtTwo, and sign().

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

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

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.

References gaussianCDF().

+ Here is the call graph for this function:

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

Definition at line 83 of file G4INCLGlobals.hh.

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

+ Here is the caller graph for this function:

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.

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.

Referenced by G4GHEKinematicsVector::Add(), G4RPGReaction::AddBlackTrackParticles(), G4PenelopeCrossSection::AddCrossSectionPoint(), G4UPiNuclearCrossSection::AddDataSet(), G4INCL::ProjectileRemnant::addMostDynamicalSpectators(), G4PenelopeCrossSection::AddShellCrossSectionPoint(), G4SolidExtentList::AddSurface(), G4ParticleHPFinalState::adjust_final_state(), G4NavigationLogger::AlongComputeStepLog(), G4VEnergyLossProcess::AlongStepDoIt(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4PreCompoundEmission::AngularDistribution(), G4Nucleus::AnnihilationEvaporationEffects(), G4ParticleHPCapture::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4ChordFinder::ApproxCurvePointV(), G4eIonisationSpectrum::AverageEnergy(), G4RDeIonisationSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageEnergy(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), G4eIonisationSpectrum::AverageValue(), G4RDeIonisationSpectrum::AverageValue(), G4eBremsstrahlungSpectrum::AverageValue(), G4RDeBremsstrahlungSpectrum::AverageValue(), G4HadronBuilder::Barion(), G4ClippablePolygon::BehindOf(), G4WilsonAblationModel::BreakItUp(), G4UnstableFragmentBreakUp::BreakUpChain(), G4SurfaceVoxelizer::BuildBitmasks(), G4SurfaceVoxelizer::BuildBoundaries(), G4SurfaceVoxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndElement(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndMaterial(), G4PenelopeIonisationXSHandler::BuildDeltaTable(), G4SurfaceVoxelizer::BuildEmpty(), G4VEnergyLossProcess::BuildLambdaTable(), G4VEmProcess::BuildLambdaTable(), G4hImpactIonisation::BuildPhysicsTable(), G4SurfaceVoxelizer::BuildReduceVoxels(), G4SurfaceVoxelizer::BuildReduceVoxels2(), DicomFileCT::BuildStructureIDs(), G4LossTableBuilder::BuildTableForModel(), G4SurfaceVoxelizer::BuildVoxelLimits(), G4ConvergenceTester::calc_slope_fit(), G4StatMFMicroCanonical::CalcEntropyOfCompoundNucleus(), G4StatMFMacroMultiNucleon::CalcMeanMultiplicity(), G4StatMFMicroPartition::CalcPartitionProbability(), G4StatMFMicroPartition::CalcPartitionTemperature(), G4StatMFMacroTemperature::CalcTemperature(), G4WeightWindowAlgorithm::Calculate(), G4UnionSolid::CalculateExtent(), G4IntersectionSolid::CalculateExtent(), G4RPGInelastic::CalculateMomenta(), G4PreCompoundTransitions::CalculateProbability(), G4SteppingManager::CalculateSafety(), G4ITStepProcessor::CalculateSafety(), G4StatMFMacroCanonical::CalculateTemperature(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), G4Trd::CheckAndSetAllParameters(), G4BoundingEnvelope::CheckBoundingPolygons(), G4MolecularDissociationTable::CheckDataConsistency(), G4GeomTools::CheckSnip(), G4DiffractiveSplitableHadron::ChooseStringEnds(), G4Nucleus::Cinema(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), XrayFluoMercuryDetectorConstruction::ComputeApparateParameters(), XrayFluoPlaneDetectorConstruction::ComputeApparateParameters(), XrayFluoDetectorConstruction::ComputeApparateParameters(), G4ChatterjeeCrossSection::ComputeCrossSection(), G4KalbachCrossSection::ComputeCrossSection(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4EmCalculator::ComputeCrossSectionPerAtom(), G4eeToTwoGammaModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4PenelopeAnnihilationModel::ComputeCrossSectionPerElectron(), G4EmCalculator::ComputeCrossSectionPerShell(), G4EmCalculator::ComputeCrossSectionPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4MuPairProductionModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4BraggModel::ComputeDEDXPerVolume(), G4BraggIonModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4MuPairProductionModel::ComputeDMicroscopicCrossSection(), G4WentzelVIRelXSection::ComputeElectronCrossSection(), G4WentzelOKandVIxSection::ComputeElectronCrossSection(), G4UrbanMscModel::ComputeGeomPathLength(), G4UrbanAdjointMscModel::ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), G4KokoulinMuonNuclearXS::ComputeMicroscopicCrossSection(), G4MuPairProductionModel::ComputeMicroscopicCrossSection(), PDBlib::ComputeNucleotideBarycenters(), G4eBremParametrizedModel::ComputeParametrizedDXSectionPerAtom(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4PathFinder::ComputeStep(), G4PropagatorInField::ComputeStep(), G4WentzelVIRelXSection::ComputeTransportCrossSectionPerAtom(), G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), G4MonopolePhysics::ConstructProcess(), G4BinaryCascade::CorrectFinalPandE(), G4VLongitudinalStringDecay::CreatePartonPair(), G4TwistedTubs::CreatePolyhedron(), G4TessellatedSolid::CreateVertexList(), G4XPDGElastic::CrossSection(), G4PEEffectFluoModel::CrossSectionPerVolume(), G4PAIModelData::CrossSectionPerVolume(), MuCrossSections::CRP_Mephi(), G4PAIModelData::DEDXPerVolume(), G4BinaryLightIonReaction::DeExciteSpectatorNucleus(), G4FissionParameters::DefineParameters(), G4hImpactIonisation::DeltaRaysEnergy(), G4INCL::DeuteronDensity::derivWavefunctionR(), G4MagneticFieldModel::DescribeYourselfTo(), G4PenelopeComptonModel::DifferentialCrossSection(), G4QGSMSplitableHadron::DiffractiveSplitUp(), G4PAIySection::DifPAIySection(), G4DiffractiveSplitableHadron::Diquark(), G4QGSMFragmentation::DiQuarkSplitup(), G4LundStringFragmentation::DiQuarkSplitup(), G4GeomTools::DiskExtent(), G4PolyconeSide::DistanceAway(), G4CutTubs::DistanceToIn(), G4Tet::DistanceToIn(), G4Para::DistanceToIn(), G4Trap::DistanceToIn(), G4Tet::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ITStepProcessor::DoStepping(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), G4EmModelManager::DumpModelList(), G4ionEffectiveCharge::EffectiveCharge(), G4PiData::ElasticXSection(), GFlashShowerModel::ElectronDoIt(), G4hImpactIonisation::ElectronicLossFluctuation(), G4BraggModel::ElectronicStoppingPower(), G4BraggIonModel::ElectronicStoppingPower(), Run::EndOfEvent(), ExGflashEventAction::EndOfEventAction(), G4BinaryLightIonReaction::EnergyAndMomentumCorrector(), G4MultiLevelLocator::EstimateIntersectionPoint(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), G4RDeIonisationParameters::Excitation(), G4UnionSolid::Extent(), G4IntersectionSolid::Extent(), G4Ellipsoid::Extent(), G4Trd::Extent(), G4PolyPhiFace::Extent(), G4Para::Extent(), G4Cons::Extent(), G4ExtrudedSolid::Extent(), G4Sphere::Extent(), G4Trap::Extent(), G4VCrossSectionSource::FcrossX(), G4INCL::ElasticChannel::fillFinalState(), G4INCL::EventInfo::fillInverseKinematics(), G4NuclearLevelData::FindLevel(), G4ChordFinderSaf::FindNextChord(), G4JTPolynomialSolver::FindRoots(), G4BoundingEnvelope::FindScaleFactor(), G4StatMF::FindTemperatureOfBreakingChannel(), G4CompetitiveFission::FissionAtomicNumber(), G4CompetitiveFission::FissionKineticEnergy(), G4RPGFragmentation::FragmentationIntegral(), G4ArrowModel::G4ArrowModel(), G4BogackiShampine23::G4BogackiShampine23(), G4BogackiShampine45::G4BogackiShampine45(), G4CashKarpRKF45::G4CashKarpRKF45(), G4ClassicalRK4::G4ClassicalRK4(), G4DormandPrince745::G4DormandPrince745(), G4DormandPrinceRK56::G4DormandPrinceRK56(), G4DormandPrinceRK78::G4DormandPrinceRK78(), G4FSALBogackiShampine45::G4FSALBogackiShampine45(), G4ImplicitEuler::G4ImplicitEuler(), G4MuPairProductionModel::G4MuPairProductionModel(), G4Orb::G4Orb(), G4PAIModelData::G4PAIModelData(), G4PAIPhotData::G4PAIPhotData(), G4ParticleHPPartial::G4ParticleHPPartial(), G4ParticleHPVector::G4ParticleHPVector(), G4PropagatorInField::G4PropagatorInField(), G4QuadrangularFacet::G4QuadrangularFacet(), G4SimpleRunge::G4SimpleRunge(), G4Sphere::G4Sphere(), G4Tet::G4Tet(), G4TriangularFacet::G4TriangularFacet(), G4TsitourasRK45::G4TsitourasRK45(), G4INCL::PhaseSpaceRauboldLynch::generate(), G4eeToHadronsModel::GenerateCMPhoton(), GFlashSamplingShowerParameterisation::GenerateEnergyProfile(), G4Clebsch::GenerateIso3(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), GFlashSamplingShowerParameterisation::GenerateNSpotProfile(), G4HadronCrossSections::GetCaptureCrossSection(), G4BCLateParticle::GetCollisions(), G4VXTRenergyLoss::GetComptonPerAtom(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4ParticleHPFissionData::GetCrossSection(), G4ParticleHPCaptureData::GetCrossSection(), G4ParticleHPElasticData::GetCrossSection(), G4ParticleHPInelasticData::GetCrossSection(), G4HadronicProcess::GetElementCrossSection(), G4EvaporationChannel::GetEmissionProbability(), G4PhotonEvaporation::GetEmissionProbability(), G4HadronCrossSections::GetFissionCrossSection(), G4INCL::ParticleTable::getLargestNuclearRadius(), G4RDVeLowEnergyLoss::GetLossWithFluct(), G4CutTubs::GetMaxMinZ(), G4ClippablePolygon::GetMaxPoint(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4Accumulables::GetMergeFunction(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4RPGInelastic::GetNormalizationConstant(), G4PairingCorrection::GetPairingCorrection(), G4VMscModel::GetParticleChangeForMSC(), G4TrajectoryDrawerUtils::GetPointsAndTimes(), G4ITNavigator2::GetRandomInCurrentVolume(), G4ParticleHPIsoData::GetXsec(), G4ParticleHPChannelList::GetXsec(), G4ParticleHPFissionBaseFS::GetXsec(), G4ParticleHPInelasticBaseFS::GetXsec(), G4ParticleHPInelasticCompFS::GetXsec(), G4ParticleHPChannel::GetXsec(), G4ParticleHPElementData::Harmonise(), G4ParticleHPChannel::Harmonise(), G4VhElectronicStoppingPower::HeEffChargeSquare(), G4BraggIonModel::HeEffChargeSquare(), inflate_table(), G4ParticleHPContAngularPar::Init(), G4FermiFragmentsPoolVI::Initialise(), G4PenelopeBremsstrahlungModel::Initialise(), G4WentzelVIModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4MuPairProductionModel::Initialise(), G4EmModelManager::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4VEmModel::InitialiseElementSelectors(), G4ePairProduction::InitialiseEnergyLossProcess(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), DetectorConstruction::InitialiseGeometryParameters(), G4CoulombScattering::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4FastPathHadronicCrossSection::fastPathEntry::Initialize(), G4INCL::NuclearPotential::NuclearPotentialIsospin::initialize(), G4PenelopeBremsstrahlungFS::InitializeEnergySampling(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4INCL::INCL::initMaxInteractionDistance(), G4INCL::INCL::initUniverseRadius(), G4Sphere::Inside(), G4KineticTrack::IntegrandFunction1(), G4KineticTrack::IntegrandFunction2(), G4INCL::IFunction1D::integrate(), G4GEMChannelVI::IntegratedProbability(), G4HETCFragment::IntegrateEmissionProbability(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4EvaporationProbability::IntegrateEmissionProbability(), G4INCL::CrossSections::interactionDistanceNN(), G4INCL::CrossSections::interactionDistancePiN(), G4eIonisationSpectrum::IntSpectrum(), G4RDeIonisationSpectrum::IntSpectrum(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4hIonEffChargeSquare::IonEffChargeSquare(), G4ExtrudedSolid::IsSameLineSegment(), G4HETCAlpha::K(), G4HETCProton::K(), G4HETCTriton::K(), G4HETCHe3::K(), G4HETCDeuteron::K(), G4HETCNeutron::K(), G4LevelReader::LevelManager(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4GHEKinematicsVector::Lor(), main(), G4LevelReader::MakeLevelManager(), MCGIDI_particle_getInternalID(), MCGIDI_POPs_findParticleIndex(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4eBremsstrahlungRelModel::MinPrimaryEnergy(), G4MuPairProductionModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4MuBremsstrahlungModel::MinPrimaryEnergy(), G4RPGReaction::NuclearReaction(), G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), G4EmCorrections::NuclearStoppingPower(), G4MagInt_Driver::OneGoodStep(), G4FSALIntegrationDriver::OneGoodStep(), G4INCL::NuclearDensityFunctions::ModifiedHarmonicOscillatorRP::operator()(), DicomVFileImage::operator+(), DicomPhantomZSliceHeader::operator+(), operator<<(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), G4PAIySection::PAIdNdxPlasmon(), G4eIonisationParameters::Parameter(), G4BremsstrahlungParameters::Parameter(), G4RDeIonisationParameters::Parameter(), G4RDBremsstrahlungParameters::Parameter(), G4INCL::ParticleEntryChannel::particleEnters(), G4PreCompoundEmission::PerformEmission(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGetMajorantSurfaceAandCParameters(), G4Vee2hadrons::PhysicsVector(), G4RPGInelastic::Pmltpc(), G4RDGenerator2BS::PolarAngle(), G4LowEnergyGammaConversion::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4eIonisationSpectrum::Probability(), G4eBremsstrahlungSpectrum::Probability(), G4RDeBremsstrahlungSpectrum::Probability(), G4RDeIonisationSpectrum::Probability(), G4PreCompoundIon::ProbabilityDistributionFunction(), G4GEMChannelVI::ProbabilityDistributionFunction(), G4RPGStrangeProduction::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGTwoCluster::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4PiData::ReactionXSection(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4GeomTools::RemoveRedundantVertices(), G4NavigationLogger::ReportOutsideMother(), CexmcPhysicsList< BasePhysics, StudiedPhysics, ProductionModel >::ResampleTrackLengthInTarget(), G4StatDouble::rms(), G4RPGReaction::Rotate(), G4VoxelSafety::SafetyForVoxelHeader(), G4ParticleHPIsotropic::Sample(), G4ParticleHPKallbachMannSyst::Sample(), G4ParticleHPFissionSpectrum::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPWattSpectrum::Sample(), G4ParticleHPSimpleEvapSpectrum::Sample(), G4ParticleHPLegendreStore::Sample(), G4ParticleHPContAngularPar::Sample(), G4ParticleHPVector::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4ParticleHPLegendreStore::SampleDiscreteTwoBody(), G4ParticleHPLegendreStore::SampleElastic(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4eBremsstrahlungSpectrum::SampleEnergy(), G4RDeBremsstrahlungSpectrum::SampleEnergy(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeIonisationModel::SampleFinalStatePositron(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4HETCChargedFragment::SampleKineticEnergy(), G4HETCNeutron::SampleKineticEnergy(), G4SampleResonance::SampleMass(), G4ParticleHPLegendreStore::SampleMax(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4LEPTSIonisationModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4WentzelVIRelXSection::SampleSingleScattering(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4GammaTransition::SampleTransition(), G4GoudsmitSaundersonTable::Sampling(), G4ParticleHPInelasticCompFS::SelectExitChannel(), G4Torus::SetAllParameters(), G4RadioactiveDecay::SetDecayHalfAngle(), G4GeomTestVolume::SetErrorsThreshold(), G4EmConfigurator::SetExtraEmModel(), G4GHEKinematicsVector::SetMassAndUpdate(), G4SurfaceVoxelizer::SetMaxVoxels(), G4GHEKinematicsVector::SetMomentumAndUpdate(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G3Division::SetRangeAndAxis(), G4WentzelOKandVIxSection::SetupKinematic(), G4LatticeReader::SkipComments(), G4TrajectoryDrawerUtils::SliceLine(), G4RPGNeutronInelastic::SlowNeutron(), G4GeomTools::SphereExtent(), G4MesonSplitter::SplitMeson(), G4SteppingManager::Stepping(), G4BraggModel::StoppingPower(), G4BraggIonModel::StoppingPower(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub(), G4Torus::SurfaceNormal(), G4EvaporationProbability::TotalProbability(), G4PiData::TotalXSection(), G4DiffractiveExcitation::UnpackMeson(), G4EmConfigurator::UpdateModelEnergyRange(), G4EmSaturation::VisibleEnergyDeposition(), G4INCL::DeuteronDensity::wavefunctionR(), and G4Clebsch::Weight().

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.

Referenced by G4ParticleHPKallbachMannSyst::A(), G4RPGReaction::AddBlackTrackParticles(), G4AdjointCSMatrix::AddData(), Histo::AddPhantomStep(), G4SolidExtentList::AddSurface(), G4AdjointPhotoElectricModel::AdjointCrossSection(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VMultipleScattering::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::AlongStepGetPhysicalInteractionLength(), G4Nucleus::AnnihilationEvaporationEffects(), G4LightMedia::AntiLambdaExchange(), G4LightMedia::AntiNeutronExchange(), G4LightMedia::AntiOmegaMinusExchange(), G4LightMedia::AntiProtonExchange(), G4LightMedia::AntiSigmaMinusExchange(), G4LightMedia::AntiSigmaPlusExchange(), G4LightMedia::AntiXiMinusExchange(), G4LightMedia::AntiXiZeroExchange(), G4RPGAntiLambdaInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiNeutronInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGAntiXiZeroInelastic::ApplyYourself(), G4EmCaptureCascade::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4eIonisationSpectrum::AverageEnergy(), G4RDeIonisationSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageValue(), G4RDeBremsstrahlungSpectrum::AverageValue(), G4HadronBuilder::Barion(), G4WilsonAblationModel::BreakItUp(), DicomFilePET::BuildActivities(), G4SurfaceVoxelizer::BuildBitmasks(), G4SurfaceVoxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndElement(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndMaterial(), G4VEmProcess::BuildLambdaTable(), G4LowEnergyBremsstrahlung::BuildLossTable(), DicomFileCT::BuildMaterials(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4tgbVolume::BuildSolidForDivision(), DicomFileCT::BuildStructureIDs(), G4SurfaceVoxelizer::BuildVoxelLimits(), G4ConvergenceTester::calc_slope_fit(), G4UnionSolid::CalculateExtent(), G4IntersectionSolid::CalculateExtent(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4GeomTools::CheckSnip(), G4Fancy3DNucleus::ChoosePositions(), G4Nucleus::Cinema(), G4HadronicInteractionRegistry::Clean(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForSecond(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForSecond(), G4ChatterjeeCrossSection::ComputeCrossSection(), G4KalbachCrossSection::ComputeCrossSection(), G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4eBremParametrizedModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4MuBremsstrahlungModel::ComputeCrossSectionPerAtom(), G4IonParametrisedLossModel::ComputeCrossSectionPerAtom(), G4PolarizedMollerBhabhaModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4MollerBhabhaModel::ComputeCrossSectionPerElectron(), G4BraggIonModel::ComputeCrossSectionPerElectron(), G4BraggModel::ComputeCrossSectionPerElectron(), G4ICRU73QOModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4BetheBlochModel::ComputeCrossSectionPerElectron(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4eBremParametrizedModel::ComputeDEDXPerVolume(), G4PAIPhotModel::ComputeDEDXPerVolume(), G4PAIModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4MuBremsstrahlungModel::ComputeDEDXPerVolume(), G4BraggIonModel::ComputeDEDXPerVolume(), G4MuBetheBlochModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4UrbanMscModel::ComputeGeomPathLength(), G4UrbanAdjointMscModel::ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), G4WentzelVIRelXSection::ComputeMaxElectronScattering(), G4WentzelOKandVIxSection::ComputeMaxElectronScattering(), G4ErrorPropagationNavigator::ComputeSafety(), G4VoxelSafety::ComputeSafety(), G4ErrorPropagationNavigator::ComputeStep(), G4PathFinder::ComputeStep(), G4PropagatorInField::ComputeStep(), G4Navigator::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator2::ComputeStep(), G4ITPathFinder::ComputeStep(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTrueStepLength(), G4ParameterisedNavigation::ComputeVoxelSafety(), G4VoxelNavigation::ComputeVoxelSafety(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), G4VLongitudinalStringDecay::CreatePartonPair(), G4LivermoreIonisationCrossSection::CrossSection(), G4PenelopeIonisationCrossSection::CrossSection(), G4PAIPhotModel::CrossSectionPerVolume(), G4PAIModel::CrossSectionPerVolume(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4DNAMolecularDissociation::DecayIt(), G4DiffractiveSplitableHadron::Diquark(), G4QGSMFragmentation::DiQuarkSplitup(), G4LundStringFragmentation::DiQuarkSplitup(), G4GeomTools::DiskExtent(), G4Ellipsoid::DistanceToIn(), G4UnionSolid::DistanceToIn(), G4IntersectionSolid::DistanceToIn(), G4CutTubs::DistanceToOut(), G4Tet::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Sphere::DistanceToOut(), G4PathFinder::DoNextCurvedStep(), G4ITPathFinder::DoNextCurvedStep(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), G4EmModelManager::DumpModelList(), GFlashShowerModel::ElectronDoIt(), G4FissionProbability::EmissionProbability(), G4RDRangeTest::Escape(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), G4RDeIonisationParameters::Excitation(), G4UnionSolid::Extent(), G4Ellipsoid::Extent(), G4IntersectionSolid::Extent(), G4Para::Extent(), G4Cons::Extent(), G4ExtrudedSolid::Extent(), G4Sphere::Extent(), G4Trap::Extent(), G4RPGInelastic::Factorial(), G4MesonAbsorption::FindAndFillCluster(), G4PhysicsVector::FindLinearEnergy(), G4ChordFinderSaf::FindNextChord(), G4ChordFinder::FindNextChord(), G4JTPolynomialSolver::FindRoots(), G4PhysicsOrderedFreeVector::FindValueBinLocation(), G3CalcParamsFn(), G4ArrowModel::G4ArrowModel(), G4ElasticData::G4ElasticData(), G4Tet::G4Tet(), G4eeToHadronsModel::GenerateCMPhoton(), G4Clebsch::GenerateIso3(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), GFlashHomoShowerParameterisation::GenerateRadius(), GFlashSamplingShowerParameterisation::GenerateRadius(), G4AntiNeutronAnnihilationAtRest::GenerateSecondaries(), G4ParticleHPVector::Get15percentBorder(), DNA::Penetration::Terrisol1990::Get3DStdDeviation(), G4INCL::ClusteringModelIntercomparison::getCluster(), G4hImpactIonisation::GetConstraints(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PenelopeIonisationCrossSection::GetCrossSection(), G4LivermoreIonisationCrossSection::GetCrossSection(), G4VEnergyLossProcess::GetDEDXDispersion(), G4PhotonEvaporation::GetEmissionProbability(), G4OpBoundaryProcess::GetFacetNormal(), G4CutTubs::GetMaxMinZ(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4Accumulables::GetMergeFunction(), G4ClippablePolygon::GetMinPoint(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4RPGInelastic::GetNormalizationConstant(), G4VMscModel::GetParticleChangeForMSC(), G4ITNavigator2::GetRandomInCurrentVolume(), G4AdjointComptonModel::GetSecondAdjEnergyMaxForScatProjToProjCase(), G4VEmAdjointModel::GetSecondAdjEnergyMaxForScatProjToProjCase(), G4ParticleHPVector::GetXsec(), G4ParticleHPPartial::GetY(), inflate_table(), G4ClippablePolygon::InFrontOf(), G4ParticleHPDeExGammas::Init(), G4ParticleHPContAngularPar::Init(), G4eeToHadronsModel::Initialise(), G4FermiFragmentsPoolVI::Initialise(), G4WentzelVIModel::Initialise(), G4EmModelManager::Initialise(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4CoulombScattering::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4FastPathHadronicCrossSection::fastPathEntry::Initialize(), G4hImpactIonisation::InitializeParametrisation(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4INCL::INCL::initUniverseRadius(), G4INCL::IFunction1D::integrate(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4INCL::IFunction1D::inverseCDFTable(), G4ExtrudedSolid::IsSameLineSegment(), G4LightMedia::KaonPlusExchange(), G4LightMedia::KaonZeroShortExchange(), G4LightMedia::LambdaExchange(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4EmCorrections::LShellCorrection(), main(), G4BetheBlochModel::MaxSecondaryEnergy(), MCGIDI_particle_getInternalID(), MCGIDI_POPs_findParticleIndex(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4LevelManager::NearestLevelIndex(), G4LightMedia::NeutronExchange(), G4RPGReaction::NuclearReaction(), G4LightMedia::OmegaMinusExchange(), DicomVFileImage::operator+(), DicomPhantomZSliceHeader::operator+(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), G4eIonisationParameters::Parameter(), G4BremsstrahlungParameters::Parameter(), G4RDeIonisationParameters::Parameter(), G4RDBremsstrahlungParameters::Parameter(), G4LightMedia::PionPlusExchange(), G4RPGInelastic::Pmltpc(), G4LowEnergyGammaConversion::PostStepDoIt(), G4LowEnergyPhotoElectric::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VMultipleScattering::PreparePhysicsTable(), G4INCL::INCL::prepareReaction(), G4eIonisationSpectrum::Probability(), G4eBremsstrahlungSpectrum::Probability(), G4RDeBremsstrahlungSpectrum::Probability(), G4RDeIonisationSpectrum::Probability(), G4LightMedia::ProtonExchange(), G4DNAWaterDissociationDisplacer::radialDistributionOfElectron(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4PathFinder::RecheckDistanceToCurrentBoundary(), G4Navigator::RecheckDistanceToCurrentBoundary(), G4ITNavigator2::RecheckDistanceToCurrentBoundary(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), G4ParticleHPContAngularPar::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4PAIModelData::SampleAlongStepTransfer(), G4UrbanMscModel::SampleCosineTheta(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4UrbanMscModel::SampleDisplacement(), G4UrbanAdjointMscModel::SampleDisplacement(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4eBremsstrahlungSpectrum::SampleEnergy(), G4RDeBremsstrahlungSpectrum::SampleEnergy(), G4UniversalFluctuation::SampleGauss(), G4SampleResonance::SampleMass(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4LEPTSDissociationModel::SampleSecondaries(), G4LEPTSExcitationModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4eBremParametrizedModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4RadioactiveDecay::SetDecayHalfAngle(), G4EmConfigurator::SetExtraEmModel(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G3Division::SetRangeAndAxis(), G4OpenInventorXtExaminerViewer::setStartingPtForAnimation(), G4VEnergyLossProcess::SetStepFunction(), G4WentzelVIRelXSection::SetupTarget(), G4WentzelOKandVIxSection::SetupTarget(), G4EmParameters::SetVerbose(), G4EmCorrections::ShellCorrection(), G4LightMedia::SigmaMinusExchange(), G4LightMedia::SigmaPlusExchange(), G4RPGNeutronInelastic::SlowNeutron(), G4GeomTools::SphereExtent(), G4VMultipleScattering::StorePhysicsTable(), G4Scheduler::SynchronizeTracks(), G4EvaporationProbability::TotalProbability(), G4EmConfigurator::UpdateModelEnergyRange(), CCalSteppingAction::UserSteppingAction(), G4Clebsch::Weight(), G4LightMedia::XiMinusExchange(), and G4LightMedia::XiZeroExchange().

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

Definition at line 96 of file G4INCLGlobals.hh.

Referenced by G4INCL::CoulombNonRelativistic::getCoulombRadius().

+ Here is the caller graph for this function:

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

Definition at line 92 of file G4INCLGlobals.hh.

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

Definition at line 79 of file G4INCLGlobals.hh.

References pi.

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

+ Here is the caller graph for this function:

Variable Documentation

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

Definition at line 72 of file G4INCLGlobals.hh.

Referenced by gaussianCDF().

const G4double G4INCL::Math::pi = 3.14159265358979323846264338328
const G4double G4INCL::Math::piOverTwo = 0.5 * pi
const G4double G4INCL::Math::sqrtFiveThirds = std::sqrt(5./3.)
const G4double G4INCL::Math::sqrtThreeFifths = std::sqrt(3./5.)

Definition at line 77 of file G4INCLGlobals.hh.

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

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

Definition at line 75 of file G4INCLGlobals.hh.

Referenced by G4INCL::InteractionAvatar::postInteraction().