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)
template<typename T>
G4int sign (T t)

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 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::toDegrees ( G4double  radians  )  [inline]

Definition at line 78 of file G4INCLGlobals.hh.

References pi.

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

00078                                                 {
00079       return radians * (180.0 / pi);
00080     }

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

Definition at line 82 of file G4INCLGlobals.hh.

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

00082                                     {
00083       if(n < 0) return 0;
00084       else return 1;
00085     }

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

Definition at line 87 of file G4INCLGlobals.hh.

References oneThird.

Referenced by G4INCL::NuclearDensityFactory::createRPCorrelationTable(), G4INCL::NuclearPotential::INuclearPotential::INuclearPotential(), and G4INCL::Random::sphereVector().

00087                                       {
00088       return std::pow(x, oneThird);
00089     }

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

Definition at line 91 of file G4INCLGlobals.hh.

References oneThird.

00091                                            {
00092       return std::pow(x, -oneThird);
00093     }

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

Definition at line 95 of file G4INCLGlobals.hh.

References twoThirds.

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

00095                                       {
00096       return std::pow(x, twoThirds);
00097     }

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

A simple sign function that allows us to port fortran code to c++ more easily.

Definition at line 102 of file G4INCLGlobals.hh.

Referenced by G4INCL::ElasticChannel::getFinalState(), G4INCL::DeltaProductionChannel::getFinalState(), G4INCL::IFunction1D::integrate(), G4DNASancheSolvatationModel::RadialDistributionOfProducts(), G4INCL::RootFinder::solve(), and G4Clebsch::Wigner3J().

00102                                                  {
00103       return t > 0 ? 1: t < 0 ? -1 : 0;
00104     }


Variable Documentation

const G4double G4INCL::Math::pi = 3.14159265358979323846264338328

Definition at line 68 of file G4INCLGlobals.hh.

Referenced by G4QNucleus::ActivateBThickness(), G4AdjointCrossSurfChecker::AddaSphericalSurface(), G4HepRepFileSceneHandler::AddSolid(), G4GMocrenFileSceneHandler::AddSolid(), G4NuclNuclDiffuseElastic::AmplitudeFar(), G4NuclNuclDiffuseElastic::AmplitudeGG(), G4NuclNuclDiffuseElastic::AmplitudeGla(), G4NuclNuclDiffuseElastic::AmplitudeNear(), G4ScreeningMottCrossSection::AngleDistribution(), G4VXTRenergyLoss::AngleXTRdEdx(), G4FTFAnnihilation::Annihilate(), G4QMDReaction::ApplyYourself(), G4NeutronHPFissionFS::ApplyYourself(), G4NeutronHPCaptureFS::ApplyYourself(), G4LowEIonFragmentation::ApplyYourself(), G4LEpp::ApplyYourself(), G4LEnp::ApplyYourself(), G4EMDissociation::ApplyYourself(), G4SphericalSurface::Area(), G4FCylindricalSurface::Area(), G4FConicalSurface::Area(), G4AblaEvaporation::BreakItUp(), G4NuclNuclDiffuseElastic::BuildAngleTable(), G4ErrorSurfaceTrajState::BuildErrorMatrix(), G4Molecule::BuildTrack(), G4PairProductionRelModel::CalcLPMFunctions(), G4StatMFMicroPartition::CalcPartitionProbability(), G4ecpssrBaseKxsModel::CalculateCrossSection(), G4Generator2BN::Calculatedsdkdt(), G4TwistedTubs::CalculateExtent(), G4ecpssrBaseLixsModel::CalculateL1CrossSection(), G4ecpssrBaseLixsModel::CalculateL2CrossSection(), G4ecpssrBaseLixsModel::CalculateL3CrossSection(), G4PreCompoundTransitions::CalculateProbability(), G4Paraboloid::CalculateSurfaceArea(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4Integrator< T, F >::Chebyshev(), G4RadioactiveDecay::ChooseCollimationDirection(), G4AnnihiToMuPair::ComputeCrossSectionPerAtom(), G4KokoulinMuonNuclearXS::ComputeDDMicroscopicCrossSection(), G4PSPassageCellFluxForCylinder3D::ComputeVolume(), G4PSDoseDepositForCylinder3D::ComputeVolume(), G4PSCellFluxForCylinder3D::ComputeVolume(), G4Generator2BN::ConstructMajorantSurface(), G4EmStandardPhysics_option4::ConstructProcess(), G4EmStandardPhysics_option3::ConstructProcess(), G4EmStandardPhysics_option2::ConstructProcess(), G4EmStandardPhysics_option1::ConstructProcess(), G4EmStandardPhysics::ConstructProcess(), G4EmPenelopePhysics::ConstructProcess(), G4EmLowEPPhysics::ConstructProcess(), G4EmLivermorePolarizedPhysics::ConstructProcess(), G4EmLivermorePhysics::ConstructProcess(), G4AngularDistributionPP::CosTheta(), G4AngularDistributionNP::CosTheta(), G4Orb::CreatePolyhedron(), G4Ellipsoid::CreateRotatedVertices(), G4DiffractiveExcitation::CreateStrings(), G4XAnnihilationChannel::CrossSection(), G4eeCrossSections::CrossSection2Kcharged(), G4eeCrossSections::CrossSection2Kneutral(), G4eeCrossSections::CrossSection2pi(), G4eeCrossSections::CrossSection3pi(), G4eeCrossSections::CrossSectionEtaG(), G4PenelopeComptonModel::CrossSectionPerVolume(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNADingfelderChargeIncreaseModel::CrossSectionPerVolume(), G4eeCrossSections::CrossSectionPi0G(), G4HEVector::Defs1(), G4GHEKinematicsVector::Defs1(), G4StokesVector::DiceUniform(), G4DNABrownianTransportation::Diffusion(), G4PAIxSection::DifPAIxSection(), G4InitXscPAI::DifPAIxSection(), G4PAIySection::DifPAIySection(), G4Abla::direct(), G4Sphere::DistanceToIn(), G4Tubs::DistanceToOut(), G4Torus::DistanceToOut(), G4Sphere::DistanceToOut(), G4CutTubs::DistanceToOut(), G4Cons::DistanceToOut(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4MagHelicalStepper::DistChord(), G4HelixMixedStepper::DistChord(), G4HelixExplicitEuler::DistChord(), G4ExactHelixStepper::DistChord(), G4QMDMeanField::DoClusterJudgment(), G4Abla::eflmac(), G4FissionProbability::EmissionProbability(), G4E1SingleProbability1::EmissionProbDensity(), G4BetaDecayCorrections::FermiFunction(), G4tgbVolume::FindOrConstructG4Solid(), G4HEKaonZeroShortInelastic::FirstIntInCasAntiKaonZero(), G4HEKaonZeroLongInelastic::FirstIntInCasAntiKaonZero(), G4HEAntiKaonZeroInelastic::FirstIntInCasAntiKaonZero(), G4HEAntiLambdaInelastic::FirstIntInCasAntiLambda(), G4HEAntiNeutronInelastic::FirstIntInCasAntiNeutron(), G4HEAntiOmegaMinusInelastic::FirstIntInCasAntiOmegaMinus(), G4HEAntiProtonInelastic::FirstIntInCasAntiProton(), G4HEAntiSigmaMinusInelastic::FirstIntInCasAntiSigmaMinus(), G4HEAntiSigmaPlusInelastic::FirstIntInCasAntiSigmaPlus(), G4HEAntiXiMinusInelastic::FirstIntInCasAntiXiMinus(), G4HEAntiXiZeroInelastic::FirstIntInCasAntiXiZero(), G4HEKaonMinusInelastic::FirstIntInCasKaonMinus(), G4HEKaonPlusInelastic::FirstIntInCasKaonPlus(), G4HEKaonZeroShortInelastic::FirstIntInCasKaonZero(), G4HEKaonZeroLongInelastic::FirstIntInCasKaonZero(), G4HEKaonZeroInelastic::FirstIntInCasKaonZero(), G4HELambdaInelastic::FirstIntInCasLambda(), G4HENeutronInelastic::FirstIntInCasNeutron(), G4HEOmegaMinusInelastic::FirstIntInCasOmegaMinus(), G4HEPionMinusInelastic::FirstIntInCasPionMinus(), G4HEPionPlusInelastic::FirstIntInCasPionPlus(), G4HEProtonInelastic::FirstIntInCasProton(), G4HESigmaMinusInelastic::FirstIntInCasSigmaMinus(), G4HESigmaPlusInelastic::FirstIntInCasSigmaPlus(), G4HEXiMinusInelastic::FirstIntInCasXiMinus(), G4HEXiZeroInelastic::FirstIntInCasXiZero(), G4ChebyshevApproximation::G4ChebyshevApproximation(), G4ConicalSurface::G4ConicalSurface(), G4DNAMolecularReactionData::G4DNAMolecularReactionData(), G4E1Probability::G4E1Probability(), G4FermiConfigurationList::G4FermiConfigurationList(), G4FTFParameters::G4FTFParameters(), G4GaussChebyshevQ::G4GaussChebyshevQ(), G4GaussHermiteQ::G4GaussHermiteQ(), G4GaussLegendreQ::G4GaussLegendreQ(), G4GeneralParticleSourceMessenger::G4GeneralParticleSourceMessenger(), G4gsrotm(), G4HETCFragment::G4HETCFragment(), G4mplIonisationModel::G4mplIonisationModel(), G4mplIonisationWithDeltaModel::G4mplIonisationWithDeltaModel(), G4NuclearFermiDensity::G4NuclearFermiDensity(), G4NuclearShellModelDensity::G4NuclearShellModelDensity(), G4PenelopeAnnihilationModel::G4PenelopeAnnihilationModel(), G4PolarizedComptonCrossSection::G4PolarizedComptonCrossSection(), G4PreCompoundIon::G4PreCompoundIon(), G4QMDMeanField::G4QMDMeanField(), G4RegionModel::G4RegionModel(), G4SphericalSurface::G4SphericalSurface(), G4SPSAngDistribution::G4SPSAngDistribution(), G4UniformElectricField::G4UniformElectricField(), G4UniformMagField::G4UniformMagField(), G4UrbanMscModel92::G4UrbanMscModel92(), G4UrbanMscModel93::G4UrbanMscModel93(), G4UrbanMscModel95::G4UrbanMscModel95(), G4UrbanMscModel96::G4UrbanMscModel96(), G4VParameterisationPara::G4VParameterisationPara(), G4VTwistedFaceted::G4VTwistedFaceted(), G4VXTRenergyLoss::G4VXTRenergyLoss(), G4WentzelOKandVIxSection::G4WentzelOKandVIxSection(), G4WentzelVIRelXSection::G4WentzelVIRelXSection(), G4NuclNuclDiffuseElastic::GammaLess(), G4NuclNuclDiffuseElastic::GammaMore(), G4eeToHadronsModel::GenerateCMPhoton(), G4AdjointPrimaryGeneratorAction::GeneratePrimaries(), G4ReactionDynamics::GenerateXandPt(), G4VXTRenergyLoss::GetAngleVector(), G4INCL::PauliStandard::getBlockingProbability(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), G4NeutronInelasticCrossSection::GetCrossSection(), G4Torus::GetCubicVolume(), G4Orb::GetCubicVolume(), G4EllipticalCone::GetCubicVolume(), G4Ellipsoid::GetCubicVolume(), G4NuclNuclDiffuseElastic::GetDiffElasticProb(), G4DiffuseElastic::GetDiffElasticProb(), G4NuclNuclDiffuseElastic::GetDiffElasticSumProb(), G4DiffuseElastic::GetDiffElasticSumProb(), G4NuclNuclDiffuseElastic::GetDiffElasticSumProbA(), G4DiffuseElastic::GetDiffElasticSumProbA(), G4TripathiLightCrossSection::GetElementCrossSection(), G4TripathiCrossSection::GetElementCrossSection(), G4IonsSihverCrossSection::GetElementCrossSection(), G4IonsKoxCrossSection::GetElementCrossSection(), G4SynchrotronRadiationInMat::GetEnergyProbSR(), G4NuclNuclDiffuseElastic::GetErfComp(), G4NuclNuclDiffuseElastic::GetErfInt(), G4NuclNuclDiffuseElastic::GetErfSer(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfProjectile(), G4NuclearAbrasionGeometry::GetExcitationEnergyOfTarget(), G4Nucleus::GetFermiMomentum(), G4SigmaZeroField::GetField(), G4SigmaPlusField::GetField(), G4SigmaMinusField::GetField(), G4PionZeroField::GetField(), G4PionPlusField::GetField(), G4PionMinusField::GetField(), G4KaonZeroField::GetField(), G4KaonPlusField::GetField(), G4KaonMinusField::GetField(), G4AntiProtonField::GetField(), G4MesonAbsorption::GetFinalState(), G4EMDissociationSpectrum::GetGeneralE1Spectrum(), G4EMDissociationSpectrum::GetGeneralE2Spectrum(), 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(), G4InelasticInteraction::GetNormalizationConstant(), G4PreCompoundNucleon::GetOpt0(), G4PreCompoundIon::GetOpt0(), G4PreCompoundProton::GetOpt2(), G4NeutronHPPhotonDist::GetPhotons(), G4Torus::GetPointOnSurface(), G4Sphere::GetPointOnSurface(), G4Polycone::GetPointOnSurface(), G4Paraboloid::GetPointOnSurface(), G4Orb::GetPointOnSurface(), G4Hype::GetPointOnSurface(), G4EllipticalTube::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4ProtonInelasticCrossSection::GetProtonCrossSection(), G4PolarizationHelper::GetRandomFrame(), G4NuclNuclDiffuseElastic::GetRatioGen(), G4GlauberGribovCrossSection::GetRatioQE(), G4GGNuclNuclCrossSection::GetRatioQE(), G4ComponentGGNuclNuclXsc::GetRatioQE(), G4ComponentGGHadronNucleusXsc::GetRatioQE(), G4GlauberGribovCrossSection::GetRatioSD(), G4GGNuclNuclCrossSection::GetRatioSD(), G4ComponentGGNuclNuclXsc::GetRatioSD(), G4ComponentGGHadronNucleusXsc::GetRatioSD(), G4NuclNuclDiffuseElastic::GetRatioSim(), G4tgrUtils::GetRotationFromDirection(), G4ScreeningMottCrossSection::GetScreeningAngle(), G4Sphere::GetSurfaceArea(), G4Orb::GetSurfaceArea(), G4QNucleus::GetTbIntegral(), G4Scatterer::GetTimeToInteraction(), G4ComponentAntiNuclNuclearXS::GetTotalElementCrossSection(), G4GGNuclNuclCrossSection::GetZandACrossSection(), G4ComponentGGNuclNuclXsc::GetZandACrossSection(), G4ElasticHadrNucleusHE::HadrNucDifferCrSec(), G4Integrator< T, F >::Hermite(), G4Ellipse::InitBounded(), G4CircularCurve::InitBounded(), G4QNucleus::InitDensity(), G4CoulombScattering::InitialiseProcess(), G4NuclNuclDiffuseElastic::InitParametersGla(), G4Integrator< T, F >::Legendre(), G4ScreeningMottCrossSection::McFcorrection(), G4EmCorrections::MottCorrection(), G4HEInelastic::NBodyPhaseSpace(), G4InitXscPAI::Normalisation(), G4PAIySection::NormShift(), G4PAIxSection::NormShift(), G4ScreeningMottCrossSection::NuclearCrossSection(), G4PiMinusStopMaterial::P4Vector(), G4PAIySection::PAIdNdxCerenkov(), G4PAIxSection::PAIdNdxCerenkov(), G4InitXscPAI::PAIdNdxCherenkov(), G4PAIxSection::PAIdNdxMM(), G4PAIySection::PAIdNdxPlasmon(), G4PAIxSection::PAIdNdxPlasmon(), G4InitXscPAI::PAIdNdxPlasmon(), G4PAIxSection::PAIdNdxResonance(), G4DNAEmfietzoglouExcitationModel::PartialCrossSection(), G4NuclNuclDiffuseElastic::PhaseFar(), G4NuclNuclDiffuseElastic::PhaseNear(), G4VAngularDistribution::Phi(), G4DipBustGenerator::PolarAngle(), G4VXTRenergyLoss::PostStepDoIt(), G4OpMieHG::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4EvaporationProbability::ProbabilityDistributionFunction(), G4NuclNuclDiffuseElastic::Profile(), G4NuclNuclDiffuseElastic::ProfileFar(), G4NuclNuclDiffuseElastic::ProfileNear(), G4Hyperbola::Project(), G4Ellipse::Project(), G4DNAMolecularDecayDisplacer::radialDistributionOfElectron(), G4DNASancheSolvatationModel::RadialDistributionOfProducts(), G4PAIySection::RePartDielectricConst(), G4PAIxSection::RePartDielectricConst(), G4InitXscPAI::RePartDielectricConst(), G4SphericalSurface::resize(), G4RPGReaction::Rotate(), G4InelasticInteraction::Rotate(), G4Generator2BN::SampleDirection(), G4AntiNuclElastic::SampleInvariantT(), G4VLongitudinalStringDecay::SampleQuarkPt(), G4XrayRayleighModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4NuclNuclDiffuseElastic::SampleThetaCMS(), G4DiffuseElastic::SampleThetaCMS(), G4DAWNFILEViewer::SendViewParameters(), G4SPSAngDistribution::SetAngDistType(), G4ConicalSurface::SetAngle(), G4KM_OpticalEqRhs::SetFactor(), G4VisCommandSceneAddLogo::SetNewValue(), G4VMultipleScattering::SetPolarAngleLimit(), G4VEmProcess::SetPolarAngleLimit(), G4AdjointPrimaryGenerator::SetSphericalAdjointPrimarySource(), G4XTRTransparentRegRadModel::SpectralXTRdEdx(), G4XTRRegularRadModel::SpectralXTRdEdx(), G4TransparentRegXTRadiator::SpectralXTRdEdx(), G4RegularXTRadiator::SpectralXTRdEdx(), G4Sphere::SurfaceNormal(), G4EllipticalCone::SurfaceNormal(), G4GeomTestVolume::TestCylinder(), G4PolarizationHelper::TestPolarizationTransformations(), toDegrees(), G4PolarizedComptonCrossSection::TotalXSection(), G4PolarizedAnnihilationCrossSection::TotalXSection(), G4ReactionKinematics::TwoBodyScattering(), G4Abla::umass(), and G4SphericalSurface::WithinBoundary().

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

Definition at line 69 of file G4INCLGlobals.hh.

Referenced by G4INCL::DeuteronDensity::derivDensityR(), G4INCL::Random::gauss(), G4INCL::PauliStandard::getBlockingProbability(), G4INCL::ElasticChannel::getFinalState(), G4INCL::DeltaProductionChannel::getFinalState(), and G4INCL::Random::normVector().

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

Definition at line 70 of file G4INCLGlobals.hh.

Referenced by G4INCL::StandardPropagationModel::generateBinaryCollisionAvatar(), G4INCL::BinaryCollisionAvatar::getChannel(), G4INCL::CrossSections::interactionDistanceNN(), G4INCL::CrossSections::interactionDistancePiN(), and G4INCL::INCL::prepareReaction().

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

Definition at line 71 of file G4INCLGlobals.hh.

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

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

Definition at line 72 of file G4INCLGlobals.hh.

Referenced by G4INCL::NuclearDensityFactory::createPCDFTable(), G4INCL::NuclearDensityFactory::createRCDFTable(), G4INCL::NuclearDensityFactory::createRPCorrelationTable(), and G4INCL::Random::gaussVector().

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

Definition at line 73 of file G4INCLGlobals.hh.

Referenced by G4GlauberGribovCrossSection::GetNucleusRadius(), G4GGNuclNuclCrossSection::GetNucleusRadius(), G4ComponentGGNuclNuclXsc::GetNucleusRadius(), G4ComponentGGHadronNucleusXsc::GetNucleusRadius(), G4GGNuclNuclCrossSection::GetNucleusRadiusGG(), G4ComponentGGNuclNuclXsc::GetNucleusRadiusGG(), pow13(), and powMinus13().

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

Definition at line 74 of file G4INCLGlobals.hh.

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

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

Definition at line 75 of file G4INCLGlobals.hh.

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

Definition at line 76 of file G4INCLGlobals.hh.

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


Generated on Mon May 27 17:54:09 2013 for Geant4 by  doxygen 1.4.7