TMath.h File Reference

#include "Rtypes.h"
#include "TMathBase.h"
#include "TError.h"
#include <algorithm>
#include <float.h>

Go to the source code of this file.

Namespaces

namespace  TMath

Classes

struct  CompareDesc< T >
struct  CompareAsc< T >

Functions

Double_t TMath::Pi ()
Double_t TMath::TwoPi ()
Double_t TMath::PiOver2 ()
Double_t TMath::PiOver4 ()
Double_t TMath::InvPi ()
Double_t TMath::RadToDeg ()
Double_t TMath::DegToRad ()
Double_t TMath::Sqrt2 ()
Double_t TMath::E ()
Double_t TMath::Ln10 ()
Double_t TMath::LogE ()
Double_t TMath::C ()
Double_t TMath::Ccgs ()
Double_t TMath::CUncertainty ()
Double_t TMath::G ()
Double_t TMath::Gcgs ()
Double_t TMath::GUncertainty ()
Double_t TMath::GhbarC ()
Double_t TMath::GhbarCUncertainty ()
Double_t TMath::Gn ()
Double_t TMath::GnUncertainty ()
Double_t TMath::H ()
Double_t TMath::Hcgs ()
Double_t TMath::HUncertainty ()
Double_t TMath::Hbar ()
Double_t TMath::Hbarcgs ()
Double_t TMath::HbarUncertainty ()
Double_t TMath::HC ()
Double_t TMath::HCcgs ()
Double_t TMath::K ()
Double_t TMath::Kcgs ()
Double_t TMath::KUncertainty ()
Double_t TMath::Sigma ()
Double_t TMath::SigmaUncertainty ()
Double_t TMath::Na ()
Double_t TMath::NaUncertainty ()
Double_t TMath::R ()
Double_t TMath::RUncertainty ()
Double_t TMath::MWair ()
Double_t TMath::Rgair ()
Double_t TMath::EulerGamma ()
Double_t TMath::Qe ()
Double_t TMath::QeUncertainty ()
Double_t TMath::Sin (Double_t)
Double_t TMath::Cos (Double_t)
Double_t TMath::Tan (Double_t)
Double_t TMath::SinH (Double_t)
Double_t TMath::CosH (Double_t)
Double_t TMath::TanH (Double_t)
Double_t TMath::ASin (Double_t)
Double_t TMath::ACos (Double_t)
Double_t TMath::ATan (Double_t)
Double_t TMath::ATan2 (Double_t, Double_t)
Double_t TMath::ASinH (Double_t)
Double_t TMath::ACosH (Double_t)
Double_t TMath::ATanH (Double_t)
Double_t TMath::Hypot (Double_t x, Double_t y)
Double_t TMath::Sqrt (Double_t x)
Double_t TMath::Ceil (Double_t x)
Int_t TMath::CeilNint (Double_t x)
Double_t TMath::Floor (Double_t x)
Int_t TMath::FloorNint (Double_t x)
Double_t TMath::Exp (Double_t x)
Double_t TMath::Ldexp (Double_t x, Int_t exp)
Double_t TMath::Factorial (Int_t i)
Double_t TMath::Power (Double_t x, Double_t y)
Double_t TMath::Log (Double_t x)
Double_t TMath::Log2 (Double_t x)
Double_t TMath::Log10 (Double_t x)
Int_t TMath::Nint (Float_t x)
Int_t TMath::Nint (Double_t x)
Int_t TMath::Finite (Double_t x)
Int_t TMath::IsNaN (Double_t x)
Long_t TMath::Hypot (Long_t x, Long_t y)
Bool_t TMath::AreEqualAbs (Double_t af, Double_t bf, Double_t epsilon)
Bool_t TMath::AreEqualRel (Double_t af, Double_t bf, Double_t relPrec)
template<typename T>
T TMath::MinElement (Long64_t n, const T *a)
template<typename T>
T TMath::MaxElement (Long64_t n, const T *a)
template<typename T>
Long64_t TMath::LocMin (Long64_t n, const T *a)
template<typename Iterator>
Iterator TMath::LocMin (Iterator first, Iterator last)
template<typename T>
Long64_t TMath::LocMax (Long64_t n, const T *a)
template<typename Iterator>
Iterator TMath::LocMax (Iterator first, Iterator last)
template<typename T>
Long64_t TMath::BinarySearch (Long64_t n, const T *array, T value)
template<typename T>
Long64_t TMath::BinarySearch (Long64_t n, const T **array, T value)
template<typename Iterator, typename Element>
Iterator TMath::BinarySearch (Iterator first, Iterator last, Element value)
ULong_t TMath::Hash (const void *txt, Int_t ntxt)
ULong_t TMath::Hash (const char *str)
template<typename Element, typename Index>
void TMath::Sort (Index n, const Element *a, Index *index, Bool_t down=kTRUE)
template<typename Iterator, typename IndexIterator>
void TMath::SortItr (Iterator first, Iterator last, IndexIterator index, Bool_t down=kTRUE)
void TMath::BubbleHigh (Int_t Narr, Double_t *arr1, Int_t *arr2)
void TMath::BubbleLow (Int_t Narr, Double_t *arr1, Int_t *arr2)
Bool_t TMath::Permute (Int_t n, Int_t *a)
void TMath::Quantiles (Int_t n, Int_t nprob, Double_t *x, Double_t *quantiles, Double_t *prob, Bool_t isSorted=kTRUE, Int_t *index=0, Int_t type=7)
template<typename T>
Bool_t TMath::IsInside (T xp, T yp, Int_t np, T *x, T *y)
template<typename T>
TTMath::Cross (const T v1[3], const T v2[3], T out[3])
Float_t TMath::Normalize (Float_t v[3])
Double_t TMath::Normalize (Double_t v[3])
template<typename T>
T TMath::NormCross (const T v1[3], const T v2[3], T out[3])
template<typename T>
TTMath::Normal2Plane (const T v1[3], const T v2[3], const T v3[3], T normal[3])
Bool_t TMath::RootsCubic (const Double_t coef[4], Double_t &a, Double_t &b, Double_t &c)
Double_t TMath::Binomial (Int_t n, Int_t k)
Double_t TMath::BinomialI (Double_t p, Int_t n, Int_t k)
Double_t TMath::BreitWigner (Double_t x, Double_t mean=0, Double_t gamma=1)
Double_t TMath::CauchyDist (Double_t x, Double_t t=0, Double_t s=1)
Double_t TMath::ChisquareQuantile (Double_t p, Double_t ndf)
Double_t TMath::FDist (Double_t F, Double_t N, Double_t M)
Double_t TMath::FDistI (Double_t F, Double_t N, Double_t M)
Double_t TMath::Gaus (Double_t x, Double_t mean=0, Double_t sigma=1, Bool_t norm=kFALSE)
Double_t TMath::KolmogorovProb (Double_t z)
Double_t TMath::KolmogorovTest (Int_t na, const Double_t *a, Int_t nb, const Double_t *b, Option_t *option)
Double_t TMath::Landau (Double_t x, Double_t mpv=0, Double_t sigma=1, Bool_t norm=kFALSE)
Double_t TMath::LandauI (Double_t x)
Double_t TMath::LaplaceDist (Double_t x, Double_t alpha=0, Double_t beta=1)
Double_t TMath::LaplaceDistI (Double_t x, Double_t alpha=0, Double_t beta=1)
Double_t TMath::LogNormal (Double_t x, Double_t sigma, Double_t theta=0, Double_t m=1)
Double_t TMath::NormQuantile (Double_t p)
Double_t TMath::Poisson (Double_t x, Double_t par)
Double_t TMath::PoissonI (Double_t x, Double_t par)
Double_t TMath::Prob (Double_t chi2, Int_t ndf)
Double_t TMath::Student (Double_t T, Double_t ndf)
Double_t TMath::StudentI (Double_t T, Double_t ndf)
Double_t TMath::StudentQuantile (Double_t p, Double_t ndf, Bool_t lower_tail=kTRUE)
Double_t TMath::Vavilov (Double_t x, Double_t kappa, Double_t beta2)
Double_t TMath::VavilovI (Double_t x, Double_t kappa, Double_t beta2)
Double_t TMath::Voigt (Double_t x, Double_t sigma, Double_t lg, Int_t R=4)
template<typename T>
Double_t TMath::Mean (Long64_t n, const T *a, const Double_t *w=0)
template<typename Iterator>
Double_t TMath::Mean (Iterator first, Iterator last)
template<typename Iterator, typename WeightIterator>
Double_t TMath::Mean (Iterator first, Iterator last, WeightIterator w)
template<typename T>
Double_t TMath::GeomMean (Long64_t n, const T *a)
template<typename Iterator>
Double_t TMath::GeomMean (Iterator first, Iterator last)
template<typename T>
Double_t TMath::RMS (Long64_t n, const T *a)
template<typename Iterator>
Double_t TMath::RMS (Iterator first, Iterator last)
template<typename T>
Double_t TMath::Median (Long64_t n, const T *a, const Double_t *w=0, Long64_t *work=0)
template<class Element, typename Size>
Element TMath::KOrdStat (Size n, const Element *a, Size k, Size *work=0)
Double_t TMath::Beta (Double_t p, Double_t q)
Double_t TMath::BetaCf (Double_t x, Double_t a, Double_t b)
Double_t TMath::BetaDist (Double_t x, Double_t p, Double_t q)
Double_t TMath::BetaDistI (Double_t x, Double_t p, Double_t q)
Double_t TMath::BetaIncomplete (Double_t x, Double_t a, Double_t b)
Double_t TMath::BesselI (Int_t n, Double_t x)
Double_t TMath::BesselK (Int_t n, Double_t x)
Double_t TMath::BesselI0 (Double_t x)
Double_t TMath::BesselK0 (Double_t x)
Double_t TMath::BesselI1 (Double_t x)
Double_t TMath::BesselK1 (Double_t x)
Double_t TMath::BesselJ0 (Double_t x)
Double_t TMath::BesselJ1 (Double_t x)
Double_t TMath::BesselY0 (Double_t x)
Double_t TMath::BesselY1 (Double_t x)
Double_t TMath::StruveH0 (Double_t x)
Double_t TMath::StruveH1 (Double_t x)
Double_t TMath::StruveL0 (Double_t x)
Double_t TMath::StruveL1 (Double_t x)
Double_t TMath::DiLog (Double_t x)
Double_t TMath::Erf (Double_t x)
Double_t TMath::ErfInverse (Double_t x)
Double_t TMath::Erfc (Double_t x)
Double_t TMath::ErfcInverse (Double_t x)
Double_t TMath::Freq (Double_t x)
Double_t TMath::Gamma (Double_t z)
Double_t TMath::Gamma (Double_t a, Double_t x)
Double_t TMath::GammaDist (Double_t x, Double_t gamma, Double_t mu=0, Double_t beta=1)
Double_t TMath::LnGamma (Double_t z)
double sin (double)
double cos (double)
double tan (double)
double sinh (double)
double cosh (double)
double tanh (double)
double asin (double)
double acos (double)
double atan (double)
double atan2 (double, double)
double sqrt (double)
double exp (double)
double pow (double, double)
double log (double)
double log10 (double)
int finite (double)
int isnan (double)
double ldexp (double, int)
double ceil (double)
double floor (double)
Double_t TMath::Sin (Double_t x)
Double_t TMath::Cos (Double_t x)
Double_t TMath::Tan (Double_t x)
Double_t TMath::SinH (Double_t x)
Double_t TMath::CosH (Double_t x)
Double_t TMath::TanH (Double_t x)
Double_t TMath::ASin (Double_t x)
Double_t TMath::ACos (Double_t x)
Double_t TMath::ATan (Double_t x)
Double_t TMath::ATan2 (Double_t y, Double_t x)
Double_t TMath::Sqrt (Double_t x)
Double_t TMath::Ceil (Double_t x)
Int_t TMath::CeilNint (Double_t x)
Double_t TMath::Floor (Double_t x)
Int_t TMath::FloorNint (Double_t x)
Double_t TMath::Exp (Double_t x)
Double_t TMath::Ldexp (Double_t x, Int_t exp)
Double_t TMath::Power (Double_t x, Double_t y)
Double_t TMath::Log (Double_t x)
Double_t TMath::Log10 (Double_t x)
Int_t TMath::Finite (Double_t x)
Int_t TMath::IsNaN (Double_t x)
template<typename T>
T TMath::NormCross (const T v1[3], const T v2[3], T out[3])
template<typename T>
T TMath::MinElement (Long64_t n, const T *a)
template<typename T>
T TMath::MaxElement (Long64_t n, const T *a)
template<typename T>
Long64_t TMath::LocMin (Long64_t n, const T *a)
template<typename Iterator>
Iterator TMath::LocMin (Iterator first, Iterator last)
template<typename T>
Long64_t TMath::LocMax (Long64_t n, const T *a)
template<typename Iterator>
Iterator TMath::LocMax (Iterator first, Iterator last)
template<typename Iterator>
Double_t TMath::Mean (Iterator first, Iterator last)
template<typename Iterator, typename WeightIterator>
Double_t TMath::Mean (Iterator first, Iterator last, WeightIterator w)
template<typename T>
Double_t TMath::Mean (Long64_t n, const T *a, const Double_t *w)
template<typename Iterator>
Double_t TMath::GeomMean (Iterator first, Iterator last)
template<typename T>
Double_t TMath::GeomMean (Long64_t n, const T *a)
template<typename Iterator>
Double_t TMath::RMS (Iterator first, Iterator last)
template<typename T>
Double_t TMath::RMS (Long64_t n, const T *a)
template<typename Iterator, typename Element>
Iterator TMath::BinarySearch (Iterator first, Iterator last, Element value)
template<typename T>
Long64_t TMath::BinarySearch (Long64_t n, const T *array, T value)
template<typename T>
Long64_t TMath::BinarySearch (Long64_t n, const T **array, T value)
template<typename Iterator, typename IndexIterator>
void TMath::SortItr (Iterator first, Iterator last, IndexIterator index, Bool_t down)
template<typename Element, typename Index>
void TMath::Sort (Index n, const Element *a, Index *index, Bool_t down)
template<typename T>
TTMath::Cross (const T v1[3], const T v2[3], T out[3])
template<typename T>
TTMath::Normal2Plane (const T p1[3], const T p2[3], const T p3[3], T normal[3])
template<typename T>
Bool_t TMath::IsInside (T xp, T yp, Int_t np, T *x, T *y)
template<typename T>
Double_t TMath::Median (Long64_t n, const T *a, const Double_t *w, Long64_t *work)
template<class Element, typename Size>
Element TMath::KOrdStat (Size n, const Element *a, Size k, Size *work)


Function Documentation

double acos ( double   ) 

Referenced by TMath::ACos(), ROOT::Math::VectorUtil::Angle(), TFormulaPrimitive::BuildBasicFormulas(), CalculateAngles(), city_distance(), ROOT::Math::gv_detail::convert(), createOnionData(), ROOT::Math::Quaternion::Distance(), gsl_poly_complex_solve_cubic(), and gsl_poly_complex_solve_quartic().

double asin ( double   ) 

Referenced by TMath::ASin(), TFormulaPrimitive::BuildBasicFormulas(), TSpectrum2Painter::ColorCalculation(), ROOT::Math::gv_detail::convert(), ROOT::Minuit2::SinParameterTransformation::Ext2int(), ROOT::Math::SinVariableTransformation::Ext2int(), and ROOT::Math::AxisAngle::operator *().

double atan ( double   ) 

Referenced by RooBreitWigner::analyticalIntegral(), TMath::ATan(), ROOT::Math::breitwigner_cdf(), ROOT::Math::breitwigner_cdf_c(), TFormulaPrimitive::BuildBasicFormulas(), ROOT::Math::cauchy_cdf(), ROOT::Math::cauchy_cdf_c(), ROOT::Minuit2::SinParameterTransformation::Ext2int(), ROOT::Math::SinVariableTransformation::Ext2int(), TQuaternion::GetQAngle(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Theta(), ROOT::Math::CylindricalEta3D< T >::Theta(), and ROOT::Math::PtEtaPhiM4D< ScalarType >::Theta().

double atan2 ( double  ,
double   
)

Referenced by RooBifurGauss::analyticalIntegral(), RooGaussModel::analyticalIntegral(), RooGaussian::analyticalIntegral(), RooArgusBG::analyticalIntegral(), ROOT::Math::RotationY::Angle(), ROOT::Math::RotationZ::Angle(), ROOT::Math::RotationX::Angle(), TMath::ATan2(), TFormulaPrimitive::BuildBasicFormulas(), RooGExpModel::calcDecayConv(), ClassImp(), ROOT::Math::gv_detail::convert(), RooGExpModel::evalCerfApprox(), RooGaussModel::evalCerfApprox(), RooGaussModel::evaluate(), ROOT::Math::RotationX::GetAngle(), ROOT::Math::RotationY::GetAngle(), ROOT::Math::RotationZ::GetAngle(), ROOT::Math::Cartesian2D< T >::Phi(), ROOT::Math::PxPyPzE4D< ScalarType >::Phi(), ROOT::Math::PxPyPzM4D< ScalarType >::Phi(), ROOT::Math::Cartesian3D< T >::Phi(), RooEllipse::RooEllipse(), RooVoigtian::RooVoigtian(), RooComplex::sqrt(), test3D(), test4D(), testCircle(), testSphere(), ROOT::Math::Cartesian3D< T >::Theta(), ROOT::Math::PxPyPzE4D< ScalarType >::Theta(), ROOT::Math::Cylindrical3D< T >::Theta(), and ROOT::Math::PxPyPzM4D< ScalarType >::Theta().

double ceil ( double   ) 

Referenced by TMath::Ceil(), TMath::CeilNint(), ClassImp(), getErrorCnt(), and TMVA::MethodBDT::InitEventSample().

double cos ( double   ) 

Referenced by RooTruthModel::analyticalIntegral(), RooSpHarmonic::analyticalIntegral(), ROOT::Math::KelvinFunctions::Bei(), ROOT::Math::KelvinFunctions::Ber(), TMath::BesselJ0(), TMath::BesselJ1(), TMath::BesselY0(), TMath::BesselY1(), TCurlyArc::Build(), TFormulaPrimitive::BuildBasicFormulas(), ROOT::Math::GaussLegendreIntegrator::CalcGaussLegendreSamplingPoints(), CalculateAngles(), ROOT::Math::Cartesian2D< T >::Cartesian2D(), ROOT::Math::Cartesian3D< T >::Cartesian3D(), ROOT::Math::VavilovAccurate::Cdf(), ROOT::Math::VavilovAccurate::Cdf_c(), city_distance(), ROOT::Math::gv_detail::convert(), TMath::Cos(), TKDE::CosineArchKernel(), ROOT::Math::cosint(), create_circ(), ROOT::Math::KelvinFunctions::DBei(), ROOT::Math::SinVariableTransformation::DInt2Ext(), ROOT::Minuit2::SinParameterTransformation::DInt2Ext(), ROOT::Math::KelvinFunctions::DKei(), TrigoFletcherFunction::DoEval(), ErrorIntegral(), RooTruthModel::evaluate(), RooSpHarmonic::evaluate(), exampleFit3D(), exclusiongraph(), RooComplex::exp(), ROOT::Math::KelvinFunctions::F1(), ROOT::Math::KelvinFunctions::F2(), gdk_win32_draw_arc(), RooBCPEffDecay::generateEvent(), RooBCPGenDecay::generateEvent(), RooBMixDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), RooBDecay::generateEvent(), TEveTrans::GetRotAngles(), TrigoFletcherFunction::Gradient(), graphpolar(), gsl_poly_complex_solve_cubic(), gsl_poly_complex_solve_quartic(), hz_calc(), interference(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), makeTree_circ(), ROOT::Math::AxisAngle::operator *(), ROOT::Minuit2::GaussRandomGen::operator()(), ROOT::Math::Cartesian3D< T >::operator=(), ROOT::Math::Cartesian2D< T >::operator=(), TSpectrum2Painter::Paint(), ROOT::Math::VavilovAccurate::Pdf(), projection(), projection_prescale(), THistPainter::ProjectSinusoidal2xy(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Px(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Px(), read(), ROOT::Math::RotationY::Rectify(), ROOT::Math::RotationZ::Rectify(), ROOT::Math::RotationX::Rectify(), robot(), RooEllipse::RooEllipse(), rotate(), ROOT::Math::Cartesian2D< T >::Rotate(), TGLMatrix::RotateLF(), TEveTrans::RotateLF(), TGLMatrix::RotatePF(), TEveTrans::RotatePF(), ROOT::Math::VectorUtil::RotateX(), ROOT::Math::VectorUtil::RotateY(), ROOT::Math::VectorUtil::RotateZ(), rxv(), ryv(), rzv(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::RotationY::SetAngle(), ROOT::Math::RotationZ::SetAngle(), ROOT::Math::RotationX::SetAngle(), TQuaternion::SetAxisQAngle(), TQuaternion::SetQAngle(), TTF::SetRotationMatrix(), ROOT::Math::sinint(), ROOT::Math::sph_legendre(), RooComplex::sqrt(), tank(), test_atan2(), test_cos(), test_length(), test_rotate(), test_unit(), testInterpolation(), tgraph2(), tornado(), TGSpeedo::Translate(), TrigoFletcherFunction::TrigoFletcherFunction(), ROOT::Math::Polar2D< T >::X(), ROOT::Math::Cylindrical3D< T >::X(), ROOT::Math::Polar3D< T >::X(), ROOT::Math::CylindricalEta3D< T >::X(), and ROOT::Math::Polar3D< T >::Z().

double cosh ( double   ) 

Referenced by TFormulaPrimitive::BuildBasicFormulas(), TMath::CosH(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Et(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Et(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Et2(), RooTruthModel::evaluate(), VectorTest< Dim >::genData(), RooBDecay::generateEvent(), ROOT::Math::PtEtaPhiM4D< ScalarType >::P(), ROOT::Math::PtEtaPhiE4D< ScalarType >::P(), and ROOT::Math::CylindricalEta3D< T >::R().

double exp ( double   ) 

Referenced by TParallelCoord::AddVariable(), RooExponential::analyticalIntegral(), RooNonCentralChiSquare::analyticalIntegral(), RooGaussModel::analyticalIntegral(), RooCBShape::analyticalIntegral(), RooPoisson::analyticalIntegral(), RooDstD0BG::analyticalIntegral(), RooTruthModel::analyticalIntegral(), RooArgusBG::analyticalIntegral(), RooMultiVarGaussian::analyticalIntegral(), TSpectrumFit::Area(), ROOT::Math::KelvinFunctions::Bei(), ROOT::Math::KelvinFunctions::Ber(), TMath::BesselI1(), TMath::BesselK0(), TMath::BesselK1(), ROOT::Math::Cephes::beta(), ROOT::Math::beta(), ROOT::Math::beta_pdf(), ROOT::Math::binomial_pdf(), calc_gauss_int(), RooGExpModel::calcDecayConv(), TMVA::MethodMLP::CalculateEstimator(), Camel2(), ROOT::Math::chisquared_pdf(), ClassImp(), TSpectrum2Painter::ColorCalculation(), RooMath::ComplexErrFunc(), TProofDrawProfile::DefVar(), TProofDrawProfile2D::DefVar(), TProofDrawHist::DefVar1D(), TProofDrawHist::DefVar2D(), TProofDrawHist::DefVar3D(), TFDISTR::Density(), TSpectrumFit::Deramp(), TSpectrum2Fit::Deramp2(), TSpectrum2Fit::Derampx(), TSpectrumFit::Derb(), TSpectrum2Fit::Derbx(), TSpectrum2Fit::Derby(), TSpectrumFit::Derderi0(), TSpectrum2Fit::Derderi01(), TSpectrum2Fit::Derderi02(), TSpectrum2Fit::Derderj02(), TSpectrumFit::Derdersigma(), TSpectrum2Fit::Derdersigmax(), TSpectrum2Fit::Derdersigmay(), TSpectrumFit::Derfc(), TSpectrum2Fit::Derfc(), TSpectrumFit::Deri0(), TSpectrum2Fit::Deri01(), TSpectrum2Fit::Deri02(), TSpectrum2Fit::Derj02(), TSpectrumFit::Derpa(), TSpectrumFit::Derpb(), TSpectrumFit::Derpsigma(), TSpectrumFit::Derpt(), TSpectrum2Fit::Derro(), TSpectrumFit::Dersigma(), TSpectrum2Fit::Dersigmax(), TSpectrum2Fit::Dersigmay(), TSpectrumFit::Dert(), TSpectrum2Fit::Dertx(), TSpectrum2Fit::Dertxy(), TSpectrum2Fit::Derty(), GaussFunction::DoEvalPar(), TAxisEditor::DoNoExponent(), TSpectrum2Fit::Erfc(), ROOT::Math::Cephes::erfc(), TSpectrumFit::Erfc(), RooGaussModel::evalCerf(), RooGExpModel::evalCerf(), RooGaussModel::evalCerfIm(), RooGExpModel::evalCerfIm(), RooGExpModel::evalCerfRe(), RooGaussModel::evalCerfRe(), RooNovosibirsk::evaluate(), RooExponential::evaluate(), RooChiSquarePdf::evaluate(), RooDstD0BG::evaluate(), RooGaussModel::evaluate(), RooBukinPdf::evaluate(), RooBifurGauss::evaluate(), RooTruthModel::evaluate(), RooVoigtian::evaluate(), RooGaussian::evaluate(), RooNonCentralChiSquare::evaluate(), RooGExpModel::evaluate(), RooArgusBG::evaluate(), RooCBShape::evaluate(), RooMultiVarGaussian::evaluate(), Roo2DKeysPdf::evaluateFull(), RooKeysPdf::evaluateFull(), TMath::Exp(), ROOT::Math::expm1(), ROOT::Math::exponential_cdf_c(), ROOT::Math::exponential_pdf(), ROOT::Math::fdistribution_pdf(), Roo2DKeysPdf::g(), RooKeysPdf::g(), ROOT::Math::VavilovAccurate::G116f2(), G__G__RooFitCore1_503_0_14(), ROOT::Math::gamma_pdf(), TRandom::Gaus(), gaus100d(), gaus10d(), gaus2D(), gaus2d(), gaus2dnormal(), gaus3d(), TMVA::MethodKNN::GausKernel(), gausnorm(), RooNDKeysPdf::gauss(), gauss2D(), gaussian(), ROOT::Math::gaussian_pdf(), TKDE::GaussianKernel(), GaussPdf(), RooBDecay::generateEvent(), genPoisson(), genPoisson2(), TMVA::MethodBDT::GetGradBoostMVA(), ROOT::Minuit2::GaussianModelFunction::GetGradient(), TMVA::MethodFDA::GetMulticlassValues(), TMVA::MethodANNBase::GetMulticlassValues(), TMVA::MethodBDT::GetMulticlassValues(), TTreeDrawArgsParser::GetVarExp(), Roo2DKeysPdf::highBoundaryCorrection(), ROOT::Math::Cephes::igam(), ROOT::Math::Cephes::igamc(), ROOT::Math::Cephes::igami(), ROOT::Math::Cephes::incbet(), ROOT::Math::Cephes::incbi(), InspectDiff(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), ROOT::Math::landau_cdf(), ROOT::Math::landau_pdf(), ROOT::Math::landau_xm1(), ROOT::Math::landau_xm2(), TGHorizontalLayout::Layout(), TGVerticalLayout::Layout(), RooGExpModel::logErfC(), ROOT::Math::lognormal_pdf(), ROOT::Math::lognormal_quantile(), ROOT::Math::lognormal_quantile_c(), Roo2DKeysPdf::lowBoundaryCorrection(), ROOT::Math::KelvinFunctions::M(), ROOT::Math::BrentMethods::MinimStep(), ROOT::Math::KelvinFunctions::N(), ROOT::Math::negative_binomial_pdf(), ROOT::Math::noncentral_chisquared_pdf(), ROOT::Math::normal_pdf(), ROOT::Minuit2::GaussianModelFunction::operator()(), GaussFunction::operator()(), GausND::operator()(), ROOT::Minuit2::GaussFunction::operator()(), RooHistError::PoissonSum::operator()(), PowerLawFunc::operator()(), TGaxis::PaintAxis(), GaussFunction::ParameterGradient(), ROOT::Math::VavilovFast::Pdf(), ROOT::Math::poisson_pdf(), ROOT::Math::Cephes::pseries(), ROOT::Math::GoFTest::PValueAD1Sample(), ROOT::Math::VavilovFast::Quantile(), TMVA::VariableInfo::ReadFromStream(), TGLCameraOverlay::RenderBar(), TSpectrum3::SearchHighRes(), seism(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::VavilovFast::SetKappaBeta2(), TSpectrum2Painter::ShadowColorCalculation(), TSpectrumFit::Shape(), TSpectrum2Fit::Shape2(), TProofDrawProfile2D::SlaveBegin(), TProofDrawHist::SlaveBegin(), TProofDrawProfile::SlaveBegin(), ROOT::Math::Cephes::stirf(), stressGeometry(), ROOT::Math::tdistribution_pdf(), tgaxis3(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Theta(), ROOT::Math::CylindricalEta3D< T >::Theta(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Theta(), timeonaxis(), and TMath::Voigt().

int finite ( double   ) 

double floor ( double   ) 

Referenced by TH2Poly::AddBinToPartition(), XrdProofdNetMgr::BalanceNodesOrder(), RooRealVar::chopAt(), TColor::CreateGradientColorTable(), RooKeysPdf::evaluate(), RooPoisson::evaluate(), TH2Poly::Fill(), TH2Poly::FindBin(), TMath::Floor(), TMath::FloorNint(), ROOT::Math::format(), RooRealVar::format(), ROOT::Math::Cephes::gamma(), genPoisson2(), TColor::HSV2RGB(), TMVA::MethodBDT::InitEventSample(), ROOT::Math::Cephes::lgam(), ROOT::Math::myRound(), ROOT::Math::EulerAngles::operator *(), ROOT::Math::RotationX::operator *(), ROOT::Math::RotationZYX::operator *(), ROOT::Math::RotationZ::operator *(), ROOT::Math::RotationY::operator *(), ROOT::Math::RotationY::Rectify(), ROOT::Math::RotationZ::Rectify(), ROOT::Math::RotationX::Rectify(), ROOT::Math::EulerAngles::Rectify(), ROOT::Math::RotationZYX::Rectify(), ROOT::Math::Cylindrical3D< T >::Restrict(), ROOT::Math::CylindricalEta3D< T >::Restrict(), ROOT::Math::Polar2D< T >::Restrict(), ROOT::Math::Polar3D< T >::Restrict(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Restrict(), ROOT::Math::PtEtaPhiM4D< ScalarType >::RestrictPhi(), testRandomDist(), and RooMCIntegrator::vegas().

int isnan ( double   ) 

Referenced by TMVA::RuleFitParams::CalcFStar(), TNeuron::GetBranch(), TMath::IsNaN(), RooAbsPdf::traceEvalHook(), RooResolutionModel::traceEvalHook(), RooAbsPdf::traceEvalPdf(), and TMultiLayerPerceptron::Train().

double ldexp ( double  ,
int   
)

Referenced by TMath::Ldexp().

double log ( double   ) 

Referenced by TMath::ACosH(), TGLScenePad::AddHistoPhysical(), RooCBShape::analyticalIntegral(), TMath::ASinH(), TMath::ATanH(), TMath::BesselK0(), TMath::BesselK1(), TMath::BesselY0(), TMath::BesselY1(), ROOT::Math::beta_pdf(), ROOT::Math::binomial_pdf(), TFumiliUnbinLikelihoodFCN::Calculate_element(), TFumiliBinLikelihoodFCN::Calculate_element(), ROOT::Math::chisquared_pdf(), ClassImp(), ROOT::Math::LorentzVector< CoordSystem >::ColinearRapidity(), TSpectrum2Painter::ColorCalculation(), ROOT::Math::cosint(), TGLPlot3D::CreatePlot(), RooStats::BernsteinCorrection::CreateQSamplingDist(), ROOT::Math::CylindricalEta3D< T >::CylindricalEta3D(), ROOT::Math::KelvinFunctions::DKei(), ROOT::Math::KelvinFunctions::DKer(), ROOT::Math::VavilovAccurate::E1plLog(), TMVA::MethodFDA::EstimatorFunction(), ROOT::Math::Impl::Eta_FromRhoZ(), ROOT::Math::Impl::Eta_FromTheta(), ROOT::Math::etaMax_impl(), ROOT::Math::Util::EvalLog(), RooNovosibirsk::evaluate(), RooBukinPdf::evaluate(), ROOT::Minuit2::FumiliStandardMaximumLikelihoodFCN::EvaluateAll(), RooNLLVar::evaluatePartition(), ROOT::Math::exponential_quantile_c(), RooAbsPdf::extendedTerm(), ROOT::Math::fdistribution_pdf(), ROOT::Math::VavilovAccurate::G116f1(), G__G__RooFitCore3_244_0_14(), G__G__RooFitCore3_244_0_15(), ROOT::Math::gamma_pdf(), TRandom::Gaus(), GaussFunction::GaussFunction(), RooBCPEffDecay::generateEvent(), RooBCPGenDecay::generateEvent(), RooGExpModel::generateEvent(), RooBMixDecay::generateEvent(), RooBDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), RooDecay::generateEvent(), genPoisson(), genPoisson2(), RooAbsPdf::getLogVal(), XrdClientConn::GetPhyConn(), ROOT::Math::Cephes::igam(), ROOT::Math::Cephes::igamc(), ROOT::Math::Cephes::igami(), RooStats::BernsteinCorrection::ImportCorrectedPdf(), ROOT::Math::Cephes::incbet(), ROOT::Math::Cephes::incbi(), ROOT::Fit::InitExpo(), ROOT::Math::VavilovAccurate::InitQuantile(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), ROOT::Math::landau_cdf(), ROOT::Math::landau_pdf(), ROOT::Math::landau_quantile(), ROOT::Math::landau_xm1(), ROOT::Math::landau_xm2(), ROOT::Math::Cephes::lgam(), TMath::Log(), ROOT::Math::log1p(), TMath::Log2(), log_gaus2d(), log_gaus3d(), RooGExpModel::logErfC(), LogMultiGaussPdf(), ROOT::Math::lognormal_cdf(), ROOT::Math::lognormal_cdf_c(), ROOT::Math::lognormal_pdf(), UnuranDistrMulti< Function >::Logpdf(), ROOT::Fit::BinData::LogTransform(), RooBlindTools::MakeGaussianOffset(), ROOT::Math::Vavilov::Mean(), ROOT::Math::BrentMethods::MinimStep(), mmalloc(), ROOT::Math::Vavilov::Mode(), ROOT::Math::VavilovAccurate::Mode(), ROOT::Math::Cephes::ndtri(), ROOT::Math::negative_binomial_pdf(), TProofServLogHandler::Notify(), TGLScenePad::ObjectPaint(), ROOT::Minuit2::FumiliMaximumLikelihoodFCN::operator()(), TBinLikelihoodFCN::operator()(), ROOT::Minuit2::GaussRandomGen::operator()(), PowerLawLogLikeFCN::operator()(), PowerLawFunc::operator()(), TSpectrum2Painter::Paint(), TMath::Poisson(), ROOT::Math::poisson_pdf(), ROOT::Math::Cephes::pseries(), ROOT::Math::LorentzVector< CoordSystem >::Rapidity(), TLorentzVector::Rapidity(), RooGrid::refine(), XrdClientMStream::RemoveParallelStream(), RooBukinPdf::RooBukinPdf(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::VavilovFast::SetKappaBeta2(), TSessionViewer::SetLogWindow(), TFumili::SGZ(), test3D(), test4D(), TSpectrum2Painter::Transform(), TGLScene::UpdateLogical(), and TGLScene::UpdatePhysioLogical().

double log10 ( double   ) 

Referenced by ROOT::Math::format(), RooRealVar::format(), gl2psPrintPDFShaderMask(), TAutoInspector::Inspect(), ROOT::ItoA(), TMath::Log10(), ROOT::Minuit2::mnbins(), ROOT::Math::myRound(), Roo1DTable::printMultiline(), and regression_averagedevs().

double pow ( double  ,
double   
)

Referenced by a(), RooHist::addAsymmetryBinWithError(), RooHist::addEfficiencyBinWithError(), RooNonCentralChiSquare::analyticalIntegral(), RooBernstein::analyticalIntegral(), RooMultiVarGaussian::analyticalIntegral(), BinomialProbHelper::BinomialProbHelper(), TGLPhysicalShape::CalculateShapeLOD(), RooRealVar::chopAt(), ClassImp(), RooStats::HypoTestResult::CLsError(), RooMath::ComplexErrFunc(), TMVA::PDEFoamDistr::Density(), ROOT::Math::IntegrandTransform::DoEval(), ROOT::Math::AdaptiveIntegratorMultiDim::DoIntegral(), ROOT::Math::WrappedTF1::DoParameterDerivative(), ROOT::Math::Impl::Eta_FromRhoZ(), RooChiSquarePdf::evaluate(), RooMoment::evaluate(), NuMuToNuE_Oscillation::evaluate(), RooBernstein::evaluate(), RooNonCentralChiSquare::evaluate(), ROOT::Math::format(), gdk_rgb_try_colormap(), GenerateEvent(), TKDE::GetBias(), TMVA::Tools::GetCorrelationRatio(), TKDE::GetRAMISE(), gl2psAddBoundaryInList(), glViewerLOD(), gsl_poly_complex_solve_cubic(), gsl_poly_complex_solve_quartic(), hz_calc(), RooDataHist::importDHistSet(), ROOT::Math::Cephes::incbet(), ROOT::Math::Vavilov::Kurtosis(), ROOT::Minuit2::mnbins(), ROOT::Math::moments(), myfunc(), myfunc2(), ROOT::Math::myRound(), ROOT::Math::noncentral_chisquared_pdf(), GausND::operator()(), RooHistError::BinomialSumEff::operator()(), RooHistError::PoissonSum::operator()(), TKDE::KernelIntegrand::operator()(), RooHistError::BinomialSumAsym::operator()(), TGraphPolargram::PaintPolarDivisions(), png_build_gamma_table(), png_init_read_transformations(), TMath::Power(), ROOT::Math::Cephes::pseries(), ROOT::Math::GoFTest::PValueAD1Sample(), TKDE::SetCanonicalBandwidth(), TKDE::SetKernel(), TKDE::SetKernelSigmas2(), TKDE::SetSigma(), TMVA::MethodBoost::SingleBoost(), ROOT::Math::Vavilov::Skewness(), ROOT::Math::Cephes::stirf(), ROOT::Math::tdistribution_pdf(), testGammaFunction(), TestSpeed(), waves(), and RooXYChi2Var::xErrorContribution().

double sin ( double   ) 

Referenced by RooTruthModel::analyticalIntegral(), RooSpHarmonic::analyticalIntegral(), ROOT::Math::KelvinFunctions::Bei(), ROOT::Math::KelvinFunctions::Ber(), TMath::BesselJ0(), TMath::BesselJ1(), TMath::BesselY0(), TMath::BesselY1(), TCurlyArc::Build(), TFormulaPrimitive::BuildBasicFormulas(), CalculateAngles(), ROOT::Math::Cartesian2D< T >::Cartesian2D(), ROOT::Math::Cartesian3D< T >::Cartesian3D(), ROOT::Math::VavilovAccurate::Cdf(), ROOT::Math::VavilovAccurate::Cdf_c(), city_distance(), ContourList(), ROOT::Math::gv_detail::convert(), ROOT::Math::cosint(), create_circ(), createOnionData(), ROOT::Math::KelvinFunctions::DBer(), TGeoHype::DistFromOutside(), ROOT::Math::KelvinFunctions::DKer(), MyMainFrame::DoDraw(), TrigoFletcherFunction::DoEval(), drawsparse(), ErrorIntegral(), NuMuToNuE_Oscillation::evaluate(), RooTruthModel::evaluate(), RooSpHarmonic::evaluate(), exampleFit3D(), exclusiongraph(), RooComplex::exp(), fg(), func(), ROOT::Math::KelvinFunctions::G1(), ROOT::Math::KelvinFunctions::G2(), ROOT::Math::Cephes::gamma(), gdk_win32_draw_arc(), RooBCPEffDecay::generateEvent(), RooBCPGenDecay::generateEvent(), RooBDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), DNDMainFrame::GetObject(), TrigoFletcherFunction::Gradient(), graph(), graphpolar(), graphShade(), gtime(), hz_calc(), ROOT::Minuit2::SinParameterTransformation::Int2ext(), ROOT::Math::SinVariableTransformation::Int2ext(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), ROOT::Math::Cephes::lgam(), RooBlindTools::MakeGaussianOffset(), makeTree_circ(), ROOT::Math::AxisAngle::operator *(), ROOT::Math::Cartesian3D< T >::operator=(), ROOT::Math::Cartesian2D< T >::operator=(), TSpectrum2Painter::Paint(), TFileInfo::ParseInput(), ROOT::Math::VavilovAccurate::Pdf(), projection(), projection_prescale(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Py(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Py(), ROOT::Math::RotationY::Rectify(), ROOT::Math::RotationZ::Rectify(), ROOT::Math::RotationX::Rectify(), ROOT::Math::Polar3D< T >::Rho(), robot(), RooEllipse::RooEllipse(), rotate(), ROOT::Math::Cartesian2D< T >::Rotate(), TGLMatrix::RotateLF(), TEveTrans::RotateLF(), TGLMatrix::RotatePF(), TEveTrans::RotatePF(), ROOT::Math::VectorUtil::RotateX(), ROOT::Math::VectorUtil::RotateY(), ROOT::Math::VectorUtil::RotateZ(), rxv(), ryv(), rzv(), seism(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::RotationY::SetAngle(), ROOT::Math::RotationZ::SetAngle(), ROOT::Math::RotationX::SetAngle(), TQuaternion::SetAxisQAngle(), TQuaternion::SetQAngle(), TTF::SetRotationMatrix(), MSIDir::SetupGuids(), TMath::Sin(), ROOT::Math::sinint(), RooComplex::sqrt(), tank(), test_atan2(), test_length(), test_rotate(), test_sin(), test_unit(), testInterpolation(), testLabelsInflateProf1D(), tgaxis3(), tgraph1(), tgraph2(), tgraph2d1(), tgraph2d2(), tgraph2d3(), theUnknownFunction(), timeonaxis(), tornado(), TGSpeedo::Translate(), TrigoFletcherFunction::TrigoFletcherFunction(), ROOT::Math::Polar3D< T >::Y(), ROOT::Math::CylindricalEta3D< T >::Y(), ROOT::Math::Cylindrical3D< T >::Y(), and ROOT::Math::Polar2D< T >::Y().

double sinh ( double   ) 

Referenced by TFormulaPrimitive::BuildBasicFormulas(), RooNovosibirsk::evaluate(), RooTruthModel::evaluate(), RooBDecay::generateEvent(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Pz(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Pz(), TLorentzVector::SetPtEtaPhiE(), TLorentzVector::SetPtEtaPhiM(), TMath::SinH(), and ROOT::Math::CylindricalEta3D< T >::Z().

double sqrt ( double   ) 

Referenced by RooComplex::abs(), TMath::ACosH(), RooHist::addAsymmetryBinWithError(), RooStats::NumberCountingPdfFactory::AddData(), RooStats::NumberCountingPdfFactory::AddDataWithSideband(), RooHist::addEfficiencyBinWithError(), TEfficiency::AgrestiCoull(), RooGExpModel::analyticalIntegral(), RooBifurGauss::analyticalIntegral(), RooGaussModel::analyticalIntegral(), RooLognormal::analyticalIntegral(), RooGaussian::analyticalIntegral(), RooNDKeysPdf::analyticalIntegral(), RooMultiVarGaussian::analyticalIntegral(), RooArgusBG::analyticalIntegral(), ROOT::Math::Sqrt< T >::apply(), RooMinuit::applyCovarianceMatrix(), RooMinimizerFcn::ApplyCovarianceMatrix(), TMath::ASinH(), TMath::BesselI(), TMath::BesselI1(), TMath::BesselJ0(), TMath::BesselJ1(), TMath::BesselK0(), TMath::BesselK1(), TMath::BesselY0(), TMath::BesselY1(), ROOT::Math::VectorUtil::boost(), ROOT::Math::VectorUtil::boostX(), ROOT::Math::VectorUtil::boostY(), ROOT::Math::VectorUtil::boostZ(), Rgl::Mc::TMeshBuilder< DataSource, ValueType >::BuildNormals(), TMVA::DataSetFactory::CalcCorrelationMatrix(), RooGExpModel::calcDecayConv(), TMVA::RuleEnsemble::CalcRuleSupport(), RooGExpModel::calcSinConv(), RooGExpModel::calcSinConvNorm(), Roo2DKeysPdf::calculateBandWidth(), RooNDKeysPdf::calculateBandWidth(), ClassImp(), RooStats::HypoTestResult::CLbError(), RooStats::HypoTestResult::CLsplusbError(), TSpectrum2Painter::ColorCalculation(), ROOT::Math::gv_detail::convert(), coordinates4D(), RooAbsData::corrcov(), RooAbsData::corrcovMatrix(), ROOT::Minuit2::Minuit2Minimizer::Correlation(), ROOT::Fit::FitResult::Correlation(), ROOT::Math::Minimizer::Correlation(), ROOT::Math::VectorUtil::CosTheta(), ROOT::Minuit2::HessianGradientCalculator::DeltaGradient(), ROOT::Math::VectorUtil::DeltaR(), TFDISTR::Density(), ROOT::Math::SqrtLowVariableTransformation::DInt2Ext(), ROOT::Minuit2::SqrtLowParameterTransformation::DInt2Ext(), ROOT::Minuit2::SqrtUpParameterTransformation::DInt2Ext(), ROOT::Math::SqrtUpVariableTransformation::DInt2Ext(), ROOT::Math::GSLSimAnFunc::Distance(), TAttLine::DistancetoLine(), TGraphAsymmErrors::Divide(), ROOT::Math::MultiNumGradFunction::DoDerivative(), doTestL(), doTestLA(), DotProduct(), ROOT::Math::PtEtaPhiM4D< ScalarType >::E(), ROOT::Math::PxPyPzM4D< ScalarType >::E(), EightBitSetColors(), ErrorIntegral(), TLorentzVector::Et(), ROOT::Math::PxPyPzM4D< ScalarType >::Et(), ROOT::Math::PxPyPzE4D< ScalarType >::Et(), ROOT::Math::Impl::Eta_FromRhoZ(), RooGExpModel::evalCerfApprox(), RooGaussModel::evalCerfApprox(), TMultiDimFit::EvalError(), TRolke::EvalLikeMod4(), RooNovosibirsk::evaluate(), RooGaussModel::evaluate(), RooBukinPdf::evaluate(), RooJeffreysPrior::evaluate(), RooVoigtian::evaluate(), RooGExpModel::evaluate(), ROOT::Minuit2::FumiliStandardMaximumLikelihoodFCN::EvaluateAll(), RooKeysPdf::evaluateFull(), ROOT::Fit::FitUtil::EvaluateLogLGradient(), ROOT::Fit::FitUtil::EvaluatePoissonBinPdf(), ROOT::Fit::FitUtil::EvaluatePoissonLogLGradient(), ExactResult(), TMVA::PDEFoam::Explore(), TFoam::Explore(), ROOT::Minuit2::SinParameterTransformation::Ext2int(), ROOT::Minuit2::SqrtUpParameterTransformation::Ext2int(), ROOT::Minuit2::SqrtLowParameterTransformation::Ext2int(), ROOT::Math::SqrtUpVariableTransformation::Ext2int(), ROOT::Math::SqrtLowVariableTransformation::Ext2int(), ROOT::Math::SinVariableTransformation::Ext2int(), feynman(), TKDTreeBinning::FillBinData(), RooAbsData::fillHistogram(), ROOT::Minuit2::MnMinos::FindCrossValue(), RooIntegralMorph::MorphCacheElem::findRange(), RooAbsPdf::fitTo(), ROOT::Minuit2::FumiliStandardChi2FCN::FumiliStandardChi2FCN(), RooKeysPdf::g(), G__G__RooFitCore1_503_0_16(), ROOT::Math::LorentzVector< CoordSystem >::Gamma(), gaus2d(), gaus2dnormal(), gaus3d(), gausnorm(), ROOT::Minuit2::GaussDataGen::GaussDataGen(), ROOT::Math::gaussian_pdf(), GaussPdf(), VectorTest< Dim >::genData(), generate(), TGenPhaseSpace::Generate(), RooAbsPdf::generateBinned(), RooBDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), genMatrix(), genPoisson(), genPoisson2(), RooTreeDataStore::get(), RooMultiVarGaussian::getAnalyticalIntegral(), TFile::GetBestBuffer(), TMapFile::GetBestBuffer(), RooHistError::getBinomialIntervalAsym(), RooHistError::getBinomialIntervalEff(), ROOT::Fit::FitResult::GetConfidenceIntervals(), ROOT::Fit::FitResult::GetCorrelationMatrix(), TKDE::GetError(), TMVA::MethodPDERS::GetError(), CmsMagField::GetField(), ROOT::Minuit2::GaussianModelFunction::GetGradient(), RooStats::ProfileLikelihoodCalculator::GetHypoTest(), TFoam::GetIntegMC(), RooHistError::getInterval(), TMVA::MethodBase::GetMaximumSignificance(), FTExtrdGlyph::GetNormal(), RooHistError::getPoissonIntervalCalc(), RooAbsReal::getPropagatedError(), TKDE::GetRAMISE(), TMVA::MethodBase::GetRegressionDeviation(), TMVA::MethodKNN::getRMS(), TMVA::MethodBase::GetSignificance(), TFoam::GetWtParams(), gl2psGetPlaneFromPoints(), gl2psNorm(), gsl_poly_complex_solve_cubic(), gsl_poly_complex_solve_quartic(), hz_calc(), ROOT::Math::Cephes::igami(), ROOT::Math::Cephes::incbi(), ROOT::Minuit2::GaussFcn2::Init(), ROOT::Fit::Init2DGaus(), TMVA::MethodRuleFit::InitEventSample(), ROOT::Fit::InitGaus(), RooNDKeysPdf::initialize(), RooSegmentedIntegrator1D::initialize(), ROOT::Minuit2::SqrtLowParameterTransformation::Int2ext(), ROOT::Minuit2::SqrtUpParameterTransformation::Int2ext(), ROOT::Math::SqrtUpVariableTransformation::Int2ext(), ROOT::Math::SqrtLowVariableTransformation::Int2ext(), ROOT::TF1Helper::IntegralError(), interference(), IntervalExamples(), ROOT::Math::VectorUtil::InvariantMass(), TFumili::InvertZ(), JeffreysPriorDemo(), kdTreeBinning(), ROOT::Math::landau_cdf(), ROOT::Math::landau_pdf(), ROOT::Math::Lmag(), Roo2DKeysPdf::loadDataSet(), RooNDKeysPdf::loadDataSet(), RooKeysPdf::LoadDataSet(), ROOT::Math::lognormal_pdf(), ROOT::Math::PxPyPzE4D< ScalarType >::M(), ROOT::Math::PtEtaPhiE4D< ScalarType >::M(), TGLVector3::Mag(), ROOT::Math::Mag(), main(), RooBlindTools::MakeGaussianOffset(), MakeHisto(), matrixOperations_do(), RooAbsData::meanVar(), ROOT::Math::GSLNLSMinimizer::Minimize(), ROOT::Math::GSLMinimizer::Minimize(), ROOT::Minuit2::SimplexBuilder::Minimum(), ROOT::Minuit2::ScanBuilder::Minimum(), ROOT::Minuit2::mneigen(), ROOT::Minuit2::MnGlobalCorrelationCoeff::MnGlobalCorrelationCoeff(), ROOT::Minuit2::MnMachinePrecision::MnMachinePrecision(), ROOT::Minuit2::MnUserParameterState::MnUserParameterState(), ROOT::Minuit2::mnvert(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Mt(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Mt(), ROOT::Math::PxPyPzM4D< ScalarType >::Mt(), ROOT::Math::PxPyPzE4D< ScalarType >::Mt(), N(), ROOT::Math::Cephes::ndtri(), TMath::NextPrime(), ROOT::Math::noncentral_chisquared_pdf(), TEfficiency::Normal(), ROOT::Math::normal_pdf(), TGLPlane::Normalise(), ROOT::Math::Plane3D::Normalize(), ROOT::Fit::FitResult::NormalizeErrors(), RooStats::HypoTestResult::NullPValueError(), OneBitSetColors(), ROOT::Math::AxisAngle::operator *(), ROOT::Minuit2::GaussianModelFunction::operator()(), ROOT::Minuit2::MnPosDef::operator()(), ROOT::Minuit2::MnFunctionCross::operator()(), ROOT::Minuit2::GaussRandomGen::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 1, M >::operator()(), GausND::operator()(), ROOT::Minuit2::MnHesse::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 3, M >::operator()(), ROOT::Minuit2::GaussFunction::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 2, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 5, M >::operator()(), ROOT::Minuit2::Numerical2PGradientCalculator::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, N, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 4, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 6, M >::operator()(), ROOT::Minuit2::operator<<(), TGLBoundingBox::Overlap(), ROOT::Math::PxPyPzE4D< ScalarType >::P(), ROOT::Math::PxPyPzM4D< ScalarType >::P(), TSpectrum2Painter::Paint(), TGraphPainter::PaintGraphPolar(), ROOT::Math::VectorUtil::Perp(), piRandom(), RooAbsReal::plotOnWithErrorBand(), printStats(), RooDLLSignificanceMCSModule::processAfterFit(), TMVA::MethodRuleFit::ProcessOptions(), ROOT::Math::PxPyPzM4D< ScalarType >::Pt(), ROOT::Math::PxPyPzE4D< ScalarType >::Pt(), ROOT::Math::Cylindrical3D< T >::R(), ROOT::Math::Cartesian3D< T >::R(), ROOT::Math::Cartesian2D< T >::R(), RooFitResult::randomizePars(), read(), ROOT::Math::Quaternion::Rectify(), ROOT::Math::Rotation3D::Rectify(), ROOT::Math::LorentzRotation::Rectify(), regression_averagedevs(), rf402_datahandling(), rf609_xychi2fit(), ROOT::Math::Cartesian3D< T >::Rho(), RooAbsData::rmsVar(), RooBukinPdf::RooBukinPdf(), RooEllipse::RooEllipse(), RooHist::RooHist(), RooVoigtian::RooVoigtian(), TMVA::Rule::RuleDist(), ROOT::Math::VavilovAccurate::Rzero(), TFoamSampler::SampleBin(), TUnuranSampler::SampleBin(), TStructViewerGUI::Scale(), TSpectrum3::SearchFast(), ROOT::Math::BoostX::SetComponents(), ROOT::Math::BoostZ::SetComponents(), ROOT::Math::Boost::SetComponents(), ROOT::Math::BoostY::SetComponents(), RooFitResult::setCovarianceMatrix(), ROOT::Math::VavilovFast::SetKappaBeta2(), TKDE::SetKernel(), ROOT::Minuit2::MnMachinePrecision::SetPrecision(), TKDE::SetSigma(), RooAbsData::sigma(), singularFunction(), TH2::Smooth(), Quad::Solve(), Rgl::Mc::TF3EdgeSplitter::SplitEdge(), TMath::Sqrt(), SumDistance2(), ROOT::Math::tdistribution_pdf(), test12(), test3D(), test4D(), test7(), test8(), TestBasic609::testCode(), TestBasic402::testCode(), testDerivation(), testDivide1(), testDivide2(), testDivide2D1(), testDivide2D2(), testDivide3D1(), testDivide3D2(), testDivideVar1(), testDivideVar2(), testDivSparse1(), testDivSparse2(), testDummy(), testFit(), TestJeffreysGaussMean(), TestJeffreysGaussMeanAndSigma(), TestJeffreysGaussSigma(), testLorentzVector(), testRandomDist(), testSphere(), testVectorUtil(), tgraph2d1(), tgraph2d2(), tgraph2d3(), Think(), TSpectrum2Painter::Transform(), TrueColorSetColors(), RooMCIntegrator::vegas(), RooDataHist::weightError(), TEfficiency::Wilson(), write(), writeTrack(), ROOT::Minuit2::MnParabola::X_neg(), and ROOT::Minuit2::MnParabola::X_pos().

double tan ( double   ) 

Referenced by TFormulaPrimitive::BuildBasicFormulas(), ROOT::Math::cauchy_quantile(), ROOT::Math::cauchy_quantile_c(), ROOT::Math::Impl::Eta_FromTheta(), genPoisson(), genPoisson2(), TMath::Tan(), test3D(), test4D(), and test_tan().

double tanh ( double   ) 

Referenced by TFormulaPrimitive::BuildBasicFormulas(), and TMath::TanH().


Generated on Tue Jul 5 16:04:32 2011 for ROOT_528-00b_version by  doxygen 1.5.1