Geant4  10.01.p03
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::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, sign(), and z.

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(), G4NeutronHPFinalState::adjust_final_state(), G4ParticleHPFinalState::adjust_final_state(), G4NavigationLogger::AlongComputeStepLog(), G4VEnergyLossProcess::AlongStepDoIt(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4PreCompoundEmission::AngularDistribution(), G4Nucleus::AnnihilationEvaporationEffects(), G4NeutronHPCapture::ApplyYourself(), 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(), G4SurfaceVoxelizer::BuildBitmasks(), G4SurfaceVoxelizer::BuildBoundaries(), G4SurfaceVoxelizer::BuildBoundingBox(), UVoxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndElement(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndMaterial(), G4PenelopeIonisationXSHandler::BuildDeltaTable(), G4SurfaceVoxelizer::BuildEmpty(), UVoxelizer::BuildEmpty(), G4VEnergyLossProcess::BuildLambdaTable(), G4VEmProcess::BuildLambdaTable(), G4hImpactIonisation::BuildPhysicsTable(), G4SurfaceVoxelizer::BuildReduceVoxels(), UVoxelizer::BuildReduceVoxels(), G4SurfaceVoxelizer::BuildReduceVoxels2(), UVoxelizer::BuildReduceVoxels2(), G4LossTableBuilder::BuildTableForModel(), G4SurfaceVoxelizer::BuildVoxelLimits(), UVoxelizer::BuildVoxelLimits(), G4ConvergenceTester::calc_slope_fit(), G4StatMFMicroCanonical::CalcEntropyOfCompoundNucleus(), G4StatMFMacroMultiNucleon::CalcMeanMultiplicity(), G4StatMFMicroPartition::CalcPartitionProbability(), G4StatMFMicroPartition::CalcPartitionTemperature(), G4StatMFMacroTemperature::CalcTemperature(), G4WeightWindowAlgorithm::Calculate(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4Tet::CalculateExtent(), G4UnionSolid::CalculateExtent(), G4IntersectionSolid::CalculateExtent(), G4RPGInelastic::CalculateMomenta(), G4PreCompoundTransitions::CalculateProbability(), G4EvaporationProbability::CalculateProbability(), G4ITStepProcessor::CalculateSafety(), G4SteppingManager::CalculateSafety(), G4StatMFMacroCanonical::CalculateTemperature(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), UTrd::CheckAndSetAllParameters(), G4Trd::CheckAndSetAllParameters(), G4MolecularDissociationTable::CheckDataConsistency(), G4DiffractiveSplitableHadron::ChooseStringEnds(), G4Nucleus::Cinema(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), XrayFluoMercuryDetectorConstruction::ComputeApparateParameters(), XrayFluoPlaneDetectorConstruction::ComputeApparateParameters(), XrayFluoDetectorConstruction::ComputeApparateParameters(), UGenericTrap::ComputeBBox(), PDBlib::ComputeBoundingVolumeParams(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4eeToTwoGammaModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4PenelopeAnnihilationModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4WentzelVIRelXSection::ComputeElectronCrossSection(), G4WentzelOKandVIxSection::ComputeElectronCrossSection(), G4UrbanMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), PDBlib::ComputeMatchEdepDNA(), G4SandiaTable::ComputeMatSandiaMatrix(), G4KokoulinMuonNuclearXS::ComputeMicroscopicCrossSection(), G4MuPairProductionModel::ComputeMicroscopicCrossSection(), PDBlib::ComputeNucleotideBarycenters(), G4eBremParametrizedModel::ComputeParametrizedDXSectionPerAtom(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4PathFinder::ComputeStep(), G4PropagatorInField::ComputeStep(), G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom(), G4WentzelVIRelXSection::ComputeTransportCrossSectionPerAtom(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4PairProductionRelModel::ComputeXSectionPerAtom(), exrdmDetectorConstruction::Construct(), G4MonopolePhysics::ConstructProcess(), G4BinaryCascade::CorrectFinalPandE(), G4VLongitudinalStringDecay::CreatePartonPair(), G4TwistedTubs::CreatePolyhedron(), UTessellatedSolid::CreateVertexList(), G4TessellatedSolid::CreateVertexList(), G4XPDGElastic::CrossSection(), G4PEEffectFluoModel::CrossSectionPerVolume(), G4PAIModelData::CrossSectionPerVolume(), MuCrossSections::CRP_Mephi(), G4PAIModelData::DEDXPerVolume(), G4BinaryLightIonReaction::DeExciteSpectatorNucleus(), G4hImpactIonisation::DeltaRaysEnergy(), G4INCL::DeuteronDensity::derivWavefunctionR(), G4MagneticFieldModel::DescribeYourselfTo(), G4PenelopeComptonModel::DifferentialCrossSection(), G4QGSMSplitableHadron::DiffractiveSplitUp(), G4DiffractiveSplitableHadron::Diquark(), G4QGSMFragmentation::DiQuarkSplitup(), G4LundStringFragmentation::DiQuarkSplitup(), UPolyconeSide::DistanceAway(), G4PolyconeSide::DistanceAway(), UTet::DistanceToIn(), G4CutTubs::DistanceToIn(), G4Tet::DistanceToIn(), UCons::DistanceToIn(), G4Para::DistanceToIn(), UTrap::DistanceToIn(), G4Trap::DistanceToIn(), UTet::DistanceToOut(), G4Tet::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4Para::DistanceToOut(), UTrap::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(), ExGflashEventAction::EndOfEventAction(), G4BinaryLightIonReaction::EnergyAndMomentumCorrector(), VUSolid::EstimateCubicVolume(), G4MultiLevelLocator::EstimateIntersectionPoint(), VUSolid::EstimateSurfaceArea(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), G4RDeIonisationParameters::Excitation(), UTrd::Extent(), UPolyPhiFace::Extent(), UMultiUnion::Extent(), UCons::Extent(), G4PolyPhiFace::Extent(), VUSolid::ExtentAxis(), G4VCrossSectionSource::FcrossX(), G4INCL::ElasticChannel::fillFinalState(), G4LevelReader::FillLevels(), G4ChordFinderSaf::FindNextChord(), G4JTPolynomialSolver::FindRoots(), G4StatMF::FindTemperatureOfBreakingChannel(), G4CompetitiveFission::FissionAtomicNumber(), G4CompetitiveFission::FissionKineticEnergy(), G4RPGFragmentation::FragmentationIntegral(), G4ArrowModel::G4ArrowModel(), G4ClassicalRK4::G4ClassicalRK4(), G4FissionParameters::G4FissionParameters(), G4ImplicitEuler::G4ImplicitEuler(), G4NeutronHPPartial::G4NeutronHPPartial(), G4NeutronHPVector::G4NeutronHPVector(), G4Orb::G4Orb(), G4PAIModelData::G4PAIModelData(), G4PAIPhotData::G4PAIPhotData(), G4ParticleHPPartial::G4ParticleHPPartial(), G4ParticleHPVector::G4ParticleHPVector(), G4PropagatorInField::G4PropagatorInField(), G4SimpleRunge::G4SimpleRunge(), G4Sphere::G4Sphere(), G4Tet::G4Tet(), G4INCL::PhaseSpaceRauboldLynch::generate(), G4eeToHadronsModel::GenerateCMPhoton(), GFlashSamplingShowerParameterisation::GenerateEnergyProfile(), G4Clebsch::GenerateIso3(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), GFlashSamplingShowerParameterisation::GenerateNSpotProfile(), G4HadronCrossSections::GetCaptureCrossSection(), G4BCLateParticle::GetCollisions(), G4VXTRenergyLoss::GetComptonPerAtom(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4NeutronHPFissionData::GetCrossSection(), G4ParticleHPFissionData::GetCrossSection(), G4NeutronHPCaptureData::GetCrossSection(), G4NeutronHPInelasticData::GetCrossSection(), G4NeutronHPElasticData::GetCrossSection(), G4ParticleHPCaptureData::GetCrossSection(), G4ParticleHPInelasticData::GetCrossSection(), G4ParticleHPElasticData::GetCrossSection(), G4HadronCrossSections::GetFissionCrossSection(), G4HETCChargedFragment::GetKineticEnergy(), G4HETCNeutron::GetKineticEnergy(), G4INCL::ParticleTable::getLargestNuclearRadius(), G4RDVeLowEnergyLoss::GetLossWithFluct(), G4CutTubs::GetMaxMinZ(), G4ClippablePolygon::GetMaxPoint(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4RPGInelastic::GetNormalizationConstant(), G4PreCompoundProton::GetOpt1(), G4ProtonEvaporationProbability::GetOpt1(), G4PreCompoundNeutron::GetOpt12(), G4PreCompoundTriton::GetOpt12(), G4PreCompoundAlpha::GetOpt12(), G4PreCompoundDeuteron::GetOpt12(), G4PreCompoundHe3::GetOpt12(), G4AlphaEvaporationProbability::GetOpt12(), G4He3EvaporationProbability::GetOpt12(), G4DeuteronEvaporationProbability::GetOpt12(), G4TritonEvaporationProbability::GetOpt12(), G4PreCompoundProton::GetOpt2(), G4PreCompoundProton::GetOpt3(), G4ProtonEvaporationProbability::GetOpt3(), G4PreCompoundNeutron::GetOpt34(), G4PreCompoundHe3::GetOpt34(), G4PreCompoundTriton::GetOpt34(), G4PreCompoundAlpha::GetOpt34(), G4PreCompoundDeuteron::GetOpt34(), G4AlphaEvaporationProbability::GetOpt34(), G4NeutronEvaporationProbability::GetOpt34(), G4He3EvaporationProbability::GetOpt34(), G4DeuteronEvaporationProbability::GetOpt34(), G4TritonEvaporationProbability::GetOpt34(), G4PairingCorrection::GetPairingCorrection(), G4VMscModel::GetParticleChangeForMSC(), G4TrajectoryDrawerUtils::GetPointsAndTimes(), G4NeutronHPFissionBaseFS::GetXsec(), G4NeutronHPIsoData::GetXsec(), G4ParticleHPFissionBaseFS::GetXsec(), G4ParticleHPIsoData::GetXsec(), G4NeutronHPChannelList::GetXsec(), G4ParticleHPChannelList::GetXsec(), G4NeutronHPInelasticBaseFS::GetXsec(), G4ParticleHPInelasticBaseFS::GetXsec(), G4NeutronHPInelasticCompFS::GetXsec(), G4ParticleHPInelasticCompFS::GetXsec(), G4NeutronHPChannel::GetXsec(), G4ParticleHPChannel::GetXsec(), G4NeutronHPElementData::Harmonise(), G4ParticleHPElementData::Harmonise(), G4NeutronHPChannel::Harmonise(), G4ParticleHPChannel::Harmonise(), G4VhElectronicStoppingPower::HeEffChargeSquare(), G4BraggIonModel::HeEffChargeSquare(), inflate_table(), G4ParticleHPContAngularPar::Init(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4WentzelVIModel::Initialise(), G4MuPairProductionModel::Initialise(), G4EmModelManager::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4VEmModel::InitialiseElementSelectors(), G4mplIonisation::InitialiseEnergyLossProcess(), G4hhIonisation::InitialiseEnergyLossProcess(), DetectorConstruction::InitialiseGeometryParameters(), G4CoulombScattering::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4INCL::NuclearPotential::NuclearPotentialIsospin::initialize(), G4PenelopeBremsstrahlungFS::InitializeEnergySampling(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4INCL::INCL::initMaxInteractionDistance(), G4INCL::INCL::initUniverseRadius(), USphere::Inside(), G4Sphere::Inside(), G4KineticTrack::IntegrandFunction1(), G4KineticTrack::IntegrandFunction2(), G4INCL::IFunction1D::integrate(), G4HETCFragment::IntegrateEmissionProbability(), G4INCL::CrossSections::interactionDistanceNN(), G4INCL::CrossSections::interactionDistancePiN(), G4eIonisationSpectrum::IntSpectrum(), G4RDeIonisationSpectrum::IntSpectrum(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4hIonEffChargeSquare::IonEffChargeSquare(), UExtrudedSolid::IsSameLineSegment(), UGenericTrap::IsSameLineSegment(), G4ExtrudedSolid::IsSameLineSegment(), G4HETCTriton::K(), G4HETCProton::K(), G4HETCHe3::K(), G4HETCAlpha::K(), G4HETCDeuteron::K(), G4HETCNeutron::K(), PDBlib::Load(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4GHEKinematicsVector::Lor(), G4eBremsstrahlungRelModel::MinPrimaryEnergy(), G4MuPairProductionModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4MuBremsstrahlungModel::MinPrimaryEnergy(), G4RPGReaction::NuclearReaction(), G4MagInt_Driver::OneGoodStep(), G4INCL::NuclearDensityFunctions::ModifiedHarmonicOscillatorRP::operator()(), DicomPhantomZSliceHeader::operator+(), operator<<(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), G4eIonisationParameters::Parameter(), G4RDeIonisationParameters::Parameter(), G4BremsstrahlungParameters::Parameter(), G4RDBremsstrahlungParameters::Parameter(), G4INCL::ParticleEntryChannel::particleEnters(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGetMajorantSurfaceAandCParameters(), G4Vee2hadrons::PhysicsVector(), G4RPGInelastic::Pmltpc(), G4RDGenerator2BS::PolarAngle(), G4LowEnergyGammaConversion::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4eBremsstrahlungSpectrum::Probability(), G4eIonisationSpectrum::Probability(), G4RDeIonisationSpectrum::Probability(), G4RDeBremsstrahlungSpectrum::Probability(), G4PreCompoundIon::ProbabilityDistributionFunction(), G4RPGStrangeProduction::ReactionStage(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4PiData::ReactionXSection(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4NavigationLogger::ReportOutsideMother(), CexmcPhysicsList< BasePhysics, StudiedPhysics, ProductionModel >::ResampleTrackLengthInTarget(), G4RPGReaction::Rotate(), G4VoxelSafety::SafetyForVoxelHeader(), UBox::SafetyFromInside(), UTet::SafetyFromOutside(), G4NeutronHPIsotropic::Sample(), G4ParticleHPIsotropic::Sample(), G4NeutronHPKallbachMannSyst::Sample(), G4ParticleHPKallbachMannSyst::Sample(), G4NeutronHPNBodyPhaseSpace::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4NeutronHPSimpleEvapSpectrum::Sample(), G4NeutronHPFissionSpectrum::Sample(), G4ParticleHPFissionSpectrum::Sample(), G4ParticleHPSimpleEvapSpectrum::Sample(), G4NeutronHPWattSpectrum::Sample(), G4ParticleHPWattSpectrum::Sample(), G4ParticleHPContAngularPar::Sample(), G4NeutronHPContAngularPar::Sample(), G4NeutronHPLegendreStore::Sample(), G4ParticleHPLegendreStore::Sample(), G4NeutronHPVector::Sample(), G4ParticleHPVector::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4NeutronHPLegendreStore::SampleDiscreteTwoBody(), G4ParticleHPLegendreStore::SampleDiscreteTwoBody(), G4NeutronHPLegendreStore::SampleElastic(), G4ParticleHPLegendreStore::SampleElastic(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4eBremsstrahlungSpectrum::SampleEnergy(), G4RDeBremsstrahlungSpectrum::SampleEnergy(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeIonisationModel::SampleFinalStatePositron(), G4UniversalFluctuation::SampleFluctuations(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4SampleResonance::SampleMass(), G4NeutronHPLegendreStore::SampleMax(), G4ParticleHPLegendreStore::SampleMax(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4LEPTSIonisationModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4WentzelVIRelXSection::SampleSingleScattering(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4NeutronHPInelasticCompFS::SelectExitChannel(), G4ParticleHPInelasticCompFS::SelectExitChannel(), G4Torus::SetAllParameters(), G4RadioactiveDecay::SetDecayHalfAngle(), G4GeomTestVolume::SetErrorsThreshold(), USphere::SetInsideRadius(), G4GHEKinematicsVector::SetMassAndUpdate(), G4SurfaceVoxelizer::SetMaxVoxels(), UVoxelizer::SetMaxVoxels(), G4GHEKinematicsVector::SetMomentumAndUpdate(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), USphere::SetOuterRadius(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G3Division::SetRangeAndAxis(), G4WentzelOKandVIxSection::SetupKinematic(), G4LatticeReader::SkipComments(), G4TrajectoryDrawerUtils::SliceLine(), G4RPGNeutronInelastic::SlowNeutron(), G4MesonSplitter::SplitMeson(), G4SteppingManager::Stepping(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub(), G4Torus::SurfaceNormal(), G4PiData::TotalXSection(), tpia_particle_getInternalID(), G4DiffractiveExcitation::UnpackMeson(), UOrb::UOrb(), G4ContinuumGammaTransition::Update(), G4EmConfigurator::UpdateModelEnergyRange(), USphere::USphere(), UTet::UTet(), 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 G4NeutronHPKallbachMannSyst::A(), 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(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGAntiNeutronInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGAntiXiZeroInelastic::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4eIonisationSpectrum::AverageEnergy(), G4RDeIonisationSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageValue(), G4RDeBremsstrahlungSpectrum::AverageValue(), G4HadronBuilder::Barion(), G4SurfaceVoxelizer::BuildBitmasks(), G4SurfaceVoxelizer::BuildBoundingBox(), UVoxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndElement(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndMaterial(), G4VEmProcess::BuildLambdaTable(), G4LowEnergyBremsstrahlung::BuildLossTable(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4tgbVolume::BuildSolidForDivision(), G4SurfaceVoxelizer::BuildVoxelLimits(), UVoxelizer::BuildVoxelLimits(), G4ConvergenceTester::calc_slope_fit(), G4USolid::CalculateExtent(), G4Box::CalculateExtent(), G4Tet::CalculateExtent(), 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(), G4RPGKPlusInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4Fancy3DNucleus::ChoosePositions(), G4Nucleus::Cinema(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForSecond(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForSecond(), PDBlib::ComputeBoundingVolumeParams(), G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4eBremParametrizedModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4MuBremsstrahlungModel::ComputeCrossSectionPerAtom(), G4IonParametrisedLossModel::ComputeCrossSectionPerAtom(), G4PolarizedMollerBhabhaModel::ComputeCrossSectionPerElectron(), G4MollerBhabhaModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4BraggIonModel::ComputeCrossSectionPerElectron(), G4BraggModel::ComputeCrossSectionPerElectron(), G4ICRU73QOModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4BetheBlochModel::ComputeCrossSectionPerElectron(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4PAIPhotModel::ComputeDEDXPerVolume(), G4eBremParametrizedModel::ComputeDEDXPerVolume(), G4PAIModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4MuBremsstrahlungModel::ComputeDEDXPerVolume(), G4BraggIonModel::ComputeDEDXPerVolume(), G4MuBetheBlochModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4UrbanMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4WentzelVIRelXSection::ComputeMaxElectronScattering(), G4WentzelOKandVIxSection::ComputeMaxElectronScattering(), G4ErrorPropagationNavigator::ComputeSafety(), G4VoxelSafety::ComputeSafety(), G4ErrorPropagationNavigator::ComputeStep(), G4PathFinder::ComputeStep(), G4PropagatorInField::ComputeStep(), G4Navigator::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator2::ComputeStep(), G4ITPathFinder::ComputeStep(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIRelModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTrueStepLength(), G4ParameterisedNavigation::ComputeVoxelSafety(), G4VoxelNavigation::ComputeVoxelSafety(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), G4VLongitudinalStringDecay::CreatePartonPair(), G4LivermoreIonisationCrossSection::CrossSection(), G4PenelopeIonisationCrossSection::CrossSection(), G4PAIPhotModel::CrossSectionPerVolume(), G4PAIModel::CrossSectionPerVolume(), G4PAIPhotonModel::CrossSectionPerVolume(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4DiffractiveSplitableHadron::Diquark(), G4QGSMFragmentation::DiQuarkSplitup(), G4LundStringFragmentation::DiQuarkSplitup(), G4Ellipsoid::DistanceToIn(), G4UnionSolid::DistanceToIn(), G4IntersectionSolid::DistanceToIn(), UTet::DistanceToOut(), 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(), VUSolid::EstimateCubicVolume(), VUSolid::EstimateSurfaceArea(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), G4RDeIonisationParameters::Excitation(), UMultiUnion::Extent(), VUSolid::ExtentAxis(), G4RPGInelastic::Factorial(), G4MesonAbsorption::FindAndFillCluster(), G4ChordFinderSaf::FindNextChord(), G4ChordFinder::FindNextChord(), G4JTPolynomialSolver::FindRoots(), G3CalcParamsFn(), G4ArrowModel::G4ArrowModel(), G4ElasticData::G4ElasticData(), G4Tet::G4Tet(), G4eeToHadronsModel::GenerateCMPhoton(), G4Clebsch::GenerateIso3(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), GFlashHomoShowerParameterisation::GenerateRadius(), GFlashSamplingShowerParameterisation::GenerateRadius(), G4AntiNeutronAnnihilationAtRest::GenerateSecondaries(), G4NeutronHPVector::Get15percentBorder(), G4ParticleHPVector::Get15percentBorder(), G4INCL::ClusteringModelIntercomparison::getCluster(), G4hImpactIonisation::GetConstraints(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PenelopeIonisationCrossSection::GetCrossSection(), G4LivermoreIonisationCrossSection::GetCrossSection(), G4VEnergyLossProcess::GetDEDXDispersion(), G4OpBoundaryProcess::GetFacetNormal(), G4CutTubs::GetMaxMinZ(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4ClippablePolygon::GetMinPoint(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4RPGInelastic::GetNormalizationConstant(), G4PreCompoundAlpha::GetOpt12(), G4PreCompoundProton::GetOpt3(), G4ProtonEvaporationProbability::GetOpt3(), G4VMscModel::GetParticleChangeForMSC(), G4AdjointComptonModel::GetSecondAdjEnergyMaxForScatProjToProjCase(), G4VEmAdjointModel::GetSecondAdjEnergyMaxForScatProjToProjCase(), G4PAIPhotonModel::GetXscPerVolume(), G4NeutronHPVector::GetXsec(), G4ParticleHPVector::GetXsec(), G4ParticleHPPartial::GetY(), G4NeutronHPPartial::GetY(), inflate_table(), G4ClippablePolygon::InFrontOf(), G4NeutronHPDeExGammas::Init(), G4ParticleHPDeExGammas::Init(), G4ParticleHPContAngularPar::Init(), G4eeToHadronsModel::Initialise(), G4WentzelVIModel::Initialise(), G4EmModelManager::Initialise(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4CoulombScattering::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4hImpactIonisation::InitializeParametrisation(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4INCL::INCL::initUniverseRadius(), G4INCL::IFunction1D::integrate(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4INCL::IFunction1D::inverseCDFTable(), UExtrudedSolid::IsSameLineSegment(), UGenericTrap::IsSameLineSegment(), G4ExtrudedSolid::IsSameLineSegment(), G4LightMedia::KaonPlusExchange(), G4LightMedia::KaonZeroShortExchange(), G4LightMedia::LambdaExchange(), PDBlib::Load(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4EmCorrections::LShellCorrection(), G4BetheBlochModel::MaxSecondaryEnergy(), G4LightMedia::NeutronExchange(), G4RPGReaction::NuclearReaction(), G4LightMedia::OmegaMinusExchange(), 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(), UUtils::Random(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4PathFinder::RecheckDistanceToCurrentBoundary(), G4Navigator::RecheckDistanceToCurrentBoundary(), G4ITNavigator2::RecheckDistanceToCurrentBoundary(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), UTet::SafetyFromInside(), USphere::SafetyFromInside(), G4ParticleHPContAngularPar::Sample(), G4NeutronHPContAngularPar::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4PAIModelData::SampleAlongStepTransfer(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4eBremsstrahlungSpectrum::SampleEnergy(), G4RDeBremsstrahlungSpectrum::SampleEnergy(), G4SampleResonance::SampleMass(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4UrbanMscModel::SampleScattering(), G4LEPTSDissociationModel::SampleSecondaries(), G4LEPTSExcitationModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4eBremParametrizedModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4PAIPhotonModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4RadioactiveDecay::SetDecayHalfAngle(), G4EmConfigurator::SetExtraEmModel(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), G3Division::SetRangeAndAxis(), G4OpenInventorXtExaminerViewer::setStartingPtForAnimation(), G4VEnergyLossProcess::SetStepFunction(), G4ScreeningMottCrossSection::SetupKinematic(), G4WentzelOKandVIxSection::SetupTarget(), G4WentzelVIRelXSection::SetupTarget(), G4EmParameters::SetVerbose(), G4EmCorrections::ShellCorrection(), G4LightMedia::SigmaMinusExchange(), G4LightMedia::SigmaPlusExchange(), G4RPGNeutronInelastic::SlowNeutron(), G4VMultipleScattering::StorePhysicsTable(), G4Scheduler::SynchronizeTracks(), G4PAIPhotonModel::TestSecondaries(), tpia_particle_getInternalID(), G4EmConfigurator::UpdateModelEnergyRange(), CCalSteppingAction::UserSteppingAction(), UTet::UTet(), 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(), 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

Definition at line 68 of file G4INCLGlobals.hh.

Referenced by G4AdjointCrossSurfChecker::AddaSphericalSurface(), G4ExtrudedSolid::AddGeneralPolygonFacets(), G4HepRepFileSceneHandler::AddSolid(), G4GMocrenFileSceneHandler::AddSolid(), G4NuclNuclDiffuseElastic::AmplitudeFar(), G4NuclNuclDiffuseElastic::AmplitudeGG(), G4NuclNuclDiffuseElastic::AmplitudeGla(), G4NuclNuclDiffuseElastic::AmplitudeNear(), G4ScreeningMottCrossSection::AngleDistribution(), G4VXTRenergyLoss::AngleXTRdEdx(), G4FTFAnnihilation::Annihilate(), G4NeutronHPFissionFS::ApplyYourself(), G4ParticleHPFissionFS::ApplyYourself(), G4NeutronHPCaptureFS::ApplyYourself(), G4ParticleHPCaptureFS::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), G4LEHadronProtonElastic::ApplyYourself(), G4QMDReaction::ApplyYourself(), G4LEnp::ApplyYourself(), G4EMDissociation::ApplyYourself(), arcCos(), arcSin(), G4MuonRadiativeDecayChannelWithSpin::atan4(), Histo::BeginOfHisto(), G4NuclNuclDiffuseElastic::BuildAngleTable(), G4DiffuseElastic::BuildAngleTable(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4Molecule::BuildTrack(), G4NeutronHPNBodyPhaseSpace::C(), G4ParticleHPNBodyPhaseSpace::C(), G4PairProductionRelModel::CalcLPMFunctions(), G4eBremsstrahlungRelModel::CalcLPMFunctions(), G4StatMFMacroMultiplicity::CalcMeanA(), G4StatMFMicroPartition::CalcPartitionProbability(), G4GEMProbability::CalcProbability(), G4hhElastic::CalculateBqQ12(), G4hhElastic::CalculateBqQ123(), G4hhElastic::CalculateBqQ13(), G4ecpssrBaseKxsModel::CalculateCrossSection(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4TwistedTubs::CalculateExtent(), G4ecpssrBaseLixsModel::CalculateL1CrossSection(), G4ecpssrBaseLixsModel::CalculateL2CrossSection(), G4ecpssrBaseLixsModel::CalculateL3CrossSection(), G4PreCompoundTransitions::CalculateProbability(), G4OpRayleigh::CalculateRayleighMeanFreePaths(), G4RKFieldIntegrator::CalculateTotalEnergy(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), CCalPrimaryGeneratorMessenger::CCalPrimaryGeneratorMessenger(), G4RadioactiveDecay::ChooseCollimationDirection(), G4NucleiModel::choosePointAlongTraj(), G4eeToHadronsModel::ComputeCMCrossSectionPerElectron(), G4AnnihiToMuPair::ComputeCrossSectionPerAtom(), G4KokoulinMuonNuclearXS::ComputeDDMicroscopicCrossSection(), G4IonisParamMat::ComputeDensityEffect(), XCrystalPlanarNucleiDensity::ComputeECForSinglePlane(), XCrystalPlanarMoliereElectricField::ComputeECForSinglePlane(), XCrystalPlanarMolierePotential::ComputeECForSinglePlane(), XCrystalPlanarMoliereTempPotential::ComputeECForSinglePlane(), XLogicalAtomicLattice::ComputeGeometricalStructureFactorSingleKind(), G4GenericTrap::ComputeIsTwisted(), ExExChProcessChanneling::ComputeOscillationPeriod(), XUnitCell::ComputeReciprocalVectorSquared(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4TablesForExtrapolator::ComputeTrasportXS(), G4PSDoseDepositForCylinder3D::ComputeVolume(), G4PSPassageCellFluxForCylinder3D::ComputeVolume(), G4PSCellFluxForCylinder3D::ComputeVolume(), GeometryConstruction::Construct(), XrayFluoMercuryDetectorConstruction::ConstructApparate(), XrayFluoPlaneDetectorConstruction::ConstructApparate(), XrayFluoDetectorConstruction::ConstructApparate(), G02DetectorConstruction::ConstructAssembly(), UltraDetectorConstruction::ConstructGround(), DetectorConstruction::ConstructLine(), G4RDGenerator2BN::ConstructMajorantSurface(), G4Generator2BN::ConstructMajorantSurface(), UltraDetectorConstruction::ConstructMirror(), UltraDetectorConstruction::ConstructUVscope(), ExExChDetectorConstruction::ConstructXtalTarget(), G4VParameterisationPolyhedra::ConvertRadiusFactor(), CLHEP::correctByPi(), G4AngularDistributionNP::CosTheta(), G4AngularDistributionPP::CosTheta(), G4INCL::CoulombNonRelativistic::coulombDeviation(), G4Orb::CreatePolyhedron(), G4USolid::CreatePolyhedron(), G4Ellipsoid::CreateRotatedVertices(), G4Paraboloid::CreateRotatedVertices(), G4DiffractiveExcitation::CreateStrings(), G4VTwistedFaceted::CreateSurfaces(), G4XAnnihilationChannel::CrossSection(), G4eeCrossSections::CrossSection2Kcharged(), G4eeCrossSections::CrossSection2Kneutral(), G4eeCrossSections::CrossSection2pi(), G4eeCrossSections::CrossSection3pi(), G4eeCrossSections::CrossSectionEtaG(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNADingfelderChargeIncreaseModel::CrossSectionPerVolume(), G4PenelopeComptonModel::CrossSectionPerVolume(), G4eeCrossSections::CrossSectionPi0G(), G4AblaInterface::DeExcite(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceUniform(), G4OpBoundaryProcess::DielectricDichroic(), G4OpBoundaryProcess::DielectricDielectric(), G4OpBoundaryProcess::DielectricLUT(), G4DNARuddIonisationModel::DifferentialCrossSection(), G4InitXscPAI::DifPAIxSection(), G4PAIxSection::DifPAIxSection(), G4PAIySection::DifPAIySection(), G4Abla::direct(), G4Sphere::DistanceToIn(), G4CutTubs::DistanceToOut(), G4OTubs::DistanceToOut(), G4Tubs::DistanceToOut(), G4Cons::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4HelixExplicitEuler::DistChord(), G4ExactHelixStepper::DistChord(), G4HelixMixedStepper::DistChord(), G4MagHelicalStepper::DistChord(), DMXParticleSource::DMXParticleSource(), G4QMDMeanField::DoClusterJudgment(), G4SingleScatter::DoCollisionStep(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), G4PhotoElectricAngularGeneratorPolarized::DSigmaKshellGavrila1959(), G4RDPhotoElectricAngularGeneratorPolarized::DSigmaKshellGavrila1959(), G4PhotoElectricAngularGeneratorPolarized::DSigmaL1shellGavrila(), G4RDPhotoElectricAngularGeneratorPolarized::DSigmaL1shellGavrila(), G4Abla::eflmac(), G4FissionProbability::EmissionProbability(), G4E1SingleProbability1::EmissionProbDensity(), Histo::EndOfHisto(), Em10RunAction::EndOfRunAction(), LaserDrivenBeamLine::FaradayCup(), G4LivermorePolarizedGammaConversionModel::Fdlor(), G4BetaDecayCorrections::FermiFunction(), G4tgbVolume::FindOrConstructG4Solid(), G4LivermorePolarizedGammaConversionModel::Fintlor(), G4LivermorePolarizedGammaConversionModel::Finvlor(), G4LivermorePolarizedGammaConversionModel::Flor(), G4StatMFMacroTemperature::FragsExcitEnergy(), G4ChebyshevApproximation::G4ChebyshevApproximation(), G4DNAMolecularReactionData::G4DNAMolecularReactionData(), G4E1Probability::G4E1Probability(), G4EmParameters::G4EmParameters(), G4FermiBreakUp::G4FermiBreakUp(), G4FTFParameters::G4FTFParameters(), G4GaussChebyshevQ::G4GaussChebyshevQ(), G4GaussHermiteQ::G4GaussHermiteQ(), G4GaussLegendreQ::G4GaussLegendreQ(), G4GeneralParticleSourceMessenger::G4GeneralParticleSourceMessenger(), G4FissionProductYieldDist::G4GetFission(), G4gsrotm(), G4HelixMixedStepper::G4HelixMixedStepper(), G4HETCFragment::G4HETCFragment(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), G4mplIonisationModel::G4mplIonisationModel(), G4mplIonisationWithDeltaModel::G4mplIonisationWithDeltaModel(), G4NuclearFermiDensity::G4NuclearFermiDensity(), G4NuclearShellModelDensity::G4NuclearShellModelDensity(), G4PenelopeAnnihilationModel::G4PenelopeAnnihilationModel(), G4Poisson(), G4PolarizedComptonCrossSection::G4PolarizedComptonCrossSection(), G4PreCompoundIon::G4PreCompoundIon(), G4QMDMeanField::G4QMDMeanField(), G4QMDParameters::G4QMDParameters(), G4SPSAngDistribution::G4SPSAngDistribution(), G4UniformElectricField::G4UniformElectricField(), G4UniformMagField::G4UniformMagField(), G4UrbanMscModel::G4UrbanMscModel(), G4VParameterisationPara::G4VParameterisationPara(), G4VTwistedFaceted::G4VTwistedFaceted(), G4VXTRenergyLoss::G4VXTRenergyLoss(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4WentzelVIRelXSection::G4WentzelVIRelXSection(), G4NeutronHPMadlandNixSpectrum::Gamma05(), G4ParticleHPMadlandNixSpectrum::Gamma05(), G4NuclNuclDiffuseElastic::GammaLess(), G4NuclNuclDiffuseElastic::GammaMore(), CexmcReimplementedGenbod::Generate(), G4eeToHadronsModel::GenerateCMPhoton(), G4SPSPosDistribution::GeneratePointsOnSurface(), ExUCNPrimaryGeneratorAction::GeneratePrimaries(), PrimaryGeneratorAction1::GeneratePrimaries(), F06PrimaryGeneratorAction::GeneratePrimaries(), XrayFluoMercuryPrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPlanePrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4WilsonAbrasionModel::GetAbradedNucleons(), G4ExtrudedSolid::GetAngle(), G4VXTRenergyLoss::GetAngleVector(), G4hhElastic::GetAqq(), G4hhElastic::GetAQQ(), G4INCL::PauliStandard::getBlockingProbability(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), G4NeutronInelasticCrossSection::GetCrossSection(), G4NuclNuclDiffuseElastic::GetDiffElasticProb(), G4DiffuseElastic::GetDiffElasticProb(), G4NuclNuclDiffuseElastic::GetDiffElasticSumProb(), G4DiffuseElastic::GetDiffElasticSumProb(), G4NuclNuclDiffuseElastic::GetDiffElasticSumProbA(), G4DiffuseElastic::GetDiffElasticSumProbA(), G4hhElastic::GetdsdtF1(), G4hhElastic::GetdsdtF12(), G4hhElastic::GetdsdtF123(), G4hhElastic::GetdsdtF123qQgG(), G4hhElastic::GetdsdtF12qQgG(), G4hhElastic::GetdsdtF13qQG(), G4hhElastic::GetdsdtF1qQgG(), G4TripathiCrossSection::GetElementCrossSection(), G4IonsKoxCrossSection::GetElementCrossSection(), G4IonsSihverCrossSection::GetElementCrossSection(), G4TripathiLightCrossSection::GetElementCrossSection(), G4SynchrotronRadiationInMat::GetEnergyProbSR(), G4NuclNuclDiffuseElastic::GetErfComp(), G4NuclNuclDiffuseElastic::GetErfInt(), G4NuclNuclDiffuseElastic::GetErfSer(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfProjectile(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfTarget(), G4hhElastic::GetExpRatioF123(), G4hhElastic::GetF1(), G4hhElastic::GetF1qQgG(), G4hhElastic::GetF2(), G4hhElastic::GetF2qQgG(), G4hhElastic::GetF3(), G4hhElastic::GetF3qQgG(), G4Nucleus::GetFermiMomentum(), G4SigmaPlusField::GetField(), G4KaonZeroField::GetField(), G4SigmaMinusField::GetField(), G4SigmaZeroField::GetField(), G4AntiProtonField::GetField(), G4KaonPlusField::GetField(), G4PionZeroField::GetField(), G4PionPlusField::GetField(), G4KaonMinusField::GetField(), G4PionMinusField::GetField(), G4MesonAbsorption::GetFinalState(), G4EMDissociationSpectrum::GetGeneralE1Spectrum(), G4EMDissociationSpectrum::GetGeneralE2Spectrum(), G4OpBoundaryProcess::GetIncidentAngle(), G4ComponentAntiNuclNuclearXS::GetInelasticElementCrossSection(), G4SynchrotronRadiationInMat::GetIntProbSR(), G4NuclNuclDiffuseElastic::GetInvCoulombElasticXsc(), G4DiffuseElastic::GetInvCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetInvElasticSumXsc(), G4DiffuseElastic::GetInvElasticSumXsc(), G4NuclNuclDiffuseElastic::GetInvElasticXsc(), G4DiffuseElastic::GetInvElasticXsc(), G4IonsShenCrossSection::GetIsoCrossSection(), G4GlauberGribovCrossSection::GetIsoCrossSection(), G4ComponentGGHadronNucleusXsc::GetIsoCrossSection(), G4NuclNuclDiffuseElastic::GetLegendrePol(), G4ElasticHadrNucleusHE::GetLightFq2(), G4CutTubs::GetMaxMinZ(), G4RPGInelastic::GetNormalizationConstant(), G4PreCompoundNucleon::GetOpt0(), G4PreCompoundIon::GetOpt0(), G4PreCompoundProton::GetOpt2(), G4ProtonEvaporationProbability::GetOpt2(), G4ParticleHPPhotonDist::GetPhotons(), G4NeutronHPPhotonDist::GetPhotons(), G4EllipticalTube::GetPointOnSurface(), G4Orb::GetPointOnSurface(), G4Polycone::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4Paraboloid::GetPointOnSurface(), G4Hype::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4Torus::GetPointOnSurface(), G4Sphere::GetPointOnSurface(), G4ProtonInelasticCrossSection::GetProtonCrossSection(), G4Absorber::GetRandomDirection(), G4PolarizationHelper::GetRandomFrame(), G4NuclNuclDiffuseElastic::GetRatioGen(), G4GlauberGribovCrossSection::GetRatioQE(), G4GGNuclNuclCrossSection::GetRatioQE(), G4ComponentGGHadronNucleusXsc::GetRatioQE(), G4ComponentGGNuclNuclXsc::GetRatioQE(), G4GlauberGribovCrossSection::GetRatioSD(), G4GGNuclNuclCrossSection::GetRatioSD(), G4ComponentGGHadronNucleusXsc::GetRatioSD(), G4ComponentGGNuclNuclXsc::GetRatioSD(), G4NuclNuclDiffuseElastic::GetRatioSim(), G4tgrUtils::GetRotationFromDirection(), G4ScreeningMottCrossSection::GetScreeningAngle(), G4Sphere::GetSurfaceArea(), G4MesonAbsorption::GetTimeToAbsorption(), G4Scatterer::GetTimeToInteraction(), G4ComponentAntiNuclNuclearXS::GetTotalElementCrossSection(), G4GGNuclNuclCrossSection::GetZandACrossSection(), G4ComponentGGNuclNuclXsc::GetZandACrossSection(), G4LivermorePolarizedGammaConversionModel::Glor(), G4ElasticHadrNucleusHE::HadrNucDifferCrSec(), G4mplIonisationModel::Initialise(), G4mplIonisationWithDeltaModel::Initialise(), G4WentzelVIModel::Initialise(), G4hCoulombScatteringModel::Initialise(), G4WentzelVIRelModel::Initialise(), G4eeCrossSections::Initialise(), G4eCoulombScatteringModel::Initialise(), G4CoulombScattering::InitialiseProcess(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4Sphere::Inside(), G4ExtrudedSolid::IsConvex(), XUnitCell::IsOrthogonal(), G4UCNBoundaryProcess::LDiffRefl(), G4BremsstrahlungParameters::LoadData(), G4NativeScreenedCoulombCrossSection::LoadData(), G4LatticeLogical::MapKtoV(), XLogicalLattice::MapKtoV(), G4LatticeLogical::MapKtoVDir(), XLogicalLattice::MapKtoVDir(), G4ScreeningMottCrossSection::McFcorrection(), G4BetaDecayCorrections::ModSquared(), G4EmCorrections::MottCorrection(), G4UCNBoundaryProcess::MRDiffRefl(), G4UCNBoundaryProcess::MRDiffTrans(), G4InitXscPAI::Normalisation(), G4PAIySection::NormShift(), G4PAIxSection::NormShift(), G4ScreeningMottCrossSection::NuclearCrossSection(), G4PAIySection::PAIdNdxCerenkov(), G4PAIxSection::PAIdNdxCerenkov(), G4InitXscPAI::PAIdNdxCherenkov(), G4PAIxSection::PAIdNdxMM(), G4InitXscPAI::PAIdNdxPlasmon(), G4PAIySection::PAIdNdxPlasmon(), G4PAIxSection::PAIdNdxPlasmon(), G4PAIxSection::PAIdNdxResonance(), G4NuclNuclDiffuseElastic::PhaseFar(), G4NuclNuclDiffuseElastic::PhaseNear(), G4VAngularDistribution::Phi(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGeneratePhiAndTheta(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronGeneratePhiAndTheta(), DetectorConstruction::PlaceWithEulerAngles(), DetectorConstruction::PlaceWithReflections(), G4RDGenerator2BS::PolarAngle(), G4RDModifiedTsai::PolarAngle(), G4DipBustGenerator::PolarAngle(), G4hhElastic::Pomeron(), G4OpMieHG::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4ScreenedNuclearRecoil::PostStepDoIt(), G4EvaporationProbability::ProbabilityDistributionFunction(), G4NuclNuclDiffuseElastic::Profile(), G4NuclNuclDiffuseElastic::ProfileFar(), G4NuclNuclDiffuseElastic::ProfileNear(), G4MuonDecayChannelWithSpin::R_c(), G4DNAWaterDissociationDisplacer::radialDistributionOfElectron(), G4DNAWaterDissociationDisplacer::radialDistributionOfProducts(), G4DNAOneStepSolvatationModel::RadialDistributionOfProducts(), G4MuElecElasticModel::RandomizeCosTheta(), G4MicroElecElasticModel::RandomizeCosTheta(), G4DNAChampionElasticModel::RandomizeCosTheta(), G4InitXscPAI::RePartDielectricConst(), G4PAIySection::RePartDielectricConst(), G4PAIxSection::RePartDielectricConst(), DetectorConstruction::ResiduesView(), G4RPGReaction::Rotate(), G4DNAScreenedRutherfordElasticModel::RutherfordCrossSection(), CLHEP::safe_acos(), G4QGSMFragmentation::Sample4Momentum(), G4LundStringFragmentation::Sample4Momentum(), G4Generator2BN::SampleDirection(), G4AntiNuclElastic::SampleInvariantT(), G4LEpp::SampleInvariantT(), G4LEnp::SampleInvariantT(), G4GEMChannel::SampleKineticEnergy(), G4VLongitudinalStringDecay::SampleQuarkPt(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4NuclNuclDiffuseElastic::SampleThetaCMS(), G4DiffuseElastic::SampleThetaCMS(), G4QMDGroundStateNucleus::samplingMomentum(), G4UCNMultiScattering::Scatter(), G4DAWNFILEViewer::SendViewParameters(), G4SPSAngDistribution::SetAngDistType(), G4KM_OpticalEqRhs::SetFactor(), CCalPrimaryGeneratorAction::SetMaximumPhi(), CCalPrimaryGeneratorAction::SetMinimumPhi(), G4EmParameters::SetMscThetaLimit(), G4LivermorePolarizedComptonModel::SetNewPolarization(), G4LowEnergyPolarizedCompton::SetNewPolarization(), G4VisCommandSceneAddLogo::SetNewValue(), G4LivermorePolarizedGammaConversionModel::SetPhi(), RMC01AnalysisManager::SetPrimaryExpSpectrumForAdjointSim(), RMC01AnalysisManager::SetPrimaryPowerLawSpectrumForAdjointSim(), G4LivermorePolarizedGammaConversionModel::SetPsi(), G4AdjointPrimaryGenerator::SetSphericalAdjointPrimarySource(), G4PomeronCrossSection::SigP(), G4RPGNeutronInelastic::SlowNeutron(), G4QGSMSplitableHadron::SoftSplitUp(), G4Torus::SolveNumericJT(), G4XTRRegularRadModel::SpectralXTRdEdx(), G4RegularXTRadiator::SpectralXTRdEdx(), G4XTRTransparentRegRadModel::SpectralXTRdEdx(), G4TransparentRegXTRadiator::SpectralXTRdEdx(), Em10XTRTransparentRegRadModel::SpectralXTRdEdx(), G4EllipticalCone::SurfaceNormal(), G4Sphere::SurfaceNormal(), RunAction::SurveyConvergence(), G4PolarizationHelper::TestPolarizationTransformations(), toDegrees(), G4PolarizedAnnihilationCrossSection::TotalXSection(), G4PolarizedComptonCrossSection::TotalXSection(), G4NeutronHPInelasticCompFS::two_body_reaction(), G4ParticleHPInelasticCompFS::two_body_reaction(), G4AblaFission::umass(), Em10SteppingAction::UserSteppingAction(), and XUnitCell::XUnitCell().

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().