►NROOT | Namespace for new ROOT classes and functions |
►NExperimental | |
CTFitResult | |
CTFunction | |
►NFit | Namespace for the fitting classes |
►NFitUtil | Namespace defining utility free functions using in Fit for evaluating the various fit method functions (chi2, likelihood, etc..) given the data and the model function |
CEvaluate | |
CIntegralEvaluator | |
CLikelihoodAux | |
CLikelihoodAux< double > | |
CBasicFCN | BasicFCN class: base class for the objective functions used in the fits It has a reference to the data and th emodel function used in the fit |
CBinData | Class describing the binned data sets : vectors of x coordinates, y values and optionally error on y values and error on coordinates The dimension of the coordinate is free There are 4 different options: |
CChi2FCN | Chi2FCN class for binnned fits using the least square methods |
CDataOptions | DataOptions : simple structure holding the options on how the data are filled |
CDataRange | Class describing the range in the coordinates it supports multiple range in a coordinate |
CDummyDeleter | |
CFcnAdapter | |
CFitConfig | Class describing the configuration of the fit, options and parameter settings using the ROOT::Fit::ParameterSettings class |
CFitData | Base class for all the fit data types: Stores the coordinates and the DataOptions |
CFitResult | 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 |
CFitter | Fitter class, entry point for performing all type of fits |
CLogLikelihoodFCN | LogLikelihoodFCN class for likelihood fits |
CParameterSettings | Class, describing value, limits and step size of the parameters Provides functionality also to set/retrieve values, step sizes, limits and fix the parameters |
CPoissonLikelihoodFCN | Class evaluating the log likelihood for binned Poisson likelihood fits it is template to distinguish gradient and non-gradient case |
CSparseData | |
CUnBinData | Class describing the unbinned data sets (just x coordinates values) of any dimensions |
►NMath | |
►NCholeskyDecompHelpers | Helpers for CholeskyDecomp |
C_decomposer | Struct to do a Cholesky decomposition |
C_decomposer< F, 0, M > | Struct to do a Cholesky decomposition (specialized, N = 0) |
C_decomposer< F, 1, M > | Struct to do a Cholesky decomposition (specialized, N = 1) |
C_decomposer< F, 2, M > | Struct to do a Cholesky decomposition (specialized, N = 2) |
C_decomposer< F, 3, M > | Struct to do a Cholesky decomposition (specialized, N = 3) |
C_decomposer< F, 4, M > | Struct to do a Cholesky decomposition (specialized, N = 4) |
C_decomposer< F, 5, M > | Struct to do a Cholesky decomposition (specialized, N = 5) |
C_decomposer< F, 6, M > | Struct to do a Cholesky decomposition (specialized, N = 6) |
C_decomposerGenDim | Struct to do a Cholesky decomposition (general dimensionality) |
C_inverter | Struct to obtain the inverse from a Cholesky decomposition |
C_inverter< F, 0, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 0) |
C_inverter< F, 1, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 1) |
C_inverter< F, 2, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 2) |
C_inverter< F, 3, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 3) |
C_inverter< F, 4, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 4) |
C_inverter< F, 5, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 5) |
C_inverter< F, 6, M > | Struct to obtain the inverse from a Cholesky decomposition (N = 6) |
C_inverterGenDim | Struct to obtain the inverse from a Cholesky decomposition (general dimensionality) |
C_solver | Struct to solve a linear system using its Cholesky decomposition |
C_solver< F, 0, V > | Struct to solve a linear system using its Cholesky decomposition (N=0) |
C_solver< F, 1, V > | Struct to solve a linear system using its Cholesky decomposition (N=1) |
C_solver< F, 2, V > | Struct to solve a linear system using its Cholesky decomposition (N=2) |
C_solver< F, 3, V > | Struct to solve a linear system using its Cholesky decomposition (N=3) |
C_solver< F, 4, V > | Struct to solve a linear system using its Cholesky decomposition (N=4) |
C_solver< F, 5, V > | Struct to solve a linear system using its Cholesky decomposition (N=5) |
C_solver< F, 6, V > | Struct to solve a linear system using its Cholesky decomposition (N=6) |
C_solverGenDim | Struct to solve a linear system using its Cholesky decomposition (generalised dimensionality) |
CPackedArrayAdapter | Adapter for packed arrays (to SMatrix indexing conventions) |
►Ndetail | |
Cmanipulator | |
►NGenVector_detail | |
►CBitReproducible | |
CDB8 | |
CBitReproducibleException | |
►Ngv_detail | |
CERROR_This_Rotation_Conversion_is_NOT_Supported | |
►NImpl | |
CPlane3D | Class describing a geometrical plane in 3 dimensions |
CTransform3D | Basic 3D Transformation class describing a rotation and then a translation The internal data are a 3D rotation data (represented as a 3x3 matrix) and a 3D vector data |
CTranslation3D | Class describing a 3 dimensional translation |
►NRoots | Root-Finding Algorithms |
CBisection | Roots::Bisection Bisection algorithm, simplest algorithm for bracketing the roots of a function, but slowest one |
CBrent | Brent-Dekker algorithm which combines an interpolation strategy with the bisection algorithm See the GSL manual for more information |
CFalsePos | False Position algorithm based on linear interpolation |
CNewton | Newton algorithm, which computes the derivative at each iteration See the GSL manual for more information |
CSecant | Secant algorithm, simplified version of Newton method, which does not require the derivative at every step |
CSteffenson | Steffenson method, providing the fastes convergence |
►NrowOffsetsUtils | |
Cindices | |
Cmake_indices | |
Cmake_indices_impl | |
Cmake_indices_impl< I, indices< Indices... >, N > | |
Cmake_indices_impl< N, indices< Indices... >, N > | |
CAdaptiveIntegratorMultiDim | Class for adaptive quadrature integration in multi-dimensions using rectangular regions |
CAddOp | Addition Operation Class |
CAddPolicy | Matrix addition policy |
CAddPolicy< T, D1, D2, MatRepSym< T, D1 >, MatRepSym< T, D1 > > | |
CAssign | Structure to assign from an expression based to general matrix to general matrix |
CAssign< T, D1, D2, A, MatRepSym< T, D1 >, MatRepStd< T, D1, D2 > > | Dummy Structure which flags an error to avoid assigment from expression based on a general matrix to a symmetric matrix |
CAssign< T, D1, D2, A, MatRepSym< T, D1 >, MatRepSym< T, D1 > > | Structure to assign from an expression based to symmetric matrix to symmetric matrix |
CAssignItr | Structure for assignment to a general matrix from iterator |
CAssignItr< T, D1, D2, MatRepSym< T, D1 > > | Specialized structure for assignment to a symmetrix matrix from iterator |
CAssignSym | Force Expression evaluation from general to symmetric |
CAxisAngle | AxisAngle class describing rotation represented with direction axis (3D Vector) and an angle of rotation around that axis |
CBaseIntegratorOptions | Base class for Numerical integration options common in 1D and multi-dimension This is an internal class and is not supposed to be instantiated by the user |
CBasicFitMethodFunction | FitMethodFunction class Interface for objective functions (like chi2 and likelihood used in the fit) In addition to normal function interface provide interface for calculating each data contrinution to the function which is required by some algorithm (like Fumili) |
CBasicMinimizer | Base Minimizer class, which defines the basic funcionality of various minimizer implementations (apart from Minuit and Minuit2) It provides support for storing parameter values, step size, parameter transofrmation etc |
CBinaryOp | BinaryOperation class A class representing binary operators in the parse tree |
CBinaryOpCopyL | Binary Operation class with value storage for the left argument |
CBinaryOpCopyR | Binary Operation class with value storage for the right argument |
CBoost | Lorentz boost class with the (4D) transformation represented internally by a 4x4 orthosymplectic matrix |
CBoostX | Class representing a Lorentz Boost along the X axis, by beta |
CBoostY | Class representing a Lorentz Boost along the Y axis, by beta |
CBoostZ | Class representing a Lorentz Boost along the Z axis, by beta |
CBrentMinimizer1D | User class for performing function minimization |
CBrentRootFinder | Class for finding the root of a one dimensional function using the Brent algorithm |
CCartesian2D | Class describing a 2D cartesian coordinate system (x, y coordinates) |
CCartesian3D | Class describing a 3D cartesian coordinate system (x, y, z coordinates) |
CChebyshevApprox | Class describing a Chebyshev series which can be used to approximate a function in a defined range [a,b] using Chebyshev polynomials |
CChebyshevPol | |
CCholeskyDecomp | Class to compute the Cholesky decomposition of a matrix |
CCholeskyDecompGenDim | Class to compute the Cholesky decomposition of a matrix |
CCholInverter | |
CCompileTimeChecker | |
CCompileTimeChecker< false > | |
CConstant | Constant expression class A class representing constant expressions (literals) in the parse tree |
CCylindrical3D | Class describing a cylindrical coordinate system based on rho, z and phi |
CCylindricalEta3D | Class describing a cylindrical coordinate system based on eta (pseudorapidity) instead of z |
CDefaultCoordinateSystemTag | DefaultCoordinateSystemTag Default tag for identifying any coordinate system |
►CDelaunay2D | Class to generate a Delaunay triangulation of a 2D set of points |
CTriangle | |
CDerivator | Class for computing numerical derivative of a function |
CDeterminant | Detrminant for a general squared matrix Function to compute the determinant from a square matrix ( \( \det(A)\)) of dimension idim and order n |
CDisplacementVector2D | Class describing a generic displacement vector in 2 dimensions |
CDisplacementVector3D | Class describing a generic displacement vector in 3 dimensions |
CDistSampler | Interface class for generic sampling of a distribution, i.e |
CDistSamplerOptions | DistSampler options class |
CDivOp | Division (element-wise) Operation Class |
CEulerAngles | EulerAngles class describing rotation as three angles (Euler Angles) |
CEvaluatorOneDim | |
CEvaluatorOneDim< const ROOT::Math::IParamMultiFunction & > | |
CExpr | |
CFabs | Unary abs Operation Class |
CFactory | Factory class holding static functions to create the interfaces like ROOT::Math::Minimizer via the Plugin Manager |
CFastInverter | Fast Matrix Inverter class Class to specialize calls to Dinv |
CFastInverter< 3 > | 3x3 direct matrix inversion using Cramer Rule use only for FastInverter |
CFastInverter< 4 > | 4x4 matrix inversion using Cramers rule |
CFastInverter< 5 > | 5x5 Matrix inversion using Cramers rule |
CFunctor | Documentation for class Functor class |
CFunctor1D | Functor1D class for one-dimensional functions |
CFunctorGradHandler | Functor Handler class for gradient functions where both callable objects are provided for the function evaluation (type Func) and for the gradient (type GradFunc) |
CFunctorHandler | Functor Handler class is responsible for wrapping any other functor and pointer to free C functions |
CFunctorImpl | FunctorImpl is a base class for the functor handler implementation class |
CGaussIntegrator | User class for performing function integration |
CGaussLegendreIntegrator | User class for performing function integration |
CGenAlgoOptions | Class implementing generic options for a numerical algorithm Just store the options in a map of string-value pairs |
CGeneticMinimizer | GeneticMinimizer |
CGeneticMinimizerParameters | |
CGenVector_exception | |
CGlobalCoordinateSystemTag | Tag for identifying vectors based on a global coordinate system |
CGoFTest | |
CGradFunctor | GradFunctor class for Multidimensional gradient functions |
CGradFunctor1D | GradFunctor1D class for one-dimensional gradient functions |
CGSL1DMinimizerWrapper | Wrapper class for gsl_min_fminimizer structure |
CGSLChebSeries | Wrapper class for C struct gsl_cheb_series |
CGSLDerivator | Class for computing numerical derivative of a function based on the GSL numerical algorithm This class is implemented using the numerical derivatives algorithms provided by GSL (see GSL Online Manual ) |
CGSLFunctionAdapter | Class for adapting any C++ functor class to C function pointers used by GSL |
CGSLFunctionDerivWrapper | Class to wrap a gsl_function_fdf (with derivatives) |
CGSLFunctionWrapper | Wrapper class to the gsl_function C structure |
CGSLIntegrationWorkspace | |
CGSLIntegrator | Class for performing numerical integration of a function in one dimension |
CGSLInterpolator | Interpolation class based on GSL interpolation functions |
CGSLMCIntegrationWorkspace | |
CGSLMCIntegrator | |
CGSLMinimizer | GSLMinimizer class |
CGSLMinimizer1D | Minimizer for arbitrary one dimensional functions |
CGSLMiserIntegrationWorkspace | Workspace for MISER |
CGSLMonteFunctionAdapter | |
CGSLMonteFunctionWrapper | Wrapper to a multi-dim function withtout derivatives for Monte Carlo multi-dimensional integration algorithm |
CGSLMultiFit | GSLMultiFit, internal class for implementing GSL non linear least square GSL fitting |
CGSLMultiFitFunctionAdapter | Class for adapting a C++ functor class to C function pointers used by GSL MultiFit Algorithm The templated C++ function class must implement: |
CGSLMultiFitFunctionWrapper | Wrapper to a multi-dim function withtout derivatives for multi-dimensional minimization algorithm |
CGSLMultiMinDerivFunctionWrapper | Wrapper for a multi-dimensional function with derivatives used in GSL multidim minimization algorithm |
CGSLMultiMinFunctionAdapter | Class for adapting any multi-dimension C++ functor class to C function pointers used by GSL MultiMin algorithms |
CGSLMultiMinFunctionWrapper | Wrapper to a multi-dim function withtout derivatives for multi-dimensional minimization algorithm |
CGSLMultiMinimizer | GSLMultiMinimizer class , for minimizing multi-dimensional function using derivatives |
CGSLMultiRootBaseSolver | GSLMultiRootBaseSolver, internal class for implementing GSL multi-root finders This is the base class for GSLMultiRootSolver (solver not using derivatives) and GSLMUltiRootDerivSolver (solver using derivatives) |
CGSLMultiRootDerivFunctionWrapper | Wrapper to a multi-dim function with derivatives for multi roots algorithm |
CGSLMultiRootDerivSolver | GSLMultiRootDerivSolver, internal class for implementing GSL multi-root finders using derivatives |
CGSLMultiRootFinder | Class for Multidimensional root finding algorithms bassed on GSL |
CGSLMultiRootFunctionAdapter | Class for adapting a C++ functor class to C function pointers used by GSL MultiRoot Algorithm The templated C++ function class must implement: |
CGSLMultiRootFunctionWrapper | Wrapper to a multi-dim function without derivatives for multi roots algorithm |
CGSLMultiRootSolver | GSLMultiRootSolver, internal class for implementing GSL multi-root finders not using derivatives |
CGSLNLSMinimizer | GSLNLSMinimizer class for Non Linear Least Square fitting It Uses the Levemberg-Marquardt algorithm from GSL Non Linear Least Square fitting |
CGSLPlainIntegrationWorkspace | |
CGSLQRngNiederreiter2 | Niederreiter generator gsl_qrng_niederreiter_2 from here |
CGSLQRngSobol | Sobol generator gsl_qrng_sobol from here |
CGSLQRngWrapper | GSLQRngWrapper class to wrap gsl_qrng structure |
CGSLQuasiRandomEngine | GSLQuasiRandomEngine Base class for all GSL quasi random engines, normally user instantiate the derived classes which creates internally the generator and uses the class ROOT::Math::QuasiRandom |
CGSLRandomEngine | GSLRandomEngine Base class for all GSL random engines, normally user instantiate the derived classes which creates internally the generator |
CGSLRngCMRG | Combined multiple recursive generator (L'Ecuyer) see here |
CGSLRngGFSR4 | Lagged Fibonacci generator by Ziff see here |
CGSLRngMinStd | MINSTD generator (Park and Miller) see here |
CGSLRngMixMax | MixMax generator based on ROOT::Math::MixMaxEngine of N=240 |
CGSLRngMRG | 5-th order multiple recursive generator (L'Ecuyer, Blouin and Coutre) see here |
CGSLRngMT | Mersenne-Twister generator gsl_rng_mt19937 from here |
CGSLRngRand | BSD rand() generator gsl_rmg_rand from here |
CGSLRngRanLux | Old Ranlux generator (James, Luscher) (default luxury level, p = 223) (This is eequivalent to TRandom1 with default luxury level) see here |
CGSLRngRanLuxD1 | Double precision (48 bits) version of Second generation of Ranlux generator with luxury level of 1 (It throws away 202 value for every 12 used) see here |
CGSLRngRanLuxD2 | Double precision (48 bits) version of Second generation of Ranlux generator with luxury level of 2 (It throws away 397 value for every 12 used) see here |
CGSLRngRanLuxS1 | Second generation of Ranlux generator for single precision with luxury level of 1 (It throws away 202 values for every 12 used) see here |
CGSLRngRanLuxS2 | Second generation of Ranlux generator for Single precision with luxury level of 2 (It throws away 397 value for every 12 used) see here |
CGSLRngRanMar | RANMAR generator see here |
CGSLRngROOTWrapper | |
CGSLRngTaus | Tausworthe generator by L'Ecuyer see here |
CGSLRngWrapper | GSLRngWrapper class to wrap gsl_rng structure |
CGSLRootFdFSolver | Root-Finder with derivatives implementation class using GSL |
CGSLRootFinder | Base class for GSL Root-Finding algorithms for one dimensional functions which do not use function derivatives |
CGSLRootFinderDeriv | Base class for GSL Root-Finding algorithms for one dimensional functions which use function derivatives |
CGSLRootFSolver | Root-Finder implementation class using GSL |
CGSLSimAnFunc | GSLSimAnFunc class description |
CGSLSimAnMinimizer | GSLSimAnMinimizer class for minimization using simulated annealing using the algorithm from GSL |
CGSLSimAnnealing | GSLSimAnnealing class for performing a simulated annealing search of a multidimensional function |
CGSLSimAnParams | Structure holding the simulated annealing parameters |
CGSLVegasIntegrationWorkspace | Workspace for VEGAS |
CIBaseFunctionMultiDimTempl | Documentation for the abstract class IBaseFunctionMultiDim |
CIBaseFunctionOneDim | Interface (abstract class) for generic functions objects of one-dimension Provides a method to evaluate the function given a value (simple double) by implementing operator() (const double ) |
CIBaseParam | Documentation for the abstract class IBaseParam |
CIGradientFunctionMultiDimTempl | Interface (abstract class) for multi-dimensional functions providing a gradient calculation |
CIGradientFunctionOneDim | Interface (abstract class) for one-dimensional functions providing a gradient calculation |
CIGradientMultiDimTempl | Gradient interface (abstract class) defining the signature for calculating the gradient of a multi-dimensional function |
CIGradientOneDim | Specialized Gradient interface(abstract class) for one dimensional functions It provides a method to evaluate the derivative of the function, Derivative and a method to evaluate at the same time the function and the derivative FdF |
CIMinimizer1D | Interface class for numerical methods for one-dimensional minimization |
CIntegrandTransform | Auxiliary inner class for mapping infinite and semi-infinite integrals |
CIntegratorMultiDim | User class for performing multidimensional integration |
CIntegratorMultiDimOptions | Numerical multi dimensional integration options |
CIntegratorOneDim | User Class for performing numerical integration of a function in one dimension |
CIntegratorOneDimOptions | Numerical one dimensional integration options |
CInterpolator | Class for performing function interpolation of points |
CInverter | Matrix Inverter class Class to specialize calls to Dinv |
CInverter< 0 > | Inverter<0> |
CInverter< 1 > | 1x1 matrix inversion \(a_{11} \to 1/a_{11}\) |
CInverter< 2 > | 2x2 matrix inversion using Cramers rule |
CIOptions | Generic interface for defining configuration options of a numerical algorithm |
CIParametricFunctionMultiDimTempl | IParamFunction interface (abstract class) describing multi-dimensional parameteric functions It is a derived class from ROOT::Math::IBaseFunctionMultiDim and ROOT::Math::IBaseParam |
CIParametricFunctionOneDim | Specialized IParamFunction interface (abstract class) for one-dimensional parametric functions It is a derived class from ROOT::Math::IBaseFunctionOneDim and ROOT::Math::IBaseParam |
CIParametricGradFunctionMultiDimTempl | Interface (abstract class) for parametric gradient multi-dimensional functions providing in addition to function evaluation with respect to the coordinates also the gradient with respect to the parameters, via the method ParameterGradient |
CIParametricGradFunctionOneDim | Interface (abstract class) for parametric one-dimensional gradient functions providing in addition to function evaluation with respect the coordinates also the gradient with respect to the parameters, via the method ParameterGradient |
►CIpoptMinimizer | IpoptMinimizer class |
CInternalTNLP | Internal class to create a TNLP object, required for Ipopt minimization in c++, every method is overloaded to pass the information to Ipopt solvers |
CIRootFinderMethod | Interface for finding function roots of one-dimensional functions |
CKahanSum | The Kahan compensate summation algorithm significantly reduces the numerical error in the total obtained by adding a sequence of finite precision floating point numbers |
►CKDTree | |
CBaseNode | |
CBinNode | |
CComparePoints | |
CCut | |
CHeadNode | |
Citerator | |
CSplitNode | |
CTerminalNode | |
CKelvinFunctions | This class calculates the Kelvin functions Ber(x), Bei(x), Ker(x), Kei(x), and their first derivatives |
CLCGEngine | |
CLocalCoordinateSystemTag | Tag for identifying vectors based on a local coordinate system |
CLorentzRotation | Lorentz transformation class with the (4D) transformation represented by a 4x4 orthosymplectic matrix |
CLorentzVector | Class describing a generic LorentzVector in the 4D space-time, using the specified coordinate system for the spatial vector part |
CLSResidualFunc | LSResidualFunc class description |
CMathMoreLib | |
CMatRepStd | Expression wrapper class for Matrix objects |
CMatRepSym | MatRepSym Matrix storage representation for a symmetric matrix of dimension NxN This class is a template on the contained type and on the symmetric matrix size, N |
CMatrixMulOp | Class for Matrix-Matrix multiplication |
CMemFunHandler | Functor Handler to Wrap pointers to member functions The member function type must be (XXX means any name is allowed) : double XXX ( double x) for 1D functions and double XXXX (const double *x) for multi-dimensional functions |
CMemGradFunHandler | Functor Handler to Wrap pointers to member functions for the evaluation of the function and the gradient |
CMersenneTwisterEngine | Random number generator class based on M |
Cmeta_col_dot | |
Cmeta_col_dot< 0 > | |
Cmeta_dot | |
Cmeta_dot< 0 > | |
Cmeta_mag | |
Cmeta_mag< 0 > | |
Cmeta_matrix_dot | |
Cmeta_matrix_dot< 0 > | |
Cmeta_row_dot | |
Cmeta_row_dot< 0 > | |
CMinimizer | Abstract Minimizer class, defining the interface for the various minimizer (like Minuit2, Minuit, GSL, etc..) Plug-in's exist in ROOT to be able to instantiate the derived classes like ROOT::Math::GSLMinimizer or ROOT::Math::Minuit2Minimizer via the plug-in manager |
CMinimizerOptions | Minimizer options |
CMinimizerVariableTransformation | Base class for MinimizerVariable transformations defining the functions to deal with bounded parameters |
CMinimTransformFunction | MinimTransformFunction class to perform a transformations on the variables to deal with fixed or limited variables (support both double and single bounds) The class manages the passed function pointer |
CMinimTransformVariable | MinimTransformVariable class Contains meta information of the variables such as bounds, fix flags and deals with transformation of the variable The class does not contain the values and the step size (error) of the variable This is an internal class used by the MinimTransformFunction class |
CMinOp | Subtraction Operation Class |
CMinus | Unary Minus Operation Class |
CMinusEquals | Evaluate the expression performing a -= operation Need to check whether creating a temporary object with the expression result (like in op: A -= A * B ) |
CMinusEquals< T, D1, D2, A, MatRepSym< T, D1 >, MatRepStd< T, D1, D2 > > | Specialization for symmetrix -= general : NOT Allowed operation |
CMinusEquals< T, D1, D2, A, MatRepSym< T, D1 >, MatRepSym< T, D1 > > | Specialization for symmetric matrices |
CMiserParameters | Structures collecting parameters for MISER multidimensional integration |
CMixMaxEngine | MixMaxEngine is a wrapper class for the MIXMAX Random number generator |
CMixMaxEngineImpl | |
CMixMaxEngineImpl< ROOT_MM_N > | |
CMulOp | Multiplication (element-wise) Operation Class |
CMultiDimParamFunctionAdapter | MultiDimParamFunctionAdapter class to wrap a one-dimensional parametric function in a multi dimensional parameteric function interface This is used typically in fitting where internally the function is stored as multidimension |
CMultiDimParamGradFunctionAdapter | MultiDimParamGradFunctionAdapter class to wrap a one-dimensional parametric gradient function in a multi dimensional parameteric gradient function interface This is used typically in fitting where internally the function is stored as multidimension |
CMultiNumGradFunction | MultiNumGradFunction class to wrap a normal function in a gradient function using numerical gradient calculation provided by the class Derivator (based on GSL numerical derivation) |
CMultPolicy | Matrix-matrix multiplication policy |
CNullTypeFunc1D | |
COneDimMultiFunctionAdapter | OneDimMultiFunctionAdapter class to wrap a multidimensional function in one dimensional one |
COneDimParamFunctionAdapter | OneDimParamFunctionAdapter class to wrap a multi-dim parameteric function in one dimensional one |
CParamFunction | Base template class for all Parametric Functions |
CParamFunctionBase | Class defining the signature for multi-dim parametric functions |
►CParamFunctorHandler | ParamFunctor Handler class is responsible for wrapping any other functor and pointer to free C functions |
CFuncEvaluator | |
CFuncEvaluator< F *, T > | |
CFuncEvaluator< F *const, T > | |
CParamFunctorTempl | Param Functor class for Multidimensional functions |
►CParamMemFunHandler | ParamFunctor Handler to Wrap pointers to member functions |
CMemFuncEvaluator | |
CPlaceExpr | |
CPlaceExpr< T, D1, D2, D3, D4, A, MatRepSym< T, D1 >, MatRepStd< T, D3, D4 > > | |
CPlaceExpr< T, D1, D2, D3, D4, A, MatRepSym< T, D1 >, MatRepSym< T, D3 > > | |
CPlaceMatrix | Structure to deal when a submatrix is placed in a matrix |
CPlaceMatrix< T, D1, D2, D3, D4, MatRepSym< T, D1 >, MatRepStd< T, D3, D4 > > | |
CPlaceMatrix< T, D1, D2, D3, D4, MatRepSym< T, D1 >, MatRepSym< T, D3 > > | |
CPlainParameters | |
CPlusEquals | Evaluate the expression performing a += operation Need to check whether creating a temporary object with the expression result (like in op: A += A * B ) |
CPlusEquals< T, D1, D2, A, MatRepSym< T, D1 >, MatRepStd< T, D1, D2 > > | Specialization for symmetrix += general : NOT Allowed operation |
CPlusEquals< T, D1, D2, A, MatRepSym< T, D1 >, MatRepSym< T, D1 > > | Specialization for symmetric matrices Evaluate the expression performing a += operation for symmetric matrices Need to have a separate functions to avoid to modify two times the off-diagonal elements (i.e applying two times the expression) Need to check whether creating a temporary object with the expression result (like in op: A += A * B ) |
CPolar2D | Class describing a polar 2D coordinate system based on r and phi Phi is restricted to be in the range [-PI,PI) |
CPolar3D | Class describing a polar coordinate system based on r, theta and phi Phi is restricted to be in the range [-PI,PI) |
CPolynomial | Parametric Function class describing polynomials of order n |
CPositionVector2D | Class describing a generic position vector (point) in 2 dimensions |
CPositionVector3D | Class describing a generic position vector (point) in 3 dimensions |
CPtEtaPhiE4D | Class describing a 4D cylindrical coordinate system using Pt , Phi, Eta and E (or rho, phi, eta , T) The metric used is (-,-,-,+) |
CPtEtaPhiM4D | Class describing a 4D cylindrical coordinate system using Pt , Phi, Eta and M (mass) The metric used is (-,-,-,+) |
CPxPyPzE4D | Class describing a 4D cartesian coordinate system (x, y, z, t coordinates) or momentum-energy vectors stored as (Px, Py, Pz, E) |
CPxPyPzM4D | Class describing a 4D coordinate system or momentum-energy vectors stored as (Px, Py, Pz, M) |
CQuasiRandom | User class for MathMore random numbers template on the Engine type |
CQuaternion | Rotation class with the (3D) rotation represented by a unit quaternion (u, i, j, k) |
CRandom | Documentation for the Random class |
CRandomFunctions | |
CRandomFunctions< EngineType, ROOT::Math::GSLRandomEngine > | Specialized implementation of the Random functions based on the GSL library |
CRandomFunctionsImpl | Definition of the generic impelmentation class for the RandomFunctions |
CRandomFunctionsImpl< TRandomEngine > | Implementation class for the RandomFunction for all the engined that derives from TRandomEngine class, which defines an interface which has TRandomEngine::Rndm() In this way we can have a common implementation for the RandomFunctions |
CRetrieveMatrix | Structure for getting sub matrices We have different cases according to the matrix representations |
CRetrieveMatrix< T, D1, D2, D3, D4, MatRepSym< T, D1 >, MatRepStd< T, D3, D4 > > | |
CRetrieveMatrix< T, D1, D2, D3, D4, MatRepSym< T, D1 >, MatRepSym< T, D3 > > | |
CRichardsonDerivator | User class for calculating the derivatives of a function |
CRMinimizer | RMinimizer class |
CRootFinder | User Class to find the Root of one dimensional functions |
CRotation3D | Rotation class with the (3D) rotation represented by a 3x3 orthogonal matrix |
CRotationX | Rotation class representing a 3D rotation about the X axis by the angle of rotation |
CRotationY | Rotation class representing a 3D rotation about the Y axis by the angle of rotation |
CRotationZ | Rotation class representing a 3D rotation about the Z axis by the angle of rotation |
CRotationZYX | Rotation class with the (3D) rotation represented by angles describing first a rotation of an angle phi (yaw) about the Z axis, followed by a rotation of an angle theta (pitch) about the Y axis, followed by a third rotation of an angle psi (roll) about the X axis |
CRowOffsets | Static structure to keep the conversion from (i,j) to offsets in the storage data for a symmetric matrix |
CSDeterminant | Dsfact |
CSinVariableTransformation | Sin Transformation class for dealing with double bounded variables |
CSInverter | Dsinv |
CSkipFunction | |
CSkipFunction< 0 > | |
►CSMatrix | SMatrix: a generic fixed size D1 x D2 Matrix class |
CSMatrixRow | |
CSMatrixRow_const | |
CSMatrixIdentity | |
CSMatrixNoInit | |
CSqr | Unary Square Operation Class |
CSqrt | Unary Square Root Operation Class |
CSqrtLowVariableTransformation | Sqrt Transformation class for dealing with lower bounded variables |
CSqrtUpVariableTransformation | Sqrt Transformation class for dealing with upper bounded variables |
CStdEngine | Class to wrap engines fron the C++ standard random library in the ROOT Random interface |
CStdEngineType | |
CStdEngineType< std::knuth_b > | |
CStdEngineType< std::minstd_rand > | |
CStdEngineType< std::mt19937 > | |
CStdEngineType< std::mt19937_64 > | |
CStdEngineType< std::random_device > | |
CStdEngineType< std::ranlux24 > | |
CStdEngineType< std::ranlux48 > | |
CStdRandomEngine | |
CSVector | SVector: a generic fixed size Vector class |
CTDataPoint | |
CTDataPointN | |
CTensorMulOp | Class for Tensor Multiplication (outer product) of two vectors giving a matrix |
CTRandomEngine | |
CTransposeOp | Class for Transpose Operations |
CTranspPolicy | Matrix transpose policy |
CTranspPolicy< T, D1, D2, MatRepSym< T, D1 > > | |
CUnaryOp | UnaryOperation class A class representing unary operators in the parse tree |
CVavilov | Base class describing a Vavilov distribution |
CVavilovAccurate | Class describing a Vavilov distribution |
CVavilovAccurateCdf | Class describing the Vavilov cdf |
CVavilovAccuratePdf | Class describing the Vavilov pdf |
CVavilovAccurateQuantile | Class describing the Vavilov quantile function |
CVavilovFast | Class describing a Vavilov distribution |
CVecExpr | Expression wrapper class for Vector objects |
CVectorMatrixColOp | Class for Vector-Matrix multiplication |
CVectorMatrixRowOp | |
CVegasParameters | Structures collecting parameters for VEGAS multidimensional integration FOr implementation of default parameters see file mathmore/src/GSLMCIntegrationWorkspace.h |
CVirtualIntegrator | Abstract class for all numerical integration methods (1D and multi-dim) Interface defining the common methods for the numerical integrator classes of one and multi dimensions The derived class VirtualIntegratorOneDim defines the methods for one-dimensional integration |
CVirtualIntegratorMultiDim | Interface (abstract) class for multi numerical integration It must be implemented by the concrete Integrator classes like ROOT::Math::GSLMCIntegrator |
CVirtualIntegratorOneDim | Interface (abstract) class for 1D numerical integration It must be implemented by the concrate Integrator classes like ROOT::Math::GSLIntegrator |
CWrappedFunction | Template class to wrap any C++ callable object which takes one argument i.e |
CWrappedMemFunction | Template class to wrap any member function of a class taking a double and returning a double in a 1D function interface For example, if you have a class like: struct X { double Eval(double x); }; you can wrapped in the following way: WrappedMemFunction<X, double ( X::* ) (double) > f; |
CWrappedMemMultiFunction | |
CWrappedMultiFunction | Template class to wrap any C++ callable object implementing operator() (const double * x) in a multi-dimensional function interface |
CWrappedParamFunction | WrappedParamFunction class to wrap any multi-dimensional function pbject implementing the operator()(const double * x, const double * p) in an interface-like IParamFunction with a vector storing and caching internally the parameter values |
CWrappedParamFunctionGen | WrappedParamGenFunction class to wrap any multi-dimensional function implementing the operator()(const double * ) in an interface-like IParamFunction, by fixing some of the variables and define them as parameters |
►NMinuit2 | |
CABObj | |
CABObj< sym, LASymMatrix, double > | |
CABObj< vec, LAVector, double > | |
CABProd | |
CABSum | |
CAlgebraicProdType | |
CAlgebraicProdType< gen, gen > | |
CAlgebraicProdType< gen, sym > | |
CAlgebraicProdType< gen, vec > | |
CAlgebraicProdType< sym, gen > | |
CAlgebraicProdType< sym, sym > | |
CAlgebraicProdType< sym, vec > | |
CAlgebraicProdType< T, T > | |
CAlgebraicProdType< vec, gen > | |
CAlgebraicProdType< vec, sym > | |
CAlgebraicSumType | |
CAlgebraicSumType< gen, vec > | |
CAlgebraicSumType< sym, vec > | |
CAlgebraicSumType< T, T > | |
CAlgebraicSumType< vec, gen > | |
CAlgebraicSumType< vec, sym > | |
CAnalyticalGradientCalculator | |
CBasicFunctionGradient | |
►CBasicFunctionMinimum | Result of the minimization; both internal and external (MnUserParameterState) representation available For the parameters at the Minimum |
CMnAboveMaxEdm | |
CMnReachedCallLimit | |
►CBasicMinimumError | Internal Class containing the error information on the estimated minimum : Error matrix + dcovar + additional flags for quality and validity checks |
CMnHesseFailed | |
CMnInvertFailed | |
CMnMadePosDef | |
CMnNotPosDef | |
CBasicMinimumParameters | |
CBasicMinimumSeed | |
CBasicMinimumState | |
CCombinedMinimizer | Combined minimizer: combination of Migrad and Simplex |
CCombinedMinimumBuilder | |
CContoursError | |
CDavidonErrorUpdator | Update of the covariance matrix for the Variable Metric minimizer (MIGRAD) |
CFCNAdapter | Template wrapped class for adapting to FCNBase signature |
CFCNBase | Interface (abstract class) defining the function to be minimized, which has to be implemented by the user |
CFCNGradAdapter | Template wrapped class for adapting to FCNBase signature a IGradFunction |
CFCNGradientBase | Extension of the FCNBase for providing the analytical Gradient of the function |
CFumiliBuilder | Builds the FunctionMinimum using the Fumili method |
CFumiliChi2FCN | Extension of the FCNBase for the Fumili method |
CFumiliErrorUpdator | 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 |
CFumiliFCNAdapter | Template wrapped class for adapting to FumiliFCNBase signature |
CFumiliFCNBase | Extension of the FCNBase for the Fumili method |
CFumiliGradientCalculator | |
CFumiliMaximumLikelihoodFCN | Extension of the FCNBase for the Fumili method |
CFumiliMinimizer | Instantiates the seed generator and Minimum builder for the Fumili minimization method |
CFumiliStandardChi2FCN | 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 |
CFumiliStandardMaximumLikelihoodFCN | Class implementing the Elements member function for the standard maximum likelihood method |
CFunctionGradient | |
CFunctionMinimizer | 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 |
►CFunctionMinimum | Class holding the full result of the minimization; both internal and external (MnUserParameterState) representation available for the parameters at the Minimum |
CMnAboveMaxEdm | |
CMnReachedCallLimit | |
Cgen | |
CGenericFunction | Class from which all the other classes, representing functions, inherit |
CGradientCalculator | Interface class for gradient calculators |
CHessianGradientCalculator | HessianGradientCalculator: class to calculate Gradient for Hessian |
CInitialGradientCalculator | Class to calculate an initial estimate of the gradient |
CLASymMatrix | Class describing a symmetric matrix of size n |
CLAVector | |
CMatrixInverse | |
CMatrixInverse< vec, M, T > | |
CMinimumBuilder | |
►CMinimumError | MinimumError keeps the inv |
CMnHesseFailed | |
CMnInvertFailed | |
CMnMadePosDef | |
CMnNotPosDef | |
CMinimumErrorUpdator | |
CMinimumParameters | |
CMinimumSeed | MinimumSeed contains the starting values for the minimization produced by the SeedGenerator |
CMinimumSeedGenerator | Base class for seed generators (starting values); the seed generator prepares initial starting values from the input (MnUserParameterState) for the minimization; |
CMinimumState | MinimumState keeps the information (position, Gradient, 2nd deriv, etc) after one minimization step (usually in MinimumBuilder) |
CMinosError | Class holding the result of Minos (lower and upper values) for a specific parameter |
CMinuit2Minimizer | Minuit2Minimizer class implementing the ROOT::Math::Minimizer interface for Minuit2 minimization algorithm |
CMinuitParameter | 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; |
CMnApplication | Application interface class for minimizers (migrad, simplex, Minimize, Scan) User normally instantiates the derived class like ROOT::Minuit2::MnMigrad for using Migrad for minimization |
CMnContours | 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; |
CMnCovarianceSqueeze | Class to reduce the covariance matrix when a parameter is fixed by removing the corresponding row and index |
►CMnCross | |
CCrossFcnLimit | |
CCrossNewMin | |
CCrossParLimit | |
CMnEigen | API class for calculating the eigenvalues of symmetric matrix |
CMnFcn | Wrapper class to FCNBase interface used internally by Minuit |
CMnFumiliMinimize | API class for minimization using Fumili technology; allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc |
CMnFunctionCross | MnFunctionCross |
CMnGlobalCorrelationCoeff | Class for global correlation coefficient |
CMnHesse | API class for calculating the numerical covariance matrix (== 2x Inverse Hessian == 2x Inverse 2nd derivative); can be used by the user or Minuit itself |
CMnLineSearch | Implements a 1-dimensional minimization along a given direction (i.e |
CMnMachinePrecision | Determines the relative floating point arithmetic precision |
CMnMigrad | API class for minimization using Variable Metric technology ("MIGRAD"); allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc |
CMnMinimize | API class for minimization using Variable Metric technology ("MIGRAD"); allows for user interaction: set/change parameters, do minimization, change parameters, re-do minimization etc |
CMnMinos | 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; |
CMnParabola | This class defines a parabola of the form a*x*x + b*x + c |
CMnParabolaFactory | |
CMnParabolaPoint | A point of a parabola |
CMnParameterScan | Scans the values of FCN as a function of one Parameter and retains the best function and Parameter values found |
CMnPlot | MnPlot produces a text-screen graphical output of (x,y) points, e.g |
CMnPosDef | Force the covariance matrix to be positive defined by adding extra terms in the diagonal |
CMnPrint | |
CMnRefCountedPointer | |
CMnReferenceCounter | |
CMnScan | 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 |
CMnSeedGenerator | Concrete implementation of the MinimumSeedGenerator interface; used within ModularFunctionMinimizer; |
CMnSimplex | API class for minimization using the Simplex method, which does not need and use the derivatives of the function, but only function values |
CMnStrategy | 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) |
CMnTiny | |
CMnTraceObject | |
CMnUserCovariance | Class containing the covariance matrix data represented as a vector of size n*(n+1)/2 Used to hide internal matrix representation to user |
CMnUserFcn | Wrapper used by Minuit of FCN interface containing a reference to the transformation object |
CMnUserParameters | 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 |
CMnUserParameterState | Class which holds the external user and/or internal Minuit representation of the parameters and errors; transformation internal <-> external on demand; |
CMnUserTransformation | Class dealing with the transformation between user specified parameters (external) and internal parameters used for minimization |
CMnVectorTransform | |
CModularFunctionMinimizer | 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 |
CMPIProcess | |
CMPITerminate | |
CNegativeG2LineSearch | 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 |
CNumerical2PGradientCalculator | Class performing the numerical gradient calculation |
CParametricFunction | Function which has parameters |
CScanBuilder | Performs a minimization using the simplex method of Nelder and Mead (ref |
CScanMinimizer | Class implementing the required methods for a minimization using SCAN API is provided in the upper ROOT::Minuit2::ModularFunctionMinimizer class |
CSimplexBuilder | Performs a minimization using the simplex method of Nelder and Mead (ref |
CSimplexMinimizer | Class implementing the required methods for a minimization using Simplex |
CSimplexParameters | Class describing the simplex set of points (f(x), x ) which evolve during the minimization iteration process |
CSimplexSeedGenerator | Generate Simplex starting point (state) |
CSinParameterTransformation | Class for the transformation for double-limited parameter Using a sin function one goes from a double-limited parameter range to an unlimited one |
CSqrtLowParameterTransformation | Transformation from external to internal Parameter based on sqrt(1 + x**2) |
CSqrtUpParameterTransformation | Transformation from external to internal Parameter based on sqrt(1 + x**2) |
CStackAllocator | StackAllocator controls the memory allocation/deallocation of Minuit |
CStackAllocatorHolder | |
CStackError | |
CStackOverflow | Define stack allocator symbol |
Csym | |
CVariableMetricBuilder | Build (find) function minimum using the Variable Metric method (MIGRAD) |
CVariableMetricEDMEstimator | |
CVariableMetricMinimizer | Instantiates the SeedGenerator and MinimumBuilder for Variable Metric Minimization method |
Cvec | |
CVectorOuterProduct | |
►NTMath | TMath |
CLimits | |
CBinaryOpPolicy | |
CCompareAsc | |
CCompareDesc | |
CContDist | Free functions adapter needed by UNURAN for onedimensional continuous distributions |
CDiscrDist | Free functions adapter needed by UNURAN for one-dimensional discrete distribution |
CHelperOps | |
CMultiDist | Free functions adapter needed by UNURAN for multidimensional cont distribution |
Crng_state_st | |
CTComplex | |
CTDecompBase | Decomposition Base class |
CTDecompBK | The Bunch-Kaufman diagonal pivoting method decomposes a real symmetric matrix A using |
CTDecompChol | Cholesky Decomposition class |
CTDecompLU | LU Decomposition class |
CTDecompQRH | QR Decomposition class |
CTDecompSparse | Sparse Symmetric Decomposition class |
CTDecompSVD | Single Value Decomposition class |
CTElementActionT | |
CTElementPosActionT | |
CTFeldmanCousins | Class to calculate the CL upper limit using the Feldman-Cousins method as described in PRD V57 #7, p3873-3889 |
CTFFTComplex | |
CTFFTComplexReal | |
CTFFTReal | |
CTFFTRealComplex | |
CTFitter | |
CTFoam | |
CTFoamCell | |
CTFoamIntegrand | |
CTFoamMaxwt | |
CTFoamSampler | TFoamSampler class class implementing the ROOT::Math::DistSampler interface using FOAM for sampling arbitrary distributions |
CTFoamVect | |
CTFumili | |
CTFumiliMinimizer | TFumiliMinimizer class: minimizer implementation based on TFumili |
CTGenPhaseSpace | Utility class to generate n-body event, with constant cross-section (default) or with Fermi energy dependence (opt="Fermi") |
CTGondzioSolver | |
CTHaarMatrixT | |
CTHilbertMatrixT | |
CTHilbertMatrixTSym | |
CTKDTree | Class implementing a kd-tree |
CTKDTreeBinning | <- TKDTreeBinning - A class providing multidimensional binning -> |
CTLinearFitter | The Linear Fitter - For fitting functions that are LINEAR IN PARAMETERS |
CTLinearMinimizer | TLinearMinimizer class: minimizer implementation based on TMinuit |
►CTLorentzRotation | Describes Lorentz transformations including Lorentz boosts and rotations (see TRotation) |
CTLorentzRotationRow | |
CTLorentzVector | TLorentzVector is a general four-vector class, which can be used either for the description of position and time (x,y,z,t) or momentum and energy (px,py,pz,E) |
CTMatrixDEigen | TMatrixDEigen |
CTMatrixDSymEigen | TMatrixDSymEigen |
CTMatrixT | TMatrixT |
CTMatrixTBase | Linear Algebra Package |
CTMatrixTColumn | |
CTMatrixTColumn_const | |
CTMatrixTDiag | |
CTMatrixTDiag_const | |
CTMatrixTFlat | |
CTMatrixTFlat_const | |
CTMatrixTLazy | Templates of Lazy Matrix classes |
CTMatrixTRow | |
CTMatrixTRow_const | |
CTMatrixTSparse | TMatrixTSparse |
CTMatrixTSparseDiag | |
CTMatrixTSparseDiag_const | |
CTMatrixTSparseRow | |
CTMatrixTSparseRow_const | |
CTMatrixTSub | |
CTMatrixTSub_const | |
CTMatrixTSym | TMatrixTSym |
CTMatrixTSymLazy | |
CTMehrotraSolver | |
CTMinuit | Implementation in C++ of the Minuit package written by Fred James |
CTMinuit2TraceObject | |
CTMinuitMinimizer | TMinuitMinimizer class: ROOT::Math::Minimizer implementation based on TMinuit |
CTMLPAnalyzer | |
CTMultiLayerPerceptron | |
CTNeuron | |
CTQpDataBase | |
CTQpDataDens | |
CTQpDataSparse | |
CTQpLinSolverBase | |
CTQpLinSolverDens | |
CTQpLinSolverSparse | |
CTQpProbBase | |
CTQpProbDens | |
CTQpProbSparse | |
CTQpResidual | |
CTQpSolverBase | |
CTQpVar | |
CTQuaternion | Quaternion is a 4-component mathematic object quite convenient when dealing with space rotation (or reference frame transformation) |
CTRandom | This is the base class for the ROOT Random number generators |
CTRandom1 | The Ranlux Random number generator class |
CTRandom2 | Random number generator class based on the maximally quidistributed combined Tausworthe generator by L'Ecuyer |
CTRandom3 | Random number generator class based on M |
CTRandomEngine | |
CTRandomGen | |
Ctriangulateio | |
CTRobustEstimator | Minimum Covariance Determinant Estimator - a Fast Algorithm invented by Peter J.Rousseeuw and Katrien Van Dreissen "A Fast Algorithm for the Minimum covariance Determinant Estimator" Technometrics, August 1999, Vol.41, NO.3 |
CTRolke | This class computes confidence intervals for the rate of a Poisson process in the presence of uncertain background and/or efficiency |
►CTRotation | Describes a rotation of objects of the TVector3 class |
CTRotationRow | |
CTSPlot | |
CTStatistic | Statistical variable, defined by its mean and variance (RMS) |
CTSynapse | |
CTUnuran | TUnuran class |
CTUnuranBaseDist | TUnuranBaseDist, base class for Unuran distribution classees such as TUnuranContDist (for one-dimension) or TUnuranMultiContDist (multi-dimension) |
CTUnuranContDist | TUnuranContDist class describing one dimensional continuous distribution |
CTUnuranDiscrDist | TUnuranDiscrDist class for one dimensional discrete distribution |
CTUnuranEmpDist | TUnuranEmpDist class for describing empiral distributions |
CTUnuranMultiContDist | TUnuranMultiContDist class describing multi dimensional continuous distributions |
CTUnuranSampler | TUnuranSampler class class implementing the ROOT::Math::DistSampler interface using the UNU.RAN package for sampling distributions |
CTVector2 | TVector2 is a general two vector class, which can be used for the description of different vectors in 2D |
CTVector3 | TVector3 is a general three vector class, which can be used for the description of different vectors in 3D |
CTVectorT | TVectorT |
CUnuranDistr | UnuranDistr Provides free function based on TF1 to be called by unuran |
CUnuranDistrMulti | Free functions for multidimensional functions needed bby UNURAN |
CUnuranRng | UnuranRng class for interface ROOT random generators to Unuran |