71 TString options,
double rho,
double nSigma,
bool rotate,
bool sortInput)
72 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
73 _rhoList(
"rhoList",
"List of rho parameters", this), _options(options), _widthFactor(rho),
74 _nSigma(nSigma), _rotate(rotate), _sortInput(sortInput), _nAdpt(1)
78 for (
const auto var : varList) {
80 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: variable " << var->
GetName()
81 <<
" is not of type RooAbsReal" << endl ;
95 TString options,
double rho,
double nSigma,
bool rotate,
bool sortInput)
96 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
97 _rhoList(
"rhoList",
"List of rho parameters", this),
98 _options(options), _widthFactor(rho), _nSigma(nSigma), _rotate(rotate),
99 _sortInput(sortInput), _nAdpt(1)
101 for (
const auto var : varList) {
103 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: variable " << var->
GetName()
104 <<
" is not of type RooAbsReal" << endl;
118 const TVectorD &rho,
TString options,
double nSigma,
bool rotate,
bool sortInput)
119 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
120 _rhoList(
"rhoList",
"List of rho parameters", this), _options(options), _widthFactor(-1.0),
121 _nSigma(nSigma), _rotate(rotate), _sortInput(sortInput), _nAdpt(1)
123 for (
const auto var : varList) {
125 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: variable " << var->
GetName()
126 <<
" is not of type RooAbsReal" << endl;
135 coutE(InputArguments)
136 <<
"ERROR: RooNDKeysPdf::RooNDKeysPdf() : The vector-size of rho is different from that of varList."
137 <<
"Unable to create the PDF." << endl;
157 const RooArgList &rhoList,
TString options,
double nSigma,
bool rotate,
bool sortInput)
158 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
159 _rhoList(
"rhoList",
"List of rho parameters", this), _options(options), _widthFactor(-1.0),
160 _nSigma(nSigma), _rotate(rotate), _sortInput(sortInput), _nAdpt(1)
162 for (
const auto var : varList) {
164 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: variable " << var->
GetName()
165 <<
" is not of type RooAbsReal" << endl;
174 for (
unsigned int i=0; i < rhoList.
size(); ++i) {
175 const auto rho = rhoList.
at(i);
177 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: parameter " << rho->
GetName()
178 <<
" is not of type RooRealVar" << endl;
187 coutE(InputArguments) <<
"ERROR: RooNDKeysPdf::RooNDKeysPdf() : The size of rhoList is different from varList."
188 <<
"Unable to create the PDF." << endl;
203 const RooArgList &rhoList,
TString options,
double nSigma,
bool rotate,
bool sortInput)
204 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
205 _rhoList(
"rhoList",
"List of rho parameters", this),
206 _options(options), _widthFactor(-1), _nSigma(nSigma), _rotate(rotate), _sortInput(sortInput),
209 for (
const auto var : varList) {
211 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: variable " << var->
GetName()
212 <<
" is not of type RooAbsReal" << endl;
222 for (
unsigned int i=0; i < rhoList.
size(); ++i) {
223 const auto rho = rhoList.
at(i);
225 coutE(InputArguments) <<
"RooNDKeysPdf::ctor(" <<
GetName() <<
") ERROR: parameter " << rho->
GetName()
226 <<
" is not of type RooRealVar" << endl;
234 coutE(InputArguments) <<
"ERROR: RooNDKeysPdf::RooNDKeysPdf() : The size of rhoList is different from varList."
235 <<
"Unable to create the PDF." << endl;
250 double rho,
double nSigma,
bool rotate,
bool sortInput)
251 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
252 _rhoList(
"rhoList",
"List of rho parameters", this), _options(
"a"), _widthFactor(rho),
253 _nSigma(nSigma), _rotate(rotate), _sortInput(sortInput), _nAdpt(1)
260 coutW(InputArguments) <<
"RooNDKeysPdf::RooNDKeysPdf() : Warning : asymmetric mirror(s) no longer supported."
274 TString options,
double rho,
double nSigma,
bool rotate,
bool sortInput)
275 :
RooAbsPdf(
name, title), _varList(
"varList",
"List of variables", this),
276 _rhoList(
"rhoList",
"List of rho parameters", this), _options(options), _widthFactor(rho),
277 _nSigma(nSigma), _rotate(rotate), _sortInput(sortInput), _nAdpt(1)
291 _varList(
"varList", this, other._varList),
292 _rhoList(
"rhoList", this, other._rhoList),
293 _options(other._options),
294 _widthFactor(other._widthFactor),
295 _nSigma(other._nSigma),
296 _fixedShape(other._fixedShape),
297 _mirror(other._mirror),
298 _debug(other._debug),
299 _verbose(other._verbose),
301 _nEvents(other._nEvents),
302 _nEventsM(other._nEventsM),
303 _nEventsW(other._nEventsW),
306 _dataPts(other._dataPts),
307 _dataPtsR(other._dataPtsR),
308 _weights0(other._weights0),
309 _weights1(other._weights1),
310 _weights(_options.Contains(
"a") ? &_weights1 : &_weights0),
311 _sortTVIdcs(other._sortTVIdcs),
312 _varName(other._varName),
319 _sigma(other._sigma),
320 _xDatLo(other._xDatLo),
321 _xDatHi(other._xDatHi),
322 _xDatLo3s(other._xDatLo3s),
323 _xDatHi3s(other._xDatHi3s),
324 _netFluxZ(other._netFluxZ),
325 _nEventsBW(other._nEventsBW),
326 _nEventsBMSW(other._nEventsBMSW),
327 _xVarLo(other._xVarLo),
328 _xVarHi(other._xVarHi),
329 _xVarLoM3s(other._xVarLoM3s),
330 _xVarLoP3s(other._xVarLoP3s),
331 _xVarHiM3s(other._xVarHiM3s),
332 _xVarHiP3s(other._xVarHiP3s),
333 _bpsIdcs(other._bpsIdcs),
334 _ibNoSort(other._ibNoSort),
335 _sIdcs(other._sIdcs),
336 _bIdcs(other._bIdcs),
337 _bmsIdcs(other._bmsIdcs),
338 _rangeBoxInfo(other._rangeBoxInfo),
339 _fullBoxInfo(other._fullBoxInfo),
341 _minWeight(other._minWeight),
342 _maxWeight(other._maxWeight),
346 _rotMat(new
TMatrixD(*other._rotMat)),
347 _sigmaR(new
TVectorD(*other._sigmaR)),
349 _sigmaAvgR(other._sigmaAvgR),
350 _rotate(other._rotate),
351 _sortInput(other._sortInput),
352 _nAdpt(other._nAdpt),
353 _tracker(other._tracker != nullptr ? new
RooChangeTracker(*other._tracker) : nullptr)
428 cxcoutD(InputArguments) <<
"RooNDKeysPdf::setOptions() options = " <<
_options
431 <<
"\n\tdebug = " <<
_debug
436 coutW(InputArguments) <<
"RooNDKeysPdf::setOptions() : Warning : nSigma = " <<
_nSigma <<
" < 2.0. "
437 <<
"Calculated normalization could be too large."
464 coutE(InputArguments) <<
"ERROR: RooNDKeysPdf::initialize() : The observable list is empty. "
465 <<
"Unable to begin generating the PDF." << endl;
470 coutE(InputArguments) <<
"ERROR: RooNDKeysPdf::initialize() : The input data set is empty. "
471 <<
"Unable to begin generating the PDF." << endl;
475 _d =
static_cast<double>(
_nDim);
477 std::vector<double> dummy(
_nDim,0.);
540 vector<RooRealVar*> dVars(
_nDim);
551 std::vector<double>& point =
_dataPts[i];
554 double myweight =
data.weight();
560 mat(j,k) += dVars[j]->getVal() * dVars[k]->getVal() * myweight;
564 point[j] = pointV[j] = dVars[j]->getVal();
566 _x0[j] += 1. * myweight;
567 _x1[j] += point[j] * myweight ;
568 _x2[j] += point[j] * point[j] * myweight ;
569 if (
_x2[j]!=
_x2[j]) exit(3);
602 for (
Int_t j=0; j<
_nDim; j++) { sigmaRraw[j] = sqrt(sigmaRraw[j]); }
641 coutI(Contents) <<
"RooNDKeysPdf::loadDataSet(" <<
this <<
")"
642 <<
"\n Number of events in dataset: " <<
_nEvents
643 <<
"\n Weighted number of events in dataset: " <<
_nEventsW << endl;
663 vector<double> dummy(
_nDim,0.);
670 vector<vector<double> > mpoints(
size,dummy);
671 vector<vector<Int_t> > mjdcs(
size);
676 vector<Int_t>& mjdxK = mjdcs[0];
677 vector<double>& mpointK = mpoints[0];
689 vector<Int_t>& mjdx0 = mjdcs[0];
691 if (
size==1 && mjdx0.empty())
continue;
695 vector<Int_t>& mjdx = mjdcs[0];
696 vector<double>& mpoint = mpoints[0];
699 Int_t eMir = 1 << mjdx.size();
700 vector<vector<double> > epoints(eMir,
x);
707 epoints[
l] = epoints[
l-size1];
709 vector<double>& epoint = epoints[
l];
710 epoint[mjdx[
Int_t(mjdx.size()-1)-
m]] = mpoint[mjdx[
Int_t(mjdx.size()-1)-
m]];
716 epoints.erase(epoints.begin());
725 for (
Int_t j=0; j<
_nDim; j++) { pointR[j] = (epoints[
m])[j]; }
748 double myweight =
data.weight();
754 coutI(Contents) <<
"RooNDKeysPdf::loadWeightSet(" <<
this <<
") : Number of weighted events : " <<
_wMap.size() << endl;
781 for (
const auto& wMapItr :
_wMap) {
782 Int_t i = wMapItr.first;
785 bool inVarRange(
true);
786 bool inVarRangePlusShell(
true);
791 inVarRange = inVarRange &&
true;
792 }
else { inVarRange = inVarRange &&
false; }
795 inVarRangePlusShell = inVarRangePlusShell &&
true;
796 }
else { inVarRangePlusShell = inVarRangePlusShell &&
false; }
801 bi->
bIdcs.push_back(i);
805 if (inVarRangePlusShell) {
815 if (inShell) bi->
sIdcs.push_back(i);
822 coutI(Contents) <<
"RooNDKeysPdf::calculateShell() : "
823 <<
"\n Events in shell " << bi->
sIdcs.size()
824 <<
"\n Events in box " << bi->
bIdcs.size()
825 <<
"\n Events in box and shell " << bi->
bpsIdcs.size()
843 cxcoutD(Eval) <<
"RooNDKeysPdf::calculatePreNorm() : "
857 for (
unsigned int i = 0; i <
_dataPtsR.size(); ++i) {
864 vector<TVectorD>::iterator dpRItr =
_dataPtsR.begin();
869 itrVecR.push_back(
itPair(i, dpRItr));
872 itrVecR.push_back(
itPair(i, dpRItr));
878 sort(itrVecR.begin(), itrVecR.end(), [=](
const itPair&
a,
const itPair&
b) {
879 return (*a.second)[j] < (*b.second)[j];
885 cxcoutD(Eval) <<
"RooNDKeysPdf::sortDataIndices() : Number of sorted events : " <<
_sortTVIdcs[j].size() << endl;
893 cxcoutD(Eval) <<
"RooNDKeysPdf::calculateBandWidth()" << endl;
904 cxcoutD(Eval) <<
"RooNDKeysPdf::calculateBandWidth() Using static bandwidth." << endl;
911 weight[j] =
_n * (*_sigmaR)[j];
918 cxcoutD(Eval) <<
"RooNDKeysPdf::calculateBandWidth() Using adaptive bandwidth." << endl;
920 double sqrt12 = sqrt(12.);
923 vector<double> dummy(
_nDim, 0.);
926 std::vector<std::vector<double>> *weights_prev(
nullptr);
927 std::vector<std::vector<double>> *weights_new(
nullptr);
948 vector<double> &weight = (*weights_new)[i];
950 double norm = (
_n * (*_sigmaR)[j]) / sqrtSigmaAvgR;
951 weight[j] = norm *
f / sqrt12;
970 std::vector<int> indices;
981 indices.push_back(ibMapItr.first);
985 for (
const auto& i : indices) {
992 const vector<double> &point =
_dataPts[i];
993 const vector<double> &weight = weights[
_idx[i]];
996 (*_dx)[j] =
x[j] - point[j];
1004 double r = (*_dx)[j];
1005 double c = 1. / (2. * weight[j] * weight[j]);
1009 g *= exp(-
c *
r *
r);
1010 g *= 1. / (sqrt2pi * weight[j]);
1027 xRm[j] = xRp[j] =
x[j];
1035 xRm[j] -=
_nSigma * (
_n * (*_sigmaR)[j]);
1036 xRp[j] +=
_nSigma * (
_n * (*_sigmaR)[j]);
1039 std::vector<TVectorD> xvecRm(1,xRm);
1040 std::vector<TVectorD> xvecRp(1,xRp);
1043 std::vector<Int_t> ibMapRT;
1048 return (*
a.second)[j] < (*
b.second)[j];
1060 auto&
m =
_nDim==1 ? ibMap : ibMapRT;
1061 m.reserve(std::distance(lo,
hi));
1062 for (it=lo; it!=
hi; ++it) {
1063 m.push_back(it->first);
1066 std::sort(
m.begin(),
m.end());
1072 for (it=lo; it!=
hi; ++it) {
1074 auto found = std::lower_bound(ibMapRT.begin(), ibMapRT.end(), it->first);
1075 if (found != ibMapRT.end() && !(it->first < *found)) {
1076 ibMap.push_back(it->first);
1080 std::sort(ibMap.begin(), ibMap.end());
1083 if (j!=
_nDim-1) { ibMapRT = std::move(ibMap); }
1091 vector<bool> doInt(
_nDim,
true);
1114 bi->
xVarLo[j] = var->getMin(rangeName);
1115 bi->
xVarHi[j] = var->getMax(rangeName);
1117 bi->
xVarLo[j] = var->getVal() ;
1118 bi->
xVarHi[j] = var->getVal() ;
1153 if (rangeName)
return 0 ;
1168 cxcoutD(Eval) <<
"Calling RooNDKeysPdf::analyticalIntegral(" <<
GetName() <<
") with code " << code
1169 <<
" and rangeName " << (rangeName?rangeName:
"<none>") << endl;
1175 vector<bool> doInt(
_nDim,
true);
1181 string rangeNameStr(rangeName) ;
1191 bool newBounds(
false);
1194 if ((var->getMin(rangeName)-bi->
xVarLo[j]!=0) ||
1195 (var->getMax(rangeName)-bi->
xVarHi[j]!=0)) {
1202 cxcoutD(Eval) <<
"RooNDKeysPdf::analyticalIntegral() : Found new boundaries ... " << (rangeName?rangeName:
"<none>") << endl;
1207 if (!bi->
filled || newBounds) {
1220 cxcoutD(Eval) <<
"RooNDKeysPdf::analyticalIntegral() : Using mirrored normalization : " << bi->
nEventsBW << endl;
1227 if (norm<0.) norm=0.;
1232 const vector<double>& weight = (*_weights)[
_idx[bi->
sIdcs[i]]];
1234 vector<double> chi(
_nDim,100.);
1237 if(!doInt[j])
continue;
1240 chi[j] = (
x[j] - bi->
xVarLo[j]) / weight[j];
1242 chi[j] = (bi->
xVarHi[j] -
x[j]) / weight[j];
1246 prob *= (0.5 +
TMath::Erf(std::abs(chi[j]) / sqrt(2.)) / 2.);
1248 prob *= (0.5 -
TMath::Erf(std::abs(chi[j]) / sqrt(2.)) / 2.);
1255 cxcoutD(Eval) <<
"RooNDKeysPdf::analyticalIntegral() : Final normalization : " << norm <<
" " << bi->
nEventsBW << endl;
1266 std::vector<RooRealVar *> varVec;
1268 for (
const auto var : varList) {
1270 coutE(InputArguments) <<
"RooNDKeysPdf::createDatasetFromHist(" <<
GetName() <<
") WARNING: variable "
1271 << var->
GetName() <<
" is not of type RooRealVar. Skip." << endl;
1274 varVec.push_back(
static_cast<RooRealVar *
>(var));
1278 unsigned int histndim(0);
1279 std::string classname = hist.
ClassName();
1280 if (classname.find(
"TH1") == 0) {
1282 }
else if (classname.find(
"TH2") == 0) {
1284 }
else if (classname.find(
"TH3") == 0) {
1287 assert(histndim == varVec.size());
1289 if (histndim > 3 || histndim <= 0) {
1290 coutE(InputArguments) <<
"RooNDKeysPdf::createDatasetFromHist(" <<
GetName()
1291 <<
") ERROR: input histogram dimension not between [1-3]: " << histndim << endl;
1299 for (
int i = 1; i <= hist.
GetXaxis()->GetNbins(); ++i) {
1303 varVec[0]->setVal(xval);
1305 if (varVec.size() == 1) {
1307 dataFromHist->
add(varSet, fval);
1310 for (
int j = 1; j <= hist.
GetYaxis()->GetNbins(); ++j) {
1312 varVec[1]->setVal(yval);
1314 if (varVec.size() == 2) {
1316 dataFromHist->
add(varSet, fval);
1319 for (
int k = 1; k <= hist.
GetZaxis()->GetNbins(); ++k) {
1321 varVec[2]->setVal(zval);
1324 dataFromHist->
add(varSet, fval);
1331 return dataFromHist;
1343 cxcoutD(Eval) <<
"RooNDKeysPdf::getWeights() Return evaluated weights." << endl;
1351 const vector<double>& weight = (*_weights)[i];
1352 mref(i,
_nDim) = weight[k];
1370 covMatRho(j, k) = (*_covMat)(j, k) *
_rho[j] *
_rho[k];
1377 (*_sigmaR)[j] = sqrt((*
_sigmaR)[j]);
size_t size(const MatrixT &matrix)
retrieve the size of a square matrix
std::vector< itPair > itVec
std::pair< Int_t, VecTVecDouble::iterator > itPair
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void data
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
TMatrixTSym< Double_t > TMatrixDSym
TMatrixT< Double_t > TMatrixD
TVectorT< Double_t > TVectorD
TIterator Use end() or range-based loops.")
const char * GetName() const override
Returns name of object.
Storage_t::size_type size() const
RooAbsArg * find(const char *name) const
Find object with given name in list.
Abstract interface for all probability density functions.
const RooArgSet * nset() const
Abstract base class for objects that represent a real value that may appear on the left hand side of ...
virtual double getMin(const char *name=nullptr) const
Get minimum of currently defined range.
Abstract base class for objects that represent a real value and implements functionality common to al...
double getVal(const RooArgSet *normalisationSet=nullptr) const
Evaluate object.
bool matchArgs(const RooArgSet &allDeps, RooArgSet &numDeps, const RooArgProxy &a) const
Utility function for use in getAnalyticalIntegral().
RooArgList is a container object that can hold multiple RooAbsArg objects.
RooAbsArg * at(Int_t idx) const
Return object at given index, or nullptr if index is out of range.
RooArgSet is a container object that can hold multiple RooAbsArg objects.
Meta object that tracks value changes in a given set of RooAbsArgs by registering itself as value cli...
bool hasChanged(bool clearState)
Returns true if state has changed since last call with clearState=true.
bool add(const RooAbsArg &var, bool valueServer, bool shapeServer, bool silent)
Overloaded RooCollection_t::add() method insert object into set and registers object as server to own...
Container class to hold unbinned data.
void add(const RooArgSet &row, double weight, double weightError)
Add one ore more rows of data.
Generic N-dimensional implementation of a kernel estimation p.d.f.
std::map< Int_t, bool > _ibNoSort
std::vector< std::vector< double > > _weights0
double analyticalIntegral(Int_t code, const char *rangeName=nullptr) const override
Implements the actual analytical integral(s) advertised by getAnalyticalIntegral.
void calculatePreNorm(BoxInfo *bi) const
bi->nEventsBMSW=0.; bi->nEventsBW=0.;
std::vector< double > _xDatHi
std::vector< std::vector< double > > * _weights
void createPdf(bool firstCall, RooDataSet const &data)
evaluation order of constructor.
double evaluate() const override
Evaluate this PDF / function / constant. Needs to be overridden by all derived classes.
void loopRange(std::vector< double > &x, std::vector< Int_t > &indices) const
determine closest points to x, to loop over in evaluate()
std::vector< double > _xDatLo
void initialize(RooDataSet const &data)
initialization
std::map< Int_t, double > _wMap
void sortDataIndices(BoxInfo *bi=nullptr)
sort entries, as needed for loopRange()
void loadDataSet(bool firstCall, RooDataSet const &data)
copy the dataset and calculate some useful variables
std::vector< TVectorD > _dataPtsR
std::vector< double > _mean
void calculateShell(BoxInfo *bi) const
determine points in +/- nSigma shell around the box determined by the variable ranges.
void calculateBandWidth()
std::vector< double > _xDatLo3s
std::vector< double > _x1
std::vector< std::vector< double > > _dataPts
std::vector< double > _x0
std::vector< double > _x2
double gauss(std::vector< double > &x, std::vector< std::vector< double > > &weights) const
loop over all closest point to x, as determined by loopRange()
std::vector< double > _rho
void loadWeightSet(RooDataSet const &data)
std::vector< itVec > _sortTVIdcs
Weights to be used. Points either to _weights0 or _weights1.
void boxInfoInit(BoxInfo *bi, const char *rangeName, Int_t code) const
std::map< std::pair< std::string, int >, BoxInfo * > _rangeBoxInfo
std::vector< Int_t > _idx
Int_t getAnalyticalIntegral(RooArgSet &allVars, RooArgSet &analVars, const char *rangeName=nullptr) const override
Interface function getAnalyticalIntergral advertises the analytical integrals that are supported.
std::vector< std::vector< double > > _weights1
std::vector< double > _xDatHi3s
TMatrixD getWeights(const int &k) const
Return evaluated weights.
std::vector< double > _sigma
void mirrorDataSet()
determine mirror dataset.
void setOptions()
set the configuration
RooDataSet * createDatasetFromHist(const RooArgList &varList, const TH1 &hist) const
std::vector< std::string > _varName
void checkInitWeights() const
RooChangeTracker * _tracker
Variable that can be changed from the outside.
virtual Double_t GetBinCenter(Int_t bin) const
Return center of bin.
TH1 is the base class of all histogram classes in ROOT.
virtual Double_t GetBinContent(Int_t bin) const
Return content of bin number bin.
const TVectorD & GetEigenValues() const
const TMatrixD & GetEigenVectors() const
virtual TMatrixTBase< Element > & Zero()
Set matrix elements to zero.
void Print(Option_t *name="") const override
Print the matrix as a table of elements.
TMatrixT< Element > & T()
const char * GetName() const override
Returns name of object.
virtual const char * ClassName() const
Returns name of class to which the object belongs.
void ToLower()
Change string to lower-case.
const char * Data() const
Bool_t Contains(const char *pat, ECaseCompare cmp=kExact) const
TVectorT< Element > & Zero()
Set vector elements to zero.
void Print(Option_t *option="") const override
Print the vector as a list of elements.
void box(Int_t pat, Double_t x1, Double_t y1, Double_t x2, Double_t y2)
RooCmdArg WeightVar(const char *name="weight", bool reinterpretAsWeight=false)
Double_t Erf(Double_t x)
Computation of the error function erf(x).
LongDouble_t Power(LongDouble_t x, LongDouble_t y)
Returns x raised to the power y.
Short_t Abs(Short_t d)
Returns the absolute value of parameter Short_t d.
constexpr Double_t TwoPi()
std::vector< double > xVarHiM3s
std::vector< Int_t > bIdcs
std::vector< double > xVarHiP3s
std::vector< double > xVarLo
std::vector< double > xVarHi
std::map< Int_t, bool > bpsIdcs
std::vector< Int_t > sIdcs
std::vector< double > xVarLoM3s
std::vector< double > xVarLoP3s
std::vector< Int_t > bmsIdcs