ROOT  6.06/09
Reference Guide
Classes | Namespaces | Functions
TMath.h File Reference
#include "Rtypes.h"
#include "TMathBase.h"
#include "TError.h"
#include <algorithm>
#include <limits>
#include <cmath>
#include <float.h>
+ Include dependency graph for TMath.h:

Go to the source code of this file.

Classes

struct  TMath::Limits< T >
 
struct  CompareDesc< T >
 
struct  CompareAsc< T >
 

Namespaces

 TMath
 

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::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)
 
template<typename T >
Int_t TMath::Nint (T x)
 
Double_t TMath::Sq (Double_t x)
 
Double_t TMath::Sqrt (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)
 Compute factorial(n). More...
 
LongDouble_t TMath::Power (LongDouble_t x, LongDouble_t y)
 
LongDouble_t TMath::Power (LongDouble_t x, Long64_t y)
 
LongDouble_t TMath::Power (Long64_t x, Long64_t y)
 
Double_t TMath::Power (Double_t x, Double_t y)
 
Double_t TMath::Power (Double_t x, Int_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::Finite (Double_t x)
 
Int_t TMath::IsNaN (Double_t x)
 
Double_t TMath::QuietNaN ()
 
Double_t TMath::SignalingNaN ()
 
Double_t TMath::Infinity ()
 
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 >
TMath::MinElement (Long64_t n, const T *a)
 
template<typename 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)
 Calculates hash index from any char string. More...
 
ULong_t TMath::Hash (const char *str)
 Return a case-sensitive hash value (endian independent). More...
 
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)
 Bubble sort variant to obtain the order of an array's elements into an index in order to do more useful things than the standard built in functions. More...
 
void TMath::BubbleLow (Int_t Narr, Double_t *arr1, Int_t *arr2)
 Opposite ordering of the array arr2[] to that of BubbleHigh. More...
 
Bool_t TMath::Permute (Int_t n, Int_t *a)
 Simple recursive algorithm to find the permutations of n natural numbers, not necessarily all distinct adapted from CERNLIB routine PERMU. More...
 
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)
 Computes sample quantiles, corresponding to the given probabilities Parameters: x -the data sample n - its size quantiles - computed quantiles are returned in there prob - probabilities where to compute quantiles nprob - size of prob array isSorted - is the input array x sorted? NOTE, that when the input is not sorted, an array of integers of size n needs to be allocated. More...
 
template<typename T >
Bool_t TMath::IsInside (T xp, T yp, Int_t np, T *x, T *y)
 
template<typename T >
T * TMath::Cross (const T v1[3], const T v2[3], T out[3])
 
Float_t TMath::Normalize (Float_t v[3])
 Normalize a vector v in place. More...
 
Double_t TMath::Normalize (Double_t v[3])
 Normalize a vector v in place. More...
 
template<typename T >
TMath::NormCross (const T v1[3], const T v2[3], T out[3])
 
template<typename T >
T * TMath::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)
 Calculates roots of polynomial of 3rd order a*x^3 + b*x^2 + c*x + d, where a == coef[3], b == coef[2], c == coef[1], d == coef[0] coef[3] must be different from 0 If the boolean returned by the method is false: ==> there are 3 real roots a,b,c If the boolean returned by the method is true: ==> there is one real root a and 2 complex conjugates roots (b+i*c,b-i*c) Author: Francois-Xavier Gentit. More...
 
Double_t TMath::Binomial (Int_t n, Int_t k)
 Calculate the binomial coefficient n over k. More...
 
Double_t TMath::BinomialI (Double_t p, Int_t n, Int_t k)
 Suppose an event occurs with probability p per trial Then the probability P of its occuring k or more times in n trials is termed a cumulative binomial probability the formula is P = sum_from_j=k_to_n(TMath::Binomial(n, j)* *TMath::Power(p, j)*TMathPower(1-p, n-j) For n larger than 12 BetaIncomplete is a much better way to evaluate the sum than would be the straightforward sum calculation for n smaller than 12 either method is acceptable ("Numerical Recipes") –implementation by Anna Kreshuk. More...
 
Double_t TMath::BreitWigner (Double_t x, Double_t mean=0, Double_t gamma=1)
 Calculate a Breit Wigner function with mean and gamma. More...
 
Double_t TMath::CauchyDist (Double_t x, Double_t t=0, Double_t s=1)
 Computes the density of Cauchy distribution at point x by default, standard Cauchy distribution is used (t=0, s=1) t is the location parameter s is the scale parameter The Cauchy distribution, also called Lorentzian distribution, is a continuous distribution describing resonance behavior The mean and standard deviation of the Cauchy distribution are undefined. More...
 
Double_t TMath::ChisquareQuantile (Double_t p, Double_t ndf)
 Evaluate the quantiles of the chi-squared probability distribution function. More...
 
Double_t TMath::FDist (Double_t F, Double_t N, Double_t M)
 Computes the density function of F-distribution (probability function, integral of density, is computed in FDistI). More...
 
Double_t TMath::FDistI (Double_t F, Double_t N, Double_t M)
 Calculates the cumulative distribution function of F-distribution, this function occurs in the statistical test of whether two observed samples have the same variance. More...
 
Double_t TMath::Gaus (Double_t x, Double_t mean=0, Double_t sigma=1, Bool_t norm=kFALSE)
 Calculate a gaussian function with mean and sigma. More...
 
Double_t TMath::KolmogorovProb (Double_t z)
 Calculates the Kolmogorov distribution function, Begin_Html. More...
 
Double_t TMath::KolmogorovTest (Int_t na, const Double_t *a, Int_t nb, const Double_t *b, Option_t *option)
 Statistical test whether two one-dimensional sets of points are compatible with coming from the same parent distribution, using the Kolmogorov test. More...
 
Double_t TMath::Landau (Double_t x, Double_t mpv=0, Double_t sigma=1, Bool_t norm=kFALSE)
 The LANDAU function. More...
 
Double_t TMath::LandauI (Double_t x)
 Returns the value of the Landau distribution function at point x. More...
 
Double_t TMath::LaplaceDist (Double_t x, Double_t alpha=0, Double_t beta=1)
 Computes the probability density function of Laplace distribution at point x, with location parameter alpha and shape parameter beta. More...
 
Double_t TMath::LaplaceDistI (Double_t x, Double_t alpha=0, Double_t beta=1)
 Computes the distribution function of Laplace distribution at point x, with location parameter alpha and shape parameter beta. More...
 
Double_t TMath::LogNormal (Double_t x, Double_t sigma, Double_t theta=0, Double_t m=1)
 Computes the density of LogNormal distribution at point x. More...
 
Double_t TMath::NormQuantile (Double_t p)
 Computes quantiles for standard normal distribution N(0, 1) at probability p ALGORITHM AS241 APPL. More...
 
Double_t TMath::Poisson (Double_t x, Double_t par)
 compute the Poisson distribution function for (x,par) The Poisson PDF is implemented by means of Euler's Gamma-function (for the factorial), so for any x integer argument it is correct. More...
 
Double_t TMath::PoissonI (Double_t x, Double_t par)
 compute the Poisson distribution function for (x,par) This is a non-smooth function. More...
 
Double_t TMath::Prob (Double_t chi2, Int_t ndf)
 Computation of the probability for a certain Chi-squared (chi2) and number of degrees of freedom (ndf). More...
 
Double_t TMath::Student (Double_t T, Double_t ndf)
 Computes density function for Student's t- distribution (the probability function (integral of density) is computed in StudentI). More...
 
Double_t TMath::StudentI (Double_t T, Double_t ndf)
 Calculates the cumulative distribution function of Student's t-distribution second parameter stands for number of degrees of freedom, not for the number of samples if x has Student's t-distribution, the function returns the probability of x being less than T. More...
 
Double_t TMath::StudentQuantile (Double_t p, Double_t ndf, Bool_t lower_tail=kTRUE)
 Computes quantiles of the Student's t-distribution 1st argument is the probability, at which the quantile is computed 2nd argument - the number of degrees of freedom of the Student distribution When the 3rd argument lower_tail is kTRUE (default)- the algorithm returns such x0, that P(x < x0)=p upper tail (lower_tail is kFALSE)- the algorithm returns such x0, that P(x > x0)=p the algorithm was taken from G.W.Hill, "Algorithm 396, Student's t-quantiles" "Communications of the ACM", 13(10), October 1970. More...
 
Double_t TMath::Vavilov (Double_t x, Double_t kappa, Double_t beta2)
 Returns the value of the Vavilov density function Parameters: 1st - the point were the density function is evaluated 2nd - value of kappa (distribution parameter) 3rd - value of beta2 (distribution parameter) The algorithm was taken from the CernLib function vavden(G115) Reference: A.Rotondi and P.Montagna, Fast Calculation of Vavilov distribution Nucl.Instr. More...
 
Double_t TMath::VavilovI (Double_t x, Double_t kappa, Double_t beta2)
 Returns the value of the Vavilov distribution function Parameters: 1st - the point were the density function is evaluated 2nd - value of kappa (distribution parameter) 3rd - value of beta2 (distribution parameter) The algorithm was taken from the CernLib function vavden(G115) Reference: A.Rotondi and P.Montagna, Fast Calculation of Vavilov distribution Nucl.Instr. More...
 
Double_t TMath::Voigt (Double_t x, Double_t sigma, Double_t lg, Int_t r=4)
 Computation of Voigt function (normalised). More...
 
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 wfirst)
 
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, const Double_t *w=0)
 
template<typename Iterator >
Double_t TMath::RMS (Iterator first, Iterator last)
 
template<typename Iterator , typename WeightIterator >
Double_t TMath::RMS (Iterator first, Iterator last, WeightIterator wfirst)
 
template<typename T >
Double_t TMath::StdDev (Long64_t n, const T *a, const Double_t *w=0)
 
template<typename Iterator >
Double_t TMath::StdDev (Iterator first, Iterator last)
 
template<typename Iterator , typename WeightIterator >
Double_t TMath::StdDev (Iterator first, Iterator last, WeightIterator wfirst)
 
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)
 Calculates Beta-function Gamma(p)*Gamma(q)/Gamma(p+q). More...
 
Double_t TMath::BetaCf (Double_t x, Double_t a, Double_t b)
 Continued fraction evaluation by modified Lentz's method used in calculation of incomplete Beta function. More...
 
Double_t TMath::BetaDist (Double_t x, Double_t p, Double_t q)
 Computes the probability density function of the Beta distribution (the distribution function is computed in BetaDistI). More...
 
Double_t TMath::BetaDistI (Double_t x, Double_t p, Double_t q)
 Computes the distribution function of the Beta distribution. More...
 
Double_t TMath::BetaIncomplete (Double_t x, Double_t a, Double_t b)
 Calculates the incomplete Beta-function. More...
 
Double_t TMath::BesselI (Int_t n, Double_t x)
 Compute the Integer Order Modified Bessel function I_n(x) for n=0,1,2,... More...
 
Double_t TMath::BesselK (Int_t n, Double_t x)
 Compute the Integer Order Modified Bessel function K_n(x) for n=0,1,2,... More...
 
Double_t TMath::BesselI0 (Double_t x)
 Compute the modified Bessel function I_0(x) for any real x. More...
 
Double_t TMath::BesselK0 (Double_t x)
 Compute the modified Bessel function K_0(x) for positive real x. More...
 
Double_t TMath::BesselI1 (Double_t x)
 Compute the modified Bessel function I_1(x) for any real x. More...
 
Double_t TMath::BesselK1 (Double_t x)
 Compute the modified Bessel function K_1(x) for positive real x. More...
 
Double_t TMath::BesselJ0 (Double_t x)
 Returns the Bessel function J0(x) for any real x. More...
 
Double_t TMath::BesselJ1 (Double_t x)
 Returns the Bessel function J1(x) for any real x. More...
 
Double_t TMath::BesselY0 (Double_t x)
 Returns the Bessel function Y0(x) for positive x. More...
 
Double_t TMath::BesselY1 (Double_t x)
 Returns the Bessel function Y1(x) for positive x. More...
 
Double_t TMath::StruveH0 (Double_t x)
 Struve Functions of Order 0. More...
 
Double_t TMath::StruveH1 (Double_t x)
 Struve Functions of Order 1. More...
 
Double_t TMath::StruveL0 (Double_t x)
 Modified Struve Function of Order 0. More...
 
Double_t TMath::StruveL1 (Double_t x)
 Modified Struve Function of Order 1. More...
 
Double_t TMath::DiLog (Double_t x)
 The DiLogarithm function Code translated by R.Brun from CERNLIB DILOG function C332. More...
 
Double_t TMath::Erf (Double_t x)
 Computation of the error function erf(x). More...
 
Double_t TMath::ErfInverse (Double_t x)
 returns the inverse error function x must be <-1<x<1 More...
 
Double_t TMath::Erfc (Double_t x)
 Compute the complementary error function erfc(x). More...
 
Double_t TMath::ErfcInverse (Double_t x)
 
Double_t TMath::Freq (Double_t x)
 Computation of the normal frequency function freq(x). More...
 
Double_t TMath::Gamma (Double_t z)
 Computation of gamma(z) for all z. More...
 
Double_t TMath::Gamma (Double_t a, Double_t x)
 Computation of the normalized lower incomplete gamma function P(a,x) as defined in the Handbook of Mathematical Functions by Abramowitz and Stegun, formula 6.5.1 on page 260 . More...
 
Double_t TMath::GammaDist (Double_t x, Double_t gamma, Double_t mu=0, Double_t beta=1)
 Computes the density function of Gamma distribution at point x. More...
 
Double_t TMath::LnGamma (Double_t z)
 Computation of ln[gamma(z)] for all z. More...
 
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)
 

Function Documentation

double acos ( double  )
double asin ( double  )
double atan ( double  )
double atan2 ( double  ,
double   
)
double ceil ( double  )
double cos ( double  )

Referenced by RooSpHarmonic::analyticalIntegral(), RooTruthModel::analyticalIntegral(), ROOT::Math::KelvinFunctions::Bei(), ROOT::Math::KelvinFunctions::Ber(), TMath::BesselJ0(), TMath::BesselJ1(), TMath::BesselY0(), TMath::BesselY1(), TCurlyArc::Build(), ROOT::Math::GaussLegendreIntegrator::CalcGaussLegendreSamplingPoints(), ROOT::Math::Cartesian2D< T >::Cartesian2D(), ROOT::Math::Cartesian3D< Double32_t >::Cartesian3D(), ROOT::Math::VavilovAccurate::Cdf(), ROOT::Math::VavilovAccurate::Cdf_c(), faddeeva_impl::cexp(), city_distance(), ClassImp(), ROOT::Math::gv_detail::convert(), ROOT::Vc::Scalar::cos(), TMath::Cos(), TKDE::CosineArchKernel(), ROOT::Math::cosint(), ROOT::Math::KelvinFunctions::DBei(), dfu(), ROOT::Minuit2::SinParameterTransformation::DInt2Ext(), ROOT::Math::SinVariableTransformation::DInt2Ext(), ROOT::Math::KelvinFunctions::DKei(), dpStep1(), RooSpHarmonic::evaluate(), RooTruthModel::evaluate(), RooComplex::exp(), ROOT::Math::KelvinFunctions::F1(), ROOT::Math::KelvinFunctions::F2(), RooBMixDecay::generateEvent(), RooBCPEffDecay::generateEvent(), RooBCPGenDecay::generateEvent(), RooBDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), TEveTrans::GetRotAngles(), gsl_poly_complex_solve_cubic(), gsl_poly_complex_solve_quartic(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), myFunc(), ROOT::Minuit2::GaussRandomGen::operator()(), ROOT::Math::AxisAngle::operator*(), ROOT::Math::Cartesian2D< T >::operator=(), ROOT::Math::Cartesian3D< Double32_t >::operator=(), TSpectrum2Painter::Paint(), parsecommandline(), ROOT::Math::VavilovAccurate::Pdf(), THistPainter::ProjectSinusoidal2xy(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Px(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Px(), quality_statistics(), ROOT::Math::RotationX::Rectify(), ROOT::Math::RotationY::Rectify(), ROOT::Math::RotationZ::Rectify(), RooEllipse::RooEllipse(), ROOT::Math::Cartesian2D< T >::Rotate(), TEveTrans::RotateLF(), TGLMatrix::RotateLF(), TEveTrans::RotatePF(), TGLMatrix::RotatePF(), ROOT::Math::VectorUtil::RotateX(), ROOT::Math::VectorUtil::RotateY(), ROOT::Math::VectorUtil::RotateZ(), rxv(), ryv(), rzv(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::RotationX::SetAngle(), ROOT::Math::RotationZ::SetAngle(), ROOT::Math::RotationY::SetAngle(), TQuaternion::SetAxisQAngle(), TQuaternion::SetQAngle(), TTF::SetRotationMatrix(), ROOT::Vc::Scalar::sincos(), ROOT::Math::sinint(), ROOT::Math::sph_legendre(), RooComplex::sqrt(), testCos(), testInterpolation(), testSincos(), TGSpeedo::Translate(), ROOT::Math::Polar2D< T >::X(), ROOT::Math::Polar3D< T >::X(), ROOT::Math::Cylindrical3D< T >::X(), ROOT::Math::CylindricalEta3D< T >::X(), and ROOT::Math::Polar3D< T >::Z().

double cosh ( double  )
double exp ( double  )

Referenced by TMVA::MethodBDT::AdaBoost(), TMVA::MethodBDT::AdaBoostR2(), TParallelCoord::AddVariable(), AnalyticalIntegral(), RooPoisson::analyticalIntegral(), RooExponential::analyticalIntegral(), RooCBShape::analyticalIntegral(), RooNonCentralChiSquare::analyticalIntegral(), RooArgusBG::analyticalIntegral(), RooDstD0BG::analyticalIntegral(), RooMultiVarGaussian::analyticalIntegral(), RooGaussModel::analyticalIntegral(), RooTruthModel::analyticalIntegral(), TSpectrumFit::Area(), ROOT::Math::KelvinFunctions::Bei(), ROOT::Math::KelvinFunctions::Ber(), TMath::BesselI1(), TMath::BesselK0(), TMath::BesselK1(), ROOT::Math::beta(), ROOT::Math::Cephes::beta(), ROOT::Math::beta_pdf(), ROOT::Math::bigaussian_pdf(), ROOT::Math::binomial_pdf(), RooGExpModel::calcDecayConv(), TMVA::MethodMLP::CalculateEstimator(), faddeeva_impl::cexp(), ROOT::Math::chisquared_pdf(), ClassImp(), TSpectrum2Painter::ColorCalculation(), ComputeAdaptiveWeights(), ROOT::Math::crystalball_cdf(), ROOT::Math::crystalball_cdf_c(), ROOT::Math::crystalball_function(), ROOT::Math::crystalball_integral(), ROOT::Math::crystalball_pdf(), TProofDrawProfile::DefVar(), TProofDrawProfile2D::DefVar(), TProofDrawHist::DefVar1D(), TProofDrawHist::DefVar2D(), TProofDrawHist::DefVar3D(), 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(), dpStep1(), TSpectrumFit::Erfc(), TSpectrum2Fit::Erfc(), ROOT::Math::Cephes::erfc(), RooGaussModel::evalCerf(), RooGExpModel::evalCerf(), RooGaussModel::evalCerfApprox(), RooGExpModel::evalCerfApprox(), RooGExpModel::evalCerfRe(), RooExponential::evaluate(), RooChiSquarePdf::evaluate(), RooArgusBG::evaluate(), RooBifurGauss::evaluate(), RooDstD0BG::evaluate(), RooGaussian::evaluate(), RooNonCentralChiSquare::evaluate(), RooVoigtian::evaluate(), RooCBShape::evaluate(), RooTruthModel::evaluate(), RooGaussModel::evaluate(), RooBukinPdf::evaluate(), RooGExpModel::evaluate(), RooMultiVarGaussian::evaluate(), Roo2DKeysPdf::evaluateFull(), ROOT::Vc::Scalar::exp(), TMath::Exp(), ROOT::Math::expm1(), ROOT::Math::exponential_cdf_c(), ROOT::Math::exponential_pdf(), ROOT::Math::fdistribution_pdf(), ROOT::FromHumanReadableSize(), RooKeysPdf::g(), Roo2DKeysPdf::g(), ROOT::Math::VavilovAccurate::G116f2(), ROOT::Math::gamma_pdf(), TRandom::Gaus(), gaus100d(), gaus10d(), gaus2d(), gaus3d(), ROOT::Math::RandomFunctionsImpl< TRandomEngine >::GausACR(), TMVA::MethodKNN::GausKernel(), gausnorm(), RooNDKeysPdf::gauss(), gaussian(), ROOT::Math::gaussian_pdf(), TKDE::GaussianKernel(), GaussPdf(), RooBDecay::generateEvent(), genPoisson(), genPoisson2(), TMVA::MethodBDT::GetGradBoostMVA(), ROOT::Minuit2::GaussianModelFunction::GetGradient(), TMVA::MethodFDA::GetMulticlassValues(), TMVA::MethodBDT::GetMulticlassValues(), TMVA::MethodANNBase::GetMulticlassValues(), TMVA::MethodPDEFoam::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(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), ROOT::Math::landau_cdf(), ROOT::Math::landau_pdf(), ROOT::Math::landau_xm1(), ROOT::Math::landau_xm2(), TGVerticalLayout::Layout(), TGHorizontalLayout::Layout(), RooKeysPdf::LoadDataSet(), RooGExpModel::logErfC(), ROOT::Math::lognormal_pdf(), ROOT::Math::lognormal_quantile(), ROOT::Math::lognormal_quantile_c(), Roo2DKeysPdf::lowBoundaryCorrection(), ROOT::Math::KelvinFunctions::M(), main(), Makepat(), RooMapCatEntry::mangle(), RooMappedCategory::Entry::mangle(), ROOT::Math::BrentMethods::MinimStep(), ROOT::Math::KelvinFunctions::N(), ROOT::Math::negative_binomial_pdf(), ROOT::Math::noncentral_chisquared_pdf(), ROOT::Math::normal_pdf(), ROOT::Minuit2::GaussFunction::operator()(), GaussFunction::operator()(), RooHistError::PoissonSum::operator()(), ROOT::Minuit2::GaussianModelFunction::operator()(), TGaxis::PaintAxis(), GaussFunction::ParameterGradient(), ROOT::Math::VavilovFast::Pdf(), ROOT::Math::poisson_pdf(), ROOT::Math::Cephes::pseries(), ROOT::Math::GoFTest::PValueAD1Sample(), ROOT::Math::GoFTest::PValueADKSamples(), ROOT::Math::VavilovFast::Quantile(), TMVA::VariableInfo::ReadFromStream(), TGLCameraOverlay::RenderBar(), RooStats::HypoTestInverterOriginal::RunAutoScan(), RooStats::HypoTestInverter::RunFixedScan(), TSpectrum3::SearchHighRes(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::VavilovFast::SetKappaBeta2(), TSpectrum2Painter::ShadowColorCalculation(), TSpectrumFit::Shape(), TSpectrum2Fit::Shape2(), TProofDrawHist::SlaveBegin(), TProofDrawProfile::SlaveBegin(), TProofDrawProfile2D::SlaveBegin(), XrdProofdProtocol::StartRootd(), ROOT::Math::Cephes::stirf(), ROOT::Math::tdistribution_pdf(), testExp(), testFrexp(), testUlpDiff(), ROOT::Math::CylindricalEta3D< T >::Theta(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Theta(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Theta(), ROOT::ToHumanReadableSize(), ulpDiffToReference(), TMVA::MethodBDT::UpdateTargets(), and TMath::Voigt().

int finite ( double  )
double floor ( double  )
int isnan ( double  )
double ldexp ( double  ,
int   
)
double log ( double  )

Referenced by TMath::ACosH(), RooCBShape::analyticalIntegral(), TMath::ASinH(), TMath::ATanH(), XrdProofConn::Authenticate(), TMath::BesselK0(), TMath::BesselK1(), TMath::BesselY0(), TMath::BesselY1(), ROOT::Math::beta_pdf(), ROOT::Math::binomial_pdf(), ROOT::Math::chisquared_pdf(), ClassImp(), ROOT::Math::LorentzVector< ROOT::Math::PxPyPzE4D< Double32_t > >::ColinearRapidity(), TSpectrum2Painter::ColorCalculation(), TGLScenePad::ComposePolymarker(), ComputeAdaptiveWeights(), ROOT::Math::cosint(), TCivetweb::Create(), TGLPlot3D::CreatePlot(), RooStats::BernsteinCorrection::CreateQSamplingDist(), ROOT::Math::crystalball_integral(), ROOT::Math::CylindricalEta3D< T >::CylindricalEta3D(), ROOT::Math::KelvinFunctions::DKei(), ROOT::Math::KelvinFunctions::DKer(), dpStep2(), 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(), ROOT::Math::gamma_pdf(), TRandom::Gaus(), ROOT::Math::RandomFunctionsImpl< TRandomEngine >::GausACR(), ROOT::Math::RandomFunctionsImpl< TRandomEngine >::GausBM(), GaussFunction::GaussFunction(), RooDecay::generateEvent(), RooBMixDecay::generateEvent(), RooBCPEffDecay::generateEvent(), RooBCPGenDecay::generateEvent(), RooBDecay::generateEvent(), RooGExpModel::generateEvent(), RooNonCPEigenDecay::generateEvent(), genPoisson(), genPoisson2(), TMVA::LogInterval::GetElement(), RooHistConstraint::getLogVal(), RooPoisson::getLogVal(), RooGaussian::getLogVal(), RooAbsPdf::getLogVal(), ROOT::Math::GoFTest::GetSigmaN(), 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(), ROOT::Vc::Scalar::log(), 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(), RooHistConstraint::logSum(), ROOT::Fit::BinData::LogTransform(), RooBlindTools::MakeGaussianOffset(), ROOT::Math::Vavilov::Mean(), ROOT::Math::BrentMethods::MinimStep(), ROOT::Math::Vavilov::Mode(), ROOT::Math::VavilovAccurate::Mode(), my_log2(), ROOT::Math::Cephes::ndtri(), ROOT::Math::negative_binomial_pdf(), TProofServLogHandler::Notify(), TGLScenePad::ObjectPaint(), ROOT::Minuit2::GaussRandomGen::operator()(), TSpectrum2Painter::Paint(), TMath::Poisson(), ROOT::Math::poisson_pdf(), RooStats::HistFactory::FlexibleInterpVar::PolyInterpValue(), ROOT::Math::Cephes::pseries(), ROOT::Math::GoFTest::PValueADKSamples(), TLorentzVector::Rapidity(), ROOT::Math::LorentzVector< ROOT::Math::PxPyPzE4D< Double32_t > >::Rapidity(), RooGrid::refine(), RooBukinPdf::RooBukinPdf(), RooStats::HypoTestInverterOriginal::RunAutoScan(), RooStats::HypoTestInverter::RunFixedScan(), RooStats::HypoTestInverter::RunLimit(), ROOT::Math::VavilovAccurate::Set(), ROOT::Math::VavilovFast::SetKappaBeta2(), TSessionViewer::SetLogWindow(), TFumili::SGZ(), test3D(), test4D(), testLog(), ROOT::ToHumanReadableSize(), TSpectrum2Painter::Transform(), TGLScene::UpdateLogical(), and TGLScene::UpdatePhysioLogical().

double log10 ( double  )
double pow ( double  ,
double   
)

Referenced by RooHist::addAsymmetryBinWithError(), RooHist::addEfficiencyBinWithError(), AnalyticalIntegral(), RooBernstein::analyticalIntegral(), RooNonCentralChiSquare::analyticalIntegral(), RooPolyVar::analyticalIntegral(), RooPolynomial::analyticalIntegral(), RooMultiVarGaussian::analyticalIntegral(), BinomialProbHelper::BinomialProbHelper(), TGLPhysicalShape::CalculateShapeLOD(), CheckBasicTreeProperties(), ClassImp(), RooStats::HypoTestResult::CLsError(), ROOT::Math::crystalball_function(), ROOT::Math::crystalball_integral(), ROOT::Math::TDataPointN< _val_type >::Distance(), ROOT::Math::TDataPoint< K, _val_type >::Distance(), ROOT::Math::IntegrandTransform::DoEval(), ROOT::Math::AdaptiveIntegratorMultiDim::DoIntegral(), ROOT::Math::WrappedTF1::DoParameterDerivative(), ROOT::Math::WrappedMultiTF1::DoParameterDerivative(), ROOT::Math::Impl::Eta_FromRhoZ(), RooChiSquarePdf::evaluate(), RooMoment::evaluate(), RooNonCentralChiSquare::evaluate(), RooPolyVar::evaluate(), RooPolynomial::evaluate(), RooStats::HistFactory::FlexibleInterpVar::evaluate(), PiecewiseInterpolation::evaluate(), ROOT::Math::format(), ROOT::FromHumanReadableSize(), TKDE::GetBias(), TMVA::Tools::GetCorrelationRatio(), ROOT::Math::KDTree< _DataPoint >::BinNode::GetEffectiveEntries(), TKDE::GetRAMISE(), ROOT::Math::GoFTest::GetSigmaN(), gl2psAddBoundaryInList(), gsl_poly_complex_solve_cubic(), gsl_poly_complex_solve_quartic(), RooDataHist::importDHistSet(), ROOT::Math::Cephes::incbet(), ROOT::Math::KDTree< _DataPoint >::BinNode::Insert(), ROOT::Math::KDTree< _DataPoint >::TerminalNode::Insert(), ROOT::Math::Vavilov::Kurtosis(), RooKeysPdf::LoadDataSet(), ROOT::Minuit2::mnbins(), ROOT::Math::moments(), myfunc(), myfunc2(), ROOT::Math::myRound(), ROOT::Math::noncentral_chisquared_pdf(), RooHistError::PoissonSum::operator()(), RooHistError::BinomialSumAsym::operator()(), RooHistError::BinomialSumEff::operator()(), TGraphPolargram::PaintPolarDivisions(), RooStats::HistFactory::FlexibleInterpVar::PolyInterpValue(), TMath::Power(), ROOT::Math::Cephes::pseries(), ROOT::Math::GoFTest::PValueAD1Sample(), RooStats::HypoTestInverterOriginal::RunAutoScan(), TKDE::SetKernel(), TKDE::SetKernelSigmas2(), TKDE::SetSigma(), TKDE::SetUserCanonicalBandwidth(), ROOT::Math::Vavilov::Skewness(), ROOT::Math::KDTree< _DataPoint >::TerminalNode::Split(), ROOT::Math::KDTree< _DataPoint >::TerminalNode::SplitEffectiveEntries(), ROOT::Math::Cephes::stirf(), ROOT::Math::tdistribution_pdf(), ROOT::Math::KDTree< _DataPoint >::TerminalNode::TerminalNode(), testProduct(), TestSpeed(), ROOT::ToHumanReadableSize(), and RooXYChi2Var::xErrorContribution().

double sin ( double  )

Referenced by RooSpHarmonic::analyticalIntegral(), RooTruthModel::analyticalIntegral(), ROOT::Math::KelvinFunctions::Bei(), ROOT::Math::KelvinFunctions::Ber(), TMath::BesselJ0(), TMath::BesselJ1(), TMath::BesselY0(), TMath::BesselY1(), TCurlyArc::Build(), ROOT::Math::Cartesian2D< T >::Cartesian2D(), ROOT::Math::Cartesian3D< Double32_t >::Cartesian3D(), ROOT::Math::VavilovAccurate::Cdf(), ROOT::Math::VavilovAccurate::Cdf_c(), faddeeva_impl::cexp(), city_distance(), ClassImp(), ROOT::Math::gv_detail::convert(), ROOT::Math::cosint(), ROOT::Math::KelvinFunctions::DBer(), TGeoHype::DistFromOutside(), ROOT::Math::KelvinFunctions::DKer(), dpStep1(), RooSpHarmonic::evaluate(), RooTruthModel::evaluate(), RooComplex::exp(), foo0(), foo1(), fooLib2(), fooLib3(), for(), fu(), func(), Functions(), ROOT::Math::KelvinFunctions::G1(), ROOT::Math::KelvinFunctions::G2(), ROOT::Math::Cephes::gamma(), ROOT::Math::RandomFunctionsImpl< TRandomEngine >::GausBM(), RooBCPEffDecay::generateEvent(), RooBCPGenDecay::generateEvent(), RooBDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), ROOT::Minuit2::SinParameterTransformation::Int2ext(), ROOT::Math::SinVariableTransformation::Int2ext(), ROOT::Math::KelvinFunctions::Kei(), ROOT::Math::KelvinFunctions::Ker(), ROOT::Math::Cephes::lgam(), RooBlindTools::MakeGaussianOffset(), name(), ROOT::Math::AxisAngle::operator*(), ROOT::Math::Cartesian2D< T >::operator=(), ROOT::Math::Cartesian3D< Double32_t >::operator=(), TSpectrum2Painter::Paint(), TFileInfo::ParseInput(), ROOT::Math::VavilovAccurate::Pdf(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Py(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Py(), ROOT::Math::RotationX::Rectify(), ROOT::Math::RotationY::Rectify(), ROOT::Math::RotationZ::Rectify(), ROOT::Math::Polar3D< T >::Rho(), RooEllipse::RooEllipse(), ROOT::Math::Cartesian2D< T >::Rotate(), TEveTrans::RotateLF(), TGLMatrix::RotateLF(), TEveTrans::RotatePF(), TGLMatrix::RotatePF(), ROOT::Math::VectorUtil::RotateX(), ROOT::Math::VectorUtil::RotateY(), ROOT::Math::VectorUtil::RotateZ(), rxv(), ryv(), rzv(), ROOT::Math::VavilovAccurate::Set(), set_ports_option(), ROOT::Math::RotationX::SetAngle(), ROOT::Math::RotationY::SetAngle(), ROOT::Math::RotationZ::SetAngle(), TQuaternion::SetAxisQAngle(), TQuaternion::SetQAngle(), TTF::SetRotationMatrix(), ROOT::Vc::Scalar::sin(), TMath::Sin(), ROOT::Vc::Scalar::sincos(), ROOT::Math::sinint(), RooComplex::sqrt(), testInterpolation(), testSin(), testSincos(), TGSpeedo::Translate(), ROOT::Math::Polar2D< T >::Y(), ROOT::Math::Polar3D< T >::Y(), ROOT::Math::Cylindrical3D< T >::Y(), and ROOT::Math::CylindricalEta3D< T >::Y().

double sinh ( double  )
double sqrt ( double  )

Referenced by RooComplex::abs(), TMath::ACosH(), RooHist::addAsymmetryBinWithError(), RooStats::NumberCountingPdfFactory::AddData(), RooStats::NumberCountingPdfFactory::AddDataWithSideband(), RooHist::addEfficiencyBinWithError(), TEfficiency::AgrestiCoull(), AnalyticalIntegral(), RooLognormal::analyticalIntegral(), RooBifurGauss::analyticalIntegral(), RooGaussian::analyticalIntegral(), RooArgusBG::analyticalIntegral(), RooMultiVarGaussian::analyticalIntegral(), RooGaussModel::analyticalIntegral(), RooGExpModel::analyticalIntegral(), RooNDKeysPdf::analyticalIntegral(), ROOT::Math::Sqrt< T >::apply(), RooMinimizerFcn::ApplyCovarianceMatrix(), RooMinuit::applyCovarianceMatrix(), ROOT::Fit::Fitter::ApplyWeightCorrection(), TMath::ASinH(), TMath::BesselI(), TMath::BesselI1(), TMath::BesselJ0(), TMath::BesselJ1(), TMath::BesselK0(), TMath::BesselK1(), TMath::BesselY0(), TMath::BesselY1(), ROOT::Math::bigaussian_pdf(), ROOT::Math::VectorUtil::boost(), ROOT::Math::VectorUtil::boostX(), ROOT::Math::VectorUtil::boostY(), ROOT::Math::VectorUtil::boostZ(), Rgl::Mc::TMeshBuilder< DataSource, ValueType >::BuildNormals(), RooCurve::calcBandInterval(), TMVA::DataSetFactory::CalcCorrelationMatrix(), RooGExpModel::calcDecayConv(), TMVA::RuleEnsemble::CalcRuleSupport(), RooGExpModel::calcSinConv(), RooGExpModel::calcSinConvNorm(), Roo2DKeysPdf::calculateBandWidth(), RooNDKeysPdf::calculateBandWidth(), ClassImp(), TSpectrum2Painter::ColorCalculation(), ComputeAdaptiveWeights(), 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(), TGDMLWrite::CreateFakeCtub(), Baker::createImage(), ROOT::Math::crystalball_cdf(), ROOT::Math::crystalball_cdf_c(), ROOT::Math::crystalball_integral(), ROOT::Math::crystalball_pdf(), ROOT::Minuit2::HessianGradientCalculator::DeltaGradient(), ROOT::Math::VectorUtil::DeltaR(), ROOT::Minuit2::SqrtLowParameterTransformation::DInt2Ext(), ROOT::Minuit2::SqrtUpParameterTransformation::DInt2Ext(), ROOT::Math::SqrtLowVariableTransformation::DInt2Ext(), ROOT::Math::SqrtUpVariableTransformation::DInt2Ext(), ROOT::Math::GSLSimAnFunc::Distance(), TAttLine::DistancetoLine(), TGraphAsymmErrors::Divide(), ROOT::Math::MultiNumGradFunction::DoDerivative(), DoNewMinimization(), DoOldMinimization(), doTestL(), doTestLA(), RooStats::LikelihoodIntervalPlot::Draw(), ROOT::Math::PxPyPzM4D< ScalarType >::E(), ROOT::Math::PtEtaPhiM4D< ScalarType >::E(), TLorentzVector::Et(), ROOT::Math::PxPyPzE4D< Double32_t >::Et(), ROOT::Math::PxPyPzM4D< ScalarType >::Et(), ROOT::Math::Impl::Eta_FromRhoZ(), RooGaussModel::evalCerfApprox(), RooGExpModel::evalCerfApprox(), TMultiDimFit::EvalError(), TRolke::EvalLikeMod4(), RooJeffreysPrior::evaluate(), RooSecondMoment::evaluate(), RooVoigtian::evaluate(), RooGaussModel::evaluate(), RooBukinPdf::evaluate(), RooGExpModel::evaluate(), ROOT::Minuit2::FumiliStandardMaximumLikelihoodFCN::EvaluateAll(), ROOT::Fit::FitUtil::EvaluateChi2(), ROOT::Fit::FitUtil::EvaluateChi2Residual(), ROOT::Fit::FitUtil::EvaluateLogLGradient(), RooChi2Var::evaluatePartition(), ROOT::Fit::FitUtil::EvaluatePoissonBinPdf(), ROOT::Fit::FitUtil::EvaluatePoissonLogLGradient(), ExactResult(), TFoam::Explore(), TMVA::PDEFoam::Explore(), ROOT::Minuit2::SinParameterTransformation::Ext2int(), ROOT::Minuit2::SqrtLowParameterTransformation::Ext2int(), ROOT::Math::SinVariableTransformation::Ext2int(), ROOT::Minuit2::SqrtUpParameterTransformation::Ext2int(), ROOT::Math::SqrtLowVariableTransformation::Ext2int(), ROOT::Math::SqrtUpVariableTransformation::Ext2int(), vdt::fast_asin(), TKDTreeBinning::FillBinData(), RooAbsData::fillHistogram(), RooAbsReal::fillHistogram(), ROOT::Minuit2::MnMinos::FindCrossValue(), RooIntegralMorph::MorphCacheElem::findRange(), ROOT::Minuit2::FumiliStandardChi2FCN::FumiliStandardChi2FCN(), RooKeysPdf::g(), ROOT::Math::LorentzVector< ROOT::Math::PxPyPzE4D< Double32_t > >::Gamma(), gaus2d(), gaus3d(), ROOT::Math::RandomFunctionsImpl< TRandomEngine >::GausBM(), gausnorm(), ROOT::Minuit2::GaussDataGen::GaussDataGen(), ROOT::Math::gaussian_pdf(), GaussPdf(), TGenPhaseSpace::Generate(), generate(), RooAbsPdf::generateBinned(), RooBDecay::generateEvent(), RooNonCPEigenDecay::generateEvent(), genMatrix(), genPoisson(), genPoisson2(), RooTreeDataStore::get(), RooVectorDataStore::get(), RooMultiVarGaussian::getAnalyticalIntegral(), TMapFile::GetBestBuffer(), TFile::GetBestBuffer(), RooHistError::getBinomialIntervalAsym(), RooHistError::getBinomialIntervalEff(), ROOT::THistStatEntries< DIMENSIONS, PRECISION >::GetBinUncertainties(), ROOT::Fit::FitResult::GetConfidenceIntervals(), ROOT::Fit::FitResult::GetCorrelationMatrix(), TEfficiency::GetEfficiencyErrorLow(), TEfficiency::GetEfficiencyErrorUp(), TKDE::GetError(), TMVA::MethodPDERS::GetError(), ROOT::Minuit2::GaussianModelFunction::GetGradient(), RooStats::AsymptoticCalculator::GetHypoTest(), TFoam::GetIntegMC(), RooHistError::getInterval(), TMVA::MethodBase::GetMaximumSignificance(), TMVA::MethodMLP::GetMvaValue(), RooVectorDataStore::getNative(), RooHistError::getPoissonIntervalCalc(), RooAbsReal::getPropagatedError(), TKDE::GetRAMISE(), TMVA::MethodBase::GetRegressionDeviation(), TMVA::MethodKNN::getRMS(), TMVA::MethodBase::GetSignificance(), TFoam::GetWtParams(), gl2psGetPlaneFromPoints(), gl2psNorm(), gl2psRescaleAndOffset(), gsl_poly_complex_solve_cubic(), gsl_poly_complex_solve_quartic(), RooStats::HybridPlot::HybridPlot(), ROOT::Math::Cephes::igami(), ROOT::Math::Cephes::incbi(), ROOT::Minuit2::GaussFcn2::Init(), ROOT::Fit::Init2DGaus(), TMVA::MethodRuleFit::InitEventSample(), ROOT::Fit::InitGaus(), RooSegmentedIntegrator1D::initialize(), RooNDKeysPdf::initialize(), ROOT::Minuit2::SqrtLowParameterTransformation::Int2ext(), ROOT::Minuit2::SqrtUpParameterTransformation::Int2ext(), ROOT::Math::SqrtLowVariableTransformation::Int2ext(), ROOT::Math::SqrtUpVariableTransformation::Int2ext(), RooStats::SamplingDistribution::IntegralAndError(), ROOT::TF1Helper::IntegralError(), ROOT::Math::VectorUtil::InvariantMass(), TFumili::InvertZ(), vdt::isqrt(), isqrt(), vdt::isqrtf(), isqrtf(), ROOT::Math::landau_cdf(), ROOT::Math::landau_pdf(), ROOT::Math::Lmag(), Roo2DKeysPdf::loadDataSet(), RooKeysPdf::LoadDataSet(), RooNDKeysPdf::loadDataSet(), ROOT::Math::lognormal_pdf(), ROOT::Math::PxPyPzE4D< Double32_t >::M(), ROOT::Math::PtEtaPhiE4D< ScalarType >::M(), ROOT::Math::Mag(), TGLVector3::Mag(), main(), RooBlindTools::MakeGaussianOffset(), matrixOperations_do(), RooAbsData::meanVar(), ROOT::Math::GSLMinimizer::Minimize(), ROOT::Math::GSLNLSMinimizer::Minimize(), ROOT::Minuit2::ScanBuilder::Minimum(), ROOT::Minuit2::SimplexBuilder::Minimum(), ROOT::Minuit2::mneigen(), ROOT::Minuit2::MnGlobalCorrelationCoeff::MnGlobalCorrelationCoeff(), ROOT::Minuit2::MnMachinePrecision::MnMachinePrecision(), ROOT::Minuit2::MnUserParameterState::MnUserParameterState(), ROOT::Minuit2::mnvert(), ROOT::Math::PxPyPzE4D< Double32_t >::Mt(), ROOT::Math::PtEtaPhiE4D< ScalarType >::Mt(), ROOT::Math::PxPyPzM4D< ScalarType >::Mt(), ROOT::Math::PtEtaPhiM4D< ScalarType >::Mt(), 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(), TGeoToOCC::OCC_Hype(), ROOT::Minuit2::GaussFunction::operator()(), ROOT::Minuit2::MnPosDef::operator()(), ROOT::Minuit2::GaussRandomGen::operator()(), ROOT::Minuit2::MnFunctionCross::operator()(), ROOT::Minuit2::Numerical2PGradientCalculator::operator()(), ROOT::Minuit2::MnHesse::operator()(), ROOT::Minuit2::GaussianModelFunction::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposerGenDim< F, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 6, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 5, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 4, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 3, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 2, M >::operator()(), ROOT::Math::CholeskyDecompHelpers::_decomposer< F, 1, M >::operator()(), ROOT::Math::AxisAngle::operator*(), ROOT::Minuit2::operator<<(), TGLBoundingBox::Overlap(), ROOT::Math::PxPyPzE4D< Double32_t >::P(), ROOT::Math::PxPyPzM4D< ScalarType >::P(), TSpectrum2Painter::Paint(), TGraphPainter::PaintGraphPolar(), parsecommandline(), performance(), ROOT::Math::VectorUtil::Perp(), piRandom(), RooAbsReal::plotOnWithErrorBand(), printStats(), RooDLLSignificanceMCSModule::processAfterFit(), TMVA::MethodRuleFit::ProcessOptions(), ROOT::Math::PxPyPzE4D< Double32_t >::Pt(), ROOT::Math::PxPyPzM4D< ScalarType >::Pt(), quality_statistics(), ROOT::Math::Cartesian2D< T >::R(), ROOT::Math::Cartesian3D< Double32_t >::R(), ROOT::Math::Cylindrical3D< T >::R(), RooFitResult::randomizePars(), read(), ROOT::Math::Quaternion::Rectify(), ROOT::Math::LorentzRotation::Rectify(), ROOT::Math::Rotation3D::Rectify(), TMVA::regression_averagedevs(), ROOT::Math::Cartesian3D< Double32_t >::Rho(), RooAbsData::rmsVar(), RooBukinPdf::RooBukinPdf(), RooEllipse::RooEllipse(), RooHist::RooHist(), RooVoigtian::RooVoigtian(), ROOT::Vc::Scalar::rsqrt(), TMVA::Rule::RuleDist(), ROOT::Math::VavilovAccurate::Rzero(), TFoamSampler::SampleBin(), TUnuranSampler::SampleBin(), TStructViewerGUI::Scale(), TSpectrum3::SearchFast(), ROOT::Math::BoostX::SetComponents(), ROOT::Math::BoostY::SetComponents(), ROOT::Math::BoostZ::SetComponents(), ROOT::Math::Boost::SetComponents(), RooFitResult::setCovarianceMatrix(), ROOT::Math::VavilovFast::SetKappaBeta2(), TKDE::SetKernel(), ROOT::Minuit2::MnMachinePrecision::SetPrecision(), TKDE::SetSigma(), RooAbsData::sigma(), singularFunction(), TH2::Smooth(), Rgl::Mc::TF3EdgeSplitter::SplitEdge(), ROOT::Vc::Scalar::sqrt(), TMath::Sqrt(), ROOT::Vc::AVX::sqrt(), ROOT::Vc::SSE::sqrt(), ROOT::Math::tdistribution_pdf(), test12(), test3D(), test4D(), testDerivation(), testDummy(), testIntegration(), testkdTreeBinning(), testRandomDist(), testRSqrt(), testSphere(), testSqrt(), testTStatistic(), testVectorUtil(), TSpectrum2Painter::Transform(), TMVA::StatDialogMVAEffs::UpdateSignificanceHists(), TFoam::Varedu(), TMVA::PDEFoam::Varedu(), RooMCIntegrator::vegas(), RooDataHist::weightError(), TEfficiency::Wilson(), write(), writeTrack(), ROOT::Minuit2::MnParabola::X_neg(), and ROOT::Minuit2::MnParabola::X_pos().

double tan ( double  )
double tanh ( double  )

Referenced by ClassImp(), and TMath::TanH().