51namespace HFitInterface {
 
   56   if (func ==
nullptr) 
return false;
 
   74   } 
else if (
option.fErrors1)
 
   79void ExamineRange(
const TAxis * axis, std::pair<double,double> range,
int &hxfirst,
int &hxlast) {
 
   82   double xlow   = range.first;
 
   83   double xhigh  = range.second;
 
   85   std::cout << 
"xlow " << xlow << 
" xhigh = " << xhigh << std::endl;
 
   90   if (ilow > hxlast || ihigh < hxfirst) {
 
   91      Warning(
"ROOT::Fit::FillData",
"fit range is outside histogram range, no fit data for %s",axis->
GetName());
 
   94   hxfirst =  std::min( std::max( ilow, hxfirst), hxlast+1) ;
 
   95   hxlast  =  std::max( std::min( ihigh, hxlast), hxfirst-1) ;
 
   97   if (hxfirst < hxlast) {
 
  123   assert(hfit != 
nullptr);
 
  142   if (range.
Size(0) != 0) {
 
  144      if (range.
Size(0) > 1  ) {
 
  145         Warning(
"ROOT::Fit::FillData",
"support only one range interval for X coordinate");
 
  151      if (range.
Size(1) > 1  )
 
  152         Warning(
"ROOT::Fit::FillData",
"support only one range interval for Y coordinate");
 
  157      if (range.
Size(2) > 1  )
 
  158         Warning(
"ROOT::Fit::FillData",
"support only one range interval for Z coordinate");
 
  162   int n = (hxlast-hxfirst+1)*(hylast-hyfirst+1)*(hzlast-hzfirst+1);
 
  165   std::cout << 
"THFitInterface: ifirst = " << hxfirst << 
" ilast =  " << hxlast
 
  166             << 
" total bins  " << 
n 
  176   if (func !=
nullptr && func->
GetNdim() == hdim-1) ndim = hdim-1;
 
  194   for ( binx = hxfirst; binx <= hxlast; ++binx) {
 
  203      for ( biny = hyfirst; biny <= hylast; ++biny) {
 
  211         for ( binz = hzfirst; binz <= hzlast; ++binz) {
 
  221            if (func != 
nullptr) {
 
  229            double error =  hfit->
GetBinError(binx, biny, binz);
 
  232            if (ndim == hdim -1) {
 
  250            std::cout << 
"bin " << binx << 
" add point " << 
x[0] << 
"  " << hfit->
GetBinContent(binx) << std::endl;
 
  259   std::cout << 
"THFitInterface::FillData: Hist FitData size is " << dv.
Size() << std::endl;
 
  269   unsigned int n = 
data.Size();
 
  274   double xmin = *(
data.GetPoint(0,valxmin));
 
  276   double valxmax = valxmin;
 
  278   for (
unsigned int i = 1; i < 
n; ++ i) {
 
  280      double x = *(
data.GetPoint(i,val) );
 
  292   if (valxmin <= 0 && valxmax > 0 ) valxmin = valxmax;
 
  293   else if (valxmax <=0 && valxmin > 0) valxmax = valxmin;
 
  294   else if (valxmin <=0 && valxmax <= 0) { valxmin = 1; valxmax = 1; }
 
  296   double slope = std::log( valxmax/valxmin) / (
xmax - 
xmin);
 
  297   double constant = std::log(valxmin) - slope * 
xmin;
 
  309   static const double sqrtpi = 2.506628;
 
  312   unsigned int n = 
data.Size();
 
  318   double rangex = 
data.Coords(
n-1)[0] - 
data.Coords(0)[0];
 
  321   if ( rangex > 0) binwidth = rangex;
 
  323   for (
unsigned int i = 0; i < 
n; ++ i) {
 
  325      double x = *(
data.GetPoint(i,val) );
 
  329      if (val > valmax) valmax = val;
 
  332         if (dx < binwidth) binwidth = dx;
 
  337   if (allcha <= 0) 
return;
 
  338   double mean = sumx/allcha;
 
  339   double rms  = sumx2/allcha - mean*mean;
 
  343      rms  = std::sqrt(rms);
 
  358   double constant = 0.5*(valmax+ binwidth*allcha/(sqrtpi*rms));
 
  379   std::cout << 
"Gaussian initial par values" << constant << 
"   " << mean << 
"  " << rms << std::endl;
 
  391   static const double sqrtpi = 2.506628;
 
  394   unsigned int n = 
data.Size();
 
  396   double sumx = 0, sumy = 0;
 
  397   double sumx2 = 0, sumy2 = 0;
 
  400   double rangex = 
data.Coords(
n-1)[0] - 
data.Coords(0)[0];
 
  401   double rangey = 
data.Coords(
n-1)[1] - 
data.Coords(0)[1];
 
  403   double binwidthx = 1, binwidthy = 1;
 
  404   if ( rangex > 0) binwidthx = rangex;
 
  405   if ( rangey > 0) binwidthy = rangey;
 
  406   double x0 = 0, y0 = 0;
 
  407   for (
unsigned int i = 0; i < 
n; ++i) {
 
  409      const double *coords = 
data.GetPoint(i,val);
 
  410      double x = coords[0], 
y = coords[1];
 
  416      if (val > valmax) valmax = val;
 
  419         if (dx < binwidthx) binwidthx = dx;
 
  421         if (dy < binwidthy) binwidthy = dy;
 
  427   if (allcha <= 0) 
return;
 
  428   double meanx = sumx/allcha, meany = sumy/allcha;
 
  429   double rmsx  = sumx2/allcha - meanx*meanx;
 
  430   double rmsy  = sumy2/allcha - meany*meany;
 
  434      rmsx  = std::sqrt(rmsx);
 
  436      rmsx  = binwidthx*
n/4;
 
  439      rmsy  = std::sqrt(rmsy);
 
  441      rmsy  = binwidthy*
n/4;
 
  451   double constant = 0.5 * (valmax+ binwidthx*allcha/(sqrtpi*rmsx))*
 
  452                           (valmax+ binwidthy*allcha/(sqrtpi*rmsy));
 
  463   std::cout << 
"2D Gaussian initial par values" 
  487   if (fitOpt.
fErrors1 || ( 
ey == 
nullptr && ( eyl == 
nullptr || eyh == 
nullptr ) ) ) {
 
  501   else if ( ( eyl != 
nullptr && eyh != 
nullptr)  && fitOpt.
fAsymErrors)  {
 
  504      bool zeroErrorX = 
true;
 
  505      bool zeroErrorY = 
true;
 
  506      while (i < gr->GetN() && (zeroErrorX || zeroErrorY)) {
 
  508         double e2Y = eyl[i] + eyh[i];
 
  509         zeroErrorX &= (e2X <= 0);
 
  510         zeroErrorY &= (e2Y <= 0);
 
  513      if (zeroErrorX && zeroErrorY)
 
  515      else if (!zeroErrorX && zeroErrorY)
 
  517      else if (zeroErrorX && !zeroErrorY) {
 
  529      bool zeroError = 
true;
 
  530      while (i < gr->GetN() && zeroError) {
 
  531         if (
ey[i] > 0) zeroError = 
false;;
 
  539   std::cout << 
"type is " << 
type << 
" graph type is " << 
gr->
IsA()->
GetName() << std::endl;
 
  549   double *ez = 
gr->GetEZ();
 
  554   if (fitOpt.
fErrors1 || ez == 
nullptr ) {
 
  568   std::cout << 
"type is " << 
type << 
" graph2D type is " << 
gr->
IsA()->
GetName() << std::endl;
 
  588   bool useRange = ( range.
Size(0) > 0);
 
  596   std::cout << 
"DoFillData: graph npoints = " << nPoints << 
" type " << 
type << std::endl;
 
  598      double a1,a2; func->
GetRange(a1,a2); std::cout << 
"func range " << a1 << 
"  " << a2 << std::endl;
 
  603   for ( 
int i = 0; i < nPoints; ++i) {
 
  608      if (useRange && (  
x[0] < 
xmin || 
x[0] > 
xmax) ) 
continue;
 
  620         dv.
Add( gx[i], gy[i] );
 
  629         dv.
Add( gx[i], gy[i], errorY );
 
  632         std::cout << 
"Point " << i << 
"  " << gx[i] <<  
"  " << gy[i]  << 
"  " << errorY << std::endl;
 
  652         if ( errorX <=0 && errorY <= 0 ) 
continue;
 
  661            dv.
Add( gx[i], gy[i], errorX, errorY );
 
  668   std::cout << 
"TGraphFitInterface::FillData Graph FitData size is " << dv.
Size() << std::endl;
 
  676   std::vector<double> min(dim);
 
  677   std::vector<double> max(dim);
 
  680   for ( 
int i = 0; i < ncells; ++i ) {
 
  719   const int dim = 
h1->GetNdimensions();
 
  720   std::vector<double> min(dim);
 
  721   std::vector<double> max(dim);
 
  722   std::vector<Int_t>  coord(dim);
 
  725   for ( 
ULong64_t i = 0; i < nEntries; i++ )
 
  728      if ( !
value ) 
continue;
 
  733      bool insertBox = 
true;
 
  734      for ( 
int j = 0; j < dim && insertBox; ++j )
 
  742         max[j] = 
h1->GetAxis(j)->GetBinUpEdge(coord[j]);
 
  763   unsigned int const ndim = 
s1->GetNdimensions();
 
  764   std::vector<double> 
xmin(ndim);
 
  765   std::vector<double> 
xmax(ndim);
 
  766   for ( 
unsigned int i = 0; i < ndim; ++i ) {
 
  788   d.GetBinDataIntegral(dv);
 
  795   assert(
gr != 
nullptr);
 
  812   if (dv.
Size() > 0 && dv.
NDim() == 1 ) {
 
  815         Error(
"FillData",
"Inconsistent TGraph with previous data set- skip all graph data");
 
  827   assert(mg != 
nullptr);
 
  830   assert(grList != 
nullptr);
 
  836   std::cout << 
"multi-graph list of graps: " << std::endl;
 
  837   while ((obj = itr())) {
 
  838      std::cout << obj->
IsA()->
GetName() << std::endl;
 
  863   std::cout << 
"Fitting MultiGraph of type  " << 
type << std::endl;
 
  873   std::cout << 
"TGraphFitInterface::FillData MultiGraph FitData size is " << dv.
Size() << std::endl;
 
  882   assert(
gr != 
nullptr);
 
  895   double *gz = 
gr->GetZ();
 
  898   if ( 
gr->GetEZ() == 
nullptr) fitOpt.
fErrors1 = 
true;
 
  905   bool useRangeX = ( range.
Size(0) > 0);
 
  906   bool useRangeY = ( range.
Size(1) > 0);
 
  915   for ( 
int i = 0; i < nPoints; ++i) {
 
  921      if (useRangeX && (  
x[0] < 
xmin || 
x[0] > 
xmax) ) 
continue;
 
  922      if (useRangeY && (  
x[1] < 
ymin || 
x[1] > 
ymax) ) 
continue;
 
  937      double errorZ = 
gr->GetErrorZ(i);
 
  941         dv.
Add( 
x, gz[i], errorZ );
 
  946         dv.
Add( 
x, gz[i], 
ex, errorZ );
 
  952         std::cout << 
"Point " << i << 
"  " << gx[i] <<  
"  " << gy[i]  << 
"  " << errorZ << std::endl;
 
  958   std::cout << 
"THFitInterface::FillData Graph2D FitData size is " << dv.
Size() << std::endl;
 
  967      Error(
"GetConfidenceIntervals",
"Invalid object used for storing confidence intervals");
 
  975   result.GetConfidenceIntervals(
d,ci,cl);
 
  977   for (
unsigned int ipoint = 0; ipoint < 
d.NPoints(); ++ipoint) {
 
  978      const double * 
x = 
d.Coords(ipoint);
 
unsigned long long ULong64_t
const Bool_t kIterBackward
void Error(const char *location, const char *msgfmt,...)
Use this function in case an error occurred.
void Warning(const char *location, const char *msgfmt,...)
Use this function in warning situations.
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 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
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 Int_t Int_t Window_t TString Int_t GCValues_t GetPrimarySelectionOwner GetDisplay GetScreen GetColormap GetNativeEvent const char const char dpyName wid window const char font_name cursor keysym reg const char only_if_exist regb h Point_t winding char text const char depth char const char Int_t count const char ColorStruct_t color const char Pixmap_t Pixmap_t PictureAttributes_t attr const char char ret_data h unsigned char height h Atom_t Int_t ULong_t ULong_t unsigned char prop_list Atom_t Atom_t Atom_t Time_t type
Class describing the binned data sets : vectors of x coordinates, y values and optionally error on y ...
void AddBinUpEdge(const double *xup)
add the bin width data, a pointer to an array with the bin upper edge information.
ErrorType GetErrorType() const
retrieve the errortype
void Add(double x, double y)
add one dim data with only coordinate and values
void Initialize(unsigned int newPoints, unsigned int dim=1, ErrorType err=kValueError)
Preallocate a data set with given size, dimension and error type.
class describing the range in the coordinates it supports multiple range in a coordinate.
unsigned int Size(unsigned int icoord=0) const
return range size for coordinate icoord (starts from zero) Size == 0 indicates no range is present [-...
void GetRange(unsigned int irange, unsigned int icoord, double &xmin, double &xmax) const
get the i-th range for given coordinate.
unsigned int Size() const
return number of fit points
unsigned int NDim() const
return coordinate data dimension
const DataOptions & Opt() const
access to options
const DataRange & Range() const
access to range
class containing the result of the fit and all the related information (fitted parameter values,...
SparseData class representing the data of a THNSparse histogram The data needs to be converted to a B...
void Add(std::vector< double > &min, std::vector< double > &max, const double content, const double error=1.0)
Adds a new bin specified by the vectors.
Class to manage histogram axis.
virtual Double_t GetBinCenter(Int_t bin) const
Return center of bin.
virtual Double_t GetBinLowEdge(Int_t bin) const
Return low edge of bin.
virtual Int_t FindFixBin(Double_t x) const
Find bin number corresponding to abscissa x.
Int_t GetLast() const
Return last bin on the axis i.e.
virtual Double_t GetBinWidth(Int_t bin) const
Return bin width.
virtual Double_t GetBinUpEdge(Int_t bin) const
Return up edge of bin.
Int_t GetFirst() const
Return first bin on the axis i.e.
static void RejectPoint(Bool_t reject=kTRUE)
Static function to set the global flag to reject points the fgRejectPoint global flag is tested by al...
virtual void GetRange(Double_t *xmin, Double_t *xmax) const
Return range of a generic N-D function.
virtual void SetParLimits(Int_t ipar, Double_t parmin, Double_t parmax)
Set lower and upper limits for parameter ipar.
static Bool_t RejectedPoint()
See TF1::RejectPoint above.
virtual void SetParameters(const Double_t *params)
virtual void SetParameter(Int_t param, Double_t value)
virtual Bool_t IsInside(const Double_t *x) const
return kTRUE if the point is inside the function range
virtual Int_t GetNdim() const
Graphics object made of three arrays X, Y and Z with the same number of points each.
A TGraphErrors is a TGraph with error bars.
Double_t GetErrorY(Int_t bin) const override
It returns the error along Y at point i.
Double_t * GetEX() const override
Double_t GetErrorX(Int_t bin) const override
It returns the error along X at point i.
Double_t * GetEY() const override
Double_t GetErrorXhigh(Int_t bin) const override
It returns the error along X at point i.
Double_t GetErrorYlow(Int_t bin) const override
It returns the error along Y at point i.
Double_t GetErrorYhigh(Int_t bin) const override
It returns the error along Y at point i.
TClass * IsA() const override
Double_t GetErrorXlow(Int_t bin) const override
It returns the error along X at point i.
A TGraph is an object made of two arrays X and Y with npoints each.
virtual void SetPoint(Int_t i, Double_t x, Double_t y)
Set x and y values for point number i.
virtual Double_t * GetEYlow() const
virtual Double_t * GetEYhigh() const
virtual void Set(Int_t n)
Set number of points in the graph Existing coordinates are preserved New coordinates above fNpoints a...
TH1 is the base class of all histogram classes in ROOT.
virtual Double_t GetBinError(Int_t bin) const
Return value of error associated to bin number bin.
virtual Int_t GetDimension() const
virtual void GetBinXYZ(Int_t binglobal, Int_t &binx, Int_t &biny, Int_t &binz) const
Return binx, biny, binz corresponding to the global bin number globalbin see TH1::GetBin function abo...
virtual Int_t GetNcells() const
Bool_t IsBinUnderflow(Int_t bin, Int_t axis=0) const
Return true if the bin is underflow.
Bool_t IsBinOverflow(Int_t bin, Int_t axis=0) const
Return true if the bin is overflow.
virtual Double_t GetBinLowEdge(Int_t bin) const
Return bin lower edge for 1D histogram.
virtual Double_t GetBinContent(Int_t bin) const
Return content of bin number bin.
Multidimensional histogram base.
A TMultiGraph is a collection of TGraph (or derived) objects.
TList * GetListOfGraphs() const
const char * GetName() const override
Returns name of object.
Mother of all ROOT objects.
virtual TClass * IsA() const
TFitResultPtr Fit(FitObject *h1, TF1 *f1, Foption_t &option, const ROOT::Math::MinimizerOptions &moption, const char *goption, ROOT::Fit::DataRange &range)
void ExamineRange(const TAxis *axis, std::pair< double, double > range, int &hxfirst, int &hxlast)
bool AdjustError(const DataOptions &option, double &error, double value=1)
bool IsPointOutOfRange(const TF1 *func, const double *x)
void Init2DGaus(const ROOT::Fit::BinData &data, TF1 *f1)
compute initial parameter for 2D gaussian function given the fit data Set the sigma limits for zero t...
void FillData(BinData &dv, const TH1 *hist, TF1 *func=nullptr)
fill the data vector from a TH1.
void InitExpo(const ROOT::Fit::BinData &data, TF1 *f1)
compute initial parameter for an exponential function given the fit data Set the constant and slope a...
void InitGaus(const ROOT::Fit::BinData &data, TF1 *f1)
compute initial parameter for gaussian function given the fit data Set the sigma limits for zero top ...
void DoFillData(BinData &dv, const TGraph *gr, BinData::ErrorType type, TF1 *func)
BinData::ErrorType GetDataType(const TGraph *gr, DataOptions &fitOpt)
bool GetConfidenceIntervals(const TH1 *h1, const ROOT::Fit::FitResult &r, TGraphErrors *gr, double cl=0.95)
compute confidence intervals at level cl for a fitted histogram h1 in a TGraphErrors gr
This file contains a specialised ROOT message handler to test for diagnostic in unit tests.
DataOptions : simple structure holding the options on how the data are filled.
bool fErrors1
use all errors equal to 1, i.e. fit without errors (default is false)
bool fAsymErrors
use asymmetric errors in the value when available, selecting them according to the on sign of residua...
bool fNormBinVolume
normalize data by a normalized the bin volume (bin volume divided by a reference value)
bool fIntegral
use integral of bin content instead of bin center (default is false)
bool fBinVolume
normalize data by the bin volume (it is used in the Poisson likelihood fits)
bool fCoordErrors
use errors on the x coordinates when available (default is true)