Logo ROOT  
Reference Guide
 
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Modules Pages
Loading...
Searching...
No Matches
ROOT::Minuit2 Namespace Reference

Namespaces

namespace  MnMatrix
 

Classes

class  ABObj
 
class  ABProd
 
class  ABSum
 
class  AnalyticalGradientCalculator
 
class  BFGSErrorUpdator
 Update of the covariance matrix for the Variable Metric minimizer (MIGRAD) More...
 
class  BFGSMinimizerType
 
class  CombinedMinimizer
 Combined minimizer: combination of Migrad and Simplex. More...
 
class  CombinedMinimumBuilder
 
class  ContoursError
 
class  DavidonErrorUpdator
 Update of the covariance matrix for the Variable Metric minimizer (MIGRAD) More...
 
class  DeleteAssignment
 
struct  DerivatorElement
 
class  ExternalInternalGradientCalculator
 Similar to the AnalyticalGradientCalculator, the ExternalInternalGradientCalculator supplies Minuit with an externally calculated gradient. More...
 
class  FCNAdapter
 template wrapped class for adapting to FCNBase signature More...
 
class  FCNBase
 Interface (abstract class) defining the function to be minimized, which has to be implemented by the user. More...
 
class  FCNGradAdapter
 template wrapped class for adapting to FCNBase signature a IGradFunction More...
 
class  FCNGradientBase
 Extension of the FCNBase for providing the analytical Gradient of the function. More...
 
class  FumiliBuilder
 Builds the FunctionMinimum using the Fumili method. More...
 
class  FumiliChi2FCN
 Extension of the FCNBase for the Fumili method. More...
 
class  FumiliErrorUpdator
 In the case of the Fumili algorithm the Error matrix (or the Hessian matrix containing the (approximate) second derivatives) is calculated using a linearization of the model function negleting second derivatives. More...
 
class  FumiliFCNAdapter
 template wrapped class for adapting to FumiliFCNBase signature More...
 
class  FumiliFCNBase
 Extension of the FCNBase for the Fumili method. More...
 
class  FumiliGradientCalculator
 Fumili gradient calculator using external gradient provided by FCN Note that the computed Hessian and G2 are an approximation valid for small residuals. More...
 
class  FumiliMaximumLikelihoodFCN
 Extension of the FCNBase for the Fumili method. More...
 
class  FumiliMinimizer
 Instantiates the seed generator and Minimum builder for the Fumili minimization method. More...
 
class  FumiliStandardChi2FCN
 Class implementing the standard chi square function, which is the sum of the squares of the figures-of-merit calculated for each measurement point, the individual figures-of-merit being: (the Value predicted by the model-measured Value)/standard deviation. More...
 
class  FumiliStandardMaximumLikelihoodFCN
 Class implementing the Elements member function for the standard maximum likelihood method. More...
 
class  FunctionGradient
 
class  FunctionMinimum
 class holding the full result of the minimization; both internal and external (MnUserParameterState) representation available for the parameters at the Minimum More...
 
class  GenericFunction
 Class from which all the other classes, representing functions, inherit. More...
 
class  GradientCalculator
 interface class for gradient calculators More...
 
class  HessianGradientCalculator
 HessianGradientCalculator: class to calculate Gradient for Hessian. More...
 
class  InitialGradientCalculator
 Class to calculate an initial estimate of the gradient. More...
 
class  LASquareMatrix
 
class  LASymMatrix
 Class describing a symmetric matrix of size n. More...
 
class  LAVector
 
class  MatrixInverse
 
class  MatrixInverse< vec, M, T >
 
class  MinimumBuilder
 
class  MinimumError
 MinimumError keeps the inv. More...
 
class  MinimumErrorUpdator
 
class  MinimumParameters
 
class  MinimumSeed
 
class  MinimumSeedGenerator
 base class for seed generators (starting values); the seed generator prepares initial starting values from the input (MnUserParameterState) for the minimization; More...
 
class  MinimumState
 MinimumState keeps the information (position, Gradient, 2nd deriv, etc) after one minimization step (usually in MinimumBuilder). More...
 
class  MinosError
 Class holding the result of Minos (lower and upper values) for a specific parameter. More...
 
class  Minuit2Minimizer
 Minuit2Minimizer class implementing the ROOT::Math::Minimizer interface for Minuit2 minimization algorithm. More...
 
class  MinuitParameter
 class for the individual Minuit Parameter with Name and number; contains the input numbers for the minimization or the output result from minimization; possible interactions: Fix/release, set/remove limits, set Value/error; More...
 
class  MnApplication
 application interface class for minimizers (migrad, simplex, Minimize, Scan) User normally instantiates the derived class like ROOT::Minuit2::MnMigrad for using Migrad for minimization More...
 
class  MnContours
 API class for Contours Error analysis (2-dim errors); minimization has to be done before and Minimum must be valid; possibility to ask only for the points or the points and associated Minos errors;. More...
 
class  MnCovarianceSqueeze
 class to reduce the covariance matrix when a parameter is fixed by removing the corresponding row and index More...
 
class  MnCross
 
class  MnEigen
 API class for calculating the eigenvalues of symmetric matrix. More...
 
class  MnFcn
 Wrapper class to FCNBase interface used internally by Minuit. More...
 
class  MnFcnCaller
 
class  MnFumiliMinimize
 API class for minimization using Fumili technology; allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc.; also used by MnMinos and MnContours;. More...
 
class  MnFunctionCross
 MnFunctionCross. More...
 
class  MnGlobalCorrelationCoeff
 class for global correlation coefficient More...
 
class  MnHesse
 API class for calculating the numerical covariance matrix (== 2x Inverse Hessian == 2x Inverse 2nd derivative); can be used by the user or Minuit itself. More...
 
class  MnLineSearch
 Implements a 1-dimensional minimization along a given direction (i.e. More...
 
class  MnMachinePrecision
 Sets the relative floating point (double) arithmetic precision. More...
 
class  MnMigrad
 API class for minimization using Variable Metric technology ("MIGRAD"); allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc.; also used by MnMinos and MnContours;. More...
 
class  MnMinimize
 API class for minimization using Variable Metric technology ("MIGRAD"); allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc.; also used by MnMinos and MnContours;. More...
 
class  MnMinos
 API class for Minos Error analysis (asymmetric errors); minimization has to be done before and Minimum must be valid; possibility to ask only for one side of the Minos Error;. More...
 
class  MnParabola
 This class defines a parabola of the form a*x*x + b*x + c. More...
 
class  MnParabolaFactory
 
class  MnParabolaPoint
 A point of a parabola. More...
 
class  MnParameterScan
 Scans the values of FCN as a function of one Parameter and retains the best function and Parameter values found. More...
 
class  MnParStr
 
class  MnPlot
 MnPlot produces a text-screen graphical output of (x,y) points, e.g. More...
 
class  MnPosDef
 Force the covariance matrix to be positive defined by adding extra terms in the diagonal. More...
 
class  MnPrint
 
class  MnScan
 API class for minimization using a scan method to find the minimum; allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc.;. More...
 
class  MnSeedGenerator
 concrete implementation of the MinimumSeedGenerator interface; used within ModularFunctionMinimizer; More...
 
class  MnSimplex
 API class for minimization using the Simplex method, which does not need and use the derivatives of the function, but only function values. More...
 
class  MnStrategy
 API class for defining four levels of strategies: low (0), medium (1), high (2), very high (>=3); acts on: Migrad (behavioural), Minos (lowers strategy by 1 for Minos-own minimization), Hesse (iterations), Numerical2PDerivative (iterations) More...
 
class  MnTiny
 
class  MnTraceObject
 
class  MnUserCovariance
 Class containing the covariance matrix data represented as a vector of size n*(n+1)/2 Used to hide internal matrix representation to user. More...
 
class  MnUserFcn
 Wrapper used by Minuit of FCN interface containing a reference to the transformation object. More...
 
class  MnUserParameters
 API class for the user interaction with the parameters; serves as input to the minimizer as well as output from it; users can interact: Fix/release parameters, set values and errors, etc.; parameters can be accessed via their Parameter number (determined internally by Minuit and followed the order how the parameters are created) or via their user-specified Name (10 character string). More...
 
class  MnUserParameterState
 class which holds the external user and/or internal Minuit representation of the parameters and errors; transformation internal <-> external on demand; More...
 
class  MnUserTransformation
 class dealing with the transformation between user specified parameters (external) and internal parameters used for minimization More...
 
class  MnVectorTransform
 
class  ModularFunctionMinimizer
 Base common class providing the API for all the minimizer Various Minimize methods are provided varying on the type of FCN function passesd and on the objects used for the parameters. More...
 
class  MPIProcess
 
class  MPITerminate
 
class  NegativeG2LineSearch
 In case that one of the components of the second derivative g2 calculated by the numerical Gradient calculator is negative, a 1dim line search in the direction of that component is done in order to find a better position where g2 is again positive. More...
 
class  Numerical2PGradientCalculator
 class performing the numerical gradient calculation More...
 
class  NumericalDerivator
 
class  ParametricFunction
 Function which has parameters. More...
 
class  PrefixStack
 
class  ScanBuilder
 Performs a minimization using the simplex method of Nelder and Mead (ref. More...
 
class  ScanMinimizer
 Class implementing the required methods for a minimization using SCAN API is provided in the upper ROOT::Minuit2::ModularFunctionMinimizer class. More...
 
class  SimplexBuilder
 Performs a minimization using the simplex method of Nelder and Mead (ref. More...
 
class  SimplexMinimizer
 Class implementing the required methods for a minimization using Simplex. More...
 
class  SimplexParameters
 class describing the simplex set of points (f(x), x ) which evolve during the minimization iteration process. More...
 
class  SimplexSeedGenerator
 generate Simplex starting point (state) More...
 
class  SinParameterTransformation
 class for the transformation for double-limited parameter Using a sin function one goes from a double-limited parameter range to an unlimited one More...
 
class  SqrtLowParameterTransformation
 Transformation from external to internal Parameter based on sqrt(1 + x**2) More...
 
class  SqrtUpParameterTransformation
 Transformation from external to internal Parameter based on sqrt(1 + x**2) More...
 
class  StackAllocator
 StackAllocator controls the memory allocation/deallocation of Minuit. More...
 
class  StackAllocatorHolder
 
class  StackError
 
class  StackOverflow
 define stack allocator symbol More...
 
class  sym
 
class  VariableMetricBuilder
 Build (find) function minimum using the Variable Metric method (MIGRAD) Two possible error updators can be chosen. More...
 
class  VariableMetricEDMEstimator
 
class  VariableMetricMinimizer
 Instantiates the SeedGenerator and MinimumBuilder for Variable Metric Minimization method. More...
 
class  vec
 
class  VectorOuterProduct
 

Typedefs

typedef LASymMatrix MnAlgebraicSymMatrix
 
typedef LAVector MnAlgebraicVector
 

Enumerations

enum  EMinimizerType {
  kMigrad , kSimplex , kCombined , kScan ,
  kFumili , kMigradBFGS
}
 
enum class  GradientParameterSpace { External , Internal }
 

Functions

int ControlPrintLevel ()
 
LAVector eigenvalues (const LASymMatrix &)
 
double inner_product (const LAVector &, const LAVector &)
 
template<class mt , class M , class T >
ABObj< mt, MatrixInverse< mt, ABObj< mt, M, T >, T >, T > Inverse (const ABObj< mt, M, T > &obj)
 
ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix >, double > > Inverse (const ABObj< sym, LASymMatrix > &obj)
 LAPACK Algebra functions specialize the Invert function for LASymMatrix.
 
int Invert (LASymMatrix &)
 
int Invert_undef_sym (LASymMatrix &)
 
LASquareMatrix MatrixProduct (const LASymMatrix &m1, const LASquareMatrix &m2)
 
void mnbins (double a1, double a2, int naa, double &bl, double &bh, int &nb, double &bwid)
 
void Mndaxpy (unsigned int, double, const double *, double *)
 
void Mndscal (unsigned int, double, double *)
 
void Mndspmv (unsigned int, double, const double *, const double *, double, double *)
 
void mndspr (unsigned int n, double alpha, const double *x, double *ap)
 
int mneigen (double *a, unsigned int ndima, unsigned int n, unsigned int mits, double *work)
 
void mnplot (double *xpt, double *ypt, char *chpt, int nxypt, int npagwd, int npagln)
 
template<class A , class B , class T >
ABObj< vec, ABProd< ABObj< sym, A, T >, ABObj< vec, B, T > >, T > operator* (const ABObj< sym, A, T > &a, const ABObj< vec, B, T > &b)
 
ABObj< vec, ABProd< ABObj< sym, LASymMatrix >, ABObj< vec, LAVector > > > operator* (const ABObj< sym, LASymMatrix > &a, const ABObj< vec, LAVector > &b)
 
ABObj< sym, LASymMatrixoperator* (double f, const LASymMatrix &obj)
 
ABObj< vec, LAVectoroperator* (double f, const LAVector &obj)
 
template<class mt , class M , class T >
ABObj< mt, M, T > operator* (T f, const ABObj< mt, M, T > &obj)
 
template<class mt , class M , class T >
ABObj< mt, M, T > operator* (T f, const M &obj)
 
template<class atype , class A , class B , class T >
ABObj< atype, ABSum< ABObj< atype, A, T >, ABObj< atype, B, T > >, T > operator+ (const ABObj< atype, A, T > &a, const ABObj< atype, B, T > &b)
 
ABObj< sym, ABSum< ABObj< sym, LASymMatrix >, ABObj< sym, LASymMatrix > > > operator+ (const ABObj< sym, LASymMatrix > &a, const ABObj< sym, LASymMatrix > &b)
 
ABObj< vec, ABSum< ABObj< vec, LAVector >, ABObj< vec, LAVector > > > operator+ (const ABObj< vec, LAVector > &a, const ABObj< vec, LAVector > &b)
 
template<class atype , class A , class B , class T >
ABObj< atype, ABSum< ABObj< atype, A, T >, ABObj< atype, B, T > >, T > operator- (const ABObj< atype, A, T > &a, const ABObj< atype, B, T > &b)
 
template<class mt , class M , class T >
ABObj< mt, M, T > operator- (const ABObj< mt, M, T > &obj)
 
ABObj< sym, ABSum< ABObj< sym, LASymMatrix >, ABObj< sym, LASymMatrix > > > operator- (const ABObj< sym, LASymMatrix > &a, const ABObj< sym, LASymMatrix > &b)
 
ABObj< vec, ABSum< ABObj< vec, LAVector >, ABObj< vec, LAVector > > > operator- (const ABObj< vec, LAVector > &a, const ABObj< vec, LAVector > &b)
 
ABObj< sym, LASymMatrixoperator- (const LASymMatrix &obj)
 
ABObj< vec, LAVectoroperator- (const LAVector &obj)
 
template<class mt , class M , class T >
ABObj< mt, M, T > operator- (const M &obj)
 
template<class mt , class M , class T >
ABObj< mt, M, T > operator/ (const ABObj< mt, M, T > &obj, T f)
 
ABObj< sym, LASymMatrixoperator/ (const LASymMatrix &obj, double f)
 
ABObj< vec, LAVectoroperator/ (const LAVector &obj, double f)
 
template<class mt , class M , class T >
ABObj< mt, M, T > operator/ (const M &obj, T f)
 
std::ostream & operator<< (std::ostream &, const ContoursError &)
 
std::ostream & operator<< (std::ostream &, const FunctionMinimum &)
 
std::ostream & operator<< (std::ostream &, const LASymMatrix &)
 
std::ostream & operator<< (std::ostream &, const LAVector &)
 
std::ostream & operator<< (std::ostream &, const MinimumState &)
 
std::ostream & operator<< (std::ostream &, const MinosError &)
 
std::ostream & operator<< (std::ostream &, const MnGlobalCorrelationCoeff &)
 
std::ostream & operator<< (std::ostream &, const MnMachinePrecision &)
 
std::ostream & operator<< (std::ostream &, const MnUserCovariance &)
 
std::ostream & operator<< (std::ostream &, const MnUserParameters &)
 
std::ostream & operator<< (std::ostream &, const MnUserParameterState &)
 
std::ostream & operator<< (std::ostream &os, const MnPrint::Oneline &x)
 
std::ostream & operator<< (std::ostream &os, const std::pair< double, double > &point)
 
std::ostream & operator<< (std::ostream &out, const DerivatorElement &value)
 
void Outer_prod (LASymMatrix &, const LAVector &, double f=1.)
 
ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector >, double > > Outer_product (const ABObj< vec, LAVector > &obj)
 LAPACK Algebra function specialize the Outer_product function for LAVector;.
 
template<class M , class T >
ABObj< sym, VectorOuterProduct< ABObj< vec, M, T >, T >, T > Outer_product (const ABObj< vec, M, T > &obj)
 
LASquareMatrix OuterProduct (const LAVector &v1, const LAVector &v2)
 
void RestoreGlobalPrintLevel (int)
 
double similarity (const LAVector &, const LASymMatrix &)
 
void StreamFullPrefix (std::ostringstream &os)
 
double sum_of_elements (const LASymMatrix &)
 
double sum_of_elements (const LAVector &v)
 
double sum_of_elements (double const *arr, unsigned int n)
 
int TurnOffPrintInfoLevel ()
 

Variables

thread_local int gMaxNP = 10
 
std::vector< std::string > gPrefixFilter
 
thread_local PrefixStack< const char * > gPrefixStack
 
thread_local int gPrintLevel = 0
 
bool gShowPrefixStack = false
 

Typedef Documentation

◆ MnAlgebraicSymMatrix

◆ MnAlgebraicVector

Enumeration Type Documentation

◆ EMinimizerType

Enumerator
kMigrad 
kSimplex 
kCombined 
kScan 
kFumili 
kMigradBFGS 

Definition at line 36 of file Minuit2Minimizer.h.

◆ GradientParameterSpace

Enumerator
External 
Internal 

Definition at line 35 of file FCNBase.h.

Function Documentation

◆ ControlPrintLevel()

int ROOT::Minuit2::ControlPrintLevel ( )

Definition at line 78 of file Minuit2Minimizer.cxx.

◆ eigenvalues()

LAVector ROOT::Minuit2::eigenvalues ( const LASymMatrix & mat)

Definition at line 513 of file MnMatrix.cxx.

◆ inner_product()

double ROOT::Minuit2::inner_product ( const LAVector & v1,
const LAVector & v2 )

Definition at line 227 of file MnMatrix.cxx.

◆ Inverse() [1/2]

template<class mt , class M , class T >
ABObj< mt, MatrixInverse< mt, ABObj< mt, M, T >, T >, T > ROOT::Minuit2::Inverse ( const ABObj< mt, M, T > & obj)
inline

Definition at line 416 of file MnMatrix.h.

◆ Inverse() [2/2]

ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix >, double > > ROOT::Minuit2::Inverse ( const ABObj< sym, LASymMatrix > & obj)
inline

LAPACK Algebra functions specialize the Invert function for LASymMatrix.

Definition at line 1141 of file MnMatrix.h.

◆ Invert()

int ROOT::Minuit2::Invert ( LASymMatrix & t)

Definition at line 207 of file MnMatrix.cxx.

◆ Invert_undef_sym()

int ROOT::Minuit2::Invert_undef_sym ( LASymMatrix & )

◆ MatrixProduct()

LASquareMatrix ROOT::Minuit2::MatrixProduct ( const LASymMatrix & m1,
const LASquareMatrix & m2 )

Definition at line 61 of file BFGSErrorUpdator.cxx.

◆ mnbins()

void ROOT::Minuit2::mnbins ( double a1,
double a2,
int naa,
double & bl,
double & bh,
int & nb,
double & bwid )

Definition at line 16 of file mnbins.cxx.

◆ Mndaxpy()

void ROOT::Minuit2::Mndaxpy ( unsigned int n,
double da,
const double * dx,
double * dy )

Definition at line 198 of file MnMatrix.cxx.

◆ Mndscal()

void ROOT::Minuit2::Mndscal ( unsigned int n,
double da,
double * dx )

Definition at line 550 of file MnMatrix.cxx.

◆ Mndspmv()

void ROOT::Minuit2::Mndspmv ( unsigned int n,
double alpha,
const double * ap,
const double * x,
double beta,
double * y )

Definition at line 127 of file MnMatrix.cxx.

◆ mndspr()

void ROOT::Minuit2::mndspr ( unsigned int n,
double alpha,
const double * x,
double * ap )
inline

Definition at line 105 of file MnMatrix.cxx.

◆ mneigen()

int ROOT::Minuit2::mneigen ( double * a,
unsigned int ndima,
unsigned int n,
unsigned int mits,
double * work )

Definition at line 233 of file MnMatrix.cxx.

◆ mnplot()

void ROOT::Minuit2::mnplot ( double * xpt,
double * ypt,
char * chpt,
int nxypt,
int npagwd,
int npagln )

Definition at line 25 of file mntplot.cxx.

◆ operator*() [1/6]

template<class A , class B , class T >
ABObj< vec, ABProd< ABObj< sym, A, T >, ABObj< vec, B, T > >, T > ROOT::Minuit2::operator* ( const ABObj< sym, A, T > & a,
const ABObj< vec, B, T > & b )

Definition at line 371 of file MnMatrix.h.

◆ operator*() [2/6]

ABObj< vec, ABProd< ABObj< sym, LASymMatrix >, ABObj< vec, LAVector > > > ROOT::Minuit2::operator* ( const ABObj< sym, LASymMatrix > & a,
const ABObj< vec, LAVector > & b )
inline

Definition at line 1133 of file MnMatrix.h.

◆ operator*() [3/6]

ABObj< sym, LASymMatrix > ROOT::Minuit2::operator* ( double f,
const LASymMatrix & obj )
inline

Definition at line 788 of file MnMatrix.h.

◆ operator*() [4/6]

ABObj< vec, LAVector > ROOT::Minuit2::operator* ( double f,
const LAVector & obj )
inline

Definition at line 1118 of file MnMatrix.h.

◆ operator*() [5/6]

template<class mt , class M , class T >
ABObj< mt, M, T > ROOT::Minuit2::operator* ( T f,
const ABObj< mt, M, T > & obj )

Definition at line 305 of file MnMatrix.h.

◆ operator*() [6/6]

template<class mt , class M , class T >
ABObj< mt, M, T > ROOT::Minuit2::operator* ( T f,
const M & obj )

Definition at line 284 of file MnMatrix.h.

◆ operator+() [1/3]

template<class atype , class A , class B , class T >
ABObj< atype, ABSum< ABObj< atype, A, T >, ABObj< atype, B, T > >, T > ROOT::Minuit2::operator+ ( const ABObj< atype, A, T > & a,
const ABObj< atype, B, T > & b )

Definition at line 340 of file MnMatrix.h.

◆ operator+() [2/3]

ABObj< sym, ABSum< ABObj< sym, LASymMatrix >, ABObj< sym, LASymMatrix > > > ROOT::Minuit2::operator+ ( const ABObj< sym, LASymMatrix > & a,
const ABObj< sym, LASymMatrix > & b )
inline

Definition at line 777 of file MnMatrix.h.

◆ operator+() [3/3]

ABObj< vec, ABSum< ABObj< vec, LAVector >, ABObj< vec, LAVector > > > ROOT::Minuit2::operator+ ( const ABObj< vec, LAVector > & a,
const ABObj< vec, LAVector > & b )
inline

Definition at line 1107 of file MnMatrix.h.

◆ operator-() [1/7]

template<class atype , class A , class B , class T >
ABObj< atype, ABSum< ABObj< atype, A, T >, ABObj< atype, B, T > >, T > ROOT::Minuit2::operator- ( const ABObj< atype, A, T > & a,
const ABObj< atype, B, T > & b )

Definition at line 349 of file MnMatrix.h.

◆ operator-() [2/7]

template<class mt , class M , class T >
ABObj< mt, M, T > ROOT::Minuit2::operator- ( const ABObj< mt, M, T > & obj)

Definition at line 319 of file MnMatrix.h.

◆ operator-() [3/7]

ABObj< sym, ABSum< ABObj< sym, LASymMatrix >, ABObj< sym, LASymMatrix > > > ROOT::Minuit2::operator- ( const ABObj< sym, LASymMatrix > & a,
const ABObj< sym, LASymMatrix > & b )
inline

Definition at line 783 of file MnMatrix.h.

◆ operator-() [4/7]

ABObj< vec, ABSum< ABObj< vec, LAVector >, ABObj< vec, LAVector > > > ROOT::Minuit2::operator- ( const ABObj< vec, LAVector > & a,
const ABObj< vec, LAVector > & b )
inline

Definition at line 1113 of file MnMatrix.h.

◆ operator-() [5/7]

ABObj< sym, LASymMatrix > ROOT::Minuit2::operator- ( const LASymMatrix & obj)
inline

Definition at line 798 of file MnMatrix.h.

◆ operator-() [6/7]

ABObj< vec, LAVector > ROOT::Minuit2::operator- ( const LAVector & obj)
inline

Definition at line 1126 of file MnMatrix.h.

◆ operator-() [7/7]

template<class mt , class M , class T >
ABObj< mt, M, T > ROOT::Minuit2::operator- ( const M & obj)

Definition at line 298 of file MnMatrix.h.

◆ operator/() [1/4]

template<class mt , class M , class T >
ABObj< mt, M, T > ROOT::Minuit2::operator/ ( const ABObj< mt, M, T > & obj,
T f )

Definition at line 312 of file MnMatrix.h.

◆ operator/() [2/4]

ABObj< sym, LASymMatrix > ROOT::Minuit2::operator/ ( const LASymMatrix & obj,
double f )
inline

Definition at line 793 of file MnMatrix.h.

◆ operator/() [3/4]

ABObj< vec, LAVector > ROOT::Minuit2::operator/ ( const LAVector & obj,
double f )
inline

Definition at line 1122 of file MnMatrix.h.

◆ operator/() [4/4]

template<class mt , class M , class T >
ABObj< mt, M, T > ROOT::Minuit2::operator/ ( const M & obj,
T f )

Definition at line 291 of file MnMatrix.h.

◆ operator<<() [1/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const ContoursError & ce )

Definition at line 398 of file MnPrint.cxx.

◆ operator<<() [2/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const FunctionMinimum & min )

Definition at line 303 of file MnPrint.cxx.

◆ operator<<() [3/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const LASymMatrix & matrix )

Definition at line 570 of file MnMatrix.cxx.

◆ operator<<() [4/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const LAVector & vec )

Definition at line 602 of file MnMatrix.cxx.

◆ operator<<() [5/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MinimumState & min )

Definition at line 331 of file MnPrint.cxx.

◆ operator<<() [6/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MinosError & me )

Definition at line 352 of file MnPrint.cxx.

◆ operator<<() [7/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MnGlobalCorrelationCoeff & coeff )

Definition at line 271 of file MnPrint.cxx.

◆ operator<<() [8/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MnMachinePrecision & prec )

Definition at line 342 of file MnPrint.cxx.

◆ operator<<() [9/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MnUserCovariance & matrix )

Definition at line 247 of file MnPrint.cxx.

◆ operator<<() [10/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MnUserParameters & par )

Definition at line 210 of file MnPrint.cxx.

◆ operator<<() [11/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MnUserParameterState & state )

Definition at line 284 of file MnPrint.cxx.

◆ operator<<() [12/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const MnPrint::Oneline & x )

Definition at line 198 of file MnPrint.cxx.

◆ operator<<() [13/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & os,
const std::pair< double, double > & point )

Definition at line 416 of file MnPrint.cxx.

◆ operator<<() [14/14]

std::ostream & ROOT::Minuit2::operator<< ( std::ostream & out,
const DerivatorElement & value )

Definition at line 284 of file NumericalDerivator.cxx.

◆ Outer_prod()

void ROOT::Minuit2::Outer_prod ( LASymMatrix & A,
const LAVector & v,
double f = 1. )

Definition at line 192 of file MnMatrix.cxx.

◆ Outer_product() [1/2]

ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector >, double > > ROOT::Minuit2::Outer_product ( const ABObj< vec, LAVector > & obj)
inline

LAPACK Algebra function specialize the Outer_product function for LAVector;.

Definition at line 1153 of file MnMatrix.h.

◆ Outer_product() [2/2]

template<class M , class T >
ABObj< sym, VectorOuterProduct< ABObj< vec, M, T >, T >, T > ROOT::Minuit2::Outer_product ( const ABObj< vec, M, T > & obj)

Definition at line 390 of file MnMatrix.h.

◆ OuterProduct()

LASquareMatrix ROOT::Minuit2::OuterProduct ( const LAVector & v1,
const LAVector & v2 )

Definition at line 48 of file BFGSErrorUpdator.cxx.

◆ RestoreGlobalPrintLevel()

void ROOT::Minuit2::RestoreGlobalPrintLevel ( int )

Definition at line 82 of file Minuit2Minimizer.cxx.

◆ similarity()

double ROOT::Minuit2::similarity ( const LAVector & avec,
const LASymMatrix & mat )

Definition at line 540 of file MnMatrix.cxx.

◆ StreamFullPrefix()

void ROOT::Minuit2::StreamFullPrefix ( std::ostringstream & os)

Definition at line 135 of file MnPrint.cxx.

◆ sum_of_elements() [1/3]

double ROOT::Minuit2::sum_of_elements ( const LASymMatrix & m)

Definition at line 98 of file MnMatrix.cxx.

◆ sum_of_elements() [2/3]

double ROOT::Minuit2::sum_of_elements ( const LAVector & v)

Definition at line 92 of file MnMatrix.cxx.

◆ sum_of_elements() [3/3]

double ROOT::Minuit2::sum_of_elements ( double const * arr,
unsigned int n )
inline

Definition at line 83 of file MnMatrix.cxx.

◆ TurnOffPrintInfoLevel()

int ROOT::Minuit2::TurnOffPrintInfoLevel ( )

Definition at line 74 of file Minuit2Minimizer.cxx.

Variable Documentation

◆ gMaxNP

thread_local int ROOT::Minuit2::gMaxNP = 10

Definition at line 557 of file MnMatrix.cxx.

◆ gPrefixFilter

std::vector<std::string> ROOT::Minuit2::gPrefixFilter

Definition at line 77 of file MnPrint.cxx.

◆ gPrefixStack

thread_local PrefixStack<const char *> ROOT::Minuit2::gPrefixStack

Definition at line 84 of file MnPrint.cxx.

◆ gPrintLevel

thread_local int ROOT::Minuit2::gPrintLevel = 0

Definition at line 81 of file MnPrint.cxx.

◆ gShowPrefixStack

bool ROOT::Minuit2::gShowPrefixStack = false

Definition at line 74 of file MnPrint.cxx.