14#ifndef RooFit_Detail_MathFuncs_h
15#define RooFit_Detail_MathFuncs_h
31 if (
n < 0 || k < 0 ||
n < k)
36 int k1 = std::min(k,
n - k);
39 for (
double i =
k1; i > 1.; --i) {
46template <
typename DoubleArray>
55 }
else if (degree == 0) {
57 }
else if (degree == 1) {
60 double a1 = coefs[1] -
a0;
63 }
else if (degree == 2) {
66 double a1 = 2 * (coefs[1] -
a0);
67 double a2 = coefs[2] -
a1 -
a0;
74 double result = coefs[0] * s;
75 for (
int i = 1; i < degree; i++) {
79 result += t * coefs[degree];
87 const double arg =
x - mean;
88 const double sig =
sigma;
89 return std::exp(-0.5 * arg * arg / (sig * sig));
92template <
typename DoubleArray>
96 for (std::size_t i = 0; i <
nFactors; ++i) {
103inline double ratio(
double numerator,
double denominator)
105 return numerator / denominator;
108inline double bifurGauss(
double x,
double mean,
double sigmaL,
double sigmaR)
129template <
bool pdfMode = false,
typename DoubleArray>
133 for (
int i =
nCoeffs - 2; i >= 0; i--) {
140template <
typename DoubleArray>
155 for (
unsigned int i = 0;
nCoeffs != i; ++i) {
165template <
typename DoubleArray>
176template <
typename DoubleArray>
180 for (
unsigned int i = 0; i <
compSize; i++) {
186inline unsigned int uniformBinNumber(
double low,
double high,
double val,
unsigned int numBins,
double coef)
188 double binWidth = (high - low) / numBins;
189 return coef * (val >= high ? numBins - 1 : std::abs((val - low) / binWidth));
192template <
typename DoubleArray>
198 while (boundaries != it && (end == it || end == it + 1 ||
x < *it)) {
201 return it - boundaries;
204template <
typename DoubleArray>
209 return coef * std::max(0, tmp);
212template <
typename DoubleArray>
215 double binWidth = (high - low) / numBins;
216 int idx = val >= high ? numBins - 1 : std::abs((val - low) / binWidth);
219 double central = low + (idx + 0.5) * binWidth;
220 if (val > low + 0.5 * binWidth && val < high - 0.5 * binWidth) {
223 slope = vals[idx] - vals[idx - 1];
225 slope = vals[idx + 1] - vals[idx];
227 return vals[idx] +
slope * (val - central) / binWidth;
240 }
else if (
x == 0.0) {
241 return std::exp(-par);
244 return std::exp(out);
258 }
else if (code == 1) {
261 return res * (std::pow(high / nominal, +
paramVal) - 1);
263 return res * (std::pow(low / nominal, -
paramVal) - 1);
265 }
else if (code == 2) {
267 double a = 0.5 * (high + low) - nominal;
268 double b = 0.5 * (high - low);
271 return (2 *
a +
b) * (
paramVal - 1) + high - nominal;
273 return -1 * (2 *
a -
b) * (
paramVal + 1) + low - nominal;
281 }
else if (code == 4 || code == 6) {
290 mod =
x * (high - nominal);
292 mod =
x * (nominal - low);
301 mod =
x * (S + t * A * (15 + t * t * (-10 + t * t * 3)));
310 }
else if (code == 5) {
325 double logHi = std::log(high);
326 double logLo = std::log(low);
343 double x0Sq = x0 * x0;
345 double a = 1. / (8 * x0) * (15 *
A0 - 7 * x0 *
S1 + x0 * x0 *
A2);
346 double b = 1. / (8 *
x0Sq) * (-24 + 24 *
S0 - 9 * x0 *
A1 + x0 * x0 *
S2);
347 double c = 1. / (4 *
x0Sq * x0) * (-5 *
A0 + 5 * x0 *
S1 - x0 * x0 *
A2);
348 double d = 1. / (4 *
x0Sq *
x0Sq) * (12 - 12 *
S0 + 7 * x0 *
A1 - x0 * x0 *
S2);
349 double e = 1. / (8 *
x0Sq *
x0Sq * x0) * (+3 *
A0 - 3 * x0 *
S1 + x0 * x0 *
A2);
356 return res * (
mod - 1.0);
362template <
typename ParamsArray,
typename DoubleArray>
366 double total = nominal;
367 for (std::size_t i = 0; i <
n; ++i) {
402 if (std::abs(pdf) < 1
e-10 && std::abs(weight) < 1
e-10) {
406 return pdf - weight - weight * (std::log(pdf) - std::log(weight));
410 return -weight * std::log(pdf);
414template <
typename DoubleArray>
419 for (
unsigned int i = 1; i <
n; ++i) {
428 double t = (
m - m0) /
sigma;
435 return std::exp(-0.5 * t * t);
441 return a * std::pow(
r / (
b - t),
n);
453 return std::erf(arg);
507 }
else if (
xMin > mean) {
524template <
bool pdfMode = false,
typename DoubleArray>
531 for (
int i =
nCoeffs - 2; i >= 0; i--) {
537 max = max * std::pow(
xMax, 1 + lowestOrder);
538 min = min * std::pow(
xMin, 1 + lowestOrder);
546#if defined(FP_FAST_FMA)
547 return std::fma(
x,
y, z);
550#if defined(__clang__)
551#pragma STDC FP_CONTRACT ON
557template <
typename DoubleArray>
597 for (
unsigned int i = 1;
iend != i; ++i) {
628 return std::exp(-2.0 * mu);
639 const double delta = 100.0 * std::sqrt(mu);
649 const unsigned int ixMax = std::min(
integrandMax + 1, (
double)std::numeric_limits<unsigned int>::max());
667 const double ix = 1 +
x;
674 const double root2 = std::sqrt(2.);
676 double ln_k = std::abs(std::log(k));
684 const double root2 = std::sqrt(2.);
696 const double sqrt2 = 1.4142135624;
701 if (std::abs(
n - 1.0) < 1.0e-05)
704 double sig = std::abs(
sigma);
706 double tmin = (
mMin - m0) / sig;
707 double tmax = (
mMax - m0) / sig;
730 result +=
a * sig / (1.0 -
n) * (std::pow(
r / (
b - tmin),
n - 1.0) - std::pow(
r / (
b - tmax),
n - 1.0));
740 double log_r = std::log(
r);
741 term1 =
a * std::pow(
r,
n - 1) * sig *
744 term1 =
a * sig / (1.0 -
n) * (std::pow(
r / (
b - tmin),
n - 1.0) - 1.0);
757template <
typename DoubleArray>
766 for (
int i = 0; i <= degree; ++i) {
771 for (
int j = i;
j <= degree; ++
j) {
784template <
typename DoubleArray>
790 for (
int i = 0; i <
n; ++i) {
791 for (
int j = 0;
j <
n; ++
j) {
795 return std::exp(-0.5 *
result);
801template <
typename DoubleArray>
805 for (std::size_t i = 0; i < nBins; ++i) {
806 double a = boundaries[i];
807 double b = boundaries[i + 1];
808 out += coefs[i] * std::max(0.0, std::min(
b,
xmax) - std::max(
a,
xmin));
823template <
class... Types>
ROOT::Detail::TRangeCast< T, true > TRangeDynCast
TRangeDynCast is an adapter class that allows the typed iteration through a TCollection.
static unsigned int total
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void char Point_t Rectangle_t WindowAttributes_t Float_t r
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void char Point_t Rectangle_t WindowAttributes_t Float_t Float_t Float_t Int_t Int_t UInt_t UInt_t Rectangle_t result
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void value
double lognormal_pdf(double x, double m, double s, double x0=0)
Probability density function of the lognormal distribution.
double landau_pdf(double x, double xi=1, double x0=0)
Probability density function of the Landau distribution:
double inc_gamma_c(double a, double x)
Calculates the normalized (regularized) upper incomplete gamma function (upper integral)
double inc_gamma(double a, double x)
Calculates the normalized (regularized) lower incomplete gamma function (lower integral)
double polynomialIntegral(DoubleArray coeffs, int nCoeffs, int lowestOrder, double xMin, double xMax)
In pdfMode, a coefficient for the constant term of 1.0 is implied if lowestOrder > 0.
double logNormalIntegral(double xMin, double xMax, double m0, double k)
double gaussianIntegral(double xMin, double xMax, double mean, double sigma)
Function to calculate the integral of an un-normalized RooGaussian over x.
double flexibleInterp(unsigned int code, ParamsArray params, unsigned int n, DoubleArray low, DoubleArray high, double boundary, double nominal, int doCutoff)
double multiVarGaussian(int n, DoubleArray x, DoubleArray mu, DoubleArray covI)
double bifurGaussIntegral(double xMin, double xMax, double mean, double sigmaL, double sigmaR)
double bernstein(double x, double xmin, double xmax, DoubleArray coefs, int nCoefs)
The caller needs to make sure that there is at least one coefficient.
double constraintSum(DoubleArray comp, unsigned int compSize)
double cbShape(double m, double m0, double sigma, double alpha, double n)
double multipdf(int idx, DoubleArray pdfs)
double chebychevIntegral(DoubleArray coeffs, unsigned int nCoeffs, double xMin, double xMax, double xMinFull, double xMaxFull)
double recursiveFraction(DoubleArray a, unsigned int n)
double cbShapeIntegral(double mMin, double mMax, double m0, double sigma, double alpha, double n)
double polynomial(DoubleArray coeffs, int nCoeffs, int lowestOrder, double x)
In pdfMode, a coefficient for the constant term of 1.0 is implied if lowestOrder > 0.
double fast_fma(double x, double y, double z) noexcept
use fast FMA if available, fall back to normal arithmetic if not
double logNormalIntegralStandard(double xMin, double xMax, double mu, double sigma)
double interpolate1d(double low, double high, double val, unsigned int numBins, DoubleArray vals)
double landau(double x, double mu, double sigma)
double gaussian(double x, double mean, double sigma)
Function to evaluate an un-normalized RooGaussian.
double poisson(double x, double par)
double binomial(int n, int k)
Calculates the binomial coefficient n over k.
unsigned int uniformBinNumber(double low, double high, double val, unsigned int numBins, double coef)
double flexibleInterpSingle(unsigned int code, double low, double high, double boundary, double nominal, double paramVal, double res)
double bernsteinIntegral(double xlo, double xhi, double xmin, double xmax, DoubleArray coefs, int nCoefs)
double chebychev(DoubleArray coeffs, unsigned int nCoeffs, double x_in, double xMin, double xMax)
double product(DoubleArray factors, std::size_t nFactors)
unsigned int rawBinNumber(double x, DoubleArray boundaries, std::size_t nBoundaries)
unsigned int binNumber(double x, double coef, DoubleArray boundaries, unsigned int nBoundaries, int nbins, int blo)
double logNormalStandard(double x, double sigma, double mu)
double bifurGauss(double x, double mean, double sigmaL, double sigmaR)
double ratio(double numerator, double denominator)
double approxErf(double arg)
double effProd(double eff, double pdf)
double poissonIntegral(int code, double mu, double x, double integrandMin, double integrandMax, unsigned int protectNegative)
double logNormal(double x, double k, double m0)
double stepFunctionIntegral(double xmin, double xmax, std::size_t nBins, DoubleArray boundaries, DoubleArray coefs)
double nll(double pdf, double weight, int binnedL, int doBinOffset)
double efficiency(double effFuncVal, int catIndex, int sigCatIndex)
double exponentialIntegral(double xMin, double xMax, double constant)
Double_t QuietNaN()
Returns a quiet NaN as defined by IEEE 754.
constexpr Double_t Sqrt2()
Double_t LnGamma(Double_t z)
Computation of ln[gamma(z)] for all z.
Double_t SignalingNaN()
Returns a signaling NaN as defined by IEEE 754](http://en.wikipedia.org/wiki/NaN#Signaling_NaN).
constexpr Double_t TwoPi()
void binNumber_pullback(Types...)
static uint64_t sum(uint64_t i)