|
Double_t | Abs (Double_t d) |
|
Float_t | Abs (Float_t d) |
|
Int_t | Abs (Int_t d) |
|
Long64_t | Abs (Long64_t d) |
|
Long_t | Abs (Long_t d) |
|
LongDouble_t | Abs (LongDouble_t d) |
|
Short_t | Abs (Short_t d) |
|
Double_t | ACos (Double_t) |
|
Double_t | ACosH (Double_t) |
|
Bool_t | AreEqualAbs (Double_t af, Double_t bf, Double_t epsilon) |
|
Bool_t | AreEqualRel (Double_t af, Double_t bf, Double_t relPrec) |
|
Double_t | ASin (Double_t) |
|
Double_t | ASinH (Double_t) |
|
Double_t | ATan (Double_t) |
|
Double_t | ATan2 (Double_t, Double_t) |
|
Double_t | ATanH (Double_t) |
|
Double_t | BesselI (Int_t n, Double_t x) |
| Compute the Integer Order Modified Bessel function I_n(x) for n=0,1,2,... and any real x. More...
|
|
Double_t | BesselI0 (Double_t x) |
| integer order modified Bessel function K_n(x) More...
|
|
Double_t | BesselI1 (Double_t x) |
| modified Bessel function K_0(x) More...
|
|
Double_t | BesselJ0 (Double_t x) |
| modified Bessel function K_1(x) More...
|
|
Double_t | BesselJ1 (Double_t x) |
| Bessel function J0(x) for any real x. More...
|
|
Double_t | BesselK (Int_t n, Double_t x) |
| integer order modified Bessel function I_n(x) More...
|
|
Double_t | BesselK0 (Double_t x) |
| modified Bessel function I_0(x) More...
|
|
Double_t | BesselK1 (Double_t x) |
| modified Bessel function I_1(x) More...
|
|
Double_t | BesselY0 (Double_t x) |
| Bessel function J1(x) for any real x. More...
|
|
Double_t | BesselY1 (Double_t x) |
| Bessel function Y0(x) for positive x. More...
|
|
Double_t | Beta (Double_t p, Double_t q) |
| Calculates Beta-function Gamma(p)*Gamma(q)/Gamma(p+q). More...
|
|
Double_t | 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 | 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 | BetaDistI (Double_t x, Double_t p, Double_t q) |
| Computes the distribution function of the Beta distribution. More...
|
|
Double_t | BetaIncomplete (Double_t x, Double_t a, Double_t b) |
| Calculates the incomplete Beta-function. More...
|
|
template<typename Iterator , typename Element > |
Iterator | BinarySearch (Iterator first, Iterator last, Element value) |
|
template<typename T > |
Long64_t | BinarySearch (Long64_t n, const T **array, T value) |
|
template<typename T > |
Long64_t | BinarySearch (Long64_t n, const T *array, T value) |
|
Double_t | Binomial (Int_t n, Int_t k) |
| Calculate the binomial coefficient n over k. More...
|
|
Double_t | 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 occurring 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 | BreitWigner (Double_t x, Double_t mean=0, Double_t gamma=1) |
| Calculate a Breit Wigner function with mean and gamma. More...
|
|
void | 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 | BubbleLow (Int_t Narr, Double_t *arr1, Int_t *arr2) |
| Opposite ordering of the array arr2[] to that of BubbleHigh. More...
|
|
constexpr Double_t | C () |
| Velocity of light in m s^{-1} . More...
|
|
Double_t | 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) More...
|
|
constexpr Double_t | Ccgs () |
| cm s^{-1} More...
|
|
Double_t | Ceil (Double_t x) |
|
Int_t | CeilNint (Double_t x) |
|
Double_t | ChisquareQuantile (Double_t p, Double_t ndf) |
| Evaluate the quantiles of the chi-squared probability distribution function. More...
|
|
Double_t | Cos (Double_t) |
|
Double_t | CosH (Double_t) |
|
template<typename T > |
T * | Cross (const T v1[3], const T v2[3], T out[3]) |
| Calculate the Cross Product of two vectors: out = [v1 x v2]. More...
|
|
constexpr Double_t | CUncertainty () |
| Speed of light uncertainty. More...
|
|
constexpr Double_t | DegToRad () |
| Conversion from degree to radian: More...
|
|
Double_t | DiLog (Double_t x) |
| Modified Struve functions of order 1. More...
|
|
constexpr Double_t | E () |
| Base of natural log: More...
|
|
Double_t | Erf (Double_t x) |
| Computation of the error function erf(x). More...
|
|
Double_t | Erfc (Double_t x) |
| Compute the complementary error function erfc(x). More...
|
|
Double_t | ErfcInverse (Double_t x) |
| returns the inverse of the complementary error function x must be 0<x<2 implement using the quantile of the normal distribution instead of ErfInverse for better numerical precision for large x More...
|
|
Double_t | ErfInverse (Double_t x) |
| returns the inverse error function x must be <-1<x<1 More...
|
|
constexpr Double_t | EulerGamma () |
| Euler-Mascheroni Constant. More...
|
|
Bool_t | Even (Long_t a) |
|
Double_t | Exp (Double_t x) |
|
Double_t | Factorial (Int_t i) |
| Compute factorial(n). More...
|
|
Double_t | 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 | 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...
|
|
Int_t | Finite (Double_t x) |
| Check if it is finite with a mask in order to be consistent in presence of fast math. More...
|
|
Int_t | Finite (Float_t x) |
| Check if it is finite with a mask in order to be consistent in presence of fast math. More...
|
|
Double_t | Floor (Double_t x) |
|
Int_t | FloorNint (Double_t x) |
|
Double_t | Freq (Double_t x) |
| Computation of the normal frequency function freq(x). More...
|
|
constexpr Double_t | G () |
| Gravitational constant in: m^{3} kg^{-1} s^{-2} . More...
|
|
Double_t | GamCf (Double_t a, Double_t x) |
| Computation of the incomplete gamma function P(a,x) via its continued fraction representation. More...
|
|
Double_t | 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 | Gamma (Double_t z) |
| Computation of gamma(z) for all z. More...
|
|
Double_t | 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 | GamSer (Double_t a, Double_t x) |
| Computation of the incomplete gamma function P(a,x) via its series representation. More...
|
|
Double_t | 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...
|
|
constexpr Double_t | Gcgs () |
| cm^{3} g^{-1} s^{-2} More...
|
|
template<typename Iterator > |
Double_t | GeomMean (Iterator first, Iterator last) |
| Return the geometric mean of an array defined by the iterators. More...
|
|
template<typename T > |
Double_t | GeomMean (Long64_t n, const T *a) |
| Return the geometric mean of an array a of size n. More...
|
|
constexpr Double_t | GhbarC () |
| \frac{G}{\hbar C} in (GeV/c^{2})^{-2} More...
|
|
constexpr Double_t | GhbarCUncertainty () |
| \frac{G}{\hbar C} uncertainty. More...
|
|
constexpr Double_t | Gn () |
| Standard acceleration of gravity in m s^{-2} . More...
|
|
constexpr Double_t | GnUncertainty () |
| Standard acceleration of gravity uncertainty. More...
|
|
constexpr Double_t | GUncertainty () |
| Gravitational constant uncertainty. More...
|
|
constexpr Double_t | H () |
| Planck's constant in J s . More...
|
|
ULong_t | Hash (const char *str) |
|
ULong_t | Hash (const void *txt, Int_t ntxt) |
| Calculates hash index from any char string. More...
|
|
constexpr Double_t | Hbar () |
| \hbar in J s More...
|
|
constexpr Double_t | Hbarcgs () |
| erg s More...
|
|
constexpr Double_t | HbarUncertainty () |
| \hbar uncertainty. More...
|
|
constexpr Double_t | HC () |
| hc in J m More...
|
|
constexpr Double_t | HCcgs () |
| erg cm More...
|
|
constexpr Double_t | Hcgs () |
| erg s More...
|
|
constexpr Double_t | HUncertainty () |
| Planck's constant uncertainty. More...
|
|
Double_t | Hypot (Double_t x, Double_t y) |
|
Long_t | Hypot (Long_t x, Long_t y) |
|
Double_t | Infinity () |
| Returns an infinity as defined by the IEEE standard. More...
|
|
constexpr Double_t | InvPi () |
| \frac{1.}{\pi} More...
|
|
template<typename T > |
Bool_t | IsInside (T xp, T yp, Int_t np, T *x, T *y) |
| Function which returns kTRUE if point xp,yp lies inside the polygon defined by the np points in arrays x and y, kFALSE otherwise. More...
|
|
Bool_t | IsNaN (Double_t x) |
|
Bool_t | IsNaN (Float_t x) |
|
constexpr Double_t | K () |
| Boltzmann's constant in J K^{-1} . More...
|
|
constexpr Double_t | Kcgs () |
| erg K^{-1} More...
|
|
Double_t | KolmogorovProb (Double_t z) |
| Calculates the Kolmogorov distribution function,. More...
|
|
Double_t | 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...
|
|
template<class Element , typename Size > |
Element | KOrdStat (Size n, const Element *a, Size k, Size *work=0) |
| Returns k_th order statistic of the array a of size n (k_th smallest element out of n elements). More...
|
|
constexpr Double_t | KUncertainty () |
| Boltzmann's constant uncertainty. More...
|
|
Double_t | Landau (Double_t x, Double_t mpv=0, Double_t sigma=1, Bool_t norm=kFALSE) |
| The LANDAU function. More...
|
|
Double_t | LandauI (Double_t x) |
| Returns the value of the Landau distribution function at point x. More...
|
|
Double_t | 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 | 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 | Ldexp (Double_t x, Int_t exp) |
|
constexpr Double_t | Ln10 () |
| Natural log of 10 (to convert log to ln) More...
|
|
Double_t | LnGamma (Double_t z) |
| Computation of ln[gamma(z)] for all z. More...
|
|
template<typename Iterator > |
Iterator | LocMax (Iterator first, Iterator last) |
| Return index of array with the maximum element. More...
|
|
template<typename T > |
Long64_t | LocMax (Long64_t n, const T *a) |
| Return index of array with the maximum element. More...
|
|
template<typename Iterator > |
Iterator | LocMin (Iterator first, Iterator last) |
| Return index of array with the minimum element. More...
|
|
template<typename T > |
Long64_t | LocMin (Long64_t n, const T *a) |
| Return index of array with the minimum element. More...
|
|
Double_t | Log (Double_t x) |
|
Double_t | Log10 (Double_t x) |
|
Double_t | Log2 (Double_t x) |
|
constexpr Double_t | LogE () |
| Base-10 log of e (to convert ln to log) More...
|
|
Double_t | 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 | Max (Double_t a, Double_t b) |
|
Float_t | Max (Float_t a, Float_t b) |
|
Int_t | Max (Int_t a, Int_t b) |
|
Long64_t | Max (Long64_t a, Long64_t b) |
|
Long_t | Max (Long_t a, Long_t b) |
|
Short_t | Max (Short_t a, Short_t b) |
|
UInt_t | Max (UInt_t a, UInt_t b) |
|
ULong64_t | Max (ULong64_t a, ULong64_t b) |
|
ULong_t | Max (ULong_t a, ULong_t b) |
|
UShort_t | Max (UShort_t a, UShort_t b) |
|
template<typename T > |
T | MaxElement (Long64_t n, const T *a) |
| Return maximum of array a of length n. More...
|
|
template<typename Iterator > |
Double_t | Mean (Iterator first, Iterator last) |
| Return the weighted mean of an array defined by the iterators. More...
|
|
template<typename Iterator , typename WeightIterator > |
Double_t | Mean (Iterator first, Iterator last, WeightIterator wfirst) |
| Return the weighted mean of an array defined by the first and last iterators. More...
|
|
template<typename T > |
Double_t | Mean (Long64_t n, const T *a, const Double_t *w=0) |
| Return the weighted mean of an array a with length n. More...
|
|
template<typename T > |
Double_t | Median (Long64_t n, const T *a, const Double_t *w=0, Long64_t *work=0) |
| Return the median of the array a where each entry i has weight w[i] . More...
|
|
Double_t | Min (Double_t a, Double_t b) |
|
Float_t | Min (Float_t a, Float_t b) |
|
Int_t | Min (Int_t a, Int_t b) |
|
Long64_t | Min (Long64_t a, Long64_t b) |
|
Long_t | Min (Long_t a, Long_t b) |
|
Short_t | Min (Short_t a, Short_t b) |
|
UInt_t | Min (UInt_t a, UInt_t b) |
|
ULong64_t | Min (ULong64_t a, ULong64_t b) |
|
ULong_t | Min (ULong_t a, ULong_t b) |
|
UShort_t | Min (UShort_t a, UShort_t b) |
|
template<typename T > |
T | MinElement (Long64_t n, const T *a) |
| Return minimum of array a of length n. More...
|
|
constexpr Double_t | MWair () |
| Molecular weight of dry air 1976 US Standard Atmosphere in kg kmol^{-1} or gm mol^{-1} More...
|
|
constexpr Double_t | Na () |
| Avogadro constant (Avogadro's Number) in mol^{-1} . More...
|
|
constexpr Double_t | NaUncertainty () |
| Avogadro constant (Avogadro's Number) uncertainty. More...
|
|
Long_t | NextPrime (Long_t x) |
| TMath Base functions. More...
|
|
template<typename T > |
Int_t | Nint (T x) |
| Round to nearest integer. Rounds half integers to the nearest even integer. More...
|
|
template<typename T > |
T * | Normal2Plane (const T v1[3], const T v2[3], const T v3[3], T normal[3]) |
| Calculate a normal vector of a plane. More...
|
|
Double_t | Normalize (Double_t v[3]) |
| Normalize a vector v in place. More...
|
|
Float_t | Normalize (Float_t v[3]) |
| Normalize a vector v in place. More...
|
|
template<typename T > |
T | NormCross (const T v1[3], const T v2[3], T out[3]) |
| Calculate the Normalized Cross Product of two vectors. More...
|
|
Double_t | NormQuantile (Double_t p) |
| Computes quantiles for standard normal distribution N(0, 1) at probability p. More...
|
|
Bool_t | Odd (Long_t a) |
|
Bool_t | 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...
|
|
constexpr Double_t | Pi () |
|
constexpr Double_t | PiOver2 () |
|
constexpr Double_t | PiOver4 () |
|
Double_t | 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 | PoissonI (Double_t x, Double_t par) |
| Compute the Poisson distribution function for (x,par) This is a non-smooth function. More...
|
|
Double_t | Power (Double_t x, Double_t y) |
|
Double_t | Power (Double_t x, Int_t y) |
|
LongDouble_t | Power (Long64_t x, Long64_t y) |
|
LongDouble_t | Power (LongDouble_t x, Long64_t y) |
|
LongDouble_t | Power (LongDouble_t x, LongDouble_t y) |
|
Double_t | 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...
|
|
constexpr Double_t | Qe () |
| Elementary charge in C . More...
|
|
constexpr Double_t | QeUncertainty () |
| Elementary charge uncertainty. More...
|
|
void | 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. More...
|
|
Double_t | QuietNaN () |
| Returns a quiet NaN as defined by IEEE 754 More...
|
|
constexpr Double_t | R () |
| Universal gas constant ( Na K ) in J K^{-1} mol^{-1} More...
|
|
constexpr Double_t | RadToDeg () |
| Conversion from radian to degree: More...
|
|
Double_t | Range (Double_t lb, Double_t ub, Double_t x) |
|
Int_t | Range (Int_t lb, Int_t ub, Int_t x) |
|
Long_t | Range (Long_t lb, Long_t ub, Long_t x) |
|
Short_t | Range (Short_t lb, Short_t ub, Short_t x) |
|
ULong_t | Range (ULong_t lb, ULong_t ub, ULong_t x) |
|
constexpr Double_t | Rgair () |
| Dry Air Gas Constant (R / MWair) in J kg^{-1} K^{-1} More...
|
|
template<typename Iterator > |
Double_t | RMS (Iterator first, Iterator last) |
| Return the Standard Deviation of an array defined by the iterators. More...
|
|
template<typename Iterator , typename WeightIterator > |
Double_t | RMS (Iterator first, Iterator last, WeightIterator wfirst) |
| Return the weighted Standard Deviation of an array defined by the iterators. More...
|
|
template<typename T > |
Double_t | RMS (Long64_t n, const T *a, const Double_t *w=0) |
| Return the Standard Deviation of an array a with length n. More...
|
|
Bool_t | 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. More...
|
|
constexpr Double_t | RUncertainty () |
| Universal gas constant uncertainty. More...
|
|
constexpr Double_t | Sigma () |
| Stefan-Boltzmann constant in W m^{-2} K^{-4}. More...
|
|
constexpr Double_t | SigmaUncertainty () |
| Stefan-Boltzmann constant uncertainty. More...
|
|
Double_t | Sign (Double_t a, Double_t b) |
|
Float_t | Sign (Float_t a, Float_t b) |
|
LongDouble_t | Sign (LongDouble_t a, LongDouble_t b) |
|
template<typename T1 , typename T2 > |
T1 | Sign (T1 a, T2 b) |
|
Double_t | SignalingNaN () |
| Returns a signaling NaN as defined by IEEE 754](http://en.wikipedia.org/wiki/NaN#Signaling_NaN) More...
|
|
Bool_t | SignBit (Double_t a) |
|
Bool_t | SignBit (Float_t a) |
|
template<typename Integer > |
Bool_t | SignBit (Integer a) |
|
Bool_t | SignBit (LongDouble_t a) |
|
Double_t | Sin (Double_t) |
|
Double_t | SinH (Double_t) |
|
template<typename Element , typename Index > |
void | Sort (Index n, const Element *a, Index *index, Bool_t down=kTRUE) |
|
template<typename Iterator , typename IndexIterator > |
void | SortItr (Iterator first, Iterator last, IndexIterator index, Bool_t down=kTRUE) |
|
Double_t | Sq (Double_t x) |
|
Double_t | Sqrt (Double_t x) |
|
constexpr Double_t | Sqrt2 () |
|
template<typename Iterator > |
Double_t | StdDev (Iterator first, Iterator last) |
|
template<typename Iterator , typename WeightIterator > |
Double_t | StdDev (Iterator first, Iterator last, WeightIterator wfirst) |
|
template<typename T > |
Double_t | StdDev (Long64_t n, const T *a, const Double_t *w=0) |
|
Double_t | StruveH0 (Double_t x) |
| Bessel function Y1(x) for positive x. More...
|
|
Double_t | StruveH1 (Double_t x) |
| Struve functions of order 0. More...
|
|
Double_t | StruveL0 (Double_t x) |
| Struve functions of order 1. More...
|
|
Double_t | StruveL1 (Double_t x) |
| Modified Struve functions of order 0. More...
|
|
Double_t | 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 | 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 | 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. More...
|
|
Double_t | Tan (Double_t) |
|
Double_t | TanH (Double_t) |
|
constexpr Double_t | TwoPi () |
|
Double_t | Vavilov (Double_t x, Double_t kappa, Double_t beta2) |
| Returns the value of the Vavilov density function. More...
|
|
Double_t | VavilovDenEval (Double_t rlam, Double_t *AC, Double_t *HC, Int_t itype) |
| Internal function, called by Vavilov and VavilovSet. More...
|
|
Double_t | VavilovI (Double_t x, Double_t kappa, Double_t beta2) |
| Returns the value of the Vavilov distribution function. More...
|
|
void | VavilovSet (Double_t rkappa, Double_t beta2, Bool_t mode, Double_t *WCM, Double_t *AC, Double_t *HC, Int_t &itype, Int_t &npt) |
| Internal function, called by Vavilov and VavilovI. More...
|
|
Double_t | Voigt (Double_t x, Double_t sigma, Double_t lg, Int_t r=4) |
| Computation of Voigt function (normalised). More...
|
|