58   if (ndim < 3) 
fNdim = 3;
 
   60      Error(
"TF3",
"function: %s/%s has dimension %d instead of 3",
name,formula,ndim);
 
   84TF3::TF3(
const char *
name,
Double_t (*fcn)(
Double_t *, 
Double_t *), 
Double_t xmin, 
Double_t xmax, 
Double_t ymin, 
Double_t ymax, 
Double_t zmin, 
Double_t zmax, 
Int_t npar,
Int_t ndim)
 
  111TF3::TF3(
const char *
name,
Double_t (*fcn)(
const Double_t *, 
const Double_t *), 
Double_t xmin, 
Double_t xmax, 
Double_t ymin, 
Double_t ymax, 
Double_t zmin, 
Double_t zmax, 
Int_t npar, 
Int_t ndim)
 
  148      rhs.TF3::Copy(*
this);
 
  235   Double_t rsign = (findmax) ? -1. : 1.;
 
  236   TF3 & function = 
const_cast<TF3&
>(*this); 
 
  237   Double_t xxmin = 0, yymin = 0, zzmin = 0, ttmin = 0;
 
  247         xx[0]=
fXmin + (i+0.5)*dx;
 
  249            xx[1]=
fYmin+(j+0.5)*dy;
 
  251               xx[2] = 
fZmin+(k+0.5)*dz;
 
  253               if (rsign*
tt < rsign*ttmin) {xxmin = xx[0], yymin = xx[1]; zzmin = xx[2]; ttmin=
tt;}
 
  273   if (rsign*fmin < rsign*zzmin) {
 
  274      if (
x) {
x[0] = xx[0]; 
x[1] = xx[1]; 
x[2] = xx[2];}
 
  278   if (
x) { 
x[0] = xxmin; 
x[1] = yymin; 
x[2] = zzmin; }
 
  300   double xx[3] = { 0,0,0 };
 
  303   x = xx[0]; 
y = xx[1]; z = xx[2];
 
  316   double xx[3] = { 0,0,0 };
 
  319   x = xx[0]; 
y = xx[1]; z = xx[2];
 
  358      Int_t intNegative = 0;
 
  360      for (k=0;k<
fNpz;k++) {
 
  361         xx[2] = 
fZmin+(k+0.5)*dz;
 
  362         for (j=0;j<
fNpy;j++) {
 
  363            xx[1] = 
fYmin+(j+0.5)*dy;
 
  364            for (i=0;i<
fNpx;i++) {
 
  365               xx[0] = 
fXmin+(i+0.5)*dx;
 
  366               integ = 
EvalPar(xx,parameters);
 
  367               if (integ < 0) {intNegative++; integ = -integ;}
 
  373      if (intNegative > 0) {
 
  374         Warning(
"GetRandom3",
"function:%s has %d negative values: abs assumed",
GetName(),intNegative);
 
  377         Error(
"GetRandom3",
"Integral of function is zero");
 
  380      for (i=1;i<=ncells;i++) {  
 
  417   if (
fSave.size() < 9) 
return 0;
 
  430   if (x < xmin || x > 
xmax) 
return 0;
 
  431   if (dx <= 0) 
return 0;
 
  434   if (y < ymin || y > 
ymax) 
return 0;
 
  435   if (dy <= 0) 
return 0;
 
  438   if (z < zmin || z > zmax) 
return 0;
 
  439   if (dz <= 0) 
return 0;
 
  451   Int_t k1      = (ibin  ) + (npx+1)*((jbin  ) + (npy+1)*(kbin  ));
 
  452   Int_t k2      = (ibin+1) + (npx+1)*((jbin  ) + (npy+1)*(kbin  ));
 
  453   Int_t k3      = (ibin+1) + (npx+1)*((jbin+1) + (npy+1)*(kbin  ));
 
  454   Int_t k4      = (ibin  ) + (npx+1)*((jbin+1) + (npy+1)*(kbin  ));
 
  455   Int_t k5      = (ibin  ) + (npx+1)*((jbin  ) + (npy+1)*(kbin+1));
 
  456   Int_t k6      = (ibin+1) + (npx+1)*((jbin  ) + (npy+1)*(kbin+1));
 
  457   Int_t k7      = (ibin+1) + (npx+1)*((jbin+1) + (npy+1)*(kbin+1));
 
  458   Int_t k8      = (ibin  ) + (npx+1)*((jbin+1) + (npy+1)*(kbin+1));
 
  483      Warning(
"Integral",
"failed for %s code=%d, maxpts=%d, epsrel=%g, nfnevl=%d, relerr=%g ",
GetName(),ifail,maxpts,epsrel,nfnevl,relerr);
 
  486      Info(
"Integral",
"Integral of %s using %d and tol=%f is %f , relerr=%f nfcn=%d",
GetName(),maxpts,epsrel,
result,relerr,nfnevl);
 
  510   h->SetDirectory(
nullptr);
 
  555   if ((npx < 2) || (npy < 2) || (npz < 2))
 
  576      zmin = 
fZmin + 0.5*dz;
 
  577      zmax = 
fZmax - 0.5*dz;
 
  579   Int_t nsave = (npx + 1)*(npy + 1)*(npz + 1);
 
  580   fSave.resize(nsave + 9);
 
  584   for (
Int_t k = 0, 
l = 0; k <= npz; k++) {
 
  586      for (
Int_t j = 0; j <= npy; j++) {
 
  588         for (
Int_t i = 0; i <= npx; i++) {
 
  598   fSave[nsave+4] = zmin;
 
  599   fSave[nsave+5] = zmax;
 
  600   fSave[nsave+6] = npx;
 
  601   fSave[nsave+7] = npy;
 
  602   fSave[nsave+8] = npz;
 
  626         out<<
"   "<<f3Name.
Data()<<
"->SetFillColor(ci);" << std::endl;
 
  628         out<<
"   "<<f3Name.
Data()<<
"->SetFillColor("<<
GetFillColor()<<
");"<<std::endl;
 
  632         out<<
"   "<<f3Name.
Data()<<
"->SetLineColor(ci);" << std::endl;
 
  634         out<<
"   "<<f3Name.
Data()<<
"->SetLineColor("<<
GetLineColor()<<
");"<<std::endl;
 
  638      out<<
"   "<<f3Name.
Data()<<
"->SetNpx("<<
GetNpx()<<
");"<<std::endl;
 
  640      out<<
"   "<<f3Name.
Data()<<
"->SetNpy("<<
GetNpy()<<
");"<<std::endl;
 
  642      out<<
"   "<<f3Name.
Data()<<
"->SetNpz("<<
GetNpz()<<
");"<<std::endl;
 
  645      out<<
"   "<<f3Name.
Data()<<
"->SetChisquare("<<
GetChisquare()<<
");"<<std::endl;
 
  649      out<<
"   "<<f3Name.
Data()<<
"->SetParameter("<<i<<
","<<
GetParameter(i)<<
");"<<std::endl;
 
  650      out<<
"   "<<f3Name.
Data()<<
"->SetParError("<<i<<
","<<
GetParError(i)<<
");"<<std::endl;
 
  652      out<<
"   "<<f3Name.
Data()<<
"->SetParLimits("<<i<<
","<<parmin<<
","<<parmax<<
");"<<std::endl;
 
  659   out<<
"   "<<f3Name.
Data()<<
"->Draw(" 
  660      <<quote<<
option<<quote<<
");"<<std::endl;
 
  687      Warning(
"SetNpz",
"Number of points must be >=4 && <= 10000, fNpz set to 4");
 
  689   } 
else if(npz > 10000) {
 
  690      Warning(
"SetNpz",
"Number of points must be >=4 && <= 10000, fNpz set to 10000");
 
  731      if (saved) { 
fSave.clear(); }
 
  743      Error(
"Moment3", 
"Integral zero over range");
 
  748   auto integrand = [&](
double *
x, 
double *) {
 
  749      return std::pow(
x[0], nx) * std::pow(
x[1], ny) * std::pow(
x[2], nz) * this->
EvalPar(x, 
nullptr);
 
  752   TF3 fnc(
"TF3_ExpValHelper", integrand, ax, bx, ay, by, az, bz, 0);
 
  768      Error(
"CentralMoment3", 
"Integral zero over range");
 
  777      auto integrandX = [&](
double *
x, 
double *) { 
return x[0] * this->
EvalPar(x, 
nullptr); };
 
  778      TF3 fncx(
"TF3_ExpValHelperx", integrandX, ax, bx, ay, by, az, bz, 0);
 
  785      auto integrandY = [&](
double *
x, 
double *) { 
return x[1] * this->
EvalPar(x, 
nullptr); };
 
  786      TF3 fncy(
"TF3_ExpValHelpery", integrandY, ax, bx, ay, by, az, bz, 0);
 
  793      auto integrandZ = [&](
double *
x, 
double *) { 
return x[2] * this->
EvalPar(x, 
nullptr); };
 
  794      TF3 fncz(
"TF3_ExpValHelperz", integrandZ, ax, bx, ay, by, az, bz, 0);
 
  801   auto integrand = [&](
double *
x, 
double *) {
 
  802      double xxx = (nx != 0) ? std::pow(
x[0] - xbar, nx) : 1.;
 
  803      double yyy = (ny != 0) ? std::pow(
x[1] - ybar, ny) : 1.;
 
  804      double zzz = (nz != 0) ? std::pow(
x[2] - zbar, nz) : 1.;
 
  805      return xxx * yyy * zzz * this->
EvalPar(x, 
nullptr);
 
  808   TF3 fnc(
"TF3_ExpValHelper",integrand,ax,bx,ay,by,az,bz,0) ;
 
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
R__EXTERN TRandom * gRandom
static unsigned int DefaultNCalls()
Param Functor class for Multidimensional functions.
virtual Color_t GetFillColor() const
Return the fill area color.
virtual Color_t GetLineColor() const
Return the line color.
void SaveAttributes(std::ostream &out, const char *name, const char *subname) override
Save axis attributes as C++ statement(s) on output stream out.
Buffer base class used for serializing objects.
virtual Version_t ReadVersion(UInt_t *start=nullptr, UInt_t *bcnt=nullptr, const TClass *cl=nullptr)=0
virtual Int_t ReadClassBuffer(const TClass *cl, void *pointer, const TClass *onfile_class=nullptr)=0
virtual Int_t WriteClassBuffer(const TClass *cl, void *pointer)=0
static Bool_t SaveColor(std::ostream &out, Int_t ci)
Save a color with index > 228 as a C++ statement(s) on output stream out.
Int_t fNdim
Function dimension.
virtual void GetParLimits(Int_t ipar, Double_t &parmin, Double_t &parmax) const
Return limits for parameter ipar.
TAxis * GetYaxis() const
Get y axis of the function.
virtual Double_t GetParError(Int_t ipar) const
Return value of parameter number ipar.
Double_t GetChisquare() const
Double_t fXmin
Lower bounds for the range.
std::unique_ptr< TMethodCall > fMethodCall
! Pointer to MethodCall in case of interpreted function
virtual void Update()
Called by functions such as SetRange, SetNpx, SetParameters to force the deletion of the associated h...
TAxis * GetZaxis() const
Get z axis of the function. (In case this object is a TF2 or TF3)
virtual Int_t GetNpar() const
TH1 * fHistogram
! Pointer to histogram used for visualisation
virtual Double_t * GetParameters() const
virtual void InitArgs(const Double_t *x, const Double_t *params)
Initialize parameters addresses.
virtual Double_t IntegralMultiple(Int_t n, const Double_t *a, const Double_t *b, Int_t maxpts, Double_t epsrel, Double_t epsabs, Double_t &relerr, Int_t &nfnevl, Int_t &ifail)
This function computes, to an attempted specified accuracy, the value of the integral.
Int_t DistancetoPrimitive(Int_t px, Int_t py) override
Compute distance from point px,py to a function.
virtual Double_t EvalPar(const Double_t *x, const Double_t *params=nullptr)
Evaluate function with given coordinates and parameters.
Int_t fNpx
Number of points used for the graphical representation.
void ExecuteEvent(Int_t event, Int_t px, Int_t py) override
Execute action corresponding to one event.
std::vector< Double_t > fSave
Array of fNsave function values.
virtual Double_t GetMinMaxNDim(Double_t *x, Bool_t findmax, Double_t epsilon=0, Int_t maxiter=0) const
Find the minimum of a function of whatever dimension.
std::vector< Double_t > fIntegral
! Integral of function binned on fNpx bins
@ kFormula
Formula functions which can be stored,.
virtual Int_t GetNpx() const
Double_t fXmax
Upper bounds for the range.
virtual Int_t GetNdim() const
virtual Double_t GetParameter(Int_t ipar) const
TAxis * GetXaxis() const
Get x axis of the function.
A 2-Dim function with parameters.
void Copy(TObject &f2) const override
Copy this F2 to a new F2.
Int_t fNpy
Number of points along y used for the graphical representation.
Double_t fYmax
Upper bound for the range in y.
Double_t fYmin
Lower bound for the range in y.
A 3-Dim function with parameters.
void GetRange(Double_t &xmin, Double_t &xmax) const override
Return range of a 1-D function.
TF3()
F3 default constructor.
void Paint(Option_t *option="") override
Paint this 3-D function with its current attributes.
virtual void GetRandom3(Double_t &xrandom, Double_t &yrandom, Double_t &zrandom, TRandom *rng=nullptr)
Return 3 random numbers following this function shape.
Bool_t IsInside(const Double_t *x) const override
Return kTRUE is the point is inside the function range.
void ExecuteEvent(Int_t event, Int_t px, Int_t py) override
Execute action corresponding to one event.
Double_t fZmin
Lower bound for the range in z.
TF3 & operator=(const TF3 &rhs)
Operator =.
virtual void SetNpz(Int_t npz=30)
Set the number of points used to draw the function.
virtual Double_t GetMaximumXYZ(Double_t &x, Double_t &y, Double_t &z)
Compute the X, Y and Z values corresponding to the maximum value of the function on its range.
virtual Double_t CentralMoment3(Double_t nx, Double_t ax, Double_t bx, Double_t ny, Double_t ay, Double_t by, Double_t nz, Double_t az, Double_t bz, Double_t epsilon=0.000001)
Return x^nx * y^ny * z^nz central moment of a 3d function in range [ax,bx],[ay,by],...
void Copy(TObject &f3) const override
Copy this F3 to a new F3.
Double_t FindMinMax(Double_t *x, bool findmax) const override
Return minimum/maximum value of the function.
~TF3() override
F3 default destructor.
Bool_t fClipBoxOn
! Is clip box on
virtual Double_t GetMinimumXYZ(Double_t &x, Double_t &y, Double_t &z)
Compute the X, Y and Z values corresponding to the minimum value of the function on its range.
virtual Double_t Moment3(Double_t nx, Double_t ax, Double_t bx, Double_t ny, Double_t ay, Double_t by, Double_t nz, Double_t az, Double_t bz, Double_t epsilon=0.000001)
Return x^nx * y^ny * z^nz moment of a 3d function in range [ax,bx],[ay,by],[az,bz].
Int_t fNpz
Number of points along z used for the graphical representation.
void Draw(Option_t *option="") override
Draw this function with its current attributes.
virtual void SetClippingBoxOn(Double_t xclip=0, Double_t yclip=0, Double_t zclip=0)
Set the function clipping box (for drawing) "on" and define the clipping box.
virtual void SetClippingBoxOff()
Set the function clipping box (for drawing) "off".
Double_t fZmax
Upper bound for the range in z.
Int_t DistancetoPrimitive(Int_t px, Int_t py) override
Compute distance from point px,py to a function.
virtual Double_t Integral(Double_t ax, Double_t bx, Double_t ay, Double_t by, Double_t az, Double_t bz, Double_t epsrel=1.e-6)
Return Integral of a 3d function in range [ax,bx],[ay,by],[az,bz] with a desired relative accuracy.
void Streamer(TBuffer &) override
Stream an object of class TF3.
TH1 * CreateHistogram() override
Create a histogram for axis range.
void Save(Double_t xmin, Double_t xmax, Double_t ymin, Double_t ymax, Double_t zmin, Double_t zmax) override
Save values of function in array fSave.
Double_t GetSave(const Double_t *x) override
Get value corresponding to X in array of fSave values.
Double_t fClipBox[3]
! Coordinates of clipbox
void SetRange(Double_t xmin, Double_t xmax) override
Initialize the upper and lower bounds to draw the function.
void SavePrimitive(std::ostream &out, Option_t *option="") override
Save primitive as a C++ statement(s) on output stream out.
TH1 is the base class of all histogram classes in ROOT.
virtual void SetDirectory(TDirectory *dir)
By default, when a histogram is created, it is added to the list of histogram objects in the current ...
TVirtualHistPainter * GetPainter(Option_t *option="")
Return pointer to painter.
void Paint(Option_t *option="") override
Control routine to paint any kind of histograms.
3-D histogram with a float per channel (see TH1 documentation)}
const char * GetName() const override
Returns name of object.
const char * GetTitle() const override
Returns title of object.
Mother of all ROOT objects.
virtual void Warning(const char *method, const char *msgfmt,...) const
Issue warning message.
virtual void AppendPad(Option_t *option="")
Append graphics object to current pad.
virtual void Error(const char *method, const char *msgfmt,...) const
Issue error message.
virtual void Info(const char *method, const char *msgfmt,...) const
Issue info message.
This is the base class for the ROOT Random number generators.
Double_t Rndm() override
Machine independent random number generator.
void ToLower()
Change string to lower-case.
const char * Data() const
TString & Append(const char *cs)
Bool_t Contains(const char *pat, ECaseCompare cmp=kExact) const
Ssiz_t Index(const char *pat, Ssiz_t i=0, ECaseCompare cmp=kExact) const
virtual void ProcessMessage(const char *mess, const TObject *obj)=0
Short_t Max(Short_t a, Short_t b)
Returns the largest of a and b.
Double_t QuietNaN()
Returns a quiet NaN as defined by IEEE 754.
Int_t Finite(Double_t x)
Check if it is finite with a mask in order to be consistent in presence of fast math.
Short_t Min(Short_t a, Short_t b)
Returns the smallest of a and b.
Long64_t BinarySearch(Long64_t n, const T *array, T value)
Binary search in an array of n values to locate value.
Double_t Infinity()
Returns an infinity as defined by the IEEE standard.