BornAgain  1.19.79
Open-source research software to simulate and fit neutron and x-ray reflectometry and grazing-incidence small-angle scattering
ROOT::Fit::FitResult Class Reference

Description

class containg the result of the fit and all the related information (fitted parameter values, error, covariance matrix and minimizer result information) Contains a pointer also to the fitted (model) function, modified with the fit parameter values. When the fit is valid, it is constructed from a Minimizer and a model function pointer

Definition at line 48 of file FitResult.h.

Collaboration diagram for ROOT::Fit::FitResult:
[legend]

Public Types

typedef ROOT::Math::IParamMultiFunction IModelFunction
 

Public Member Functions

 FitResult ()
 
 FitResult (const FitConfig &fconfig)
 
 FitResult (const FitResult &rhs)
 
virtual ~FitResult ()
 
double Chi2 () const
 Chi2 fit value in case of likelihood must be computed ? More...
 
bool Contour (unsigned int ipar, unsigned int jpar, unsigned int &npoints, double *pntsx, double *pntsy, double confLevel=0.683)
 
double Correlation (unsigned int i, unsigned int j) const
 retrieve correlation elements More...
 
double CovMatrix (unsigned int i, unsigned int j) const
 retrieve covariance matrix element More...
 
int CovMatrixStatus () const
 covariance matrix status code using Minuit convention : =0 not calculated, =1 approximated, =2 made pos def , =3 accurate More...
 
double Edm () const
 Expected distance from minimum. More...
 
double Error (unsigned int i) const
 parameter error by index More...
 
const std::vector< double > & Errors () const
 parameter errors (return st::vector) More...
 
void FillResult (const std::shared_ptr< ROOT::Math::Minimizer > &min, const FitConfig &fconfig, const std::shared_ptr< IModelFunction > &f, bool isValid, unsigned int sizeOfData=0, bool binFit=true, const ROOT::Math::IMultiGenFunction *chi2func=0, unsigned int ncalls=0)
 
const BinDataFittedBinData () const
 return BinData used in the fit (return a nullptr in case a different fit is done or the data are not available Pointer is managed internally, it must not be deleted More...
 
const IModelFunctionFittedFunction () const
 Return pointer to model (fit) function with fitted parameter values. Pointer is managed internally. I must not be deleted. More...
 
void GetConfidenceIntervals (const BinData &data, double *ci, double cl=0.95, bool norm=false) const
 
std::vector< double > GetConfidenceIntervals (double cl=0.95, bool norm=false) const
 
void GetConfidenceIntervals (unsigned int n, unsigned int stride1, unsigned int stride2, const double *x, double *ci, double cl=0.95, bool norm=false) const
 
template<class Matrix >
void GetCorrelationMatrix (Matrix &mat) const
 fill a correlation matrix elements using a generic symmetric matrix class implementing operator(i,j) the matrix must be previously allocates with right size (npar * npar) More...
 
template<class Matrix >
void GetCovarianceMatrix (Matrix &mat) const
 fill covariance matrix elements using a generic matrix class implementing operator(i,j) the matrix must be previously allocates with right size (npar * npar) More...
 
const double * GetErrors () const
 parameter errors (return const pointer) More...
 
std::string GetParameterName (unsigned int ipar) const
 get name of parameter (deprecated) More...
 
const double * GetParams () const
 parameter values (return const pointer) More...
 
double GlobalCC (unsigned int i) const
 parameter global correlation coefficient More...
 
bool HasMinosError (unsigned int i) const
 query if parameter i has the Minos error More...
 
int Index (const std::string &name) const
 get index for parameter name (return -1 if not found) More...
 
bool IsEmpty () const
 True if a fit result does not exist (even invalid) with parameter values. More...
 
bool IsParameterBound (unsigned int ipar) const
 query if a parameter is bound More...
 
bool IsParameterFixed (unsigned int ipar) const
 query if a parameter is fixed More...
 
bool IsValid () const
 
double LowerError (unsigned int i) const
 lower Minos error. If Minos has not run for parameter i return the parabolic error More...
 
double MinFcnValue () const
 Return value of the objective function (chi2 or likelihood) used in the fit. More...
 
const std::string & MinimizerType () const
 minimizer type More...
 
unsigned int NCalls () const
 Number of function calls to find minimum. More...
 
unsigned int Ndf () const
 Number of degree of freedom. More...
 
unsigned int NFreeParameters () const
 get total number of free parameters More...
 
bool NormalizedErrors () const
 flag to chek if errors are normalized More...
 
void NormalizeErrors ()
 normalize errors using chi2/ndf for chi2 fits More...
 
unsigned int NPar () const
 total number of parameters (abbreviation) More...
 
unsigned int NTotalParameters () const
 get total number of parameters More...
 
FitResultoperator= (const FitResult &rhs)
 
double Parameter (unsigned int i) const
 parameter value by index More...
 
bool ParameterBounds (unsigned int ipar, double &lower, double &upper) const
 retrieve parameter bounds - return false if parameter is not bound More...
 
const std::vector< double > & Parameters () const
 parameter values (return std::vector) More...
 
double ParError (unsigned int i) const
 parameter error by index More...
 
std::string ParName (unsigned int i) const
 name of the parameter More...
 
void Print (std::ostream &os, bool covmat=false) const
 print the result and optionaly covariance matrix and correlations More...
 
void PrintCovMatrix (std::ostream &os) const
 print error matrix and correlations More...
 
double Prob () const
 p value of the fit (chi2 probability) More...
 
bool Scan (unsigned int ipar, unsigned int &npoints, double *pntsx, double *pntsy, double xmin=0, double xmax=0)
 
void SetMinosError (unsigned int i, double elow, double eup)
 set the Minos errors for parameter i (called by the Fitter class when running Minos) More...
 
int Status () const
 minimizer status code More...
 
bool Update (const std::shared_ptr< ROOT::Math::Minimizer > &min, bool isValid, unsigned int ncalls=0)
 
double UpperError (unsigned int i) const
 upper Minos error. If Minos has not run for parameter i return the parabolic error More...
 
double Value (unsigned int i) const
 parameter value by index More...
 

Protected Member Functions

std::shared_ptr< IModelFunctionModelFunction ()
 Return pointer non const pointer to model (fit) function with fitted parameter values. used by Fitter class. More...
 
void SetModelFunction (const std::shared_ptr< IModelFunction > &func)
 

Protected Attributes

std::map< unsigned int, unsigned int > fBoundParams
 
double fChi2
 
std::vector< double > fCovMatrix
 
int fCovStatus
 
double fEdm
 
std::vector< double > fErrors
 
std::shared_ptr< FitData > fFitData
 model function resulting from the fit. More...
 
std::shared_ptr< IModelFunctionfFitFunc
 objective function used for fitting More...
 
std::map< unsigned int, bool > fFixedParams
 data set used in the fit More...
 
std::vector< double > fGlobalCC
 
std::shared_ptr< ROOT::Math::MinimizerfMinimizer
 
std::string fMinimType
 
std::map< unsigned int, std::pair< double, double > > fMinosErrors
 
unsigned int fNCalls
 
unsigned int fNdf
 
unsigned int fNFree
 
bool fNormalized
 
std::shared_ptr< ROOT::Math::IMultiGenFunctionfObjFunc
 minimizer object used for fitting More...
 
std::vector< std::pair< double, double > > fParamBounds
 
std::vector< double > fParams
 
std::vector< std::string > fParNames
 
int fStatus
 
double fVal
 
bool fValid
 

Friends

class Fitter
 

Member Typedef Documentation

◆ IModelFunction

Constructor & Destructor Documentation

◆ FitResult() [1/3]

ROOT::Fit::FitResult::FitResult ( )

Default constructor for an empty (non valid) fit result

◆ FitResult() [2/3]

ROOT::Fit::FitResult::FitResult ( const FitConfig fconfig)

Constructor from a fit-config for a dummy fit (e.g. when only one fcn evaluation is done)

◆ FitResult() [3/3]

ROOT::Fit::FitResult::FitResult ( const FitResult rhs)

Copy constructor.

◆ ~FitResult()

virtual ROOT::Fit::FitResult::~FitResult ( )
virtual

Destructor

Member Function Documentation

◆ Chi2()

double ROOT::Fit::FitResult::Chi2 ( ) const
inline

Chi2 fit value in case of likelihood must be computed ?

Definition at line 161 of file FitResult.h.

161 { return fChi2; }

References fChi2.

◆ Contour()

bool ROOT::Fit::FitResult::Contour ( unsigned int  ipar,
unsigned int  jpar,
unsigned int &  npoints,
double *  pntsx,
double *  pntsy,
double  confLevel = 0.683 
)

create contour of two parameters around the minimum pass as option confidence level: default is a value of 0.683

◆ Correlation()

double ROOT::Fit::FitResult::Correlation ( unsigned int  i,
unsigned int  j 
) const
inline

retrieve correlation elements

Definition at line 227 of file FitResult.h.

227  {
228  if ( i >= fErrors.size() || j >= fErrors.size() ) return 0;
229  if (fCovMatrix.size() == 0) return 0; // no matrix is available in case of non-valid fits
230  double tmp = CovMatrix(i,i)*CovMatrix(j,j);
231  return ( tmp > 0) ? CovMatrix(i,j)/ std::sqrt(tmp) : 0;
232  }
std::vector< double > fErrors
Definition: FitResult.h:364
double CovMatrix(unsigned int i, unsigned int j) const
retrieve covariance matrix element
Definition: FitResult.h:217
std::vector< double > fCovMatrix
Definition: FitResult.h:365

References CovMatrix(), fCovMatrix, and fErrors.

Here is the call graph for this function:

◆ CovMatrix()

double ROOT::Fit::FitResult::CovMatrix ( unsigned int  i,
unsigned int  j 
) const
inline

retrieve covariance matrix element

Definition at line 217 of file FitResult.h.

217  {
218  if ( i >= fErrors.size() || j >= fErrors.size() ) return 0;
219  if (fCovMatrix.size() == 0) return 0; // no matrix is available in case of non-valid fits
220  if ( j < i )
221  return fCovMatrix[j + i* (i+1) / 2];
222  else
223  return fCovMatrix[i + j* (j+1) / 2];
224  }

References fCovMatrix, and fErrors.

Referenced by Correlation().

◆ CovMatrixStatus()

int ROOT::Fit::FitResult::CovMatrixStatus ( ) const
inline

covariance matrix status code using Minuit convention : =0 not calculated, =1 approximated, =2 made pos def , =3 accurate

Definition at line 143 of file FitResult.h.

143 { return fCovStatus; }

References fCovStatus.

◆ Edm()

double ROOT::Fit::FitResult::Edm ( ) const
inline

Expected distance from minimum.

Definition at line 127 of file FitResult.h.

127 { return fEdm; }

References fEdm.

◆ Error()

double ROOT::Fit::FitResult::Error ( unsigned int  i) const
inline

parameter error by index

Definition at line 187 of file FitResult.h.

187  {
188  return (i < fErrors.size() ) ? fErrors[i] : 0;
189  }

References fErrors.

◆ Errors()

const std::vector<double>& ROOT::Fit::FitResult::Errors ( ) const
inline

parameter errors (return st::vector)

Definition at line 170 of file FitResult.h.

170 { return fErrors; }

References fErrors.

◆ FillResult()

void ROOT::Fit::FitResult::FillResult ( const std::shared_ptr< ROOT::Math::Minimizer > &  min,
const FitConfig fconfig,
const std::shared_ptr< IModelFunction > &  f,
bool  isValid,
unsigned int  sizeOfData = 0,
bool  binFit = true,
const ROOT::Math::IMultiGenFunction chi2func = 0,
unsigned int  ncalls = 0 
)

Fill the fit result from a Minimizer instance after fitting Run also Minos if requested from the configuration

◆ FittedBinData()

const BinData* ROOT::Fit::FitResult::FittedBinData ( ) const

return BinData used in the fit (return a nullptr in case a different fit is done or the data are not available Pointer is managed internally, it must not be deleted

◆ FittedFunction()

const IModelFunction* ROOT::Fit::FitResult::FittedFunction ( ) const
inline

Return pointer to model (fit) function with fitted parameter values. Pointer is managed internally. I must not be deleted.

fitting quantities

Definition at line 149 of file FitResult.h.

149  {
150  return fFitFunc.get();
151  }
std::shared_ptr< IModelFunction > fFitFunc
objective function used for fitting
Definition: FitResult.h:358

References fFitFunc.

◆ GetConfidenceIntervals() [1/3]

void ROOT::Fit::FitResult::GetConfidenceIntervals ( const BinData data,
double *  ci,
double  cl = 0.95,
bool  norm = false 
) const

evaluate confidence interval for the point specified in the passed data sets the confidence interval are returned in the array ci cl is the desired confidence interval value. This method is mantained for backward compatibility and will be deprecated

◆ GetConfidenceIntervals() [2/3]

std::vector<double> ROOT::Fit::FitResult::GetConfidenceIntervals ( double  cl = 0.95,
bool  norm = false 
) const

evaluate confidence interval for the data set used in the last fit the confidence interval are returned as a vector of data points

◆ GetConfidenceIntervals() [3/3]

void ROOT::Fit::FitResult::GetConfidenceIntervals ( unsigned int  n,
unsigned int  stride1,
unsigned int  stride2,
const double *  x,
double *  ci,
double  cl = 0.95,
bool  norm = false 
) const

get confidence intervals for an array of n points x. stride1 indicates the stride in the coordinate space while stride2 the stride in dimension space. For 1-dim points : stride1=1, stride2=1 for multi-dim points arranged as (x0,x1,...,xN,y0,....yN) stride1=1 stride2=n for multi-dim points arraged as (x0,y0,..,x1,y1,...,xN,yN,..) stride1=ndim, stride2=1

the confidence interval are returned in the array ci cl is the desired confidedence interval value norm is a flag to control if the intervals need to be normalized to the chi2/ndf value The intervals can be corrected optionally using the chi2/ndf value of the fit if a chi2 fit is performed. This has changed since ROOT 6.14, before the interval were corrected by default.

◆ GetCorrelationMatrix()

template<class Matrix >
void ROOT::Fit::FitResult::GetCorrelationMatrix ( Matrix &  mat) const
inline

fill a correlation matrix elements using a generic symmetric matrix class implementing operator(i,j) the matrix must be previously allocates with right size (npar * npar)

Definition at line 251 of file FitResult.h.

251  {
252  unsigned int npar = fErrors.size();
253  if (fCovMatrix.size() != npar*(npar+1)/2) return; // do nothing
254  for (unsigned int i = 0; i< npar; ++i) {
255  for (unsigned int j = 0; j<=i; ++j) {
256  double tmp = fCovMatrix[i * (i +3)/2 ] * fCovMatrix[ j * (j+3)/2 ];
257  mat(i,j) = (tmp > 0) ? fCovMatrix[j + i*(i+1)/2 ] / std::sqrt(tmp) : 0;
258  if (i != j) mat(j,i) = mat(i,j);
259  }
260  }
261  }

References fCovMatrix, and fErrors.

◆ GetCovarianceMatrix()

template<class Matrix >
void ROOT::Fit::FitResult::GetCovarianceMatrix ( Matrix &  mat) const
inline

fill covariance matrix elements using a generic matrix class implementing operator(i,j) the matrix must be previously allocates with right size (npar * npar)

Definition at line 237 of file FitResult.h.

237  {
238  unsigned int npar = fErrors.size();
239  if (fCovMatrix.size() != npar*(npar+1)/2 ) return; // do nothing
240  for (unsigned int i = 0; i< npar; ++i) {
241  for (unsigned int j = 0; j<=i; ++j) {
242  mat(i,j) = fCovMatrix[j + i*(i+1)/2 ];
243  if (i != j) mat(j,i) = mat(i,j);
244  }
245  }
246  }

References fCovMatrix, and fErrors.

◆ GetErrors()

const double* ROOT::Fit::FitResult::GetErrors ( ) const
inline

parameter errors (return const pointer)

Definition at line 172 of file FitResult.h.

172 { return (fErrors.empty()) ? 0 : &fErrors.front(); }

References fErrors.

◆ GetParameterName()

std::string ROOT::Fit::FitResult::GetParameterName ( unsigned int  ipar) const
inline

get name of parameter (deprecated)

Definition at line 329 of file FitResult.h.

329  {
330  return ParName(ipar);
331  }
std::string ParName(unsigned int i) const
name of the parameter

References ParName().

Here is the call graph for this function:

◆ GetParams()

const double* ROOT::Fit::FitResult::GetParams ( ) const
inline

parameter values (return const pointer)

Definition at line 177 of file FitResult.h.

177 { return &fParams.front(); }
std::vector< double > fParams
Definition: FitResult.h:363

References fParams.

◆ GlobalCC()

double ROOT::Fit::FitResult::GlobalCC ( unsigned int  i) const
inline

parameter global correlation coefficient

Definition at line 211 of file FitResult.h.

211  {
212  return (i < fGlobalCC.size() ) ? fGlobalCC[i] : -1;
213  }
std::vector< double > fGlobalCC
Definition: FitResult.h:366

References fGlobalCC.

◆ HasMinosError()

bool ROOT::Fit::FitResult::HasMinosError ( unsigned int  i) const

query if parameter i has the Minos error

◆ Index()

int ROOT::Fit::FitResult::Index ( const std::string &  name) const

get index for parameter name (return -1 if not found)

◆ IsEmpty()

bool ROOT::Fit::FitResult::IsEmpty ( ) const
inline

True if a fit result does not exist (even invalid) with parameter values.

Definition at line 118 of file FitResult.h.

118 { return (fParams.size() == 0); }

References fParams.

◆ IsParameterBound()

bool ROOT::Fit::FitResult::IsParameterBound ( unsigned int  ipar) const

query if a parameter is bound

◆ IsParameterFixed()

bool ROOT::Fit::FitResult::IsParameterFixed ( unsigned int  ipar) const

query if a parameter is fixed

◆ IsValid()

bool ROOT::Fit::FitResult::IsValid ( ) const
inline

True if fit successful, otherwise false. A fit is considered successful if the minimizer succeded in finding the minimum. It could happen that subsequent operations like error analysis (e.g. Minos) failed. In that case the status can be still true if the original minimization algorithm succeeded in finding the minimum. One can query in that case the minimizer return status using Status(). It is responability to the Minimizer class to tag a found minimum as valid or not and to produce also a status code.

Definition at line 115 of file FitResult.h.

115 { return fValid; }

References fValid.

◆ LowerError()

double ROOT::Fit::FitResult::LowerError ( unsigned int  i) const

lower Minos error. If Minos has not run for parameter i return the parabolic error

◆ MinFcnValue()

double ROOT::Fit::FitResult::MinFcnValue ( ) const
inline

Return value of the objective function (chi2 or likelihood) used in the fit.

Definition at line 121 of file FitResult.h.

121 { return fVal; }

References fVal.

◆ MinimizerType()

const std::string& ROOT::Fit::FitResult::MinimizerType ( ) const
inline

minimizer type

minimization quantities

Definition at line 103 of file FitResult.h.

103 { return fMinimType; }
std::string fMinimType
Definition: FitResult.h:368

References fMinimType.

◆ ModelFunction()

std::shared_ptr<IModelFunction> ROOT::Fit::FitResult::ModelFunction ( )
inlineprotected

Return pointer non const pointer to model (fit) function with fitted parameter values. used by Fitter class.

Definition at line 339 of file FitResult.h.

339 { return fFitFunc; }

References fFitFunc.

◆ NCalls()

unsigned int ROOT::Fit::FitResult::NCalls ( ) const
inline

Number of function calls to find minimum.

Definition at line 124 of file FitResult.h.

124 { return fNCalls; }
unsigned int fNCalls
Definition: FitResult.h:350

References fNCalls.

◆ Ndf()

unsigned int ROOT::Fit::FitResult::Ndf ( ) const
inline

Number of degree of freedom.

Definition at line 164 of file FitResult.h.

164 { return fNdf; }
unsigned int fNdf
Definition: FitResult.h:349

References fNdf.

◆ NFreeParameters()

unsigned int ROOT::Fit::FitResult::NFreeParameters ( ) const
inline

get total number of free parameters

Definition at line 135 of file FitResult.h.

135 { return fNFree; }
unsigned int fNFree
Definition: FitResult.h:348

References fNFree.

◆ NormalizedErrors()

bool ROOT::Fit::FitResult::NormalizedErrors ( ) const
inline

flag to chek if errors are normalized

Definition at line 310 of file FitResult.h.

310 { return fNormalized; }

References fNormalized.

◆ NormalizeErrors()

void ROOT::Fit::FitResult::NormalizeErrors ( )

normalize errors using chi2/ndf for chi2 fits

◆ NPar()

unsigned int ROOT::Fit::FitResult::NPar ( ) const
inline

total number of parameters (abbreviation)

Definition at line 132 of file FitResult.h.

132 { return NTotalParameters(); }
unsigned int NTotalParameters() const
get total number of parameters
Definition: FitResult.h:130

References NTotalParameters().

Here is the call graph for this function:

◆ NTotalParameters()

unsigned int ROOT::Fit::FitResult::NTotalParameters ( ) const
inline

get total number of parameters

Definition at line 130 of file FitResult.h.

130 { return fParams.size(); }

References fParams.

Referenced by NPar().

◆ operator=()

FitResult& ROOT::Fit::FitResult::operator= ( const FitResult rhs)

Assignment operator

◆ Parameter()

double ROOT::Fit::FitResult::Parameter ( unsigned int  i) const
inline

parameter value by index

Definition at line 182 of file FitResult.h.

182 { return fParams[i]; }

References fParams.

◆ ParameterBounds()

bool ROOT::Fit::FitResult::ParameterBounds ( unsigned int  ipar,
double &  lower,
double &  upper 
) const

retrieve parameter bounds - return false if parameter is not bound

◆ Parameters()

const std::vector<double>& ROOT::Fit::FitResult::Parameters ( ) const
inline

parameter values (return std::vector)

Definition at line 175 of file FitResult.h.

175 { return fParams; }

References fParams.

◆ ParError()

double ROOT::Fit::FitResult::ParError ( unsigned int  i) const
inline

parameter error by index

Definition at line 191 of file FitResult.h.

191  {
192  return (i < fErrors.size() ) ? fErrors[i] : 0;
193  }

References fErrors.

◆ ParName()

std::string ROOT::Fit::FitResult::ParName ( unsigned int  i) const

name of the parameter

Referenced by GetParameterName().

◆ Print()

void ROOT::Fit::FitResult::Print ( std::ostream &  os,
bool  covmat = false 
) const

print the result and optionaly covariance matrix and correlations

◆ PrintCovMatrix()

void ROOT::Fit::FitResult::PrintCovMatrix ( std::ostream &  os) const

print error matrix and correlations

◆ Prob()

double ROOT::Fit::FitResult::Prob ( ) const

p value of the fit (chi2 probability)

◆ Scan()

bool ROOT::Fit::FitResult::Scan ( unsigned int  ipar,
unsigned int &  npoints,
double *  pntsx,
double *  pntsy,
double  xmin = 0,
double  xmax = 0 
)

scan likelihood value of parameter and fill the given graph.

◆ SetMinosError()

void ROOT::Fit::FitResult::SetMinosError ( unsigned int  i,
double  elow,
double  eup 
)

set the Minos errors for parameter i (called by the Fitter class when running Minos)

◆ SetModelFunction()

void ROOT::Fit::FitResult::SetModelFunction ( const std::shared_ptr< IModelFunction > &  func)
inlineprotected

Definition at line 340 of file FitResult.h.

340 { fFitFunc = func; }

References fFitFunc.

◆ Status()

int ROOT::Fit::FitResult::Status ( ) const
inline

minimizer status code

Definition at line 138 of file FitResult.h.

138 { return fStatus; }

References fStatus.

◆ Update()

bool ROOT::Fit::FitResult::Update ( const std::shared_ptr< ROOT::Math::Minimizer > &  min,
bool  isValid,
unsigned int  ncalls = 0 
)

Update the fit result with a new minimization status To be run only if same fit is performed with same configuration Note that in this case MINOS is not re-run. If one wants to run also MINOS a new result must be created

◆ UpperError()

double ROOT::Fit::FitResult::UpperError ( unsigned int  i) const

upper Minos error. If Minos has not run for parameter i return the parabolic error

◆ Value()

double ROOT::Fit::FitResult::Value ( unsigned int  i) const
inline

parameter value by index

Definition at line 180 of file FitResult.h.

180 { return fParams[i]; }

References fParams.

Friends And Related Function Documentation

◆ Fitter

friend class Fitter
friend

Definition at line 343 of file FitResult.h.

Member Data Documentation

◆ fBoundParams

std::map<unsigned int, unsigned int> ROOT::Fit::FitResult::fBoundParams
protected

Definition at line 361 of file FitResult.h.

◆ fChi2

double ROOT::Fit::FitResult::fChi2
protected

Definition at line 355 of file FitResult.h.

Referenced by Chi2().

◆ fCovMatrix

std::vector<double> ROOT::Fit::FitResult::fCovMatrix
protected

Definition at line 365 of file FitResult.h.

Referenced by Correlation(), CovMatrix(), GetCorrelationMatrix(), and GetCovarianceMatrix().

◆ fCovStatus

int ROOT::Fit::FitResult::fCovStatus
protected

Definition at line 352 of file FitResult.h.

Referenced by CovMatrixStatus().

◆ fEdm

double ROOT::Fit::FitResult::fEdm
protected

Definition at line 354 of file FitResult.h.

Referenced by Edm().

◆ fErrors

std::vector<double> ROOT::Fit::FitResult::fErrors
protected

◆ fFitData

std::shared_ptr<FitData> ROOT::Fit::FitResult::fFitData
protected

model function resulting from the fit.

Definition at line 359 of file FitResult.h.

◆ fFitFunc

std::shared_ptr<IModelFunction> ROOT::Fit::FitResult::fFitFunc
protected

objective function used for fitting

Definition at line 358 of file FitResult.h.

Referenced by FittedFunction(), ModelFunction(), and SetModelFunction().

◆ fFixedParams

std::map<unsigned int, bool> ROOT::Fit::FitResult::fFixedParams
protected

data set used in the fit

Definition at line 360 of file FitResult.h.

◆ fGlobalCC

std::vector<double> ROOT::Fit::FitResult::fGlobalCC
protected

Definition at line 366 of file FitResult.h.

Referenced by GlobalCC().

◆ fMinimizer

std::shared_ptr<ROOT::Math::Minimizer> ROOT::Fit::FitResult::fMinimizer
protected

Definition at line 356 of file FitResult.h.

◆ fMinimType

std::string ROOT::Fit::FitResult::fMinimType
protected

Definition at line 368 of file FitResult.h.

Referenced by MinimizerType().

◆ fMinosErrors

std::map<unsigned int, std::pair<double,double> > ROOT::Fit::FitResult::fMinosErrors
protected

Definition at line 367 of file FitResult.h.

◆ fNCalls

unsigned int ROOT::Fit::FitResult::fNCalls
protected

Definition at line 350 of file FitResult.h.

Referenced by NCalls().

◆ fNdf

unsigned int ROOT::Fit::FitResult::fNdf
protected

Definition at line 349 of file FitResult.h.

Referenced by Ndf().

◆ fNFree

unsigned int ROOT::Fit::FitResult::fNFree
protected

Definition at line 348 of file FitResult.h.

Referenced by NFreeParameters().

◆ fNormalized

bool ROOT::Fit::FitResult::fNormalized
protected

Definition at line 347 of file FitResult.h.

Referenced by NormalizedErrors().

◆ fObjFunc

std::shared_ptr<ROOT::Math::IMultiGenFunction> ROOT::Fit::FitResult::fObjFunc
protected

minimizer object used for fitting

Definition at line 357 of file FitResult.h.

◆ fParamBounds

std::vector<std::pair<double,double> > ROOT::Fit::FitResult::fParamBounds
protected

Definition at line 362 of file FitResult.h.

◆ fParams

std::vector<double> ROOT::Fit::FitResult::fParams
protected

Definition at line 363 of file FitResult.h.

Referenced by GetParams(), IsEmpty(), NTotalParameters(), Parameter(), Parameters(), and Value().

◆ fParNames

std::vector<std::string> ROOT::Fit::FitResult::fParNames
protected

Definition at line 369 of file FitResult.h.

◆ fStatus

int ROOT::Fit::FitResult::fStatus
protected

Definition at line 351 of file FitResult.h.

Referenced by Status().

◆ fVal

double ROOT::Fit::FitResult::fVal
protected

Definition at line 353 of file FitResult.h.

Referenced by MinFcnValue().

◆ fValid

bool ROOT::Fit::FitResult::fValid
protected

Definition at line 346 of file FitResult.h.

Referenced by IsValid().


The documentation for this class was generated from the following file: