SG++-Doxygen-Documentation
sgpp::base::DataVector Class Reference

A class to store one-dimensional data. More...

#include <DataVector.hpp>

Inheritance diagram for sgpp::base::DataVector:

Public Member Functions

void abs ()
 Sets all elements to their absolute value. More...
 
void accumulate (const DataVector &vec)
 
void add (const DataVector &vec)
 Adds the values from another DataVector to the current values. More...
 
size_t append ()
 Appends a new element and returns index of it. More...
 
size_t append (double value)
 Appends a new element and returns index of new element. More...
 
void axpy (double a, DataVector &x)
 Adds a*x to current vector. More...
 
void componentwise_div (const DataVector &vec)
 Divides the current DataVector component-wise by another DataVector. More...
 
void componentwise_mult (const DataVector &vec)
 Multiplies the current DataVector component-wise with another DataVector. More...
 
void copyFrom (const DataVector &vec)
 Copies the data from another DataVector vec. More...
 
 DataVector ()
 Create an empty DataVector. More...
 
 DataVector (const DataVector &)=default
 Copy constructor. More...
 
 DataVector (size_t size)
 Create a DataVector with size elements (uninitialized values). More...
 
 DataVector (size_t size, double value)
 Create a DataVector with size elements and initializes all elements with the same value. More...
 
 DataVector (double *input, size_t size)
 Create a new DataVector from a double array with size elements. More...
 
 DataVector (std::vector< double > input)
 Create a new DataVector from a std::vector<double>. More...
 
 DataVector (std::vector< int > input)
 Create a new DataVector from a std::vector<int>. More...
 
double dotProduct (const DataVector &vec) const
 Returns the dot product of the two vectors. More...
 
double get (size_t i) const
 Returns the i-th element. More...
 
size_t getNumberNonZero () const
 Determines the number of non-zero elements in the vector. More...
 
double * getPointer ()
 gets a pointer to the data array More...
 
const double * getPointer () const
 gets a const pointer to the data array More...
 
size_t getSize () const
 gets the elements stored in the vector More...
 
void insert (size_t index, double value)
 Inserts a new element at the given index. More...
 
double l2Norm () const
 Returns the vector's \(l^2\)-norm, i.e., \(\sqrt{ \sum_i x_i^2 }\). More...
 
double max () const
 Returns the maximum over all entries. More...
 
double maxNorm () const
 calculates the vector's max norm More...
 
double min () const
 Returns the minimum over all entries. More...
 
void minmax (double *min, double *max) const
 Determines minimum and maximum over all entries. More...
 
void mult (double scalar)
 multiplies all elements by a constant factor More...
 
void normalize ()
 Normalizes vector entries to [0,1]. More...
 
void normalize (double border)
 Normalizes vector entries to [border, 1-border]. More...
 
DataVectoroperator= (const DataVector &)=default
 Move constructor. More...
 
void partitionClasses (double threshold)
 Partitions vector into two classes using a choosen border. More...
 
void remove (std::vector< size_t > &indexesToRemove)
 Removes indexes form the vector. More...
 
void resizeZero (size_t nrows)
 Resizes the DataVector to size elements. More...
 
void restructure (std::vector< size_t > &remainingIndex)
 Resizes the DataVector by removing entries. More...
 
double RMSNorm () const
 Returns the vector's root mean square (RMS)-norm, i.e., \(\sqrt{ 1/N \sum_{i=1}^N x_i^2 }\). More...
 
void set (size_t i, double value)
 Sets the element at index i to value. More...
 
void setAll (double value)
 Sets all values of DataVector to value. More...
 
void sqr ()
 Squares all elements of the DataVector. More...
 
void sqrt ()
 Takes the square root of all elements of the DataVector. More...
 
void sub (const DataVector &vec)
 Subtracts the values from another DataVector of the current values. More...
 
double sum () const
 Returns the sum of all elements. More...
 
void toFile (const std::string &fileName) const
 
void toString (std::string &text) const
 Writes the data stored in the DataVector into a string. More...
 
std::string toString () const
 Returns a description of the DataVector as a string. More...
 
 ~DataVector ()=default
 Move assignment operator. More...
 

Static Public Member Functions

static DataVector fromFile (const std::string &fileName)
 
static DataVector fromString (const std::string &serializedVector)
 

Detailed Description

A class to store one-dimensional data.

Typically, an object of type DataVector will contain an array of (hierarchical) coefficients (or surplusses), or the coordinates of a data point at which a sparse grid function should be evaluated.

Constructor & Destructor Documentation

◆ DataVector() [1/7]

sgpp::base::DataVector::DataVector ( )

Create an empty DataVector.

◆ DataVector() [2/7]

sgpp::base::DataVector::DataVector ( const DataVector )
default

Copy constructor.

◆ ~DataVector()

sgpp::base::DataVector::~DataVector ( )
default

Move assignment operator.

Destructor

◆ DataVector() [3/7]

sgpp::base::DataVector::DataVector ( size_t  size)
explicit

Create a DataVector with size elements (uninitialized values).

Parameters
sizeNumber of elements

◆ DataVector() [4/7]

sgpp::base::DataVector::DataVector ( size_t  size,
double  value 
)

Create a DataVector with size elements and initializes all elements with the same value.

Parameters
sizeNumber of elements
valueValue for all entries

◆ DataVector() [5/7]

sgpp::base::DataVector::DataVector ( double *  input,
size_t  size 
)

Create a new DataVector from a double array with size elements.

Parameters
inputdouble array that contains the data
sizenumber of elements

◆ DataVector() [6/7]

sgpp::base::DataVector::DataVector ( std::vector< double >  input)
explicit

Create a new DataVector from a std::vector<double>.

Parameters
inputstd::vector<double> that contains the data

◆ DataVector() [7/7]

sgpp::base::DataVector::DataVector ( std::vector< int >  input)
explicit

Create a new DataVector from a std::vector<int>.

Parameters
inputstd::vector<int> that contains the data

Member Function Documentation

◆ abs()

void sgpp::base::DataVector::abs ( )

Sets all elements to their absolute value.

References python.statsfileInfo::i.

Referenced by sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::solver::LassoFunction::eval(), and get().

◆ accumulate()

void sgpp::base::DataVector::accumulate ( const DataVector vec)

References python.statsfileInfo::i.

Referenced by get().

◆ add()

void sgpp::base::DataVector::add ( const DataVector vec)

Adds the values from another DataVector to the current values.

Modifies the current values.

Parameters
vecThe DataVector which is added to the current values

References python.statsfileInfo::i.

Referenced by sgpp::datadriven::PrimalDualSVM::add(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyMassMatrixComplete(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyMassMatrixInner(), sgpp::base::OperationEvalGradientWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientModWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientWaveletBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineClenshawCurtisNaive::evalGradient(), sgpp::base::OperationEvalGradientModFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineClenshawCurtisNaive::evalGradient(), sgpp::base::OperationEvalHessianModWaveletNaive::evalHessian(), sgpp::base::OperationEvalHessianWaveletNaive::evalHessian(), sgpp::base::OperationEvalHessianWaveletBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModBsplineNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::OperationEvalHessianFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianModBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::ForwardSelectorRefinementIndicator::ForwardSelectorRefinementIndicator(), get(), sgpp::datadriven::LearnerSGDEOnOffParallel::mergeAlphaValues(), sgpp::pde::StdUpDown::mult(), sgpp::base::OperationMultipleEvalInterModLinear::mult(), sgpp::pde::UpDownFourOpDims::mult(), sgpp::pde::UpDownOneOpDim::mult(), sgpp::pde::UpDownTwoOpDims::mult(), sgpp::pde::OperationParabolicPDESolverSystemFreeBoundaries::mult(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::mult(), sgpp::pde::OperationParabolicPDESolverSystemDirichlet::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult_transpose(), sgpp::base::AlgorithmDGEMV< BASIS >::mult_transposed(), sgpp::pde::StdUpDown::multParallelBuildingBlock(), sgpp::pde::UpDownOneOpDim::multParallelBuildingBlock(), sgpp::pde::UpDownTwoOpDims::multParallelBuildingBlock(), sgpp::base::OperationMultipleEvalInterModLinear::multTranspose(), sgpp::optimization::optimizer::CMAES::optimize(), sgpp::datadriven::BayesianOptimization::setScales(), sgpp::solver::ConjugateGradients::solve(), sgpp::solver::BiCGStab::solve(), sgpp::solver::Fista< F >::solve(), sgpp::pde::UpDownOneOpDimWithShadow::specialOP(), sgpp::pde::UpDownOneOpDim::specialOP(), sgpp::pde::UpDownTwoOpDims::specialOpOne(), sgpp::pde::UpDownTwoOpDims::specialOpOneAndOpTwo(), sgpp::pde::UpDownTwoOpDims::specialOpTwo(), sgpp::pde::UpDownFourOpDims::specialOpX(), sgpp::datadriven::ModelFittingDensityEstimationCG::update(), sgpp::pde::UpDownOneOpDimWithShadow::updown(), sgpp::pde::StdUpDown::updown(), sgpp::pde::UpDownOneOpDim::updown(), sgpp::pde::UpDownTwoOpDims::updown(), sgpp::pde::HeatEquationParabolicPDESolverSystem::~HeatEquationParabolicPDESolverSystem(), and sgpp::solver::StepsizeControlEJ::~StepsizeControlEJ().

◆ append() [1/2]

◆ append() [2/2]

size_t sgpp::base::DataVector::append ( double  value)

Appends a new element and returns index of new element.

Parameters
valueValue of new element
Returns
Index of new element

◆ axpy()

◆ componentwise_div()

void sgpp::base::DataVector::componentwise_div ( const DataVector vec)

Divides the current DataVector component-wise by another DataVector.

Modifies the current values. Performs

for i from 1 to this.getSize()
this[i] /= vec[i]

Note: No check for division by zero!

Parameters
vecthe DataVector which the current DataVector is divided by

References python.statsfileInfo::i.

Referenced by get().

◆ componentwise_mult()

void sgpp::base::DataVector::componentwise_mult ( const DataVector vec)

Multiplies the current DataVector component-wise with another DataVector.

Modifies the current values. Performs

for i from 1 to this.getSize()
this[i] *= vec[i]
Parameters
vecthe DataVector which is multiplied to current DataVector

References python.statsfileInfo::i.

Referenced by sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::DMWeightMatrix::generateb(), get(), l2Norm(), sgpp::datadriven::OperationRegularizationDiagonal::mult(), and sgpp::datadriven::LearnerBase::train().

◆ copyFrom()

void sgpp::base::DataVector::copyFrom ( const DataVector vec)

Copies the data from another DataVector vec.

Disregards the number of entries set for the two vectors, i.e., just copies the data entry by entry. If the size matches, the current DataVector is an exact copy of vec. If not, as many elements as possible are copied, and everything else is left untouched.

Parameters
vecThe source DataVector containing the data

Referenced by sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::base::OperationEvalModLinear::eval(), get(), sgpp::combigrid::PolynomialChaosExpansion::getComponentSobolIndices(), and sgpp::datadriven::OperationRegularizationDiagonal::mult().

◆ dotProduct()

◆ fromFile()

DataVector sgpp::base::DataVector::fromFile ( const std::string &  fileName)
static

◆ fromString()

DataVector sgpp::base::DataVector::fromString ( const std::string &  serializedVector)
static

◆ get()

double sgpp::base::DataVector::get ( size_t  i) const
inline

Returns the i-th element.

Parameters
iposition of the element
Returns
data[i]

References abs(), accumulate(), add(), axpy(), componentwise_div(), componentwise_mult(), copyFrom(), dotProduct(), getPointer(), python.statsfileInfo::i, l2Norm(), max(), maxNorm(), min(), minmax(), mult(), RMSNorm(), sqr(), sqrt(), sub(), and sum().

Referenced by sgpp::base::DirichletUpdateVector::applyDirichletConditions(), sgpp::datadriven::LearnerSGDEOnOffParallel::assembleNextBatchData(), sgpp::base::DirichletGridConverter::buildInnerGridWithCoefs(), sgpp::base::DirichletGridConverter::calcInnerCoefs(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatOnlineDE::computeDensityFunction(), sgpp::base::PrecisionConverter::convertDataVectorToDataVectorSP(), sgpp::datadriven::DBMatOfflineOrthoAdapt::decomposeMatrix(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::base::OperationQuadratureModLinear::doQuadrature(), sgpp::base::OperationFirstMomentLinearBoundary::doQuadrature(), sgpp::base::OperationQuadratureLinear::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentBspline::doQuadrature(), sgpp::base::OperationSecondMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationFirstMomentBspline::doQuadrature(), sgpp::base::OperationFirstMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBspline::doQuadrature(), sgpp::base::OperationFirstMomentLinear::doQuadrature(), sgpp::base::OperationSecondMomentModLinear::doQuadrature(), sgpp::base::OperationSecondMomentModPoly::doQuadrature(), sgpp::base::OperationSecondMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPoly::doQuadrature(), sgpp::base::OperationFirstMomentModBspline::doQuadrature(), sgpp::base::OperationSecondMomentPolyBoundary::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentModLinear::doQuadrature(), sgpp::base::OperationFirstMomentModPoly::doQuadrature(), sgpp::base::OperationFirstMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPoly::doQuadrature(), sgpp::base::OperationFirstMomentPolyBoundary::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationQuadratureLinearBoundary::doQuadrature(), sgpp::base::OperationSecondMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentLinearBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationFirstMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentLinear::doQuadrature(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRefinement(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_in_next_dim(), sgpp::base::DataMatrix::expand(), sgpp::base::ForwardSelectorRefinementIndicator::ForwardSelectorRefinementIndicator(), sgpp::datadriven::LearnerSVM::getAccuracy(), sgpp::datadriven::LearnerSGD::getAccuracy(), sgpp::datadriven::LearnerBase::getAccuracy(), sgpp::datadriven::LearnerSGDE::getAccuracy(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracy(), sgpp::datadriven::LearnerSGDEOnOffParallel::getAccuracy(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracyBL(), sgpp::datadriven::LearnerSGD::getBatchError(), sgpp::datadriven::LearnerBase::getCassificatorQuality(), sgpp::datadriven::LearnerSGD::getError(), sgpp::datadriven::LearnerSVM::getError(), sgpp::datadriven::LearnerSGDEOnOffParallel::getError(), sgpp::datadriven::AlgorithmAdaBoostBase::getMaxGridPoint(), sgpp::datadriven::AlgorithmAdaBoostBase::getMeanGridPoint(), sgpp::base::ClenshawCurtisTable::getPoint(), sgpp::datadriven::AlgorithmAdaBoostBase::getROC(), sgpp::datadriven::AlgorithmAdaBoostBase::getSumGridPoint(), sgpp::datadriven::RefinementHandler::handleSurplusBasedRefinement(), sgpp::datadriven::DataBasedRefinementFunctor::isWithinSupport(), sgpp::datadriven::MetaLearner::learnAndTestString(), sgpp::datadriven::OperationDensityMargTo1D::margToDimXs(), sgpp::datadriven::Accuracy::measure(), sgpp::datadriven::NegativeLogLikelihood::measure(), sgpp::datadriven::LearnerSGDEOnOffParallel::mergeAlphaValues(), sgpp::pde::UpDownOneOpDim::mult(), sgpp::base::DirichletUpdateVector::multiply(), sgpp::base::DirichletUpdateVector::multiplyBoundary(), sgpp::base::DirichletUpdateVector::multiplyBoundaryVector(), sgpp::pde::UpDownOneOpDim::multParallelBuildingBlock(), sgpp::base::DehierarchisationFundamentalSpline::operator()(), sgpp::base::DehierarchisationModFundamentalSpline::operator()(), sgpp::base::ForwardSelectorRefinementIndicator::operator()(), sgpp::base::ImpurityRefinementIndicator::operator()(), sgpp::base::PredictiveRefinementIndicator::operator()(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::prepare(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::prepare(), sgpp::base::DirichletGridConverter::rebuildInnerGridWithCoefs(), sgpp::base::DataMatrix::setColumn(), sgpp::base::DataMatrix::setRow(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::pde::HeatEquationSolver::storeInnerRHS(), sgpp::pde::PoissonEquationSolver::storeInnerRHS(), sgpp::pde::HeatEquationSolver::storeInnerSolution(), sgpp::pde::PoissonEquationSolver::storeInnerSolution(), sgpp::datadriven::LearnerSGD::storeResults(), sgpp::datadriven::LearnerSVM::storeResults(), sgpp::datadriven::LearnerSGDE::storeResults(), sgpp::datadriven::test_calculateROCcurve(), sgpp::datadriven::LearnerSGD::train(), sgpp::datadriven::LearnerSVM::train(), sgpp::datadriven::LearnerSGDE::train(), sgpp::datadriven::ModelFittingClassification::update(), sgpp::base::ForwardSelectorRefinementIndicator::update(), sgpp::base::ImpurityRefinementIndicator::update(), and sgpp::base::DirichletGridConverter::updateBoundaryCoefs().

◆ getNumberNonZero()

size_t sgpp::base::DataVector::getNumberNonZero ( ) const

Determines the number of non-zero elements in the vector.

Returns
The number of non-zero elements

References python.statsfileInfo::i.

Referenced by getSize().

◆ getPointer() [1/2]

◆ getPointer() [2/2]

const double * sgpp::base::DataVector::getPointer ( ) const

gets a const pointer to the data array

Returns
const pointer to the data array

References python.statsfileInfo::data.

◆ getSize()

size_t sgpp::base::DataVector::getSize ( ) const
inline

gets the elements stored in the vector

Deprecated:
in favour of the equivalent size() method
Returns
elements stored in the vector

References getNumberNonZero(), normalize(), partitionClasses(), toFile(), and toString().

Referenced by sgpp::base::DataMatrix::addReduce(), sgpp::datadriven::AlgorithmAdaBoostIdentity::alphaSolver(), sgpp::base::DataMatrix::appendCol(), sgpp::base::DataMatrix::appendRow(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyLOperatorComplete(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyLOperatorInner(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyMassMatrixComplete(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyMassMatrixInner(), sgpp::combigrid::MCIntegrator::average(), sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyDowndate(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyUpdate(), python.uq.uq_setting.UQSetting.UQSetting::convert(), sgpp::base::PrecisionConverter::convertDataVectorSPToDataVector(), sgpp::base::PrecisionConverter::convertDataVectorToDataVectorSP(), sgpp::base::HashGenerator::decodeCoords(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), doAllRefinements(), sgpp::datadriven::OperationDensityConditional::doConditional(), sgpp::datadriven::OperationDensityConditionalLinear::doConditional(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::OperationLimitFunctionValueRange::doLimitation(), sgpp::base::OperationQuadratureModLinearClenshawCurtis::doQuadrature(), sgpp::base::OperationQuadratureLinearClenshawCurtis::doQuadrature(), sgpp::base::OperationQuadratureModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationQuadraturePolyClenshawCurtis::doQuadrature(), sgpp::base::OperationQuadraturePolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationQuadratureLinearClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationQuadraturePolyBoundary::doQuadrature(), sgpp::base::OperationQuadratureBsplineBoundary::doQuadrature(), sgpp::base::OperationQuadratureBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationQuadratureFundamentalSpline::doQuadrature(), sgpp::base::OperationQuadratureModBspline::doQuadrature(), sgpp::base::OperationQuadratureModFundamentalSpline::doQuadrature(), sgpp::base::OperationQuadratureModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationQuadraturePoly::doQuadrature(), sgpp::base::OperationQuadratureModPoly::doQuadrature(), sgpp::base::OperationQuadratureBspline::doQuadrature(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling_in_next_dim(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation1D(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation_start_dimX(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_start_dimX(), sgpp::combigrid::Ishigami::eval(), sgpp::base::OperationEvalModLinear::eval(), sgpp::solver::ElasticNetFunction::eval(), sgpp::solver::GroupLassoFunction::eval(), sgpp::combigrid::Parabola::eval(), sgpp::combigrid::Parabola_uniform::eval(), sgpp::base::OperationEvalGradient::evalGradient(), sgpp::base::OperationEvalHessian::evalHessian(), sgpp::combigrid::GaussLegendreQuadrature::evaluate(), sgpp::combigrid::GaussLegendreQuadrature::evaluate_iteratively(), sgpp::combigrid::GaussLegendreQuadrature::evaluate_sumexp(), sgpp::combigrid::GaussLegendreQuadrature::evaluate_sumexp_iteratively(), sgpp::pde::PDESolver::evaluateCuboid(), sgpp::base::DataMatrix::expand(), sgpp::datadriven::DensityOCLMultiPlatform::OperationDensityOCLMultiPlatform< T >::finalize_rhs_generation(), sgpp::datadriven::OperationMakePositiveCandidateSetAlgorithm::findNodesWithNegativeCoefficients(), sgpp::base::DataMatrix::fromString(), sgpp::optimization::IterativeGridGeneratorRitterNovak::generate(), sgpp::datadriven::clusteringmpi::OperationDensityRhsMPI::generate_b(), sgpp::datadriven::DensityOCLMultiPlatform::OperationDensityOCLMultiPlatform< T >::generateb(), sgpp::pde::OperationParabolicPDESolverSystemFreeBoundaries::generateRHS(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::generateRHS(), sgpp::pde::OperationParabolicPDESolverSystemDirichlet::generateRHS(), sgpp::datadriven::ClassificationLearner::getAccuracy(), sgpp::datadriven::LearnerSVM::getAccuracy(), sgpp::datadriven::LearnerSGD::getAccuracy(), sgpp::datadriven::LearnerBase::getAccuracy(), sgpp::datadriven::LearnerSGDE::getAccuracy(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracy(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracyBL(), sgpp::datadriven::KernelDensityEstimator::getBandwidths(), sgpp::datadriven::LearnerBase::getCassificatorQuality(), sgpp::base::DataMatrix::getColumn(), sgpp::combigrid::PolynomialChaosExpansion::getComponentSobolIndices(), sgpp::optimization::RandomNumberGenerator::getGaussianRV(), sgpp::datadriven::RegressionLearner::getMSE(), sgpp::datadriven::AlgorithmAdaBoostBase::getROC(), sgpp::base::DataMatrix::getRow(), sgpp::quadrature::NaiveSampleGenerator::getSample(), sgpp::quadrature::StratifiedSampleGenerator::getSample(), sgpp::datadriven::RuleOfThumb::getSampleMean(), sgpp::datadriven::RuleOfThumb::getSampleVariance(), python.uq.uq_setting.UQSetting.UQSetting::getTimeDependentResults(), sgpp::combigrid::PolynomialChaosExpansion::getTotalSobolIndices(), sgpp::optimization::RandomNumberGenerator::getUniformRV(), sgpp::datadriven::RefinementHandler::handleSurplusBasedRefinement(), hpx_main(), sgpp::datadriven::DBMatOfflineOrthoAdapt::invert_symmetric_tridiag(), sgpp::datadriven::DataBasedRefinementFunctor::isWithinSupport(), sgpp::optimization::optimizer::lineSearchArmijo(), main(), sgpp::datadriven::OperationMakePositive::makeCurrentNodalValuesPositive(), sgpp::datadriven::OperationDensityMargTo1D::margToDimXs(), sgpp::solver::StepsizeControl::maxNorm(), sgpp::datadriven::MSE::measure(), sgpp::datadriven::LearnerSGDEOnOffParallel::mergeAlphaValues(), sgpp::pde::OperationLaplaceModPoly::mult(), sgpp::pde::OperationLaplaceModPolyClenshawCurtis::mult(), sgpp::pde::OperationLaplacePoly::mult(), sgpp::pde::OperationLaplacePolyClenshawCurtis::mult(), sgpp::pde::OperationLaplacePolyClenshawCurtisBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotBspline::mult(), sgpp::pde::OperationMatrixLTwoDotBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotModPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotModPoly::mult(), sgpp::pde::OperationMatrixLTwoDotPolyBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotPolyClenshawCurtisBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotModBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotBsplineBoundary::mult(), sgpp::pde::OperationLaplaceBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotPoly::mult(), sgpp::pde::OperationLaplacePolyBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotPeriodic::mult(), sgpp::pde::OperationMatrixLTwoDotModLinear::mult(), sgpp::pde::OperationMatrixLTwoDotPolyClenshawCurtis::mult(), sgpp::pde::OperationLaplaceBspline::mult(), sgpp::pde::OperationLaplaceBsplineBoundary::mult(), sgpp::pde::OperationLaplaceModBspline::mult(), sgpp::pde::OperationLaplaceModBsplineClenshawCurtis::mult(), sgpp::pde::StdUpDown::mult(), sgpp::pde::UpDownOneOpDimWithShadow::mult(), sgpp::datadriven::OperationMultiEvalStreaming::mult(), sgpp::base::OperationDiagonal::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPeriodic::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPoly::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBspline::mult(), sgpp::base::OperationMultipleEvalInterModLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPoly::mult(), sgpp::pde::OperationLaplaceExplicitBspline::mult(), sgpp::pde::OperationLaplaceExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModifiedLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBsplineClenshawCurtis::mult(), sgpp::pde::OperationLaplaceExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::mult(), sgpp::pde::UpDownFourOpDims::mult(), sgpp::datadriven::DMSystemMatrix::mult(), sgpp::pde::UpDownOneOpDim::mult(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::mult(), sgpp::pde::UpDownOneOpDimEnhanced::mult(), sgpp::datadriven::DMWeightMatrix::mult(), sgpp::pde::UpDownTwoOpDims::mult(), sgpp::pde::OperationParabolicPDESolverSystemFreeBoundaries::mult(), sgpp::datadriven::PiecewiseConstantSmoothedRegressionSystemMatrix::mult(), sgpp::combigrid::LTwoScalarProductHashMapNakBsplineBoundaryCombigrid::mult(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::mult(), sgpp::datadriven::DensitySystemMatrix::mult(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::mult(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::mult(), sgpp::pde::OperationParabolicPDESolverSystemDirichlet::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult(), sgpp::base::AlgorithmDGEMV< BASIS >::mult(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::mult(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::mult(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::mult(), sgpp::datadriven::clusteringmpi::OperationDensityMultMPI::mult(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::mult(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::mult(), sgpp::base::DataMatrix::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult_transpose(), sgpp::base::AlgorithmDGEMV< BASIS >::mult_transposed(), sgpp::datadriven::PrimalDualSVM::multiply(), sgpp::pde::StdUpDown::multParallelBuildingBlock(), sgpp::pde::UpDownOneOpDimEnhanced::multParallelBuildingBlock(), sgpp::pde::UpDownOneOpDim::multParallelBuildingBlock(), sgpp::pde::UpDownTwoOpDims::multParallelBuildingBlock(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::multTranspose(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::base::OperationMultipleEvalInterModLinear::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::multTranspose(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::multTranspose(), sgpp::datadriven::OperationMakePositiveFindIntersectionCandidates::nextCandidates(), sgpp::datadriven::OperationMakePositiveHybridFindIntersectionCandidates::nextCandidates(), sgpp::combigrid::DataVectorEqualTo::operator()(), sgpp::combigrid::DataVectorHash::operator()(), sgpp::datadriven::MaximumLikelihoodCrossValidation::optimizeBandwidths(), sgpp::solver::VarTimestep::predictor(), sgpp::solver::RidgeFunction::prox(), sgpp::solver::LassoFunction::prox(), sgpp::solver::GroupLassoFunction::prox(), sgpp::pde::PDESolver::refineInitialGridSurplusSubDomain(), sgpp::pde::PDESolver::refineInitialGridSurplusToMaxLevelSubDomain(), RMSNorm(), python.uq.uq_setting.UQSetting.UQSetting::runSamples(), python.uq.uq_setting.UQSetting.UQSetting::runSamples_withoutDistribution(), sgpp::datadriven::KernelDensityEstimator::setBandwidths(), sgpp::base::DataMatrix::setColumn(), sgpp::combigrid::CombigridOperation::setParameters(), sgpp::base::DataMatrix::setRow(), sgpp::optimization::sle_solver::BiCGStab::setStartingPoint(), sgpp::datadriven::RegressionLearner::setWeights(), sgpp::solver::ConjugateGradients::solve(), sgpp::optimization::sle_solver::Armadillo::solve(), sgpp::optimization::sle_solver::Eigen::solve(), sgpp::optimization::sle_solver::GaussianElimination::solve(), sgpp::datadriven::DBMatDMSOrthoAdapt::solve(), sgpp::optimization::sle_solver::UMFPACK::solve(), sgpp::solver::BiCGStab::solve(), sgpp::optimization::sle_solver::Auto::solve(), sgpp::solver::Fista< F >::solve(), sgpp::optimization::sle_solver::BiCGStab::solve(), sgpp::solver::StepsizeControl::solve(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::solveSLE(), sgpp::pde::OperationLaplaceLinearStretched::specialOP(), sgpp::pde::OperationLaplaceLinear::specialOP(), sgpp::pde::OperationLaplaceExplicitLinear::specialOP(), sgpp::pde::UpDownOneOpDimWithShadow::specialOP(), sgpp::pde::UpDownOneOpDim::specialOP(), sgpp::pde::UpDownTwoOpDims::specialOpOne(), sgpp::pde::UpDownTwoOpDims::specialOpOneAndOpTwo(), sgpp::pde::UpDownTwoOpDims::specialOpTwo(), sgpp::pde::UpDownFourOpDims::specialOpX(), sgpp::pde::HeatEquationSolver::storeInnerRHS(), sgpp::pde::PoissonEquationSolver::storeInnerRHS(), sgpp::pde::HeatEquationSolver::storeInnerSolution(), sgpp::pde::PoissonEquationSolver::storeInnerSolution(), sgpp::datadriven::LearnerSGD::storeResults(), sgpp::datadriven::LearnerSVM::storeResults(), sgpp::datadriven::LearnerSGDE::storeResults(), sgpp::datadriven::test_calculateROCcurve(), sgpp::datadriven::test_dataset_mse(), sgpp::datadriven::test_datasetWithCharacteristicNumber(), sgpp::datadriven::ClassificationLearner::train(), sgpp::datadriven::LearnerSGD::train(), sgpp::datadriven::LearnerBase::train(), sgpp::datadriven::RegressionLearner::train(), sgpp::datadriven::LearnerSGDE::train(), sgpp::datadriven::SparseGridDensityEstimator::train(), sgpp::datadriven::LearnerSGDE::trainOnline(), sgpp::datadriven::LearnerSGDEOnOffParallel::updateAlpha(), sgpp::pde::UpDownOneOpDimWithShadow::updown(), sgpp::pde::StdUpDown::updown(), sgpp::pde::UpDownOneOpDim::updown(), sgpp::pde::UpDownTwoOpDims::updown(), verifyLearned(), sgpp::optimization::file_io::writeGrid(), sgpp::optimization::file_io::writeVector(), sgpp::pde::HeatEquationParabolicPDESolverSystem::~HeatEquationParabolicPDESolverSystem(), sgpp::solver::StepsizeControlEJ::~StepsizeControlEJ(), and sgpp::solver::StepsizeControlH::~StepsizeControlH().

◆ insert()

void sgpp::base::DataVector::insert ( size_t  index,
double  value 
)

Inserts a new element at the given index.

Parameters
indexIndex of new element
valueValue of new element

Referenced by sgpp::optimization::IterativeGridGeneratorRitterNovak::generate().

◆ l2Norm()

◆ max()

◆ maxNorm()

double sgpp::base::DataVector::maxNorm ( ) const

◆ min()

◆ minmax()

void sgpp::base::DataVector::minmax ( double *  min,
double *  max 
) const

Determines minimum and maximum over all entries.

Parameters
minReference variable for the minimum
maxReference variable for the maximum

References python.statsfileInfo::i.

Referenced by get(), and normalize().

◆ mult()

void sgpp::base::DataVector::mult ( double  scalar)

multiplies all elements by a constant factor

Parameters
scalarthe constant

References python.statsfileInfo::i.

Referenced by sgpp::datadriven::PrimalDualSVM::add(), sgpp::datadriven::DBMatOnlineDE::computeDensityFunction(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::OperationDensityConditional::doConditional(), sgpp::datadriven::OperationDensityConditionalLinear::doConditional(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::combigrid::Ishigami::eval(), sgpp::datadriven::DBMatOnlineDE::eval(), sgpp::datadriven::DensitySystemMatrix::generateb(), sgpp::pde::OperationEllipticPDESolverSystemDirichlet::generateRHS(), get(), sgpp::combigrid::PolynomialChaosExpansion::getComponentSobolIndices(), sgpp::base::GaussLegendreQuadRule1D::getLevelPointsAndWeightsNormalized(), sgpp::combigrid::PolynomialChaosExpansion::getTotalSobolIndices(), sgpp::pde::OperationParabolicPDESolverSystemFreeBoundaries::mult(), sgpp::pde::OperationParabolicPDESolverSystemDirichlet::mult(), sgpp::datadriven::PrimalDualSVM::multiply(), sgpp::optimization::optimizer::CMAES::optimize(), sgpp::optimization::optimizer::LevenbergMarquardt::optimize(), sgpp::solver::ElasticNetFunction::prox(), sgpp::datadriven::BayesianOptimization::setScales(), sgpp::solver::ConjugateGradients::solve(), sgpp::solver::BiCGStab::solve(), sgpp::solver::Fista< F >::solve(), sgpp::datadriven::LearnerSGD::train(), and sgpp::datadriven::ModelFittingDensityEstimationCG::update().

◆ normalize() [1/2]

◆ normalize() [2/2]

void sgpp::base::DataVector::normalize ( double  border)

Normalizes vector entries to [border, 1-border].

Parameters
borderwidth of border

References python.statsfileInfo::i, max(), min(), and minmax().

◆ operator=()

DataVector& sgpp::base::DataVector::operator= ( const DataVector )
default

Move constructor.

Copy assignment operator

◆ partitionClasses()

void sgpp::base::DataVector::partitionClasses ( double  threshold)

Partitions vector into two classes using a choosen border.

Parameters
thresholdvalue of the border

References python.statsfileInfo::i.

Referenced by getSize().

◆ remove()

void sgpp::base::DataVector::remove ( std::vector< size_t > &  indexesToRemove)

Removes indexes form the vector.

Throws an exception if the boundaries are violated

Parameters
indexesToRemovea vector if indexes that will be removed from the vector

References python.statsfileInfo::i.

Referenced by python.uq.uq_setting.UQSetting.UQSetting::cleanUp(), sgpp::datadriven::ModelFittingDensityEstimationOnOff::refine(), sgpp::datadriven::ModelFittingDensityEstimationCG::refine(), sgpp::datadriven::LearnerSGDEOnOffParallel::updateAlpha(), and sgpp::datadriven::DBMatOnlineDE::updateRhs().

◆ resizeZero()

void sgpp::base::DataVector::resizeZero ( size_t  nrows)

Resizes the DataVector to size elements.

All new additional entries are set to zero. If nrows is smaller than the current number of rows, all superfluous entries are removed.

Parameters
nrowsNew number of rows of the DataVector

Referenced by sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRefinement(), sgpp::datadriven::OperationMakePositiveHybridFindIntersectionCandidates::findIntersections(), sgpp::datadriven::RegressionLearner::getMSE(), sgpp::combigrid::PolynomialChaosExpansion::getTotalSobolIndices(), sgpp::datadriven::OperationMakePositive::makeCurrentNodalValuesPositive(), sgpp::datadriven::LearnerSGDEOnOffParallel::mergeAlphaValues(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::mult(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::multTranspose(), sgpp::datadriven::OperationMakePositiveFindIntersectionCandidates::nextCandidates(), sgpp::datadriven::SparseGridDensityEstimator::optimizeLambdaCV(), sgpp::datadriven::LearnerSGDE::optimizeLambdaCV(), sgpp::datadriven::ModelFittingLeastSquares::refine(), sgpp::datadriven::ModelFittingDensityEstimationCG::refine(), sgpp::datadriven::ModelFittingDensityEstimationOnOff::refine(), sgpp::datadriven::DBMatOnlineDEChol::solveSLE(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::solveSLE(), sgpp::datadriven::LearnerSGD::train(), sgpp::datadriven::LearnerSGDEOnOffParallel::updateAlpha(), sgpp::datadriven::DBMatOnlineDE::updateRhs(), and sgpp::combigrid::PolynomialChaosExpansion::variance().

◆ restructure()

void sgpp::base::DataVector::restructure ( std::vector< size_t > &  remainingIndex)

Resizes the DataVector by removing entries.

Throws an exception if boundaries a violated.

Parameters
remainingIndexvector that contains the remaining indices of the DataVector

References python.statsfileInfo::i.

Referenced by sgpp::base::HashCoarsening::free_coarsen_NFirstOnly().

◆ RMSNorm()

double sgpp::base::DataVector::RMSNorm ( ) const

Returns the vector's root mean square (RMS)-norm, i.e., \(\sqrt{ 1/N \sum_{i=1}^N x_i^2 }\).

If the vector's entries correspond to function values on a full grid, this is the discrete \(L^2\)-norm of the corresponding function.

Returns
The vector's root mean square-norm.

References getSize(), sqr(), and sum().

Referenced by get().

◆ set()

void sgpp::base::DataVector::set ( size_t  i,
double  value 
)

Sets the element at index i to value.

Parameters
iIndex
valueNew value for element

References python.statsfileInfo::i.

Referenced by sgpp::base::DataMatrix::addReduce(), sgpp::base::DirichletUpdateVector::applyDirichletConditions(), sgpp::datadriven::LearnerSGDEOnOffParallel::assembleNextBatchData(), sgpp::base::DirichletGridConverter::calcInnerCoefs(), sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyUpdateLambda(), sgpp::datadriven::AlgorithmAdaBoostBase::classif(), sgpp::datadriven::DBMatOnlineDE::computeDensityFunction(), sgpp::base::PrecisionConverter::convertDataVectorSPToDataVector(), sgpp::datadriven::Friedman1Generator::createData(), sgpp::datadriven::Friedman2Generator::createData(), sgpp::datadriven::Friedman3Generator::createData(), sgpp::datadriven::DBMatOfflineOrthoAdapt::decomposeMatrix(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRefinement(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation_in_next_dim(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation_in_next_dim(), sgpp::datadriven::ModelFittingClassification::evaluate(), sgpp::datadriven::LearnerSGD::getBatchError(), sgpp::datadriven::LearnerSGD::getError(), sgpp::datadriven::LearnerSVM::getError(), sgpp::base::HashGridPoint::getStandardCoordinates(), sgpp::datadriven::OperationDensityMargTo1D::margToDimXs(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::multImpl(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::multImpl(), sgpp::base::DirichletUpdateVector::multiply(), sgpp::base::DirichletUpdateVector::multiplyBoundary(), sgpp::base::DirichletUpdateVector::multiplyBoundaryVector(), sgpp::pde::OperationLaplaceExplicitLinear::OperationLaplaceExplicitLinear(), sgpp::base::ImpurityRefinementIndicator::operator()(), sgpp::datadriven::LearnerSVM::predict(), sgpp::datadriven::LearnerSGD::predict(), sgpp::datadriven::LearnerSGDE::predict(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::prepare(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::prepare(), sgpp::datadriven::ARFFTools::readARFF(), sgpp::datadriven::CSVTools::readCSV(), sgpp::base::DirichletUpdateVector::setBoundariesToZero(), sgpp::base::DirichletUpdateVector::setInnerPointsToZero(), sgpp::datadriven::LearnerSGD::storeResults(), sgpp::datadriven::LearnerSVM::storeResults(), sgpp::datadriven::LearnerSGDE::storeResults(), sgpp::datadriven::test_datasetWithCharacteristicNumber(), sgpp::base::DirichletGridConverter::updateBoundaryCoefs(), sgpp::base::EvalCuboidGenerator::~EvalCuboidGenerator(), sgpp::base::EvalCuboidGeneratorForStretching::~EvalCuboidGeneratorForStretching(), and sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::~OperationMatrixLTwoDotExplicitLinearBoundary().

◆ setAll()

void sgpp::base::DataVector::setAll ( double  value)

Sets all values of DataVector to value.

Parameters
valueNew value for all entries

References python.statsfileInfo::i.

Referenced by sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyLOperatorComplete(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyLOperatorInner(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyMassMatrixComplete(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::applyMassMatrixInner(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyUpdateLambda(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::OperationDensityConditional::doConditional(), sgpp::datadriven::OperationDensityConditionalLinear::doConditional(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::OperationDensityMarginalize::doMarginalize(), sgpp::datadriven::OperationDensityMarginalizeLinear::doMarginalize(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation(), sgpp::pde::OperationLaplaceModLinear::down(), sgpp::pde::OperationLaplaceModLinear::downOpDim(), sgpp::combigrid::PolynomialChaosExpansion::eval(), sgpp::combigrid::PolynomialStochasticCollocation::eval(), sgpp::base::OperationEvalLinearClenshawCurtisNaive::eval(), sgpp::base::OperationEvalModLinearClenshawCurtisNaive::eval(), sgpp::base::OperationEvalPolyClenshawCurtisNaive::eval(), sgpp::base::OperationEvalModPolyClenshawCurtisNaive::eval(), sgpp::base::OperationEvalLinearClenshawCurtisBoundaryNaive::eval(), sgpp::base::OperationEvalModPolyNaive::eval(), sgpp::base::OperationEvalPolyClenshawCurtisBoundaryNaive::eval(), sgpp::base::OperationEvalPolyBoundaryNaive::eval(), sgpp::base::OperationEvalPolyNaive::eval(), sgpp::base::OperationEvalLinearBoundaryNaive::eval(), sgpp::base::OperationEvalLinearNaive::eval(), sgpp::base::OperationEvalModLinearNaive::eval(), sgpp::base::OperationEvalWaveletBoundaryNaive::eval(), sgpp::base::OperationEvalWaveletNaive::eval(), sgpp::base::OperationEvalModWaveletNaive::eval(), sgpp::base::OperationEvalNakBsplineBoundaryCombigridNaive::eval(), sgpp::base::OperationEvalFundamentalSplineNaive::eval(), sgpp::base::OperationEvalBsplineBoundaryNaive::eval(), sgpp::base::OperationEvalBsplineClenshawCurtisNaive::eval(), sgpp::base::OperationEvalModFundamentalSplineNaive::eval(), sgpp::base::OperationEvalModBsplineNaive::eval(), sgpp::base::OperationEvalBsplineNaive::eval(), sgpp::base::OperationEvalModBsplineClenshawCurtisNaive::eval(), sgpp::optimization::InterpolantVectorFunctionGradient::eval(), sgpp::optimization::InterpolantVectorFunctionHessian::eval(), sgpp::optimization::InterpolantVectorFunction::eval(), sgpp::datadriven::AlgorithmAdaBoostBase::eval(), sgpp::base::OperationEvalGradientWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientWaveletBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientModWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineClenshawCurtisNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineClenshawCurtisNaive::evalGradient(), sgpp::base::OperationEvalGradientModFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalHessianModWaveletNaive::evalHessian(), sgpp::base::OperationEvalHessianWaveletNaive::evalHessian(), sgpp::base::OperationEvalHessianWaveletBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModBsplineNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::OperationEvalHessianFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::OperationEvalPartialDerivativeWaveletBoundaryNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeModWaveletNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeWaveletNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeBsplineBoundaryNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeBsplineClenshawCurtisNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeBsplineNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeFundamentalSplineNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeModBsplineNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeModFundamentalSplineNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeModBsplineClenshawCurtisNaive::evalPartialDerivative(), sgpp::datadriven::OperationMakePositiveFindIntersectionCandidates::findIntersections(), sgpp::datadriven::OperationMakePositiveFindIntersectionCandidatesJoin::findIntersections(), sgpp::datadriven::ModelFittingDensityEstimationCG::fit(), sgpp::optimization::IterativeGridGeneratorLinearSurplus::generate(), sgpp::optimization::IterativeGridGeneratorRitterNovak::generate(), sgpp::datadriven::DensitySystemMatrix::generateb(), sgpp::pde::OperationParabolicPDESolverSystemFreeBoundaries::generateRHS(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::generateRHS(), sgpp::pde::OperationParabolicPDESolverSystemDirichlet::generateRHS(), sgpp::datadriven::LearnerSGD::getError(), sgpp::datadriven::LearnerSVM::getError(), sgpp::pde::OperationEllipticPDESolverSystemDirichlet::getGridCoefficientsForCG(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::getMaxInversionError(), sgpp::optimization::test_problems::Sphere::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::Schwefel::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::Ackley::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::BubbleWrap::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::Rastrigin::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::Rosenbrock::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::EasomYang::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::Griewank::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::TremblingParabola::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::G12::getOptimalPointUndisplaced(), sgpp::optimization::test_problems::G03::getOptimalPointUndisplaced(), hpx_main(), sgpp::datadriven::KernelDensityEstimator::initialize(), sgpp::datadriven::LearnerSGD::LearnerSGD(), main(), sgpp::optimization::SLE::matrixVectorMultiplication(), sgpp::base::OperationMultipleEvalLinearBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalBsplineClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalBsplineBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalLinearNaive::mult(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalModBsplineClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalModLinearClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalModPolyClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalPolyBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalPolyNaive::mult(), sgpp::base::OperationMultipleEvalBsplineNaive::mult(), sgpp::base::OperationMultipleEvalModBsplineNaive::mult(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisBoundaryNaive::mult(), sgpp::pde::StdUpDown::mult(), sgpp::pde::UpDownOneOpDimWithShadow::mult(), sgpp::datadriven::OperationMultiEvalStreaming::mult(), sgpp::base::OperationMultipleEvalInterModLinear::mult(), sgpp::pde::UpDownFourOpDims::mult(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::mult(), sgpp::pde::UpDownOneOpDim::mult(), sgpp::pde::UpDownOneOpDimEnhanced::mult(), sgpp::pde::UpDownTwoOpDims::mult(), sgpp::pde::OperationParabolicPDESolverSystemFreeBoundaries::mult(), sgpp::datadriven::PiecewiseConstantSmoothedRegressionSystemMatrix::mult(), sgpp::combigrid::LTwoScalarProductHashMapNakBsplineBoundaryCombigrid::mult(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::mult(), sgpp::datadriven::DensitySystemMatrix::mult(), sgpp::pde::HeatEquationParabolicPDESolverSystemParallelOMP::mult(), sgpp::pde::OperationParabolicPDESolverSystemDirichlet::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult(), sgpp::base::AlgorithmDGEMV< BASIS >::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult_transpose(), sgpp::base::AlgorithmDGEMV< BASIS >::mult_transposed(), sgpp::pde::StdUpDown::multParallelBuildingBlock(), sgpp::pde::UpDownOneOpDimEnhanced::multParallelBuildingBlock(), sgpp::pde::UpDownOneOpDim::multParallelBuildingBlock(), sgpp::pde::UpDownTwoOpDims::multParallelBuildingBlock(), sgpp::base::OperationMultipleEvalLinearNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalBsplineClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalModLinearClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyNaive::multTranspose(), sgpp::base::OperationMultipleEvalModPolyClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalModBsplineClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalBsplineBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalModBsplineNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalBsplineNaive::multTranspose(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::multTranspose(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::base::OperationMultipleEvalInterModLinear::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::datadriven::OperationMakePositiveFindIntersectionCandidates::nextCandidates(), sgpp::datadriven::OperationMakePositiveLoadFullGridCandidates::nextCandidates(), sgpp::pde::OperationLaplaceExplicitLinear::OperationLaplaceExplicitLinear(), sgpp::pde::UpdPhidPhiBBIterativeLinearStretchedBoundary::operator()(), sgpp::pde::UpdPhidPhiBBIterativeLinearBoundary::operator()(), sgpp::pde::DowndPhidPhiBBIterativeLinear::operator()(), sgpp::pde::DowndPhidPhiBBIterativeLinearBoundary::operator()(), sgpp::pde::DowndPhidPhiBBIterativeLinearStretchedBoundary::operator()(), sgpp::pde::DowndPhidPhiBBIterativeLinearStretched::operator()(), sgpp::base::DehierarchisationPoly::operator()(), sgpp::base::DehierarchisationPolyBoundary::operator()(), sgpp::base::HierarchisationPolyBoundary::operator()(), sgpp::base::DehierarchisationModPoly::operator()(), sgpp::base::HierarchisationModPoly::operator()(), sgpp::base::HierarchisationPoly::operator()(), sgpp::base::DehierarchisationModLinearClenshawCurtis::operator()(), sgpp::base::HierarchisationModLinearClenshawCurtis::operator()(), sgpp::base::DehierarchisationPolyClenshawCurtis::operator()(), sgpp::base::HierarchisationPolyClenshawCurtis::operator()(), sgpp::base::DehierarchisationModPolyClenshawCurtis::operator()(), sgpp::base::DehierarchisationPolyClenshawCurtisBoundary::operator()(), sgpp::base::HierarchisationModPolyClenshawCurtis::operator()(), sgpp::base::HierarchisationPolyClenshawCurtisBoundary::operator()(), sgpp::base::ImpurityRefinementIndicator::operator()(), sgpp::datadriven::SilvermansRule::optimizeBandwidths(), sgpp::datadriven::KernelDensityEstimator::pdf(), sgpp::datadriven::RegressionLearner::setWeights(), sgpp::solver::ConjugateGradients::solve(), sgpp::solver::BiCGStab::solve(), sgpp::optimization::sle_solver::BiCGStab::solve(), sgpp::pde::UpDownOneOpDimWithShadow::specialOP(), sgpp::datadriven::LearnerLeastSquaresIdentity::testRegular(), sgpp::datadriven::LearnerSGDE::train(), sgpp::datadriven::SparseGridDensityEstimator::train(), sgpp::pde::OperationLaplaceModLinear::up(), sgpp::pde::UpDownOneOpDimWithShadow::updown(), sgpp::pde::OperationLaplaceModLinear::upOpDim(), sgpp::pde::HeatEquationParabolicPDESolverSystem::~HeatEquationParabolicPDESolverSystem(), sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::~OperationMatrixLTwoDotExplicitLinearBoundary(), and sgpp::solver::StepsizeControlEJ::~StepsizeControlEJ().

◆ sqr()

◆ sqrt()

void sgpp::base::DataVector::sqrt ( )

Takes the square root of all elements of the DataVector.

References python.statsfileInfo::i.

Referenced by get().

◆ sub()

◆ sum()

◆ toFile()

void sgpp::base::DataVector::toFile ( const std::string &  fileName) const

References python.statsfileInfo::f, and toString().

Referenced by getSize(), and main().

◆ toString() [1/2]

void sgpp::base::DataVector::toString ( std::string &  text) const

Writes the data stored in the DataVector into a string.

Parameters
textstring to which the data is written

References python.statsfileInfo::i.

Referenced by python.controller.LearnerEventController.LearnerEventController::__repr__(), python.controller.SolverEventController.SolverEventController::__repr__(), python.uq.learner.Learner.Learner::createMemento(), python.learner.Learner.Learner::createMemento(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation1D(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation1D(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation1D(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation1D(), sgpp::datadriven::OperationMultiEvalHPX::mult(), sgpp::optimization::operator<<(), sgpp::optimization::optimizer::Rprop::optimize(), sgpp::optimization::optimizer::AdaptiveGradientDescent::optimize(), sgpp::optimization::optimizer::BFGS::optimize(), sgpp::optimization::optimizer::GradientDescent::optimize(), sgpp::optimization::optimizer::LogBarrier::optimize(), sgpp::optimization::optimizer::NLCG::optimize(), sgpp::optimization::optimizer::AugmentedLagrangian::optimize(), sgpp::optimization::optimizer::SquaredPenalty::optimize(), sgpp::optimization::optimizer::LevenbergMarquardt::optimize(), sgpp::optimization::optimizer::AdaptiveNewton::optimize(), sgpp::optimization::optimizer::Newton::optimize(), and python.learner.formatter.GridFormatter.GridFormatter::serialize().

◆ toString() [2/2]


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