ROOT
6.06/09
Reference Guide
|
Classes | |
class | ABObj |
class | ABObj< sym, LASymMatrix, double > |
class | ABObj< vec, LAVector, double > |
class | ABProd |
class | ABSum |
class | AlgebraicProdType |
class | AlgebraicProdType< gen, gen > |
class | AlgebraicProdType< gen, sym > |
class | AlgebraicProdType< gen, vec > |
class | AlgebraicProdType< sym, gen > |
class | AlgebraicProdType< sym, sym > |
class | AlgebraicProdType< sym, vec > |
class | AlgebraicProdType< T, T > |
class | AlgebraicProdType< vec, gen > |
class | AlgebraicProdType< vec, sym > |
class | AlgebraicSumType |
class | AlgebraicSumType< gen, vec > |
class | AlgebraicSumType< sym, vec > |
class | AlgebraicSumType< T, T > |
class | AlgebraicSumType< vec, gen > |
class | AlgebraicSumType< vec, sym > |
class | AnalyticalGradientCalculator |
class | BasicFunctionGradient |
class | BasicFunctionMinimum |
result of the minimization; both internal and external (MnUserParameterState) representation available For the parameters at the Minimum More... | |
class | BasicMinimumError |
Internal Class containing the error information on the estimated minimum : Error matrix + dcovar + additional flags for quality and validity checks. More... | |
class | BasicMinimumParameters |
class | BasicMinimumSeed |
class | BasicMinimumState |
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 | 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 | FlatRandomGen |
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 |
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 | FunctionMinimizer |
base class for function minimizers; user may give FCN or FCN with Gradient, Parameter starting values and initial Error guess (sigma) (or "step size"), or Parameter starting values and initial covariance matrix; covariance matrix is stored in Upper triangular packed storage format, e.g. More... | |
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 | GaussDataGen |
class | GaussFcn |
class | GaussFcn2 |
class | GaussFunction |
class | GaussianModelFunction |
Sample implementation of a parametric function. More... | |
class | GaussRandomGen |
class | gen |
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 | 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 |
MinimumSeed contains the starting values for the minimization produced by the SeedGenerator. More... | |
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 | MnFumiliMinimize |
API class for minimization using Fumili technology; allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc. 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 |
determines the relative floating point 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. 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. 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 | 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 | MnRefCountedPointer |
class | MnReferenceCounter |
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 three levels of strategies: low (0), medium (1), high (>=2); 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. 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 | ParametricFunction |
Function which has parameters. More... | |
class | Quad12F |
class | Quad1F |
class | Quad4F |
class | Quad4FGrad |
class | Quad8F |
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) 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 } |
Functions | |
template<class mt , class M , class T > | |
ABObj< mt, M, T > | operator* (T f, const M &obj) |
template<class mt , class M , class T > | |
ABObj< mt, M, T > | operator/ (const M &obj, T f) |
template<class mt , class M , class T > | |
ABObj< mt, M, T > | operator- (const M &obj) |
template<class atype , class A , class btype , class B , class T > | |
ABObj< typename AlgebraicProdType< atype, btype >::Type, ABProd< ABObj< atype, A, T >, ABObj< btype, B, T > >, T > | operator* (const ABObj< atype, A, T > &a, const ABObj< btype, B, T > &b) |
template<class atype , class A , class btype , class B , class T > | |
ABObj< typename AlgebraicSumType< atype, btype >::Type, ABSum< ABObj< atype, A, T >, ABObj< btype, B, T > >, T > | operator+ (const ABObj< atype, A, T > &a, const ABObj< btype, B, T > &b) |
template<class atype , class A , class btype , class B , class T > | |
ABObj< typename AlgebraicSumType< atype, btype >::Type, ABSum< ABObj< atype, A, T >, ABObj< btype, B, T > >, T > | operator- (const ABObj< atype, A, T > &a, const ABObj< btype, B, T > &b) |
ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > | Inverse (const ABObj< sym, LASymMatrix, double > &obj) |
LAPACK Algebra functions specialize the Invert function for LASymMatrix. More... | |
template<class T > | |
ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > | operator* (T f, const ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > &inv) |
template<class T > | |
ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > | operator/ (const ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > &inv, T f) |
template<class T > | |
ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > | operator- (const ABObj< sym, MatrixInverse< sym, ABObj< sym, LASymMatrix, double >, double >, double > &inv) |
int | Invert (LASymMatrix &) |
int | Invert_undef_sym (LASymMatrix &) |
ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, double >, double >, double > | Outer_product (const ABObj< vec, LAVector, double > &obj) |
LAPACK Algebra function specialize the Outer_product function for LAVector;. More... | |
template<class T > | |
ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, T >, T >, T > | operator* (T f, const ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, T >, T >, T > &obj) |
template<class T > | |
ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, T >, T >, T > | operator/ (const ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, T >, T >, T > &obj, T f) |
template<class T > | |
ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, T >, T >, T > | operator- (const ABObj< sym, VectorOuterProduct< ABObj< vec, LAVector, T >, T >, T > &obj) |
void | Outer_prod (LASymMatrix &, const LAVector &, double f=1.) |
int | Mndaxpy (unsigned int, double, const double *, int, double *, int) |
int | Mndscal (unsigned int, double, double *, int) |
int | Mndspmv (const char *, unsigned int, double, const double *, const double *, int, double, double *, int) |
template<class mt , class M , class T > | |
ABObj< mt, MatrixInverse< mt, ABObj< mt, M, T >, T >, T > | Inverse (const ABObj< mt, M, T > &obj) |
std::ostream & | operator<< (std::ostream &, const FunctionMinimum &) |
std::ostream & | operator<< (std::ostream &, const MinimumState &) |
std::ostream & | operator<< (std::ostream &, const LAVector &) |
std::ostream & | operator<< (std::ostream &, const LASymMatrix &) |
std::ostream & | operator<< (std::ostream &, const MnUserParameters &) |
std::ostream & | operator<< (std::ostream &, const MnUserCovariance &) |
std::ostream & | operator<< (std::ostream &, const MnGlobalCorrelationCoeff &) |
std::ostream & | operator<< (std::ostream &, const MnUserParameterState &) |
std::ostream & | operator<< (std::ostream &, const MnMachinePrecision &) |
std::ostream & | operator<< (std::ostream &, const MinosError &) |
std::ostream & | operator<< (std::ostream &, const ContoursError &) |
template<class M , class T > | |
ABObj< sym, VectorOuterProduct< ABObj< vec, M, T >, T >, T > | Outer_product (const ABObj< vec, M, T > &obj) |
double | inner_product (const LAVector &, const LAVector &) |
double | similarity (const LAVector &, const LASymMatrix &) |
double | sum_of_elements (const LASymMatrix &) |
int | mneigen (double *, unsigned int, unsigned int, unsigned int, double *, double) |
LAVector | eigenvalues (const LASymMatrix &mat) |
double | mnddot (unsigned int, const double *, int, const double *, int) |
int | mnvert (MnAlgebraicSymMatrix &a) |
Inverts a symmetric matrix. More... | |
int | mndspr (const char *, unsigned int, double, const double *, int, double *) |
double | mndasum (unsigned int, const double *, int) |
double | sum_of_elements (const LAVector &v) |
int | TurnOffPrintInfoLevel () |
int | ControlPrintLevel () |
void | RestoreGlobalPrintLevel (int) |
void | mnbins (double a1, double a2, int naa, double &bl, double &bh, int &nb, double &bwid) |
void | PrintContourPoint (const std::pair< double, double > &point) |
bool | mnlsame (const char *, const char *) |
int | mnxerbla (const char *, int) |
void | mnplot (double *xpt, double *ypt, char *chpt, int nxypt, int npagwd, int npagln) |
Variables | |
int | gPrintLevel = 0 |
Definition at line 41 of file MnMatrix.h.
Definition at line 42 of file MnMatrix.h.
Enumerator | |
---|---|
kMigrad | |
kSimplex | |
kCombined | |
kScan | |
kFumili |
Definition at line 40 of file Minuit2Minimizer.h.
int ROOT::Minuit2::ControlPrintLevel | ( | ) |
Definition at line 75 of file Minuit2Minimizer.cxx.
LAVector ROOT::Minuit2::eigenvalues | ( | const LASymMatrix & | mat | ) |
Definition at line 20 of file LaEigenValues.cxx.
Referenced by ROOT::Minuit2::MnPosDef::operator()(), and ROOT::Minuit2::MnEigen::operator()().
Definition at line 19 of file LaInnerProduct.cxx.
Referenced by ROOT::Minuit2::VariableMetricBuilder::Minimum(), ROOT::Minuit2::FumiliBuilder::Minimum(), ROOT::Math::GoFTest::SetParameters(), TKDE::SetSigma(), and ROOT::Minuit2::DavidonErrorUpdator::Update().
|
inline |
LAPACK Algebra functions specialize the Invert function for LASymMatrix.
Definition at line 27 of file LaInverse.h.
Referenced by ROOTwriter.ROOTwriter::TGeoIntersection(), ROOTwriter.ROOTwriter::TGeoSubtraction(), and ROOTwriter.ROOTwriter::TGeoUnion().
|
inline |
Definition at line 60 of file MatrixInverse.h.
int ROOT::Minuit2::Invert | ( | LASymMatrix & | t | ) |
Definition at line 22 of file LaInverse.cxx.
Referenced by ROOT::Minuit2::MnUserParameterState::Hessian(), ROOT::Minuit2::BasicMinimumError::Hessian(), TMatrixT< Element >::InvertFast(), ROOT::Minuit2::LASymMatrix::LASymMatrix(), ROOT::Minuit2::MnGlobalCorrelationCoeff::MnGlobalCorrelationCoeff(), ROOT::Minuit2::MnCovarianceSqueeze::operator()(), ROOT::Minuit2::MnHesse::operator()(), ROOT::Minuit2::LASymMatrix::operator+=(), ROOT::Minuit2::LASymMatrix::operator=(), TMatrixT< Element >::TMatrixT(), TMatrixTSym< Element >::TMatrixTSym(), and ROOT::Minuit2::FumiliErrorUpdator::Update().
int ROOT::Minuit2::Invert_undef_sym | ( | LASymMatrix & | ) |
void ROOT::Minuit2::mnbins | ( | double | a1, |
double | a2, | ||
int | naa, | ||
double & | bl, | ||
double & | bh, | ||
int & | nb, | ||
double & | bwid | ||
) |
Definition at line 17 of file mnbins.cxx.
Referenced by mnplot().
Definition at line 22 of file mndasum.cxx.
Referenced by sum_of_elements().
int ROOT::Minuit2::Mndaxpy | ( | unsigned int | n, |
double | da, | ||
const double * | dx, | ||
int | incx, | ||
double * | dy, | ||
int | incy | ||
) |
Definition at line 20 of file mndaxpy.cxx.
Referenced by ROOT::Minuit2::LAVector::operator+=(), ROOT::Minuit2::LASymMatrix::operator+=(), ROOT::Minuit2::LAVector::operator-=(), and ROOT::Minuit2::LASymMatrix::operator-=().
double ROOT::Minuit2::mnddot | ( | unsigned int | n, |
const double * | dx, | ||
int | incx, | ||
const double * | dy, | ||
int | incy | ||
) |
Definition at line 20 of file mnddot.cxx.
Referenced by inner_product(), and similarity().
Definition at line 20 of file mndscal.cxx.
Referenced by ROOT::Minuit2::LASymMatrix::LASymMatrix(), ROOT::Minuit2::LAVector::operator*=(), ROOT::Minuit2::LASymMatrix::operator*=(), ROOT::Minuit2::LAVector::operator+=(), and ROOT::Minuit2::LASymMatrix::operator+=().
int ROOT::Minuit2::Mndspmv | ( | const char * | uplo, |
unsigned int | n, | ||
double | alpha, | ||
const double * | ap, | ||
const double * | x, | ||
int | incx, | ||
double | beta, | ||
double * | y, | ||
int | incy | ||
) |
Definition at line 23 of file mndspmv.cxx.
Referenced by ROOT::Minuit2::LAVector::LAVector(), ROOT::Minuit2::LAVector::operator+=(), and ROOT::Minuit2::LAVector::operator=().
int ROOT::Minuit2::mndspr | ( | const char * | uplo, |
unsigned int | n, | ||
double | alpha, | ||
const double * | x, | ||
int | incx, | ||
double * | ap | ||
) |
Definition at line 23 of file mndspr.cxx.
Referenced by Outer_prod().
int ROOT::Minuit2::mneigen | ( | double * | a, |
unsigned int | ndima, | ||
unsigned int | n, | ||
unsigned int | mits, | ||
double * | work, | ||
double | precis | ||
) |
Definition at line 22 of file mnteigen.cxx.
Referenced by eigenvalues().
bool ROOT::Minuit2::mnlsame | ( | const char * | ca, |
const char * | cb | ||
) |
Definition at line 22 of file mnlsame.cxx.
void ROOT::Minuit2::mnplot | ( | double * | xpt, |
double * | ypt, | ||
char * | chpt, | ||
int | nxypt, | ||
int | npagwd, | ||
int | npagln | ||
) |
Definition at line 26 of file mntplot.cxx.
Referenced by ROOT::Minuit2::MnPlot::operator()().
int ROOT::Minuit2::mnvert | ( | MnAlgebraicSymMatrix & | a | ) |
Inverts a symmetric matrix.
Matrix is first scaled to have all ones on the diagonal (equivalent to change of units) but no pivoting is done since matrix is positive-definite.
Definition at line 24 of file mnvert.cxx.
Referenced by Invert().
int ROOT::Minuit2::mnxerbla | ( | const char * | srname, |
int | info | ||
) |
Definition at line 27 of file mnxerbla.cxx.
|
inline |
Definition at line 32 of file LaInverse.h.
|
inline |
Definition at line 35 of file LaOuterProduct.h.
|
inline |
|
inline |
Definition at line 42 of file LaInverse.h.
|
inline |
Definition at line 49 of file LaOuterProduct.h.
|
inline |
|
inline |
Definition at line 37 of file LaInverse.h.
|
inline |
Definition at line 42 of file LaOuterProduct.h.
|
inline |
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const FunctionMinimum & | min | ||
) |
Definition at line 245 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MinimumState & | min | ||
) |
Definition at line 284 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const LAVector & | vec | ||
) |
Definition at line 76 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const LASymMatrix & | matrix | ||
) |
Definition at line 91 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MnUserParameters & | par | ||
) |
Definition at line 109 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MnUserCovariance & | matrix | ||
) |
Definition at line 158 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MnGlobalCorrelationCoeff & | coeff | ||
) |
Definition at line 195 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MnUserParameterState & | state | ||
) |
Definition at line 213 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MnMachinePrecision & | prec | ||
) |
Definition at line 302 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const MinosError & | me | ||
) |
Definition at line 315 of file MnPrint.cxx.
std::ostream & ROOT::Minuit2::operator<< | ( | std::ostream & | os, |
const ContoursError & | ce | ||
) |
Definition at line 357 of file MnPrint.cxx.
void ROOT::Minuit2::Outer_prod | ( | LASymMatrix & | A, |
const LAVector & | v, | ||
double | f = 1. |
||
) |
Definition at line 50 of file LaOuterProduct.cxx.
Referenced by ROOT::Minuit2::LASymMatrix::LASymMatrix(), ROOT::Minuit2::LASymMatrix::operator+=(), and ROOT::Minuit2::LASymMatrix::operator=().
|
inline |
LAPACK Algebra function specialize the Outer_product function for LAVector;.
Definition at line 28 of file LaOuterProduct.h.
Referenced by ROOT::Minuit2::DavidonErrorUpdator::Update().
|
inline |
Definition at line 40 of file VectorOuterProduct.h.
Definition at line 29 of file MnContours.cxx.
Referenced by ROOT::Minuit2::MnContours::Contour().
void ROOT::Minuit2::RestoreGlobalPrintLevel | ( | int | ) |
double ROOT::Minuit2::similarity | ( | const LAVector & | , |
const LASymMatrix & | |||
) |
Definition at line 21 of file LaVtMVSimilarity.cxx.
Referenced by ROOT::Minuit2::VariableMetricEDMEstimator::Estimate(), and ROOT::Minuit2::DavidonErrorUpdator::Update().
Definition at line 20 of file LaSumOfElements.cxx.
double ROOT::Minuit2::sum_of_elements | ( | const LASymMatrix & | m | ) |
Definition at line 26 of file LaSumOfElements.cxx.
Referenced by ROOT::Minuit2::DavidonErrorUpdator::Update(), and ROOT::Minuit2::FumiliErrorUpdator::Update().
int ROOT::Minuit2::TurnOffPrintInfoLevel | ( | ) |
int ROOT::Minuit2::gPrintLevel = 0 |
Definition at line 37 of file MnPrint.cxx.
Referenced by ROOT::Minuit2::MnPrint::Level(), and ROOT::Minuit2::MnPrint::SetLevel().