▼Njson | |
CDictNode | |
CIDNode | |
CJSON | |
Cjson_exception | |
CListNode | |
CNode | |
CTextNode | |
CToken | |
▼Npython | |
►Ncontroller | |
►NCheckpointController | |
CCheckpointController | Class for handling events for storing and restoring of checkpoints |
►NInfoToFile | |
CInfoToFile | The class processes the progress information from Learner and LinearSolver and stores it into the file |
►NInfoToGraph | |
CInfoToGraph | This class processes the information about the current state of the learning process and presents it in form of a graph |
►NInfoToScreen | |
CInfoToScreen | The class processes the progress information from Learner and LinearSolver and shows it on the terminal screen |
►NInfoToScreenRegressor | |
CInfoToScreenRegressor | Prints some regression specific information together with information processed by InfoToScreen |
►NLearnerEventController | |
CLearnerEventController | Abstract class of Subscribers of LearnerEvents |
►NSolverEventController | |
CSolverEventController | Abstract class of Subscribers of LinearSolverEvents |
►NTerminalController | |
CTerminalController | The class provides the functionality for launching of learning jobs from terminal using console parameters or a configuration file |
►Ndata | |
►NARFFAdapter | |
CARFFAdapter | Class implements the interface of DataAdapter for storing and restoring of input data into / from files in ARFF-format |
►NCSVAdapter | |
CCSVAdapter | Class implements the interface of DataAdapter for storing and restoring of input data into / from files in CSV-format |
►NDataAdapter | |
CDataAdapter | Abstract class defines the interface for storing and loading of input data |
►NDataContainer | |
CDataContainer | |
►NDataEntry | |
CDataEntry | A container for tuple of a point and its corresponding value |
►NDataSpecification | |
CDataSpecification | The class encapsulates the description of the data set, like names of dimensions and source file |
►Nlearner | |
►NClassifier | |
CClassifier | The class implements the abstract methods from Learner and allows to accomplish basic classification tasks |
►Nfolding | |
►NFilesFoldingPolicy | |
CFilesFoldingPolicy | Provides functionality for accomplishment of learning with cross-validation by generating a set of training data/validation data pairs from the set of files This class corresponds to the old doFoldf() method |
►NFoldingPolicy | |
CFoldingPolicy | Abstract class for providing functionality for accomplishment of learning with cross-validation by generating a set of training data/validation data pairs |
►NRandomFoldingPolicy | |
CRandomFoldingPolicy | Provides functionality for accomplishment of learning with cross-validation by generating a set of training data/validation data pairs randomly This class corresponds to the old doFold() method |
►NSequentialFoldingPolicy | |
CSequentialFoldingPolicy | Provides functionality for accomplishment of learning with cross-validation by generating a set of training data/validation data pairs sequentially This class corresponds to the old doFolds() method |
►NStratifiedFoldingPolicy | |
CStratifiedFoldingPolicy | Provides functionality for accomplishment of learning with cross-validation by generating a set of training data/validation data pairs with equal distribution of points from two different classes between folds |
►Nformatter | |
►NGridFormatter | |
CGridFormatter | Provides functionality for the runtime serialization of the Grid object |
►NGridImageFormatter | |
CGridImageFormatter | |
►NLearnedKnowledgeFormatter | |
CLearnedKnowledgeFormatter | Provides functionality for the runtime serialization of the LearnedKnowledge object |
►NLearnerFormatter | |
CLearnerFormatter | |
►NLearnedKnowledge | |
CLearnedKnowledge | Class keeps all information, which was learned during the learning process |
►NLearner | |
CLearner | The class implements the routines common for classifier and regressor |
CLearnerEvents | Constants of different learning events |
►NLearnerBuilder | |
►CLearnerBuilder | Implement mechanisms to create customized learning system |
CCGSolverDescriptor | CGSolver Descriptor helps to implement fluid interface patter on python it encapsulates functionality concerning creation of the CG-Solver |
CFoldingDescriptor | Folding Descriptor helps to implement fluid interface patter on python it encapsulates functionality concerning the usage for N-fold cross-validation |
CGridDescriptor | Grid Descriptor helps to implement fluid interface patter on python it encapsulates functionality concerning creation of the grid |
CSpecificationDescriptor | TrainingSpecification Descriptor helps to implement fluid interface patter on python it encapsulates functionality concerning creation of the training specification |
CStopPolicyDescriptor | TrainingStopPolicy Descriptor helps to implement fluid interface patter on python it encapsulates functionality concerning creation of the training stop policy |
►NRegressor | |
CRegressor | Subclass of Learner, responsible for regression |
►Nsolver | |
►NCGSolver | |
CCGSolver | This is a decorator for sgpp::ConjugateGradients class |
►NLinearSolver | |
CLinearSolver | Abstract class for solution of system of linear equations |
CLinearSolverEvents | Constants of different solving events |
►NTrainingSpecification | |
CTrainingSpecification | Collection of parameters, which specify the learning process |
►NTrainingStopPolicy | |
CTrainingStopPolicy | The class implements heuristics for testing if the learn process should be finished before learner is overfitted |
►NTypes | |
CBorderTypes | Constants for types of grid borders |
CSolverTypes | Constants for types of linear solvers |
►Ntools | |
CMatrix | |
►Nuq | |
►Nanalysis | |
►NAnalysis | |
CAnalysis | |
CAnalysisHash | |
►Nasgc | |
►Nanova | |
►NhdmrAnalytic | |
CHDMRAnalytic | |
►NASGCAnalysis | |
CASGCAnalysis | |
►NASGCAnalysisBuilder | |
CASGCAnalysisBuilder | |
►NASGCAnalysisSpecification | |
CASGCAnalysisSpecification | |
►NASGCDescriptor | |
CASGCDescriptor | |
►NASGCKnowledge | |
CASGCKnowledge | |
►NASGCKnowledgeFormatter | |
CASGCKnowledgeFormatter | |
►NKnowledgeTypes | |
CKnowledgeTypes | |
►Nmc | |
►NMCAnalysis | |
CMCAnalysis | |
►Ndists | |
►NBeta | |
CBeta | |
►NCorr | |
CCorr | |
►NCorrBeta | |
CCorrBeta | |
►NDataDist | |
CDataDist | |
►NDist | |
CDist | |
►NEstimatedDist | |
CEstimatedDist | |
►NJ | |
CJ | |
►NKDEDist | |
CKDEDist | |
►NLibAGFDist | |
CLibAGFDist | |
►NLognormal | |
CLognormal | |
►NMultivariateNormal | |
CMultivariateNormal | |
►NNatafDist | |
CNatafDist | |
►NNormal | |
CNormal | |
►Noptimization | |
►NSGDEdist | |
CSGDEdist | |
►NTLognormal | |
CTLognormal | |
►NTNormal | |
CTNormal | |
►NUniform | |
CUniform | |
►Nestimators | |
►NAnalyticEstimationStrategy | |
CAnalyticEstimationStrategy | |
►NCollocationPointsStrategy | |
CCollocationPointsStrategy | |
►NEstimator | |
CEstimator | |
►NMarginalAnalyticEstimationStrategy | |
CMarginalAnalyticEstimationStrategy | |
►NMarginalIntegralStrategy | |
CMarginalIntegralStrategy | |
►NMCEstimator | |
CMCEstimator | |
►NMonteCarloStrategy | |
CMonteCarloStrategy | |
►NPiecewiseConstantIntegralStrategy | |
CPiecewiseConstantIntegralStrategy | |
►NSparseGridEstimationStrategy | |
CSparseGridEstimationStrategy | |
►NSparseGridEstimator | |
CSparseGridEstimator | |
►Nlearner | |
►Nbuilder | |
►NCGSolverDescriptor | |
CCGSolverDescriptor | |
►NGridDescriptor | |
CGridDescriptor | |
►NInterpolantSpecificationDescriptor | |
CInterpolantSpecificationDescriptor | |
►NLearnerBuilder | |
CLearnerBuilder | Implement mechanisms to create customized learning system |
►NRegressorSpecificationDescriptor | |
CFoldingDescriptor | |
CFoldingStrategy | |
CRegressorSpecificationDescriptor | |
►NSimulationLearnerBuilder | |
CSimulationLearnerBuilder | |
CSimulationLearnerDescriptor | |
►NInterpolant | |
CInterpolant | |
►NLearner | |
CLearner | |
CLearnerEvents | |
►NRegressor | |
CRegressor | |
►NSimulationLearner | |
CSimulationLearner | |
►NSimulationLearnerSpecification | |
CSimulationLearnerSpecification | |
►Nmanager | |
►NASGCStatistics | |
CASGCStatistics | |
►NASGCUQManager | |
CASGCUQManager | |
►NASGCUQManagerBuilder | |
CASGCUQManagerBuilder | |
►Nmodels | |
►NAnalyticModels | |
CAtan | |
CParabola | |
►NModel | |
CModel | |
►NtestEnvironments | |
CProbabilisticSpaceSGpp | |
CTestEnvironmentMC | |
CTestEnvironmentSG | |
►Noperations | |
►NforcePositivity | |
►NestimateDensity | |
CEstimateDensityAlgorithm | |
►NfindCandidateSet | |
CCandidateSet | |
►NfindIntersections | |
CIntersectionCandidates | |
►NfindIntersectionsSubspaceBased | |
CIntersectionSubspaceCandidates | |
►NfullGridSearch | |
CFullGridCandidates | |
►NinterpolateFunction | |
CInterpolateFunction | |
►NinterpolationAlgorithm | |
CInterpolationAlgorithm | |
►NlocalFullGridSearch | |
CLocalFullGrid | |
CLocalFullGridCandidates | |
►NlocalHierarchicalIntersectionSearch | |
CLocalHierarchicalIntersectionCandidates | |
►NoperationMakePositive | |
COperationMakePositive | |
►NoperationMakePositiveFast | |
COperationMakePositiveFast | |
►NscaledMinOfParents | |
CScaledMinOfParents | |
►NsearchNextLevel | |
CSearchLevelWiseForCandidates | |
►NsetGridPointsToZero | |
CSetGridPointsToZero | |
►NnatafTransformation | |
CNatafTransformation | |
►Nparameters | |
►NDeterministicParameter | |
CDeterministicParameter | |
►NParameter | |
CParameter | |
►NParameterBuilder | |
CDeterministicParameterBuilder | |
CGeneralParameterBuilder | |
CParameterBuilder | |
CUncertainParameterBuilder | |
►NParameterDescriptor | |
CDeterministicParameterDescriptor | |
CParameterDescriptor | |
CUncertainParameterDesciptor | |
►NParameterSet | |
CParameterSet | |
CParameterSetIterator | |
►NUncertainParameter | |
CUncertainParameter | |
►Nplot | |
►Nquadrature | |
►Nbilinearform | |
►NBilinearGaussQuadratureStrategy | |
CBilinearGaussQuadratureStrategy | |
►NBilinearQuadratureStrategy | |
CBilinearQuadratureStrategy | |
►NDiscreteBilinearScipyQuadratureStrategy | |
CDiscreteBilinearScipyQuadratureStrategy | |
►NPiecewiseConstantQuadratureStrategy | |
CPiecewiseConstantQuadratureStrategy | |
►NSparseGridQuadratureStrategy | |
CSparseGridQuadratureStrategy | |
►NUniformQuadratureStrategy | |
CUniformQuadratureStrategy | |
►NHashQuadrature | |
CHashQuadrature | |
CHashQuadratureMap | |
►Nlinearform | |
►NLinearGaussQuadratureStrategy | |
CLinearGaussQuadratureStrategy | |
►NLinearQuadratureStrategy | |
CLinearQuadratureStrategy | |
►Nmarginalization | |
►Nstrategies | |
►NGaussHermiteQuadrature | |
CGaussHermiteQuadrature | |
►NGaussLegendreQuadrature | |
CGaussLegendreQuadrature | |
►NQuadratureFactory | |
CQuadratureFactory | |
►NQuadratureStrategy | |
CQuadratureStrategy | |
►Ntrilinearform | |
►NTrilinearGaussQuadratureStrategy | |
CTrilinearGaussQuadratureStrategy | |
►NTrilinearQuadratureStrategy | |
CTrilinearQuadratureStrategy | |
►Nrefinement | |
►NAdmissibleSet | |
CAdmissibleSetGenerator | |
CAdmissibleSparseGridNodeSet | |
CRefinableNodesSet | |
►NLocalRefinementStrategy | |
CAddNode | |
CANOVARefinement | |
CCreateAllChildrenRefinement | |
CLocalRefinementStrategy | |
►NRefinementManager | |
CRefinementManager | |
►NRefinementManagerDescriptor | |
CAdmissibleSetDescriptor | |
CMostPromisingChildrenDescriptor | |
CRefineCurrentNodesDescriptor | |
CRefinementManagerDescriptor | |
►NRefinementStrategy | |
CAnchoredExpectationValueOptRanking | |
CAnchoredMeanSquaredOptRanking | |
CAnchoredVarianceOptRanking | |
CAnchoredWeightedL2OptRanking | |
CExpectationValueBFRanking | |
CExpectationValueOptRanking | |
CLinearSurplusEstimationRanking | |
CMeanSquaredOptRanking | |
CPredictiveRanking | |
CRanking | |
CSquaredSurplusBFRanking | |
CSquaredSurplusRanking | |
CSurplusRanking | |
CSurplusRatioEstimationRanking | |
CSurplusRatioRanking | |
CVarianceBFRanking | |
CVarianceOptRanking | |
CWeightedL2BFRanking | |
CWeightedL2OptRanking | |
CWeightedSurplusBFRanking | |
CWeightedSurplusRanking | |
►Nsampler | |
►Nasgc | |
►NASGCSampler | |
CASGCSampler | |
►NASGCSamplerBuilder | |
CASGCSamplerBuilder | |
CASGCSamplerStopPolicyDescriptor | |
►NASGCSamplerFormatter | |
CASGCSamplerFormatter | |
►NASGCSamplerSpecification | |
CASGCSamplerSpecification | |
►NASGCSamplerStopPolicy | |
CASGCSamplerStopPolicy | The class implements heuristics for testing if the learn process should be finished before learner is overfitted |
►NMCSampler | |
CMCSampler | |
►NSample | |
CDistributionType | |
CSample | |
CSamples | |
CSamplesIterator | |
CSampleType | |
►NSampler | |
CSampler | |
►Ntransformation | |
►NJointTransformation | |
CJointTransformation | |
►NLinearTransformation | |
CLinearTransformation | |
►NRosenblattTransformation | |
CRosenblattTransformation | |
►NTransformation | |
CTransformation | |
►Nuq_setting | |
►Nsamplingresult | |
CSamplingresult | |
►NUQBuilder | |
CUQBuilder | |
►NUQSetting | |
CUQSampleType | |
CUQSetting | |
►NUQSettingAdapter | |
CUQSettingAdapter | |
►NUQSettingFormatter | |
CUQSettingFormatter | |
►NUQSettingManager | |
CSampler | |
CUQSettingManager | |
►NUQSpecification | |
CUQSpecification | |
►Nutils | |
►NGzipSerializer | |
CGzipSerializer | The class provides the method, used by subclasses to work with gzip-compressed files |
►Njson | |
C_StringGenerator | Json.py implements a JSON (http://json.org) reader and writer |
CJsonReader | Reader for json-formatted objects |
CJsonWriter | Writer for json-formatted objects |
CReadException | Exceptions which can happen during the reading process |
CWriteException | Exceptions which can happen during the writing process |
▼Nsgpp | This header contains some utility functions |
►Nbase | |
CAbstractRefinement | Abstract refinement class for sparse grids |
CAbstractRefinement_refinement_key | |
CAdaptivityConfiguration | Structure that can be used by application to define adaptivity strategies |
Calgorithm_exception | Exception that is thrown in case of an application failure |
CAlgorithmDGEMV | Basic multiplaction with B and B^T on grids with no boundaries |
CAlgorithmEvaluation | Basic algorithm for getting all affected basis functions |
CAlgorithmEvaluationTransposed | Basic algorithm for getting all affected basis functions |
CAlgorithmMultipleEvaluation | Abstract implementation for multiple function evaluations |
CANOVAHashRefinement | |
Capplication_exception | Exception that is thrown in case of an application failure |
CBasis | Basis class for basis functions |
CBatchConfiguration | Structure to provide parameters for the BatchLearner |
CBoundaryGridGenerator | This class provides the interface for the grid generation for grids with boundaries, pentagon cut through sub space scheme |
CBoundingBox | This class implements the boundaries of the sparse grid |
CBoundingBox1D | Struct that defines the boundaries for one specific dimension |
CBreadthFirstSearch | Class for applying a functor of type FUNC on all grid points of a sparse grid in a breadth-first search (BFS) manner |
CBsplineBasis | B-spline basis on Noboundary grids |
CBsplineBoundaryBasis | B-spline basis on Boundary grids |
CBsplineBoundaryGrid | Grid with Bspline basis functions with boundaries, pentagon cut |
CBsplineClenshawCurtisBasis | B-spline basis on Clenshaw-Curtis grids |
CBsplineClenshawCurtisGrid | Grid with Clenshaw-Curtis Bspline basis functions with boundaries, pentagon cut |
CBsplineGrid | Grid with Bspline basis functions |
CBsplineModifiedBasis | Modified B-spline basis on Noboundary grids |
CBsplineModifiedClenshawCurtisBasis | B-spline basis on Clenshaw-Curtis grids |
CClenshawCurtisTable | Lookup table for 1D Clenshaw-Curtis points |
CCoarseningFunctor | Abstract class that defines the interfaces that coarsening functors have to provide |
CCombiGridConfiguration | Structure that can be used by applications to cluster combi grid information |
CConfigurationParameters | |
CConvertLinearToPrewavelet | Class that implements the transformation of a hierarchical linear sparse grid to a hierarchical prewavelet sparse grid |
CConvertPrewaveletToLinear | Class that implements the transformation of a hierarchical prewavelet sparse grid to a hierarchical linear sparse grid |
Cdata_exception | Exception that is thrown in case of a data failure (conversion, creation, ...) |
CDataMatrix | A class to store two-dimensional data |
CDataMatrixSP | A class to store two-dimensional data |
CDataVector | A class to store one-dimensional data |
CDataVectorSP | A class to store one-dimensional data |
CDehierarchisationFundamentalSpline | Functor for dehierarchization with fundamental splines via BreadthFirstSearch |
CDehierarchisationLinear | Class that implements the dehierarchisation on a linear sparse grid |
CDehierarchisationLinearBoundary | Class that implements the dehierarchisation on a linear sparse grid with boundaries |
CDehierarchisationLinearClenshawCurtis | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationLinearClenshawCurtisBoundary | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationLinearStretched | Class that implements the dehierarchisation on a linear sparse grid |
CDehierarchisationLinearStretchedBoundary | Class that implements the dehierarchisation on a linear sparse grid with boundaries |
CDehierarchisationModFundamentalSpline | Functor for dehierarchization with modified fundamental splines via BreadthFirstSearch |
CDehierarchisationModLinear | Class that implements the dehierarchisation on a mod linear sparse grid |
CDehierarchisationModLinearClenshawCurtis | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationModPoly | Class that implements the dehierarchisation on a modified polynomial sparse grid |
CDehierarchisationModPolyClenshawCurtis | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationPoly | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationPolyBoundary | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationPolyClenshawCurtis | Class that implements the dehierarchisation on a polynomial sparse grid |
CDehierarchisationPolyClenshawCurtisBoundary | Class that implements the dehierarchisation on a polynomial sparse grid |
CDirichletGridConverter | This class handles the conversion of a boundary grid with dirichlet boundary conditions into an inner |
CDirichletUpdateVector | This class is useful if you do some PDE calculations with Dirichlet Boundary Conditions |
CEvalCuboidGenerator | This class builds a cuboid in the d-dimension space |
CEvalCuboidGeneratorForStretching | This class builds a cuboid in the d-dimension space |
Cfactory_exception | Exception that is thrown in case of a grid failure |
Cfile_exception | Exception that is thrown in case of a file failure |
CForwardSelectorRefinement | |
CForwardSelectorRefinement_refinement_key | Container type for forward selector (combined-measure) refinement collection |
CForwardSelectorRefinementIndicator | A refinement indicator for support vector classification using sparse grids (according to König BA) |
CFundamentalSplineBasis | Fundamental spline basis on Noboundary grids |
CFundamentalSplineGrid | Grid with fundamental spline basis functions |
CFundamentalSplineModifiedBasis | Modified fundamental spline basis on Noboundary grids |
CGaussHermiteQuadRule1D | Load gauss quadrature points for standard normal weight function |
CGaussLegendreQuadRule1D | |
CGeneralGridConfiguration | Struct to cluster general grid information for different grid "super" types |
CGeneralizedBoundaryGridGenerator | This class provides the interface for the grid generation for grids with boundaries, pentagon cut through sub space scheme |
Cgeneration_exception | Exception that is thrown in case of a grid generation failure |
CGetAffectedBasisFunctions | Basic algorithm for getting all affected basis functions |
CGetAffectedBasisFunctions< LinearBoundaryBasis< unsigned int, unsigned int > > | Template Specialization for LinearBoundaryBasis basis |
CGetAffectedBasisFunctions< LinearClenshawCurtisBoundaryBasis< unsigned int, unsigned int > > | Template Specialization for LinearClenshawCurtisBoundaryBasis basis |
CGetAffectedBasisFunctions< LinearPeriodicBasis< unsigned int, unsigned int > > | Template Specialization for PeriodicBasis basis |
CGetAffectedBasisFunctions< LinearStretchedBoundaryBasis< unsigned int, unsigned int > > | Template Specialization for LinearStretchedBoundaryBasis basis |
CGetAffectedBasisFunctions< PolyBoundaryBasis< unsigned int, unsigned int > > | Template Specialization for PolyBoundaryBasis basis |
CGetAffectedBasisFunctions< PolyClenshawCurtisBoundaryBasis< unsigned int, unsigned int > > | Template Specialization for PolyClenshawCurtisBoundaryBasis basis |
CGetAffectedBasisFunctions< PrewaveletBasis< unsigned int, unsigned int > > | Template Specialization for prewavelet basis |
CGrid | Abstract base class for all types grids used in sgpp the class gives pure virtual function definitions that have to be implemented by all types of grids |
CGridDataBase | Class that allows to keep a storage of arbitrary grid points |
CGridGenerator | Abstract class that defines the interfaces for the different grid's GridGenerators |
CGridPrinter | This class implements a utility that allows you to print a grid to file |
CGridPrinterForStretching | This class implements a utility that allows you to print a grid to file |
CGridStencil | Grid with linear base functions |
CHashCoarsening | Standard free coarsening class for sparse grids, only inner grid points can be removed |
CHashGenerator | This class provides the generation functionality of sparse grids based on hashmaps |
CHashGridIterator | This class can be used for storage agnostic algorithms |
CHashGridPoint | This Class represents one Gridpoint |
CHashGridPointEqualityFunctor | |
CHashGridPointHashFunctor | |
CHashGridPointPointerEqualityFunctor | |
CHashGridPointPointerHashFunctor | |
CHashGridStorage | Generic hash table based storage of grid points |
CHashRefinement | Free refinement class for sparse grids |
CHashRefinementBoundaries | Standard free refinement class for sparse grids with boundaries |
CHashRefinementBoundariesMaxLevel | Standard free refinement class for sparse grids with boundaries with a maximal level depth of refinement |
CHashRefinementInconsistent | Free refinement class for sparse grids |
CHashRefinementInteraction | The HashRefinementInteraction class |
CHermiteBasis | |
CHierarchisationFundamentalSpline | Functor for hierarchization with fundamental splines via BreadthFirstSearch |
CHierarchisationLinear | Class that implements the hierarchisation on a linear sparse grid |
CHierarchisationLinearBoundary | Class that implements the hierarchisation on a linear sparse grid with boundaries |
CHierarchisationLinearClenshawCurtis | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationLinearClenshawCurtisBoundary | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationLinearStretched | Class that implements the hierarchisation on a linear sparse grid |
CHierarchisationLinearStretchedBoundary | Class that implements the hierarchisation on a linear sparse grid with boundaries |
CHierarchisationModFundamentalSpline | Functor for hierarchization with modified fundamental splines via BreadthFirstSearch |
CHierarchisationModLinear | Class that implements the hierarchisation on a mod linear sparse grid |
CHierarchisationModLinearClenshawCurtis | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationModPoly | Class that implements the hierarchisation on a modified polynomial sparse grid |
CHierarchisationModPolyClenshawCurtis | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationPoly | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationPolyBoundary | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationPolyClenshawCurtis | Class that implements the hierarchisation on a polynomial sparse grid |
CHierarchisationPolyClenshawCurtisBoundary | Class that implements the hierarchisation on a polynomial sparse grid |
CImpurityRefinement | |
CImpurityRefinement_refinement_key | Container type for impurity refinement collection |
CImpurityRefinementIndicator | A refinement indicator for classification problems based on impurity measures (e.g |
►CIndexInSubspaceGenerator | Container for the index_vectors of a subspace |
Citerator | Iterator class compatible with STL forward iterator (no const iterator) |
CKernelSourceBuilderBase | |
CL0BoundaryGridGenerator | This class provides the interface for the grid generation for grids with boundaries, diagonal cut through sub space scheme |
CLinearBasis | Linear basis on Noboundary grids |
CLinearBoundaryBasis | Linear basis on Boundary grids |
CLinearBoundaryGrid | Grid with linear base functions with boundaries, pentagon cut |
CLinearClenshawCurtisBasis | Linear basis on Clenshaw-Curtis grids |
CLinearClenshawCurtisBoundaryBasis | Linear basis on Clenshaw-Curtis grids |
CLinearClenshawCurtisBoundaryGrid | Grid with Clenshaw-Curtis linear base functions with boundaries, pentagon cut |
CLinearClenshawCurtisGrid | Grid with modified Clenshaw-Curtis poly basis functions |
CLinearGrid | Grid with linear base functions |
CLinearGridStencil | Grid with linear base functions |
CLinearL0BoundaryGrid | Grid with linear base functions with boundaries |
CLinearLoadBalancer | |
CLinearLoadBalancerMultiPlatform | |
CLinearModifiedBasis | Modified linear basis on Noboundary grids |
CLinearModifiedClenshawCurtisBasis | Modified polynomial base functions |
CLinearPeriodicBasis | Linear basis functions with boundaries And here we have another implicit dependence on tensor products |
CLinearStretchedBasis | Linearstretched base functions |
CLinearStretchedBoundaryBasis | Linearstretched basis functions with boundaries And here we have another implicit dependence on tensor products |
CLinearStretchedBoundaryGrid | Grid with linear base functions with boundaries, pentagon cut |
CLinearStretchedGrid | Grid with linearstretched base functions |
CLinearTruncatedBoundaryGrid | Grid with linear base functions with boundaries, pentagon cut Generalization of the LinearL0Boundary and LinearBoundary Grids The sparse grid does contain all fullgrids with |l|<a given level, and l_min>l_user For l_user=0 we obtain the LinearL0BoundaryGrid and for l_user=1 we obtain the linear truncated boundary grid |
CModBsplineClenshawCurtisGrid | Grid with modified Clenshaw-Curtis Bspline basis functions |
CModBsplineGrid | Grid with modified Bspline basis functions |
CModFundamentalSplineGrid | Grid with modified fundamental spline basis functions |
CModLinearClenshawCurtisGrid | Grid with modified Clenshaw-Curtis poly basis functions |
CModLinearGrid | Grid with modified linear base functions |
CModLinearGridStencil | Grid with linear base functions |
CModPolyClenshawCurtisGrid | Grid with modified Clenshaw-Curtis poly basis functions |
CModPolyGrid | Grid with modified polynomial base functions |
CModWaveletGrid | Grid with modified wavelet base functions |
CMultipleClassPoint | Multiple Class Point provides a structure to save additional data for each GridPoint in a Sparse Grid |
CMultipleClassRefinement | Refinement class for sparse grids |
CNakBsplineBoundaryCombigridBasis | Hierarchical Not-a-knot B-spline basis |
CNakBsplineBoundaryCombigridGrid | Grid with B-spline basis functions with not-a-knot boundary conditions |
Cnot_implemented_exception | Exception that is thrown in case of an application failure |
COCLBufferWrapperSD | |
COCLClonedBuffer | |
COCLClonedBufferMultiPlatform | |
COCLConfigurationParameters | |
COCLDevice | |
COCLManager | |
COCLManagerMultiPlatform | |
COCLOperationConfiguration | |
COCLPlatformWrapper | |
COCLStretchedBuffer | |
COCLStretchedBufferMultiPlatform | |
COCLZeroCopyBuffer | |
Coperation_exception | Exception that is thrown in case of a grid operation failure |
COperationArbitraryBoundaryHierarchisation | This class implements the hierarchisation and dehierarchisation on sparse grids which do not have a grid point at the boundary in each direction for every inner point (boundaryLevel > 1) |
COperationConfiguration | |
COperationConvert | Operation that cpnverts a given basis into the normal, linear hat basis and vice versa |
COperationConvertPrewavelet | |
COperationDiagonal | Implementation of diagonal Operation for all kinds of grids |
COperationEval | Operation that evaluates the current sparse grid function defined by the coefficient vector alpha at a given point |
COperationEvalBsplineBoundaryNaive | Operation for evaluating B-spline linear combinations on Boundary grids |
COperationEvalBsplineClenshawCurtisNaive | Operation for evaluating B-spline linear combinations on Clenshaw-Curtis grids |
COperationEvalBsplineNaive | Operation for evaluating B-spline linear combinations on Noboundary grids |
COperationEvalFundamentalSplineNaive | Operation for evaluating B-spline linear combinations on Noboundary grids |
COperationEvalGradient | Abstract operation for evaluating a linear combination of basis functions and its gradient |
COperationEvalGradientBsplineBoundaryNaive | Operation for evaluating B-spline linear combinations on Boundary grids and their gradients |
COperationEvalGradientBsplineClenshawCurtisNaive | Operation for evaluating B-spline linear combinations on Clenshaw-Curtis grids and their gradients |
COperationEvalGradientBsplineNaive | Operation for evaluating B-spline linear combinations on Noboundary grids and their gradients |
COperationEvalGradientFundamentalSplineNaive | Operation for evaluating B-spline linear combinations on Noboundary grids and their gradients |
COperationEvalGradientModBsplineClenshawCurtisNaive | Operation for evaluating modified Clenshaw-Curtis B-spline linear combinations on Noboundary grids and their gradients |
COperationEvalGradientModBsplineNaive | Operation for evaluating modified B-spline linear combinations on Noboundary grids and their gradients |
COperationEvalGradientModFundamentalSplineNaive | Operation for evaluating modified B-spline linear combinations on Noboundary grids and their gradients |
COperationEvalGradientModWaveletNaive | Operation for evaluating modified wavelet linear combinations on Noboundary grids and their gradients |
COperationEvalGradientWaveletBoundaryNaive | Operation for evaluating wavelet linear combinations on Boundary grids and their gradients |
COperationEvalGradientWaveletNaive | Operation for evaluating wavelet linear combinations on Noboundary grids and their gradients |
COperationEvalHessian | Abstract operation for evaluating a linear combination of basis functions, its gradient and its Hessian |
COperationEvalHessianBsplineBoundaryNaive | Operation for evaluating B-spline linear combinations on Boundary grids, their gradients and their Hessians |
COperationEvalHessianBsplineClenshawCurtisNaive | Operation for evaluating B-spline linear combinations on Clenshaw-Curtis grids, their gradients and their Hessians |
COperationEvalHessianBsplineNaive | Operation for evaluating B-spline linear combinations on Noboundary grids, their gradients and their Hessians |
COperationEvalHessianFundamentalSplineNaive | Operation for evaluating B-spline linear combinations on Noboundary grids, their gradients and their Hessians |
COperationEvalHessianModBsplineClenshawCurtisNaive | Operation for evaluating modified Clenshaw-Curtis B-spline linear combinations on Noboundary grids, their gradients, and their Hessians |
COperationEvalHessianModBsplineNaive | Operation for evaluating modified B-spline linear combinations on Noboundary grids, their gradients and their Hessians |
COperationEvalHessianModFundamentalSplineNaive | Operation for evaluating modified B-spline linear combinations on Noboundary grids, their gradients and their Hessians |
COperationEvalHessianModWaveletNaive | Operation for evaluating modified wavelet linear combinations on Noboundary grids, their gradients and their Hessians |
COperationEvalHessianWaveletBoundaryNaive | Operation for evaluating wavelet linear combinations on Boundary grids, their gradients and their Hessians |
COperationEvalHessianWaveletNaive | Operation for evaluating wavelet linear combinations on Noboundary grids, their gradients and their Hessians |
COperationEvalLinear | This class implements OperationEval for a grids with linear basis ansatzfunctions without boundaries |
COperationEvalLinearBoundary | This class implements OperationEval for a grids with linear basis ansatzfunctions with boundaries |
COperationEvalLinearBoundaryNaive | |
COperationEvalLinearClenshawCurtisBoundaryNaive | |
COperationEvalLinearClenshawCurtisNaive | |
COperationEvalLinearNaive | |
COperationEvalLinearStretched | This class implements OperationEval for a grids with linear basis ansatzfunctions without boundaries |
COperationEvalLinearStretchedBoundary | This class implements OperationEval for a grids with linear basis ansatzfunctions with boundaries |
COperationEvalModBsplineClenshawCurtisNaive | Operation for evaluating modified Clenshaw-Curtis B-spline linear combinations on Noboundary grids |
COperationEvalModBsplineNaive | Operation for evaluating modified B-spline linear combinations on Noboundary grids |
COperationEvalModFundamentalSplineNaive | Operation for evaluating modified B-spline linear combinations on Noboundary grids |
COperationEvalModLinear | This class implements OperationEval for a grids with mod linear basis ansatzfunctions with |
COperationEvalModLinearClenshawCurtisNaive | |
COperationEvalModLinearNaive | |
COperationEvalModPoly | This class implements OperationEval for a grids with mod poly basis ansatzfunctions with |
COperationEvalModPolyClenshawCurtisNaive | |
COperationEvalModPolyNaive | |
COperationEvalModWaveletNaive | Operation for evaluating modified wavelet linear combinations on Noboundary grids |
COperationEvalNakBsplineBoundaryCombigridNaive | Operation for evaluating B-spline linear combinations on Boundary grids with not-a-knot boundary conditions |
COperationEvalPartialDerivative | Abstract operation for evaluating a partial derivative of a linear combination of basis functions |
COperationEvalPartialDerivativeBsplineBoundaryNaive | Operation for evaluating partial derivatives of B-spline linear combinations on Boundary grids |
COperationEvalPartialDerivativeBsplineClenshawCurtisNaive | Operation for evaluating partial derivatives of B-spline linear combinations on Clenshaw-Curtis grids |
COperationEvalPartialDerivativeBsplineNaive | Operation for evaluating partial derivatives of B-spline linear combinations on Noboundary grids |
COperationEvalPartialDerivativeFundamentalSplineNaive | Operation for evaluating partial derivatives of B-spline linear combinations on Noboundary grids |
COperationEvalPartialDerivativeModBsplineClenshawCurtisNaive | Operation for evaluating partial derivatives of modified Clenshaw-Curtis B-spline linear combinations on Noboundary grids |
COperationEvalPartialDerivativeModBsplineNaive | Operation for evaluating partial derivatives of modified B-spline linear combinations on Noboundary grids |
COperationEvalPartialDerivativeModFundamentalSplineNaive | Operation for evaluating partial derivatives of modified B-spline linear combinations on Noboundary grids |
COperationEvalPartialDerivativeModWaveletNaive | Operation for evaluating partial derivatives of modified wavelet linear combinations on Noboundary grids |
COperationEvalPartialDerivativeWaveletBoundaryNaive | Operation for evaluating partial derivatives of wavelet linear combinations on Boundary grids |
COperationEvalPartialDerivativeWaveletNaive | Operation for evaluating partial derivatives of wavelet linear combinations on Noboundary grids |
COperationEvalPeriodic | This class implements OperationEval for a grids with periodic linear basis ansatzfunctions with |
COperationEvalPoly | This class implements OperationEval for a grids with poly basis ansatzfunctions with |
COperationEvalPolyBoundary | This class implements OperationEval for a grids with poly basis ansatzfunctions with |
COperationEvalPolyBoundaryNaive | |
COperationEvalPolyClenshawCurtisBoundaryNaive | |
COperationEvalPolyClenshawCurtisNaive | |
COperationEvalPolyNaive | |
COperationEvalPrewavelet | This class implements OperationEval for a grids with prewavelet basis ansatzfunctions without boundaries |
COperationEvalWaveletBoundaryNaive | Operation for evaluating wavelet linear combinations on Boundary grids |
COperationEvalWaveletNaive | Operation for evaluating wavelet linear combinations on Noboundary grids |
COperationFirstMoment | This class provides the first moment of a sparse grid function |
COperationFirstMomentBspline | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentBsplineBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentBsplineClenshawCurtis | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentLinear | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentLinearBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentModBspline | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentModBsplineClenshawCurtis | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentModLinear | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentModPoly | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentModPolyClenshawCurtis | FirstMomemnt of sparse grid function, ModPolyClenshawCurtis grid |
COperationFirstMomentPoly | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentPolyBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentPolyClenshawCurtis | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationFirstMomentPolyClenshawCurtisBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationHierarchisation | This class implements the hierarchisation and dehierarchisation on the sparse grid |
COperationHierarchisationFundamentalSpline | Hierarchisation on sparse grid, fundamental spline basis |
COperationHierarchisationLinear | Hierarchisation on sparse grid, linear grid without boundaries |
COperationHierarchisationLinearBoundary | Hierarchisation on sparse grid, linear case with boundaries |
COperationHierarchisationLinearClenshawCurtis | Hierarchisation on sparse grid, poly case |
COperationHierarchisationLinearClenshawCurtisBoundary | Hierarchisation on sparse grid, poly case |
COperationHierarchisationLinearStretched | Hierarchisation on sparse grid, linear grid without boundaries |
COperationHierarchisationLinearStretchedBoundary | Hierarchisation on sparse grid, linear stretched case with boundaries |
COperationHierarchisationModBspline | Hierarchisation on sparse grid, mod bspline case |
COperationHierarchisationModFundamentalSpline | Hierarchisation on sparse grid, modified fundamental spline basis |
COperationHierarchisationModLinear | Hierarchisation on sparse grid, mod linear case |
COperationHierarchisationModLinearClenshawCurtis | Hierarchisation on sparse grid, poly case |
COperationHierarchisationModPoly | Hierarchisation on sparse grid, mod poly case |
COperationHierarchisationModPolyClenshawCurtis | Hierarchisation on sparse grid, poly case |
COperationHierarchisationModWavelet | Hierarchisation on sparse grid, mod wavelet case |
COperationHierarchisationPoly | Hierarchisation on sparse grid, poly case |
COperationHierarchisationPolyBoundary | Hierarchisation on sparse grid, poly case |
COperationHierarchisationPolyClenshawCurtis | Hierarchisation on sparse grid, poly case |
COperationHierarchisationPolyClenshawCurtisBoundary | Hierarchisation on sparse grid, poly case |
COperationHierarchisationPrewavelet | Hierarchisation on sparse grid with prewavelets and no boundary |
COperationIdentity | Implementation of identity Operation for all kinds of grids |
COperationMatrix | Abstract definition of a matrix operator interface |
COperationMatrixSP | Abstract definition of a matrix operator interface |
COperationMultipleEval | Interface for multiplication with Matrices \(B\) and \(B^T\) |
COperationMultipleEvalBsplineBoundaryNaive | |
COperationMultipleEvalBsplineClenshawCurtisNaive | |
COperationMultipleEvalBsplineNaive | |
COperationMultipleEvalInterModLinear | This class implements OperationMultipleEval for a grids with mod linear basis ansatzfunctions and a set of interactions that limit the subspaces that are included |
COperationMultipleEvalLinear | This class implements OperationB for a grids with linear basis ansatzfunctions without boundaries |
COperationMultipleEvalLinearBoundary | This class implements OperationMultipleEval for a grids with linear basis ansatzfunctions with boundaries |
COperationMultipleEvalLinearBoundaryNaive | |
COperationMultipleEvalLinearClenshawCurtisBoundaryNaive | |
COperationMultipleEvalLinearClenshawCurtisNaive | |
COperationMultipleEvalLinearNaive | |
COperationMultipleEvalLinearStretched | This class implements OperationB for a grids with linearstretched basis ansatzfunctions without boundaries |
COperationMultipleEvalLinearStretchedBoundary | This class implements OperationMultipleEval for a grids with linearstretched basis ansatzfunctions with boundaries |
COperationMultipleEvalModBsplineClenshawCurtisNaive | |
COperationMultipleEvalModBsplineNaive | |
COperationMultipleEvalModLinear | This class implements OperationMultipleEval for a grids with mod linear basis ansatzfunctions |
COperationMultipleEvalModLinearClenshawCurtisNaive | |
COperationMultipleEvalModPoly | This class implements OperationMultipleEval for a grids with mod poly basis ansatzfunctions |
COperationMultipleEvalModPolyClenshawCurtisNaive | |
COperationMultipleEvalPeriodic | This class implements OperationMultipleEval for a grids with periodic linear basis ansatzfunctions |
COperationMultipleEvalPoly | This class implements OperationMultipleEval for a grids with poly basis ansatzfunctions |
COperationMultipleEvalPolyBoundary | This class implements OperationMultipleEval for a grids with poly basis ansatzfunctions |
COperationMultipleEvalPolyBoundaryNaive | |
COperationMultipleEvalPolyClenshawCurtisBoundaryNaive | |
COperationMultipleEvalPolyClenshawCurtisNaive | |
COperationMultipleEvalPolyNaive | |
COperationMultipleEvalPrewavelet | This class implements OperationMultipleEval for a grids with prewavelet ansatzfunctions without boundaries |
COperationQuadrature | This class provides the quadrature of a sparse grid function |
COperationQuadratureBspline | Quadrature on sparse grid, Bsplinenomial grid without boundaries |
COperationQuadratureBsplineBoundary | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadratureBsplineClenshawCurtis | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadratureFundamentalSpline | Quadrature on sparse grid, FundamentalSplinenomial grid without boundaries |
COperationQuadratureLinear | Quadrature on sparse grid, linear grid without boundaries |
COperationQuadratureLinearBoundary | Quadrature on sparse grid, linear grid without boundaries |
COperationQuadratureLinearClenshawCurtis | Quadrature on sparse grid, linear grid without boundaries |
COperationQuadratureLinearClenshawCurtisBoundary | Quadrature on sparse grid, linear grid without boundaries |
COperationQuadratureMC | Quadrature on any sparse grid (that has OperationMultipleEval implemented) using Monte Carlo |
COperationQuadratureModBspline | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadratureModBsplineClenshawCurtis | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadratureModFundamentalSpline | Quadrature on sparse grid, ModFundamentalSplinenomial grid without boundaries |
COperationQuadratureModLinear | Quadrature on sparse grid, modified linear grid |
COperationQuadratureModLinearClenshawCurtis | Quadrature on sparse grid, linear grid without boundaries |
COperationQuadratureModPoly | Quadrature on sparse grid, modified polynomial grid without boundaries |
COperationQuadratureModPolyClenshawCurtis | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadraturePoly | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadraturePolyBoundary | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadraturePolyClenshawCurtis | Quadrature on sparse grid, polynomial grid without boundaries |
COperationQuadraturePolyClenshawCurtisBoundary | Quadrature on sparse grid, polynomial grid without boundaries |
COperationSecondMoment | This class provides the second moment of a sparse grid function |
COperationSecondMomentBspline | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentBsplineBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentBsplineClenshawCurtis | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentLinear | SecondMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentLinearBoundary | SecondMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentModBspline | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentModBsplineClenshawCurtis | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentModLinear | SecondMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentModPoly | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentModPolyClenshawCurtis | FirstMomemnt of sparse grid function, ModPolyClenshawCurtis grid |
COperationSecondMomentPoly | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentPolyBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentPolyClenshawCurtis | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationSecondMomentPolyClenshawCurtisBoundary | FirstMomemnt of sparse grid function, linear grid without boundaries |
COperationStencilHierarchisation | This class implements abstract hierarchisation and dehierarchisation routines on the sparse grid by logging the operations into three arrays rather than actually applying them to the data vector object |
COperationStencilHierarchisationLinear | Hierarchisation on sparse grid, linear grid without boundaries |
COperationStencilHierarchisationModLinear | Hierarchisation on sparse grid, linear grid with modified basis functions |
CPeriodicGrid | Grid with modified linear base functions |
CPeriodicGridGenerator | GridGenerator for periodic grids with boundaries |
CPolyBasis | Polynomial basis functions |
CPolyBoundaryBasis | Polynomial basis functions with boundaries |
CPolyBoundaryGrid | Trapezoid boundary grid with polynomial base functions |
CPolyClenshawCurtisBasis | Polynomial basis functions |
CPolyClenshawCurtisBoundaryBasis | Polynomial basis functions |
CPolyClenshawCurtisBoundaryGrid | Grid with Clenshaw-Curtis linear base functions with boundaries, pentagon cut |
CPolyClenshawCurtisGrid | Grid with modified Clenshaw-Curtis poly basis functions |
CPolyGrid | Grid with polynomial base functions |
CPolyModifiedBasis | Modified polynomial base functions |
CPolyModifiedClenshawCurtisBasis | Modified polynomial base functions |
CPrecisionConverter | Copies data from DataVector objects into DataVectorSP objects and vice versa |
CPredictiveRefinement | |
CPredictiveRefinement_refinement_key | Container type for predictive refinement collection |
CPredictiveRefinementIndicator | A refinement error indicator for regression problems based on the residuals of the datasets |
CPrewaveletBasis | Class representing a prewavelet base |
CPrewaveletGrid | Grid with prewavelet base functions |
CPrewaveletGridGenerator | GridGenerator for prewavelet grids without boundaries |
CQuadRule1D | |
CQueueLoadBalancerMutex | |
CQueueLoadBalancerOpenMP | |
CRefinementDecorator | RefinementDecorator enhances the behavior of underlying Refinement objects using Decorator design pattern |
CRefinementFunctor | Abstract class that defines the interface that refinement functors have to provide |
CRegularGridConfiguration | Structure that can be used by applications to cluster regular grid information |
CScreenOutput | This is used to implement the output on the command line |
CSGppStopwatch | OS-independent version of a stop watch (using std::chrono) |
Csolver_exception | Exception that is thrown in case of a solver operation failure |
CSquareRootGrid | Grid with linear base functions with boundaries, pentagon cut |
CSquareRootGridGenerator | This class provides the interface for the grid generation for grids with boundaries, pentagon cut through sub space scheme |
CStandardGridGenerator | GridGenerator for standard grids without boundaries |
CStdNormalDistribution | This provides an implementation of the standradized normal distribution |
CStencilDehierarchisationLinear | Class that implements the dehierarchisation on a linear sparse grid |
CStencilDehierarchisationModLinear | Class that implements the dehierarchisation on a linear sparse grid |
CStencilHierarchisationLinear | Class that implements the hierarchisation on a linear sparse grid |
CStencilHierarchisationModLinear | Class that implements the hierarchisation on a linear sparse grid |
CStretchedBoundaryGridGenerator | TODOTEXT |
CStretching | Stretching can be done in different ways: |
CStretching1D | |
►CSubspaceGenerator | |
Citerator | |
CSubspaceRefinement | |
CSurplusCoarseningFunctor | A coarsening functor, removing points according to the minimal absolute values in a DataVector provided |
CSurplusRefinementFunctor | A refinement functor, refining according to the maximal absolute values in a DataVector provided |
CSurplusVolumeCoarseningFunctor | A coarsening functor, removing points according to the minimal absolute values in a DataVector provided, weighted with the corresponding basis function's surplus, i.e., with \(2^{-|\vec{l}|_1} = 2^{\sum_{k=1}^d l_d}\) |
CSurplusVolumeRefinementFunctor | A refinement functor, refining according to the maximal absolute values in a DataVector provided, weighted with the corresponding basis function's surplus, i.e., with \(2^{-|\vec{l}|_1} = 2^{\sum_{k=1}^d l_d}\) |
Csweep | Standard sweep operation FUNC should be a class with overwritten operator() |
Ctool_exception | Exception that is thrown in case of a tool operation failure |
CWaveletBasis | Wavelet basis on Noboundary grids |
CWaveletBoundaryBasis | Wavelet basis on Boundary grids |
CWaveletBoundaryGrid | Grid with wavelet base functions with boundaries, pentagon cut |
CWaveletGrid | Grid with wavelet base functions |
CWaveletModifiedBasis | Modified wavelet basis on Noboundary grids |
►Ncombigrid | |
CAbstractCombigridStorage | Abstract base class for storage storing a float_t for each level-index-pair |
CAbstractEvaluator | Abstract base class for one-dimensional numerical evaluation methods |
CAbstractFullGridEvaluationStrategy | |
CAbstractFullGridEvaluator | Abstract class for doing an evaluation on a full grid, yielding a value of the template type V |
CAbstractFullGridSummationStrategy | |
CAbstractGrowthStrategy | Defines a converter from a level to a number of points, i |
CAbstractInfiniteFunctionBasis1D | |
CAbstractLevelEvaluator | This class abstracts a lot of methods of CombigridEvaluator for classes that do not want to carry around its template parameter, e |
CAbstractLinearEvaluator | See also AbstractEvaluator |
CAbstractMultiStorage | Interface for storage classes which store values of type T |
CAbstractMultiStorageIterator | Abstract base class for iterators iterating over (existing or maybe also non-existing) entries of an AbstractMultiStorage |
CAbstractPermutationIterator | Iterates over the elements of a permutation |
CAbstractPointDistribution | An abstract point distribution provides a set of n one-dimensional grid points for each value of n |
CAbstractPointHierarchy | Contains all the necessary information about a family of one-dimensional grids: |
CAbstractPointOrdering | An AbstractPointOrdering may (via convertIndex()) define a reordering of the points so that the same points in different levels have the same indices |
CAbstractSerializationStrategy | This is an abstract base class for strategies converting between an object of type T (template parameter) and std::string for serialization and deserialization |
CAbstractTreeStorageNode | Interface class for TreeStorage-nodes |
CAdaptiveRefinementStrategy | This class is a helper class to configure some adaptive refinement methods |
CArrayEvaluator | This class takes a 1D linear evaluator operating on scalars (which is given through the template type ScalarEvaluator) and uses multiple instances of it for doing multi-evaluation |
CAtanBeta | |
CAtanUniform | |
CAveragingLevelManager | This is a simple LevelManager implementation that does level norm prediction for adaptive refinement by averaging the norms of predecessor levels divided by their number of new points |
►CBinaryHeap | Implements a max heap using a binary heap |
CHandle | |
CHeapElement | |
CBoundedSumMultiIndexIterator | This class can be used to generate multi-indices with bounded 1-norm |
CBSplineInterpolationCoefficientEvaluator | |
CBSplineInterpolationEvaluator | This evaluator calculates the B spline evaluations b_i(evaluatioinPoint) for B splines b_i of degree 'degree' and saves these in basisValues |
CBSplineQuadratureEvaluator | This evaluator calculates the integrals int b_i(x) dx for B splines b_i |
CBSplineScalarProductEvaluator | This evaluator calculates the scalar products int b_i(x) b_j(x) dx for B splines b_i and b_j |
CBsplineStochasticCollocation | |
CChebyshevDistribution | Provides Chebyshev grid points, that is, the points 0.5 - 0.5*cos((2k + 1)*pi/(2n)) for k = 0, ..., n-1 |
CClenshawCurtisDistribution | Provides Clenshaw-Curtis grid points, that is, the points 0.5 - 0.5 cos(k*pi/(n-1)) for k = 0, ..., n or 0.5, if n = 1 |
CCO2 | |
CCombiEvaluators | This class provides standard configurations of 1D-evaluators (single- and multi-evaluation) |
CCombigridEvaluator | The CombigridEvaluator class evaluates a numerical method on different full grids and combines them using the combination technique |
CCombigridMultiOperation | Interface class for simple usage of the combigrid module |
CCombigridMultiOperationImpl | |
CCombigridOperation | Interface class for simple usage of the combigrid module |
CCombigridOperationImpl | |
CCombigridSurrogateModel | |
CCombigridSurrogateModelConfiguration | |
CCombigridTensorOperation | |
CCombigridTensorOperationImpl | |
CCombigridTreeStorage | Implementation of the AbstractCombigridStorage using TreeStorage<TreeStorage<float_t>> |
CCombigridTreeStorageImpl | |
CCombiHierarchies | This class provides standard configurations of point hierarchies |
CCubicSplineInterpolationEvaluator | |
CCustomGrowthStrategy | The level-numPoints-mapping can be customized with a function |
CDataVectorEqualTo | Helper class used internally as an equality predicate |
CDataVectorHash | Helper class used internally as a hash function for DataVector objects |
CDebugfct | |
CDefaultSerializationStrategy | This serialization strategy uses the operators << and >> on streams that are overloaded for many standard types |
CEvaluatorConfiguration | |
CExponentialChebyshevPermutationIterator | Sorted-permutation-iterator for ExponentialChebyshevPointOrdering |
CExponentialChebyshevPointOrdering | PointOrdering class with the slowest growth (n = 3^l) possible in order to make Chebyshev points nested |
CExponentialGrowthStrategy | NumPoints = (l == 0) ? 1 : 2^l + 1 Yields nested points for e |
CExponentialLevelorderPermutationIterator | Sorted-permutation-iterator class for ExponentialLevelorderPointOrdering |
CExponentialLevelorderPointOrdering | PointOrdering class with the slowest possible growth (n = (l == 1) ? 1 : 2^l + 1) to make Clenshaw-Curtis-points / uniform points with boundary nested |
CExponentialNoBoundaryPermutationIterator | Sorted-permutation-iterator for ExponentialNoBoundaryPointOrdering |
CExponentialNoBoundaryPointOrdering | Point ordering class with the slowest possible growth (n = 2^(l+1) - 1) that makes uniform points without boundary nested |
CFirstMomentNormStrategy | |
CFloatArrayVector | This class models a vector of scalars supporting operations such as addition, scalar multiplication and componentwise muliplication |
CFloatScalarVector | This class models a single scalar supporting operations such as addition, scalar multiplication and componentwise muliplication |
CFloatSerializationStrategy | This class provides a serialization strategy for floating-point types (float, double), though not particularly well-compressed (roughly 70 characters per float will be used) |
CFloatTensorVector | |
CFullGridCallbackEvaluator | Implementation of the AbstractFullGridLinearEvaluator class using a callback function that takes a single point and returns a function value at that point |
CFullGridGridBasedEvaluator | Implementation of the AbstractFullGridLinearEvaluator class using a callback function that If you want to be able to use different function values at the same point in different levels (for example because you are implementing a PDE solver), set exploitNesting to false in the constructor of CombigridTreeStorage |
CFullGridLinearSummationStrategy | |
CFullGridOptimizedPCESummationStrategy | This is an experimental class using an alternative basis change for PCE |
CFullGridPCESummationStrategy | This is an experimental class using an alternative basis change for PCE |
CFullGridQuadraticSummationStrategy | |
CFullGridTensorVarianceSummationStrategy | |
CFullGridVarianceSummationStrategy | |
CFunctionLookupTable | This class wraps a MultiFunction and stores computed values using a hashtable to avoid reevaluating a function at points where it already has been evaluated |
CFunctionLookupTableImpl | Helper to realize the PIMPL pattern |
CGaussLegendreQuadrature | Uses Gauss-Legendre quadrature to approximate the integral of a function on the domain [0, 1] |
CGeneralFunction | Wrapper for std::function<Out(In)> |
CGeneralFunction1 | |
CGeneralFunctionDirector | This is a helper class used internally to wrap python functions into GeneralFunction objects |
CGeneralFunctionDirector1 | |
CGenz | |
CGFDirWrapper | This is a protected helper class used internally to wrap python functions into MultiFunction objects |
CGFDirWrapper1 | |
CIdentityPointOrdering | Point ordering class that uses the identity mapping to compute a level-independent index (i.e |
CInternalTreeStorageNode | Each inner node of the storage contains a vector of other nodes |
CInterpolationCoefficientEvaluator | |
CIshigami | |
CIterationPolicy | With the IterationPolicy class, an AbstractMultiStorage can be configured to traverse its entries in a different order than the identity order |
CKahanAdder | Kahan adder (a numerically more precise method to add many numbers) |
CL2LejaPointDistribution | |
CLagrangePolynom | Class for a LagrangePolynom, used to eval it |
CLejaPointDistribution | Provides Leja points (which are nested, i |
CLevelInfo | Stores necessary information about the computation status of a level |
CLevelInfos | |
CLevelManager | This class provides functionality to conveniently add levels to a CombigridEvaluator |
CLinearGrowthStrategy | Calculation: numPoints := 1 + factor * level, where factor is a parameter passed to the class |
CLinearInterpolationEvaluator | This evaluator does linear interpolation on the given grid points |
CLowestTreeStorageNode | The Tree does not contain single elements of T in its leafs |
CLTwoScalarProductHashMapNakBsplineBoundaryCombigrid | |
CMCIntegrator | Monte-Carlo-Quadrature for testing issues |
CMixedOptimizer | |
CMonomialFunctionBasis1D | |
CMultiIndexIterator | Iterates over a hypercube of multi-indices |
CNestedPointHierarchy | PointHierarchy class for nested point hierarchies (computes the nested points only once), see also AbstractPointHierarchy |
CNewtonOptimizer | |
CNonNestedPointHierarchy | PointHierarchy class for point hierarchies that are not fully nested (see also AbstractPointHierarchy) |
CNormalAdder | Standard adder with the same interface as the Kahan adder |
CNormStrategy | |
COptimizationGuess | |
COrthogonalBasisFunctionsCollection | |
COrthogonalPolynomialBasis1D | |
COrthogonalPolynomialBasis1DConfiguration | |
COrthogonalPolynomialBasis1DParameters | |
CParabola | |
CParabola_uniform | |
CPolynomialChaosExpansion | |
CPolynomialInterpolationEvaluator | This evaluator does polynomial interpolation (using the barycentric approach) on the given grid points |
CPolynomialQuadratureEvaluator | This evaluator does quadrature based on the given grid points |
CPolynomialScalarProductEvaluator | This evaluator calculates the scalar products \(\int b_i b_j\) |
CPolynomialStochasticCollocation | |
CProbabilityDensityFunction1D | |
CProbabilityDensityFunction1DConfiguration | |
CProbabilityDensityFunctionParameters | |
CPtrGuard | Helper class implementing a lock guard for std::shared_ptr<mutex> that does not lock a mutex if it is nullptr |
CQueueComparator | This class is a comparator to compare objects of type QueueEntry |
CQueueEntry | This is a header containing helper classes for the implementation of LevelManager |
CRegularLevelManager | This class provides an adaption strategy that is equivalent to adding levels regularly |
CSecondMomentNormStrategy | |
CSortedPermutationIterator | Sorted-permutation-iterator (e.g |
CStopwatch | Simple stopwatch implementation |
CTensorGrid | |
CThreadPool | This implements a thread-pool with a pre-specified number of threads that process a list of tasks |
CTreeStorage | The TreeStorage class is an optimized implementation of a storage that stores values addressed by MultiIndex-objects |
CTreeStorageContext | Context for the TreeStorage class |
CTreeStorageGuidedIterator | Iterator class that travels "along" a MultiIndexIterator through a TreeStorage |
CTreeStorageSerializationStrategy | This class provides a serialization strategy for TreeStorage<T>-objects (though not particularly well-compressed) |
CTreeStorageStoredDataIterator | Iterator for the TreeStorage class that only traverses entries stored in the storage |
CTrisectionOptimizer | |
CUniformBoundaryPointDistribution | Uniform points, i |
CUniformPointDistribution | Uniform points, i |
CVarianceNormStrategy | |
CWeightedRatioLevelManager | This refinement criterion implements the one proposed by ´Gerstner and Griebel: Dimension-adaptive Tensor-Product Quadrature, p |
CWeightFunctionsCollection | |
►Ndatadriven | |
►Nclusteringmpi | |
CDensityRhsWorker | |
CDensityWorker | |
CGraphCreationWorker | |
CMPIEnviroment | |
CMPIWorkerBase | Base class for MPI master node operations |
CMPIWorkerGraphBase | |
CMPIWorkerGridBase | |
CMPIWorkerPackageBase | |
COperationDensityMultMPI | |
COperationDensityRhsMPI | |
COperationDummy | |
COperationGraphCreationMPI | |
COperationPrunedGraphCreationMPI | |
CPrunedGraphCreationWorker | |
CSimpleQueue | |
CWorkerDummy | |
►NClusteringOCL | |
COperationClusteringOCL | |
►NDensityOCLMultiPlatform | |
CKernelCreateGraph | OpenCL kernel class for operation to create a k nearest neighbor graph |
CKernelDensityB | Class for the OpenCL density matrix vector multiplication |
CKernelDensityMult | Class for the OpenCL density matrix vector multiplication |
CKernelPruneGraph | OpenCL kernel for density based pruning of a graph |
COperationCreateGraphOCL | Pure virtual base class for the k nearest neighbor opencl operation |
COperationCreateGraphOCLSingleDevice | Operation for creation of a k nearest neighbors graph using a dataset |
COperationDensity | Base class for density multiplication operation |
COperationDensityOCLMultiPlatform | Class for opencl density multiplication and density right hand side vector |
COperationPruneGraphOCL | Pure virtual base class for the graph pruning operation |
COperationPruneGraphOCLMultiPlatform | Operation for density based graph pruning |
CSourceBuilderB | OpenCL source builder for density right hand side vector |
CSourceBuilderCreateGraph | OpenCL source builder for k nearest neighbors graph creation |
CSourceBuilderMult | OpenCL source builder for density matrix vector multiplication |
CSourceBuilderPruneGraph | OpenCL source builder for density based graph pruning |
►NMultipleEvalHPX | |
CLoadBalancerComponent | |
CLocalityMultiplier | |
►NPiecewiseConstantRegression | |
CNode | |
►NstreamingBSplineOCL | |
CgetType | |
CgetType< double > | |
CgetType< float > | |
►NStreamingModOCLFastMultiPlatform | |
CConfiguration | |
CKernelMult | |
CKernelMultTranspose | |
CSourceBuilderMult | |
CSourceBuilderMultTranspose | |
►NStreamingModOCLMaskMultiPlatform | |
CConfiguration | |
CKernelMult | |
CKernelMultTranspose | |
CSourceBuilderMult | |
CSourceBuilderMultTranspose | |
►NStreamingModOCLOpt | |
CConfiguration | |
CKernelMult | |
CKernelMultTranspose | |
CSourceBuilderMult | |
CSourceBuilderMultTranspose | |
►NStreamingModOCLUnified | |
CConfiguration | |
CKernelMult | |
CKernelMultTranspose | |
CSourceBuilderMult | |
CSourceBuilderMultTranspose | |
►NStreamingOCLMultiPlatform | |
CConfiguration | Configuration class for the operation OperationMultiEvalStreamingOCLMultiPlatform |
CKernelMult | Kernel that provide the MultiEval \(v:= B^T \alpha\) operation for a single OpenCL device |
CKernelMultTranspose | Kernel that provide the transposed MultiEval operation \(v':= B v\) for a single OpenCL device |
COperationMultiEvalStreamingOCLMultiPlatform | This class provides an operation for evaluating multiple grid points in the domain and doing least squares data mining |
CSourceBuilderMult | Class for creating compute kernels for the MultiEval operation \(v:= B^T \alpha\) |
CSourceBuilderMultTranspose | Class for creating compute kernels for the transposed MultiEval operation \(v':= B v\) |
CAbstractOperationMultipleEvalSubspace | |
CAccuracy | Metric that quantifies the difference between predicted values and actual values in terms of mean squared error (MSE) |
CAlgorithmAdaBoostBase | |
CAlgorithmAdaBoostIdentity | |
CArffFileSampleProvider | ArffFileSampleProvider allows reading data in ARFF format into a sgpp::datadriven::Dataset object |
CARFFTools | Class that provides functionality to read ARFF files |
CAssignBatchNetworkMessage | Message wrapped in MPI_Packet specifying an order to a worker to train from a batch |
CAssignSystemMatrixUpdateNetworkMessage | Message wrapped in MPI_Packet specifying an order to a worker to update a class' system matrix decomposition |
CAssignTaskResult | Used by the MPI Task Scheduler to deliver the result of assigning the requested task |
CBayesianOptimization | Class to host all methods to perform Bayesian Optimization |
CBOConfig | Container class to store a conrete hyperparameter configuration for interaction with Bayesian Optimization |
CBoHyperparameterOptimizer | BoHyperparameterOptimizer coordinates data input, fitting and validation modules similarly to SparseGridMiner |
CClassificationLearner | The ClassificationLearner class Solves a classification problem |
CClassificationMinerFactory | Concrete Factory that builds an instance of sgpp::datadriven::SparseGridMiner for classification |
CClassificatorQuality | Struct to encapsulate the classsifiers quality by its characteristic numbers |
CConfigurationBit | This class implements a boolean representation of hyperparameters for harmonica |
CConfigurationRestriction | This class represents a constraint on the ConfigurationBits used by harmonica |
CContinuousParameter | Concrete class for hyperparameter with continuous values |
CCrossvalidationConfiguration | |
CCrossvalidationForRegularizationConfiguration | |
CCSVFileSampleProvider | CSVFileSampleProvider allows reading data in CSV format into a sgpp::datadriven::Dataset object |
CCSVTools | Class that provides functionality to read CSV files |
CDatabaseConfiguration | Configuration structure for the offline datamatrix decomposition database |
CDataBasedRefinementFunctor | Data based refinement uses data points to find refinement candidates |
CDataMiningConfigParser | |
CDataset | |
CDatasetGenerator | |
CDatasetTools | |
CDataShufflingFunctor | A class to provide functionality to shuffle (reorder) the data samples before the sample provider accesses it |
CDataShufflingFunctorCrossValidation | A pseudo shuffling functor, that maps indices 0...foldSize-1 to the current fold while mapping the other indices sequentially to the rest of the dataset |
CDataShufflingFunctorFactory | Concrete factory to build an instance of sgpp::datadriven::DataShufflingFunctor |
CDataShufflingFunctorRandom | A simple shuffling functor for data samples that performs a random shuffling of the data |
CDataShufflingFunctorSequential | A simple shuffling functor for data samples that performs no shuffling at all, i.e |
CDataSource | DataSource is a high level, easy to use interface for accessing data provided by a all kinds of sgpp::datadriven::SampleProvider |
CDataSourceBuilder | Generate an instance of sgpp::datadriven::DataSource using the Builder Pattern |
CDataSourceConfig | Configuration structure used for all kinds of SampleProviders including default values |
CDataSourceCrossValidation | DataSourceCrossValidation is a high level interface to provide functionality for processing data using a cross validation enviroment |
CDataSourceFileTypeParser | Convenience class to convert strings to sgpp::datadriven::DataSourceFileType and generate string representations for values of sgpp::datadriven::DataSourceFileType |
CDataSourceIterator | Iterator object for walking convenient walking over the batches of a sgpp::datadriven::DataSource |
CDataSourceShufflingTypeParser | Convenience class to convert strings to sgpp::datadriven::DataSourceShufflingType and generate string representations for values of sgpp::datadriven::DataSourceShufflingType |
CDataSourceSplitting | DataSourceSlitting is a high level interface to provide functionality for processing data epoch-wise with a validation set that is retrieved at initialization time using the first samples the sample provider provides |
CDataTransformation | DataTransformation is an abstraction for an object that provides different transformations on datasets, for example Rosenblatt-transformation to get a uniform distribution over the unit cube |
CDataTransformationBuilder | Helper class to build all kinds of transformation based on given configuration |
CDataTransformationConfig | |
CDataTransformationTypeParser | Convenience class to convert strings to sgpp::datadriven::DataTransformationType and generate string representations for values of sgpp::datadriven::DataTransformationType |
CDBMatDatabase | A database class to store and retrieve online matrix decompositions for the sparse grid density estimation |
CDBMatDecompMatrixSolver | |
CDBMatDMSChol | Class to solve the system of equations with a LL'-decomposed matrix |
CDBMatDMSDenseIChol | Solve the system of equations with a LL'-decomposed matrix where LL' is created by an iterative, incomplete cholesky factorization on a dense matrix |
CDBMatDMSOrthoAdapt | This class solves an (lhs + lambda*I) * alpha = b system of linear equations after the offline and online phases are done |
CDBMatOffline | Class that is used to decompose and store the left-hand-side matrix for the density based classification approach (The classification is divided into two parts: the offline step that does not depend on the actual data and the online step that depends on the data) |
CDBMatOfflineChol | DBMatOffline specialization that uses a cholesky factorization on a dense matrix |
CDBMatOfflineDenseIChol | DBMatOfflineChol specialization that uses a parallel, iterative incomplete cholesky factorization on a dense matrix |
CDBMatOfflineGE | DBMatOffline specialization as a base class for all algorithms based on gaussian elimination on a dense matrix |
CDBMatOfflineOrthoAdapt | |
CDBMatOnline | Class for objects that can be used in the online step of the classification (The classification is divided into two parts: the offline step that does not depend on the actual data and the online step that depends on the data) |
CDBMatOnlineDE | Class that stores, generates and manipulates a density function during online phase in on/off learning |
CDBMatOnlineDEChol | |
CDBMatOnlineDEOrthoAdapt | |
CDensityEstimationConfiguration | |
CDensityEstimationFitterFactory | Concrete factory to build instances of sgpp::datadriven::ModelFittingDensityEstimation |
CDensityEstimationMinerFactory | Concrete Factory that builds an instance of sgpp::datadriven::SparseGridMiner for Density Estimation |
CDensityEstimationTypeParser | |
CDensityEstimator | |
CDensitySystemMatrix | Class that implements the virtual class OperationMatrix for the application of classification for the Systemmatrix by using a density function |
CDiscreteParameter | Concrete class for hyperparameter with discrete values |
CDMSystemMatrix | Class that implements the virtual class base::OperationMatrix for the application of classification for the Systemmatrix |
CDMSystemMatrixBase | Abstract class that defines the virtual class base::OperationMatrix for classification and regression problems |
CDMSystemMatrixBaseSP | Abstract class that defines the virtual class base::OperationMatrix for classification and regression problems (single precision version) |
CDMWeightMatrix | Class that implements the virtual class OperationMatrix for the application of classification for the Systemmatrix with weight |
CEpanechnikovKernel | |
CFileSampleDecorator | FileSampleDecorator provides an interface to provide generic manipulations for various kinds of sgpp::datadriven::FileSampleProvider using the decorator pattern |
CFileSampleProvider | sgpp::datadriven::FileSampleProvider is an specialization of sgpp::datadriven::SampleProvider and provides an interface for all sample providers that get their samples from files |
CFitterConfiguration | General configuration object for fitters |
CFitterConfigurationClassification | Configuration for fitter scenarios using classification |
CFitterConfigurationDensityEstimation | Configuration for fitter scenarios using density estimation |
CFitterConfigurationLeastSquares | Configuration for fitter scenarios using least squares optimization |
CFitterFactory | Abstract factory to build all kinds of fitters/models based on a given configuration |
CFitterTypeParser | Convenience class to convert strings to sgpp::datadriven::FitterType and generate string representations for values of sgpp::datadriven::FitterType |
CFriedman1Generator | |
CFriedman2Generator | |
CFriedman3Generator | |
CGaussianKernel | |
CGeneralGridTypeParser | Parser class to parse a general grid type into a GeneralGridType enum type and vice versa |
CGridFactory | Factory class to create grids based on a configuration file |
CGridPointBasedRefinementFunctor | Grid Point based refinement for classification problems solved by a SG density estimation approach |
CGridTypeParser | |
CHarmonica | Class to host all methods required to perform the harmonica algorithm |
CHarmonicaHyperparameterOptimizer | HarmonicaHyperparameterOptimizer coordinates data input, fitting and validation modules similarly to SparseGridMiner |
CHashGridPointCompare | |
CHPOConfig | Configuration for HyperparameterOptimizer |
CHyperParameter | Class to represent a hyperparameter |
CHyperparameterOptimizer | HyperparameterOptimizer uses fitters provided by a fitterFactory to test in a SparseGridMiner It offers access to different hyperparameter optimization procedures |
CKDEMaximumLikelihoodCrossValidation | |
CKernel | |
CKernelDensityEstimator | |
CLearner | This class implements standard sparse grid regression with an arbitrary regularization operator |
CLearnerBase | Abstract class that implements a regression/classification learner based on spatial adaptive Sparse Grids |
CLearnerBaseSP | Abstract class that implements a regression/classification learner based on spatial adaptive Sparse Grids |
CLearnerConfiguration | Structure that contains information about the learners behaviour |
CLearnerLeastSquaresIdentity | This class implements standard sparse grid regression with an Identity matrix as regularization operator |
CLearnerScenario | |
CLearnerSGD | LearnerSGD learns the data using stochastic gradient descent |
CLearnerSGDE | |
CLearnerSGDEConfiguration | |
CLearnerSGDEOnOffParallel | LearnerSGDEOnOffParallel learns the data using sparse grid density estimation |
CLearnerSVM | LearnerSVM learns the data using support vector machines and sparse grid kernels |
CLearnerTiming | Strcut to encapsulate the learner's timings during training |
CLearnerVectorizedPerformance | Struct that defines return for calculation the performance of a vectorized learner |
CLearnerVectorizedPerformanceCalculator | Class that provides functionality in order to determine a LearnerVectorized's performance |
CLeastSquaresRegressionFitterFactory | Concrete factory to build instances of sgpp::datadriven::ModelFittingLeastSquares |
CLeastSquaresRegressionMinerFactory | Concrete Factory that builds an instance of sgpp::datadriven::SparseGridMiner for Least Squares Regression |
CLevelIndexPair | Pair to hold the level and the index of a grid point in one dimension |
CLogDensitySystemMatrix | Class that implements the virtual class OperationMatrix for the application of classification for the Systemmatrix by using a density function |
CMakePositiveConfiguration | |
CMatrixDecompositionTypeParser | |
CMaximumLikelihoodCrossValidation | |
CMergeGridNetworkMessage | Packet wrapper in MPI_Packet containing segmented data from the alpha vector of the trained system |
CMessageTrackRequest | Structure that holds data for pending tracking requests that need to be checked against incoming messages |
CMetaLearner | |
CMetric | We use metrics to quantify approximation quality of a trained model |
CMinerFactory | Abstract factory to build different kinds of Miners based on a configuration which is parsed from a file |
CModelFittingBase | Base class for arbitrary machine learning models based on adaptive sparse grids |
CModelFittingBaseSingleGrid | Base class for models operating on a single grid (i.e |
CModelFittingClassification | Fitter object that encapsulates density based classification using instances of ModelFittingDensityEstimation for each class |
CModelFittingDensityEstimation | Abstract super class to encapsulate density estimation models such as using offline/-online splitting or conjugate gradients in order to solve the system |
CModelFittingDensityEstimationCG | Fitter object that encapsulates the usage of sparse grid density estimation with identity as regularization |
CModelFittingDensityEstimationOnOff | Fitter object that encapsulates the usage of sparse grid density estimation with identity as regularization |
CModelFittingLeastSquares | Fitter object that encapsulates the usage of sparse grid based regression with identity as regularization |
CMortonOrder | |
CMPI_Packet | A packet sent over MPI, using a command as a descriptor, and a wrapped package in the payload for data |
CMPIMethods | |
CMPIRequestPool | |
CMPITaskScheduler | |
CMSE | Metric that quantifies the difference between predicted values and actual values in terms of mean squared error (MSE) |
CMultiGridRefinementFunctor | Abstract super-class for refinement functors operating on multiple grids |
CMultipleClassRefinementFunctor | Multiple class refinement is based on the zero-crossing based refinement |
CMultiSurplusRefinementFunctor | Wrapper of SurplusRefinementFunctor for multi grid scenarios |
CNearestNeighbors | The NearestNeighbors class |
CNegativeLogLikelihood | Metric that quantifies the likelihood of a dataset given the density function |
COperationCovariance | This class provides the covariance matrix a sparse grid function |
COperationDensityConditional | Conditionalize Probability Density Function |
COperationDensityConditionalKDE | |
COperationDensityConditionalLinear | Marginalize Probability Density Function |
COperationDensityMarginalize | Marginalize Probability Density Function |
COperationDensityMarginalizeKDE | Marginalize Probability Density Function |
COperationDensityMarginalizeLinear | Marginalize Probability Density Function |
COperationDensityMargTo1D | Marginalize Probability Density Function |
COperationDensityRejectionSampling | Sampling on all dimensions |
COperationDensityRejectionSamplingLinear | Sampling with rejection sampling method |
COperationDensitySampling | Sampling on all dimensions |
COperationDensitySampling1D | Sample 1D Probability Density Function |
COperationDensitySampling1DLinear | |
COperationDensitySamplingLinear | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationDotProductLinear | |
COperationDotProductModLinear | |
COperationInverseRosenblattTransformation | Sampling on all dimensions |
COperationInverseRosenblattTransformation1DBspline | |
COperationInverseRosenblattTransformation1DBsplineBoundary | |
COperationInverseRosenblattTransformation1DBsplineClenshawCurtis | |
COperationInverseRosenblattTransformation1DLinear | |
COperationInverseRosenblattTransformation1DModBspline | |
COperationInverseRosenblattTransformation1DModBsplineClenshawCurtis | |
COperationInverseRosenblattTransformation1DModPoly | |
COperationInverseRosenblattTransformation1DModPolyClenshawCurtis | |
COperationInverseRosenblattTransformation1DPoly | |
COperationInverseRosenblattTransformation1DPolyBoundary | |
COperationInverseRosenblattTransformation1DPolyClenshawCurtis | |
COperationInverseRosenblattTransformation1DPolyClenshawCurtisBoundary | |
COperationInverseRosenblattTransformationBspline | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationBsplineBoundary | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationBsplineClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationKDE | Do inverse transformation in all dimensions |
COperationInverseRosenblattTransformationLinear | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationModBspline | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationModBsplineClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationModPoly | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationModPolyClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationPoly | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationPolyBoundary | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationPolyClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationInverseRosenblattTransformationPolyClenshawCurtisBoundary | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationLimitFunctionValueRange | |
COperationMakePositive | This class enforces the function value range of a sparse grid function to be larger than 0 |
COperationMakePositiveCandidateSetAlgorithm | |
COperationMakePositiveFindIntersectionCandidates | |
COperationMakePositiveFindIntersectionCandidatesJoin | |
COperationMakePositiveHybridFindIntersectionCandidates | |
COperationMakePositiveInterpolateBoundaryOfSupport | |
COperationMakePositiveInterpolateExp | |
COperationMakePositiveInterpolateFunction | |
COperationMakePositiveInterpolationAlgorithm | |
COperationMakePositiveLoadFullGridCandidates | |
COperationMakePositiveSetToZero | |
COperationMultiEvalCuda | OperationMultipleEval for polynomial basis functions (grad >= 2) using CUDA on grids without boundary nodes |
COperationMultiEvalHPX | This class is a HPX wrapper for other MultiEval-operations that uses a very simple master-slave distributed processing |
COperationMultiEvalModMaskStreaming | |
COperationMultiEvalMPI | This class is a MPI wrapper for other MultiEval-operations that uses a very simple master-slave MPI parallelization |
COperationMultiEvalStreaming | |
COperationMultiEvalStreamingBSplineOCL | |
COperationMultiEvalStreamingModOCLFastMultiPlatform | |
COperationMultiEvalStreamingModOCLMaskMultiPlatform | |
COperationMultiEvalStreamingModOCLOpt | |
COperationMultiEvalStreamingModOCLUnified | |
COperationMultipleEvalConfiguration | |
COperationMultipleEvalMatrix | Wrapper class for matrix multiplication for use in solver |
COperationMultipleEvalSubspaceCombined | Multiple evaluation operation that uses the subspace structure to save work compared to the naive or streaming variants |
COperationMultipleEvalSubspaceSimple | Multiple evaluation operation that uses the subspace structure to save work compared to the naive or streaming variants |
COperationPiecewiseConstantRegression | |
COperationRegularizationDiagonal | Implementation of the application of a diagonal matrix to a DataVector for regularization |
COperationRegularizationDiagonalLinearBoundary | Implementation of the application of a diagonal matrix to a DataVector for regularization |
COperationRosenblattTransformation | Sampling on all dimensions |
COperationRosenblattTransformation1DBspline | |
COperationRosenblattTransformation1DBsplineBoundary | |
COperationRosenblattTransformation1DBsplineClenshawCurtis | |
COperationRosenblattTransformation1DLinear | |
COperationRosenblattTransformation1DModBspline | |
COperationRosenblattTransformation1DModBsplineClenshawCurtis | |
COperationRosenblattTransformation1DModPoly | |
COperationRosenblattTransformation1DModPolyClenshawCurtis | |
COperationRosenblattTransformation1DPoly | |
COperationRosenblattTransformation1DPolyBoundary | |
COperationRosenblattTransformation1DPolyClenshawCurtis | |
COperationRosenblattTransformation1DPolyClenshawCurtisBoundary | |
COperationRosenblattTransformationBspline | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationBsplineBoundary | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationBsplineClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationKDE | Do transformation in all dimensions |
COperationRosenblattTransformationLinear | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationModBspline | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationModBsplineClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationModPoly | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationModPolyClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationPoly | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationPolyBoundary | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationPolyClenshawCurtis | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationRosenblattTransformationPolyClenshawCurtisBoundary | Keep applying marginalize to function until it's reduced to only 1 dimension |
COperationTest | Operation the tests the function that is applied the current Sparse sgpp::base::Grid at a given point |
COperationTestLinear | This class implements OperationTest for a grids with linear basis ansatzfunctions without boundaries |
COperationTestLinearBoundary | This class implements OperationTest for a grids with linear basis ansatzfunctions with boundaries |
COperationTestLinearStretched | This class implements OperationTest for a grids with linearstretched basis ansatzfunctions without boundaries |
COperationTestLinearStretchedBoundary | This class implements OperationTest for a grids with linear basis ansatzfunctions with boundaries |
COperationTestModBspline | This class implements OperationTest for a grids with modified bspline basis functions with a certain degree |
COperationTestModLinear | This class implements sgpp::base::OperationEval for a grids with mod linear basis ansatzfunctions with |
COperationTestModPoly | This class implements OperationTest for a grids with mod poly basis ansatzfunctions with |
COperationTestModWavelet | This class implements OperationTest for a grid with mod wavelet basis ansatzfunctions |
COperationTestPoly | This class implements OperationTest for a grids with poly basis ansatzfunctions with |
COperationTestPrewavelet | This class implements OperationTest for a grids with prewavelet basis ansatzfunctions without boundaries |
COperationTransformation1D | Sample 1D Probability Density Function |
CPartitioningTool | The methods in this class calculate size and offset of a segment for a partition of a domain |
CPendingMPIRequest | |
CPiecewiseConstantSmoothedRegressionSystemMatrix | Class that implements the virtual class OperationMatrix for the application of classification for the Systemmatrix by using a density function |
CPrimalDualSVM | Implementation of a support vector machine in primal formulation which additionally stores support vectors |
CRefinementFunctorTypeParser | |
CRefinementHandler | |
CRefinementMonitor | Superclass for refinement monitors |
CRefinementMonitorConvergence | A monitor to decide if a learning algorithm has converged |
CRefinementMonitorFactory | Factory to create refinement monitors |
CRefinementMonitorPeriodic | A monitor that decides whether refinements should be performed using a simple periodic approach: After at least a certain amount of instances has arrived, the monitor will allow a new refinement |
CRefinementResult | Structure to hold the grid modifications for a refinement cycle for one class |
CRefinementResultNetworkMessage | Packet wrapped in an UPDATE_GRID MPI_Packet, containing segmented changes for a specified class |
CRefinementResultSystemMatrixNetworkMessage | Packet wrapped in a RefinementResultNetwork Message that contains additional information required when updating the system matrix |
►CRegressionLearner | The RegressionLearner class Solves a regression problem with continuous target vector |
CSolver | |
CRegularizationConfiguration | |
CRegularizationTypeParser | |
CRosenblattTransformation | |
CRosenblattTransformationConfig | Configuration structure for Rosenblatt transformation including default values |
CRoundRobinScheduler | |
CRuleOfThumb | |
CSampleProvider | SampleProvider is an abstraction for object that provide sample data from various sources for example datasets from files (ARFF, CSV) or synthetic datasets generated by sampling functions ( Friedmann datasets) |
CScorer | Base class for supervised learning used to fit a model and quantify accuracy using a sgpp::datadriven::Metric with either testing or cross validation |
CScorerConfiguration | Set of parameters to define a scorer instance |
CScorerFactory | Factory to build the scorer |
CScorerMetricTypeParser | Convenience class to convert strings to sgpp::datadriven::ScorerMetricType and generate string representations for values of sgpp::datadriven::ScorerMetricType |
CScottsRule | |
CSGDEConfiguration | |
CSilvermansRule | |
CSLESolverTypeParser | Convenience class to convert strings to sgpp::solver::SLESolverType and generate string representations for values of sgpp::solver::SLESolverType |
CSortedDataset | Dataset that can be ordered. Accessing the included DataMatrix might invalidate the order |
CSparseGridDensityEstimator | |
CSparseGridDensityEstimatorConfiguration | |
CSparseGridMiner | SparseGridMiner models the entire mining process for data mining with sparse grids |
CSparseGridMinerCrossValidation | SparseGridMinerCrossValidation models a datamining process that involves cross validation to validate the accuracy of the model itself |
CSparseGridMinerSplitting | SparseGridMiner models a datamining process that involves a dataset that is first split into validation and training data |
CStreamingBSplineOCLKernelImpl | |
CStreamingBSplineOCLKernelSourceBuilder | |
CStringTokenizer | |
CSubspaceNodeCombined | |
CSubspaceNodeSimple | |
CSystemMatrixLeastSquaresIdentity | Class that implements the virtual class base::OperationMatrix for the application of classification for the Systemmatrix |
CTestsetConfiguration | |
CTunableParameter | |
CUniversalMinerFactory | Concrete Factory that builds an instance of sgpp::datadriven::SparseGridMiner for the fitting task specified by the configuration |
CZeroCrossingRefinementFunctor | Zero-crossing-based refinement uses zero crossings of the difference PDFS f_1 - f_2 to determine areas of interest for the refinement process |
►Noptimization | |
►Noptimizer | |
CAdaptiveGradientDescent | Gradient descent with adaptive step size |
CAdaptiveNewton | Newton method with adaptive step size |
CAugmentedLagrangian | Augmented Lagrangian method for constrained optimization |
CBFGS | BFGS method for unconstrained optimization |
CCMAES | Gradient-free CMA-ES method |
CConstrainedOptimizer | Abstract class for solving constrained optimization problems |
CDifferentialEvolution | Gradient-free Differential Evolution method |
CGradientDescent | Gradient-based method of steepest descent |
CLeastSquaresOptimizer | Abstract class for solving non-linear least squares problems |
CLevenbergMarquardt | Levenberg-Marquardt algorithm for least squares optimization |
CLogBarrier | Log Barrier method for constrained optimization |
CMultiStart | Meta optimization algorithm calling local algorithm multiple times |
CNelderMead | Gradient-free Nelder-Mead method |
CNewton | Gradient-based nonlinear conjugate gradient method |
CNLCG | Gradient-based nonlinear conjugate gradient method |
CRprop | Rprop method for unconstrained optimization |
CSquaredPenalty | Squared Penalty method for constrained optimization |
CUnconstrainedOptimizer | Abstract class for optimizing objective functions |
►Nsle_solver | |
CArmadillo | Linear system solver using Armadillo (direct full solver) |
CAuto | Automatic choice of external linear solver |
CBiCGStab | Linear system solver implementing the iterative BiCGStab method |
CEigen | Linear system solver using Eigen (direct full solver) |
CGaussianElimination | Linear system solver implementing the direct Gaussian elimination |
CGmmpp | Linear system solver using Gmm++ (iterative sparse solver) |
CSLESolver | Abstract class for solving systems of linear equations |
CUMFPACK | Linear system solver using UMFPACK (direct sparse solver) |
►Ntest_problems | |
CAbsoluteValue | Absolute value unconstrained test problem |
CAbsoluteValueObjective | Absolute value objective function |
CAckley | Ackley unconstrained test problem |
CAckleyObjective | Ackley objective function |
CBeale | Beale unconstrained test problem |
CBealeObjective | Beale objective function |
CBranin | Branin unconstrained test problem |
CBraninObjective | Branin objective function |
CBubbleWrap | Bubble wrap unconstrained test problem |
CBubbleWrapObjective | Bubble wrap objective function |
CConstrainedTestProblem | Base class for analytical, constrained test problems |
CEasomYang | Easom-Yang unconstrained test problem |
CEasomYangObjective | Easom-Yang objective function |
CEggholder | Eggholder unconstrained test problem |
CEggholderObjective | Eggholder objective function |
CFloudas | Floudas constrained test problem |
CFloudasEqualityConstraint | Floudas equality constraint function |
CFloudasInequalityConstraint | Floudas inequality constraint function |
CFloudasObjective | Floudas objective function |
CG03 | G03 constrained test problem |
CG03EqualityConstraint | G03 equality constraint function |
CG03InequalityConstraint | G03 inequality constraint function |
CG03Objective | G03 objective function |
CG04 | G04 constrained test problem |
CG04EqualityConstraint | G04 equality constraint function |
CG04InequalityConstraint | G04 inequality constraint function |
CG04Objective | G04 objective function |
CG05 | G05 constrained test problem |
CG05EqualityConstraint | G05 equality constraint function |
CG05InequalityConstraint | G05 inequality constraint function |
CG05Objective | G05 objective function |
CG06 | G06 constrained test problem |
CG06EqualityConstraint | G06 equality constraint function |
CG06InequalityConstraint | G06 inequality constraint function |
CG06Objective | G06 objective function |
CG08 | G08 constrained test problem |
CG08EqualityConstraint | G08 equality constraint function |
CG08InequalityConstraint | G08 inequality constraint function |
CG08Objective | G08 objective function |
CG09 | G09 constrained test problem |
CG09EqualityConstraint | G09 equality constraint function |
CG09InequalityConstraint | G09 inequality constraint function |
CG09Objective | G09 objective function |
CG10 | G10 constrained test problem |
CG10EqualityConstraint | G10 equality constraint function |
CG10InequalityConstraint | G10 inequality constraint function |
CG10Objective | G10 objective function |
CG11 | G11 constrained test problem |
CG11EqualityConstraint | G11 equality constraint function |
CG11InequalityConstraint | G11 inequality constraint function |
CG11Objective | G11 objective function |
CG12 | G12 constrained test problem |
CG12EqualityConstraint | G12 equality constraint function |
CG12InequalityConstraint | G12 inequality constraint function |
CG12Objective | G12 objective function |
CG13 | G13 constrained test problem |
CG13EqualityConstraint | G13 equality constraint function |
CG13InequalityConstraint | G13 inequality constraint function |
CG13Objective | G13 objective function |
CGoldsteinPrice | Goldstein-Price unconstrained test problem |
CGoldsteinPriceObjective | Goldstein-Price objective function |
CGriewank | Griewank unconstrained test problem |
CGriewankObjective | Griewank objective function |
CHartman3 | Hartman3 unconstrained test problem |
CHartman3Objective | Hartman3 objective function |
CHartman6 | Hartman6 unconstrained test problem |
CHartman6Objective | Hartman6 objective function |
CHimmelblau | Himmelblau unconstrained test problem |
CHimmelblauObjective | Himmelblau objective function |
CHoelderTable | Hoelder table unconstrained test problem |
CHoelderTableObjective | Hoelder table objective function |
CIncreasingPower | Increasing power unconstrained test problem |
CIncreasingPowerObjective | Increasing power objective function |
CMichalewicz | Michalewicz unconstrained test problem |
CMichalewiczObjective | Michalewicz objective function |
CMladineo | Mladineo unconstrained test problem |
CMladineoObjective | Mladineo objective function |
CPerm | Perm unconstrained test problem |
CPermObjective | Perm objective function |
CRastrigin | Rastrigin unconstrained test problem |
CRastriginObjective | Rastrigin objective function |
CRosenbrock | Rosenbrock unconstrained test problem |
CRosenbrockObjective | Rosenbrock objective function |
CSchwefel | Schwefel unconstrained test problem |
CSchwefelObjective | Schwefel objective function |
CSHCB | SHCB unconstrained test problem |
CSHCBObjective | SHCB objective function |
CSimionescu | Simionescu constrained test problem |
CSimionescuEqualityConstraint | Simionescu equality constraint function |
CSimionescuInequalityConstraint | Simionescu inequality constraint function |
CSimionescuObjective | Simionescu objective function |
CSoland | Soland constrained test problem |
CSolandEqualityConstraint | Soland equality constraint function |
CSolandInequalityConstraint | Soland inequality constraint function |
CSolandObjective | Soland objective function |
CSphere | Sphere unconstrained test problem |
CSphereObjective | Sphere objective function |
CTestScalarFunction | Base class for analytical objective function examples ("test functions") |
CTestVectorFunction | Base class for analytical constraint function examples ("test functions") |
CTremblingParabola | Trembling parabola unconstrained test problem |
CTremblingParabolaObjective | Trembling parabola objective function |
CUnconstrainedTestProblem | Base class for analytical, unconstrained test problems |
CCloneableSLE | Abstract class for "cloneable" linear systems |
CComponentScalarFunction | One component of a vector-valued function |
CComponentScalarFunctionGradient | One component of a vector-valued function gradient |
CComponentScalarFunctionHessian | One component of a vector-valued function Hessian |
CEmptyVectorFunction | Singleton containing an empty implementation of VectorFunction |
CEmptyVectorFunctionGradient | Singleton containing an empty implementation of VectorFunctionGradient |
CFullSLE | Full linear system, essentially a wrapper around base::DataMatrix |
CHashRefinementMultiple | Descendant of base::HashRefinement refining without the generation of hierarchical ancestors |
CHierarchisationSLE | Linear system of the hierarchization in a sparse grid |
CInterpolantScalarFunction | Sparse grid interpolant of a scalar-valued function |
CInterpolantScalarFunctionGradient | Sparse grid interpolant gradient of a scalar-valued function |
CInterpolantScalarFunctionHessian | Sparse grid interpolant Hessian of a scalar-valued function |
CInterpolantVectorFunction | Sparse grid interpolant of a vector-valued function |
CInterpolantVectorFunctionGradient | Sparse grid interpolant gradient of a vector-valued function |
CInterpolantVectorFunctionHessian | Sparse grid interpolant Hessian of a vector-valued function |
CIterativeGridGenerator | Abstract base class for iterative grid generation methods |
CIterativeGridGeneratorLinearSurplus | Iterative grid generation based on linear surplusses |
CIterativeGridGeneratorRitterNovak | Iterative grid generation based on Ritter/Novak's refinement criterion |
CIterativeGridGeneratorSOO | Iterative grid generator using simultaneous optimistic optimization (SOO) |
CMutexType | Wrapper for OpenMP nested locks |
COperationMultipleHierarchisation | Abstract operation for hierarchization and dehierarchization for multiple sets of function values at the grid nodes |
COperationMultipleHierarchisationBspline | Hierarchisation operation for B-spline basis functions on Noboundary grids |
COperationMultipleHierarchisationBsplineBoundary | Hierarchisation operation for B-spline basis functions on Boundary grids |
COperationMultipleHierarchisationBsplineClenshawCurtis | Hierarchisation operation for B-spline basis functions on Clenshaw-Curtis grids |
COperationMultipleHierarchisationFundamentalSpline | Hierarchisation operation for B-spline basis functions on Noboundary grids |
COperationMultipleHierarchisationLinear | Hierarchisation operation for linear basis functions on Noboundary grids |
COperationMultipleHierarchisationLinearBoundary | Hierarchisation operation for linear basis functions on Boundary grids |
COperationMultipleHierarchisationLinearClenshawCurtis | Hierarchisation operation for linear basis functions on Clenshaw-Curtis grids |
COperationMultipleHierarchisationModBspline | Hierarchisation operation for modified B-spline basis functions on Noboundary grids |
COperationMultipleHierarchisationModBsplineClenshawCurtis | Hierarchisation operation for modified B-spline basis functions on Noboundary grids |
COperationMultipleHierarchisationModFundamentalSpline | Hierarchisation operation for modified B-spline basis functions on Noboundary grids |
COperationMultipleHierarchisationModLinear | Hierarchisation operation for modified linear basis functions on Noboundary grids |
COperationMultipleHierarchisationModWavelet | Hierarchisation operation for modified wavelet basis functions on Noboundary grids |
COperationMultipleHierarchisationWavelet | Hierarchisation operation for wavelet basis functions on Noboundary grids |
COperationMultipleHierarchisationWaveletBoundary | Hierarchisation operation for wavelet basis functions on Boundary grids |
CPrinter | Singleton class to facilitate debugging output |
CRandomNumberGenerator | Singleton class for generating pseudo-random numbers (wrapper around std::mt19937 from <random>) |
CScalarFunction | Abstract base class for scalar-valued functions \(f\colon [0, 1]^d \to \mathbb{R}\) (e.g., objective functions in optimization) |
CScalarFunctionGradient | Abstract base class for scalar-valued functions \(f\colon [0, 1]^d \to \mathbb{R}\) together with their gradients \(\nabla f\colon [0, 1]^d \to \mathbb{R}^d\) (e.g., gradients of objective functions in optimization) |
CScalarFunctionHessian | Abstract base class for scalar-valued functions \(f\colon [0, 1]^d \to \mathbb{R}\) together with their gradients \(\nabla f\colon [0, 1]^d \to \mathbb{R}^d\) and Hessians \(H_f\colon [0, 1]^d \to \mathbb{R}^{d \times d}\) (e.g., Hessians of objective functions in optimization) |
CScopedLock | Wrapper around MutexType which locks and unlocks upon construction/destruction |
CSLE | Abstract class representing a system of linear equations |
CVectorFunction | Abstract base class for vector-valued functions \(g\colon [0, 1]^d \to \mathbb{R}^m\) (e.g., equality/inequality constraints \(g(\vec{x}) \le \vec{0}\) or \(g(\vec{x}) = \vec{0}\) in optimization) |
CVectorFunctionGradient | Abstract base class for vector-valued functions \(g\colon [0, 1]^d \to \mathbb{R}^m\) together with their Jacobians \(\nabla g\colon [0, 1]^d \to \mathbb{R}^{m \times d}\), i.e |
CVectorFunctionHessian | Abstract base class for vector-valued functions \(g\colon [0, 1]^d \to \mathbb{R}^m\) together with their Jacobians \(\nabla g\colon [0, 1]^d \to \mathbb{R}^{m \times d}\), i.e |
CWrapperScalarFunction | Implementation of ScalarFunction that wraps a std::function object |
CWrapperScalarFunctionGradient | Implementation of ScalarFunctionGradient that wraps a std::function object |
CWrapperScalarFunctionHessian | Implementation of ScalarFunctionHessian that wraps a std::function object |
CWrapperVectorFunction | Implementation of VectorFunction that wraps a std::function object |
CWrapperVectorFunctionGradient | Implementation of VectorFunctionGradient that wraps a std::function object |
CWrapperVectorFunctionHessian | Implementation of VectorFunctionHessian that wraps a std::function object |
►Npde | |
CDowndPhidPhiBBIterativeLinear | This class is helper class to implement the complete Down of following bilinearform \(\int_{x} \frac{\partial \phi(x)}{x} \frac{\partial \phi(x)}{x} dx\) for a given dimension by an iterative algorithms on adaptive Sparse Grids with linear ansatzfunctions without boundaries |
CDowndPhidPhiBBIterativeLinearBoundary | This class is helper class to implement the complete Down of following bilinearform \(\int_{x} \frac{\partial \phi(x)}{x} \frac{\partial \phi(x)}{x} dx\) for a given dimension by an iterative algorithms on adaptive Sparse Grids with linear ansatzfunctions with boundaries |
CDowndPhidPhiBBIterativeLinearStretched | This class is helper class to implement the complete Down of following bilinearform \(\int_{x} \frac{\partial \phi(x)}{x} \frac{\partial \phi(x)}{x} dx\) for a given dimension by an iterative algorithms on adaptive Sparse Grids with linear ansatzfunctions without boundaries |
CDowndPhidPhiBBIterativeLinearStretchedBoundary | This class is helper class to implement the complete Down of following bilinearform \(\int_{x} \frac{\partial \phi(x)}{x} \frac{\partial \phi(x)}{x} dx\) for a given dimension by an iterative algorithms on adaptive Sparse Grids with linear ansatzfunctions with boundaries |
CdPhidPhiDownModLinear | Implementation of sweep operator (): 1D Down for Bilinearform \(\int_{x} \frac{\partial \phi(x)}{\partial x} \frac{\partial \phi(x)}{\partial x} dx\) on mod-linear grids |
CdPhidPhiUpModLinear | Implementation of sweep operator (): 1D Up for Bilinearform \(\int_{x} \frac{\partial \phi(x)}{\partial x} \frac{\partial \phi(x)}{\partial x} dx\) on mod-linear grids |
CEllipticPDESolver | This class extends the PDESolver with functions that are needed to solve elliptic PDEs |
CHeatEquationParabolicPDESolverSystem | This class implements the ParabolicPDESolverSystem for the Heat Equation |
CHeatEquationParabolicPDESolverSystemParallelOMP | This class implements the ParabolicPDESolverSystem for the Heat Equation |
CHeatEquationSolver | This class provides a simple-to-use solver of the multi dimensional Heat Equation on Sparse Grids |
CHeatEquationSolverWithStretching | This class provides a simple-to-use solver of the multi dimensional Heat Equation that uses Sparse Grids |
CLaplaceDownGradientPrewavelet | Implements the downGradient Method needed for the Laplace operator on prewavelet grids |
CLaplaceEnhancedDownBBLinear | Implementation of sweep operator () for enhanced Laplace operator, down operation |
CLaplaceEnhancedDownBBLinearBoundary | Implementation of sweep operator () for enhanced Laplace operator, down operation |
CLaplaceEnhancedUpBBLinear | Implementation of sweep operator () for enhanced Laplace operator, up operation |
CLaplaceEnhancedUpBBLinearBoundary | Implementation of sweep operator () for enhanced Laplace operator, up operation |
CLaplaceUpGradientPrewavelet | Implements the upGradient Method needed for the Laplace operator on prewavelet grids |
CLaplaceUpPrewavelet | Implements the down Method needed for the Laplace operator on prewavelet grids |
COperationEllipticPDESolverSystem | Abstract definition of a System that is used to solve elliptic partial differential equations |
COperationEllipticPDESolverSystemDirichlet | Defines a System that is used to solve elliptic partial differential equations |
COperationEllipticPDESolverSystemFreeBoundaries | Defines a System that is used to solve elliptic partial differential equations |
COperationLaplaceBspline | Implementation for Bspline functions of Laplace Operation, bspline grids without boundaries |
COperationLaplaceBsplineBoundary | Implementation for BsplineBoundary functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceBsplineClenshawCurtis | Implementation for BsplineClenshawCurtis functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceEnhancedLinear | Implements the Laplace operator based on the UpDownOneOpDimEnhanced method |
COperationLaplaceEnhancedLinearBoundary | Implements the Laplace operator based on the UpDownOneOpDimEnhanced method |
COperationLaplaceExplicitBspline | Implementation for B-spline functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceExplicitLinear | Implementation for B-spline functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceExplicitModBspline | Implementation for B-spline functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceLinear | Implementation for linear functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceLinearBoundary | Implementation of Laplace for linear functions with boundaries |
COperationLaplaceLinearStretched | Implementation for linear functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceLinearStretchedBoundary | Implementation of Laplace for linear functions with boundaries |
COperationLaplaceModBspline | Implementation for ModBspline functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceModBsplineClenshawCurtis | Implementation for ModBsplineClenshawCurtis functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceModLinear | Implementation of Laplace for mod linear functions |
COperationLaplaceModPoly | Implementation for ModPoly functions of Laplace Operation, linear grids without boundaries |
COperationLaplaceModPolyClenshawCurtis | Implementation for ModPolyClenshawCurtis functions of Laplace Operation, linear grids without boundaries |
COperationLaplacePoly | Implementation for Poly functions of Laplace Operation, linear grids without boundaries |
COperationLaplacePolyBoundary | Implementation for PolyBoundary functions of Laplace Operation, linear grids without boundaries |
COperationLaplacePolyClenshawCurtis | Implementation for PolyClenshawCurtis functions of Laplace Operation, linear grids without boundaries |
COperationLaplacePolyClenshawCurtisBoundary | Implementation for PolyClenshawCurtisBoundary functions of Laplace Operation, linear grids without boundaries |
COperationLaplacePrewavelet | Implementation for linear functions of Laplace Operation, prewavelet grids without boundaries |
COperationLTwoDotProductLinear | Implements the standard L 2 scalar product on linear grids (no boundaries) |
COperationLTwoDotProductLinearBoundary | Implements the standard L 2 scalar product on linear boundary grids |
COperationLTwoDotProductLinearStretched | Implements the standard L 2 scalar product on linear grids (no boundaries) |
COperationLTwoDotProductLinearStretchedBoundary | Implements the standard L 2 scalar product on linear boundary grids |
COperationMatrixLTwoDotBspline | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotBsplineBoundary | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotBsplineClenshawCurtis | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotExplicitBspline | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitBsplineBoundary | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitBsplineClenshawCurtis | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitLinear | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitLinearBoundary | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitModBspline | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitModBsplineClenshawCurtis | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitModifiedLinear | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitModLinear | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitModPoly | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitModPolyClenshawCurtis | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitPeriodic | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitPoly | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitPolyBoundary | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitPolyClenshawCurtis | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary | Explicit representation of the matrix \((\Phi_i,\Phi_j)_{L2}\) for a sparse grid |
COperationMatrixLTwoDotModBspline | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotModBsplineClenshawCurtis | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotModLinear | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotModPoly | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotModPolyClenshawCurtis | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotPeriodic | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotPoly | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotPolyBoundary | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotPolyClenshawCurtis | Implements the standard L 2 scalar product on periodic grids |
COperationMatrixLTwoDotPolyClenshawCurtisBoundary | Implements the standard L 2 scalar product on periodic grids |
COperationParabolicPDESolverSystemDirichlet | Defines a System that is used to solve parabolic partial differential equations |
COperationParabolicPDESolverSystemFreeBoundaries | Defines a System that is used to solve parabolic partial differential equations |
CParabolicPDESolver | This class extends the PDESolver with functions that are needed to solve parabolic PDEs |
CPDESolver | This class provides defines a implements basic task and tools which are useful while solving PDEs |
CPhiPhiDownBBLinear | Implementation of sweep operator (): 1D Down for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) |
CPhiPhiDownBBLinearBoundary | Implementation of sweep operator (): 1D Down for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) on linear boundary grids |
CPhiPhiDownBBLinearStretched | Implementation of sweep operator (): 1D Down for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) |
CPhiPhiDownBBLinearStretchedBoundary | Implementation of sgpp::base::sweep operator (): 1D Down for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) on linear boundary grids |
CPhiPhiDownModLinear | Implementation of sweep operator (): 1D Down for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) on mod-linear grids |
CPhiPhiUpBBLinear | Implementation of sweep operator (): 1D Up for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) |
CPhiPhiUpBBLinearBoundary | Implementation of sweep operator (): 1D Up for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) on linear boundary grids |
CPhiPhiUpBBLinearStretched | Implementation of sweep operator (): 1D Up for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) |
CPhiPhiUpBBLinearStretchedBoundary | Implementation of sgpp::base::sweep operator (): 1D Up for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) on linear boundary grids |
CPhiPhiUpModLinear | Implementation of sweep operator (): 1D Up for Bilinearform \(\int_{x} \phi(x) \phi(x) dx\) on mod-linear grids |
CPoissonEquationEllipticPDESolverSystemDirichlet | This class uses OperationEllipticPDESolverSystemDirichlet to define a solver system for the Poission Equation |
CPoissonEquationSolver | This class provides a simple-to-use solver of the multi dimensional Poisson Equation on Sparse Grids |
CStdUpDown | Implements a standard Up/Down Schema without any operation dim |
CUpDownFourOpDims | Implements the Up/Down scheme with four dimensions with special operations: i,j,k,l |
CUpDownOneOpDim | Implements the Up/Down scheme with one dimension with a special operation |
CUpDownOneOpDimEnhanced | Implements a modified Up/Down Schema with one operation dim |
CUpDownOneOpDimWithShadow | Implements the Up/Down scheme with one dimension with a special operation |
CUpDownTwoOpDims | Implements the Up/Down scheme with two dimensions with special operations: i,j |
CUpdPhidPhiBBIterativeLinearBoundary | This class is helper class to implement the complete Up of following bilinearform \(\int_{x} \frac{\partial \phi(x)}{x} \frac{\partial \phi(x)}{x} dx\) for a given dimension by an iterative algorithms on adaptive Sparse Grids with linear ansatzfunctions with boundaries |
CUpdPhidPhiBBIterativeLinearStretchedBoundary | This class is helper class to implement the complete Up of following bilinearform \(\int_{x} \frac{\partial \phi(x)}{x} \frac{\partial \phi(x)}{x} dx\) for a given dimension by an iterative algorithms on adaptive Sparse Grids with linear ansatzfunctions with boundaries |
►Nquadrature | |
CHaltonSampleGenerator | |
CLatinHypercubeSampleGenerator | The class NaiveSampleGenerator implements a simple MonteCarlo sample generator |
CNaiveSampleGenerator | The class NaiveSampleGenerator implements a simple MonteCarlo sample generator |
COperationQuadratureMCAdvanced | Quadrature on any sparse grid (that has OperationMultipleEval implemented) using various Monte Carlo Methods (Advanced) |
CRandom | Wraps the random generator to use |
CSampleGenerator | Base class for all types of MonteCarlo sample generators used in SGPP |
CStratifiedSampleGenerator | The class StratifiedSampleGenerator subdivides every dimension in a given number of strata |
►Nsolver | |
CAdamsBashforth | This class implements the explicit Adams-Bashforth method for solving ordinary partial equations |
CBiCGStab | |
CBiCGStabSP | |
CConjugateGradients | |
CConjugateGradientsSP | |
CCrankNicolson | This class implements the Crank-Nicolson method for solving ordinary partial equations |
CElasticNetFunction | The ElasticNetFunction class |
CEuler | This class implements the explicit and implicit Euler method for solving ordinary partial equations |
CFista | Fast Iterative Shrinkage Tresholding Algorithm is a solver for least-squares problems |
CFistaBase | |
CGroupLassoFunction | The GroupLassoFunction class |
CLassoFunction | The LassoFunction class |
CODESolver | |
COperationParabolicPDESolverSystem | Abstract definition of a System that is used to solve parabolic partial differential equations |
CRegularizationFunction | Baseclass for regularization functions that can be used in conjunction with a proximal solver |
CRidgeFunction | The RidgeFunction class |
CSGSolver | Abstract class that defines a solver used in Sparse Grids Applications |
CSGSolverSP | Abstract class that defines a solver used in Sparse Grids Applications |
CSLESolver | |
CSLESolverConfiguration | |
CSLESolverSP | |
CSLESolverSPConfiguration | |
CStepsizeControl | This class implements a step size control using Adams-Bashforth and Crank-Nicolson for solving ordinary partial equations |
CStepsizeControlBDF | This class implements a step size control using the midpoint method and BDF2 for solving ordinary partial equations |
CStepsizeControlEJ | This class implements a time step size control using 1D-Diffusion for solving ordinary partial equations |
CStepsizeControlH | This class implements a step size control using Crank-Nicolson with different step sizes for solving ordinary partial equations |
CStepsizeControlMC | This class implements a step size control using Adams-Bashforth and Crank-Nicolson for solving ordinary partial equations |
CVarTimestep | This class implements a step size control using Adams-Bashforth and Crank-Nicolson for solving ordinary partial equations |
CZeroFunction | The ZeroFunction class |