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

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

#include <DataMatrix.hpp>

Inheritance diagram for sgpp::base::DataMatrix:

Public Member Functions

void abs ()
 Sets all elements to their absolute value. More...
 
void add (const DataMatrix &matr)
 Adds the values from another DataMatrix to the current values. More...
 
void addReduce (DataVector &reduction)
 Reduce the DataMatrix along the columns by adding all entries in one row. More...
 
void addReduce (DataVector &reduction, DataVector &beta, size_t start_beta)
 Reduce the DataMatrix along the columns by adding all entries in one row. More...
 
size_t appendCol (const DataVector &vec)
 Appends a new Col with data contained in DataVector vec and returns index of new col. More...
 
size_t appendRow ()
 Appends a new row and returns index of it. More...
 
size_t appendRow (const DataVector &vec)
 Appends a new row with data contained in DataVector vec and returns index of new row. More...
 
void componentwise_div (const DataMatrix &matr)
 Divides the current DataMatrix component-wise by another DataMatrix. More...
 
void componentwise_mult (const DataMatrix &matr)
 Multiplies the current DataMatrix component-wise with another DataMatrix. More...
 
void copyFrom (const DataMatrix &matr)
 Copies the data from another DataMatrix matr. More...
 
 DataMatrix ()
 Creates an empty two-dimensional DataMatrix. More...
 
 DataMatrix (const DataMatrix &)=default
 Copy constructor. More...
 
 DataMatrix (size_t nrows, size_t ncols)
 Create a two-dimensional DataMatrix with nrows rows and ncols columns (uninitialized values). More...
 
 DataMatrix (size_t nrows, size_t ncols, double value)
 Create a two-dimensional DataMatrix with nrows rows and ncols columns and initializes all elements with the same value. More...
 
 DataMatrix (const double *input, size_t nrows, size_t ncols)
 Create a new DataMatrix from a double array. More...
 
void expand (const DataVector &expand)
 expands a given DataVector into a DataMatrix. More...
 
double get (size_t row, size_t col) const
 Returns the value of the element at position [row,col]. More...
 
size_t getAdditionallyReservedRows () const
 Returns the number of unused rows. More...
 
void getColumn (size_t col, DataVector &vec) const
 Copies the values of a column to the DataVector vec. More...
 
size_t getNcols () const
 Returns the number of columns of the DataMatrix. More...
 
size_t getNrows () const
 Returns the number of rows of the DataMatrix. More...
 
size_t getNumberNonZero () const
 Determines the number of non-zero elements in the vector. More...
 
double * getPointer ()
 Returns pointer to double array containing underlying data. More...
 
const double * getPointer () const
 Returns const pointer to double array containing underlying data. More...
 
void getRow (size_t row, DataVector &vec) const
 Copies the values of a row to the DataVector vec. More...
 
void getRow (size_t row, std::vector< double > &vec) const
 Copies the values of a row to the std::vector vec. More...
 
size_t getSize () const
 Returns the total number of (used) elements, i.e., getNrows()*getNCols() More...
 
double max (size_t col) const
 Returns the maximum value of column col. More...
 
double max () const
 Returns the maximum over all entries. More...
 
double min (size_t col) const
 Returns the minimum value of column col. More...
 
double min () const
 Returns the minimum over all entries. More...
 
void minmax (size_t col, double *min, double *max) const
 Determines minimum and maximum of column col. 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 mult (const DataVector &x, DataVector &y)
 Multiplies the matrix with a vector x and stores the result in another vector y. More...
 
void normalizeDimension (size_t d)
 Normalizes the d-th dimension (entries in the d-th column) to \([0,1]\). More...
 
void normalizeDimension (size_t d, double border)
 Normalizes the d-th dimension (entries in the d-th column) to \([border,1-border]\). More...
 
double & operator() (size_t row, size_t col)
 Returns the value of the element at position [row,col]. More...
 
const double & operator() (size_t row, size_t col) const
 Returns the value of the element at position [row,col]. More...
 
DataMatrixoperator= (const DataMatrix &)=default
 Move constructor. More...
 
void reserveAdditionalRows (size_t inc_nrows)
 Reserves memory for potentially inc_nrows new rows; the actual number of rows remains unchanged. More...
 
void resize (size_t nrows)
 Resizes the DataMatrix to nrows rows. More...
 
void resize (size_t nrows, size_t ncols)
 Resizes the DataMatrix to nrows rows and ncols columns. More...
 
void resizeQuadratic (size_t size)
 Resizes the quadratic DataMatrix to size rows and size columns. More...
 
void resizeRows (size_t nrows)
 Resizes the DataMatrix to nrows rows. More...
 
void resizeRowsCols (size_t nrows, size_t ncols)
 Resizes the DataMatrix to nrows rows and ncols columns. More...
 
void resizeToSubMatrix (size_t row_1, size_t col_1, size_t row_2, size_t col_2)
 Resize current matrix to the submatrix Mat[row_1:row_2, col_1:col_2]. More...
 
void resizeZero (size_t nrows)
 Resizes the DataMatrix to nrows rows. More...
 
void resizeZero (size_t nrows, size_t ncols)
 Resizes the DataMatrix to nrows rows and ncols columns. More...
 
void set (size_t row, size_t col, double value)
 Sets the element at position [row,col] to value. More...
 
void setAll (double value)
 Sets all entries of DataMatrix to value. More...
 
void setColumn (size_t col, const DataVector &vec)
 Sets a column of the DataMatrix to the values of a DataVector vec. More...
 
void setRow (size_t row, const DataVector &vec)
 Sets a row of the DataMatrix to the values of a DataVector vec. More...
 
void sqr ()
 Squares all elements of the DataMatrix. More...
 
void sqrt ()
 Takes the square root of all elements of the DataMatrix. More...
 
void sub (const DataMatrix &matr)
 Subtracts the values from another DataMatrix 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 DataMatrix into a string. More...
 
std::string toString () const
 Returns a description of the DataMatrix as a string. More...
 
void transpose ()
 Transposes this DataMatrix. More...
 
 ~DataMatrix ()=default
 Move assignment operator. More...
 

Static Public Member Functions

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

Detailed Description

A class to store two-dimensional data.

Typically, DataMatrix would contain a set of (d-dimensional) data or evaluation points, i.e., the DataMatrix consists of d columns, and each row is one of the points. Thus, typical functionality like obtaining the maximum for a certain dimension (or attribute), or normalizing all data points to the unit interval for a certain dimension are provided.

Constructor & Destructor Documentation

◆ DataMatrix() [1/5]

sgpp::base::DataMatrix::DataMatrix ( )

Creates an empty two-dimensional DataMatrix.

◆ DataMatrix() [2/5]

sgpp::base::DataMatrix::DataMatrix ( const DataMatrix )
default

Copy constructor.

◆ ~DataMatrix()

sgpp::base::DataMatrix::~DataMatrix ( )
default

Move assignment operator.

Destructor

◆ DataMatrix() [3/5]

sgpp::base::DataMatrix::DataMatrix ( size_t  nrows,
size_t  ncols 
)

Create a two-dimensional DataMatrix with nrows rows and ncols columns (uninitialized values).

Parameters
nrowsNumber of rows
ncolsNumber of columns

◆ DataMatrix() [4/5]

sgpp::base::DataMatrix::DataMatrix ( size_t  nrows,
size_t  ncols,
double  value 
)

Create a two-dimensional DataMatrix with nrows rows and ncols columns and initializes all elements with the same value.

Parameters
nrowsNumber of rows
ncolsNumber of columns
valueValue for all entries

◆ DataMatrix() [5/5]

sgpp::base::DataMatrix::DataMatrix ( const double *  input,
size_t  nrows,
size_t  ncols 
)

Create a new DataMatrix from a double array.

The double array contains the entries row-wise: x0_0,x0_1,...,x0_ncol-1, x1_0,x1_1,... ... xnrow_0, xnrow_1,...,xnrow_ncol-1

Parameters
inputdouble array that contains the data
nrowsnumber of rows
ncolsnumber of columns

Member Function Documentation

◆ abs()

void sgpp::base::DataMatrix::abs ( )

Sets all elements to their absolute value.

References python.statsfileInfo::i.

Referenced by set().

◆ add()

◆ addReduce() [1/2]

void sgpp::base::DataMatrix::addReduce ( DataVector reduction)

Reduce the DataMatrix along the columns by adding all entries in one row.

Parameters
reductionDataVector into which the reduce columns are stored

References sgpp::base::DataVector::getSize(), python.statsfileInfo::i, python.utils.statsfile2gnuplot::j, sgpp::base::DataVector::set(), and analyse_erg::tmp.

Referenced by set().

◆ addReduce() [2/2]

void sgpp::base::DataMatrix::addReduce ( DataVector reduction,
DataVector beta,
size_t  start_beta 
)

Reduce the DataMatrix along the columns by adding all entries in one row.

Parameters
reductionDataVector to which the reduce columns are added
betavector with length of number of columns beta[i] is multiplied to each element row[j][i]
start_betawhere to start using the beta coefficients

References sgpp::base::DataVector::getSize(), python.statsfileInfo::i, python.utils.statsfile2gnuplot::j, sgpp::base::DataVector::set(), and analyse_erg::tmp.

◆ appendCol()

size_t sgpp::base::DataMatrix::appendCol ( const DataVector vec)

Appends a new Col with data contained in DataVector vec and returns index of new col.

Parameters
vecDataVector (length has to match getNcols()) with data
Returns
Index of new col

References sgpp::base::DataVector::getSize().

Referenced by sgpp::combigrid::BsplineStochasticCollocation::eval(), and sgpp::datadriven::BayesianOptimization::updateGP().

◆ appendRow() [1/2]

size_t sgpp::base::DataMatrix::appendRow ( )

◆ appendRow() [2/2]

size_t sgpp::base::DataMatrix::appendRow ( const DataVector vec)

Appends a new row with data contained in DataVector vec and returns index of new row.

Parameters
vecDataVector (length has to match getNcols()) with data
Returns
Index of new row

References sgpp::base::DataVector::getSize().

◆ componentwise_div()

void sgpp::base::DataMatrix::componentwise_div ( const DataMatrix matr)

Divides the current DataMatrix component-wise by another DataMatrix.

Modifies the current values. Performs

for i from 1 to this.getTotalSize()
this[i] /= matr[i]

Note: No check for division by zero!

Parameters
matrthe DataMatrix which the current DataMatrix is divided by

References python.statsfileInfo::i.

Referenced by set().

◆ componentwise_mult()

void sgpp::base::DataMatrix::componentwise_mult ( const DataMatrix matr)

Multiplies the current DataMatrix component-wise with another DataMatrix.

Modifies the current values. Performs

for i from 1 to this.getSize()
this[i] *= matr[i]
Parameters
matrthe DataMatrix which is multiplied to current DataMatrix

References python.statsfileInfo::i.

Referenced by set().

◆ copyFrom()

void sgpp::base::DataMatrix::copyFrom ( const DataMatrix matr)

Copies the data from another DataMatrix matr.

Disregards the number of rows and columns set for the two matrices, i.e., just copies the data entry by entry (and row by row). If the dimensions match (nrows, ncols), the current DataMatrix is an exact copy of matr. If not, as many elements as possible are copied, and everything else is left untouched.

Parameters
matrThe source DataMatrix containing the data

Referenced by sgpp::datadriven::DBMatOfflineChol::choleskyModification().

◆ expand()

void sgpp::base::DataMatrix::expand ( const DataVector expand)

expands a given DataVector into a DataMatrix.

Parameters
expandDataVector that should be expanded

References sgpp::base::DataVector::get(), sgpp::base::DataVector::getSize(), python.statsfileInfo::i, and python.utils.statsfile2gnuplot::j.

Referenced by set().

◆ fromFile()

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

◆ fromString()

◆ get()

double sgpp::base::DataMatrix::get ( size_t  row,
size_t  col 
) const
inline

Returns the value of the element at position [row,col].

Parameters
rowRow
colColumn
Returns
Value of the element

Referenced by sgpp::datadriven::DBMatDMSDenseIChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyForwardSolve(), sgpp::datadriven::DBMatOfflineDenseIChol::choleskyModification(), sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::datadriven::AlgorithmAdaBoostBase::classif(), sgpp::datadriven::DataBasedRefinementFunctor::computeHkl(), sgpp::datadriven::DBMatOnlineDE::computeL2Error(), sgpp::base::PrecisionConverter::convertDataMatrixToDataMatrixSP(), sgpp::datadriven::DensityEstimator::corrcoef(), sgpp::datadriven::Friedman1Generator::createData(), sgpp::datadriven::Friedman2Generator::createData(), sgpp::datadriven::Friedman3Generator::createData(), sgpp::datadriven::BayesianOptimization::decomposeCholesky(), sgpp::datadriven::DBMatOfflineDenseIChol::decomposeMatrix(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::base::OperationFirstMomentLinearBoundary::doQuadrature(), sgpp::base::OperationFirstMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationFirstMomentModPoly::doQuadrature(), sgpp::base::OperationSecondMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPoly::doQuadrature(), sgpp::base::OperationSecondMomentPolyBoundary::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentModLinear::doQuadrature(), sgpp::base::OperationFirstMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPoly::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPolyBoundary::doQuadrature(), sgpp::base::OperationSecondMomentBspline::doQuadrature(), sgpp::base::OperationFirstMomentLinear::doQuadrature(), sgpp::base::OperationSecondMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationFirstMomentBspline::doQuadrature(), sgpp::base::OperationSecondMomentModBspline::doQuadrature(), sgpp::base::OperationFirstMomentModBspline::doQuadrature(), sgpp::base::OperationSecondMomentModLinear::doQuadrature(), sgpp::base::OperationSecondMomentModPoly::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationFirstMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationSecondMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentLinearBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentLinear::doQuadrature(), sgpp::quadrature::OperationQuadratureMCAdvanced::doQuadratureL2Error(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation(), sgpp::combigrid::PolynomialChaosExpansion::eval(), sgpp::combigrid::PolynomialStochasticCollocation::eval(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracyBL(), sgpp::datadriven::DBMatOfflineDenseIChol::ichol(), sgpp::datadriven::BayesianOptimization::likelihood(), sgpp::pde::OperationMatrixLTwoDotPeriodic::mult(), sgpp::pde::UpDownTwoOpDims::mult(), sgpp::pde::UpDownTwoOpDims::multParallelBuildingBlock(), sgpp::datadriven::OperationMultiEvalMPI::multSlave(), sgpp::pde::OperationMatrixLTwoDotExplicitLinear::OperationMatrixLTwoDotExplicitLinear(), sgpp::pde::OperationMatrixLTwoDotExplicitModifiedLinear::OperationMatrixLTwoDotExplicitModifiedLinear(), sgpp::pde::OperationMatrixLTwoDotExplicitPeriodic::OperationMatrixLTwoDotExplicitPeriodic(), sgpp::base::HierarchisationFundamentalSpline::operator()(), sgpp::base::HierarchisationModFundamentalSpline::operator()(), sgpp::base::DehierarchisationFundamentalSpline::operator()(), sgpp::base::DehierarchisationModFundamentalSpline::operator()(), sgpp::base::ImpurityRefinementIndicator::operator()(), sgpp::pde::LaplaceEnhancedDownBBLinearBoundary::operator()(), sgpp::base::PredictiveRefinementIndicator::operator()(), sgpp::datadriven::KernelDensityEstimator::pdf(), sgpp::datadriven::OperationMultiEvalCuda::prepare(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::datadriven::BayesianOptimization::solveCholeskySystem(), sgpp::base::ForwardSelectorRefinementIndicator::update(), and sgpp::base::ImpurityRefinementIndicator::update().

◆ getAdditionallyReservedRows()

size_t sgpp::base::DataMatrix::getAdditionallyReservedRows ( ) const
inline

Returns the number of unused rows.

Returns
number of unused rows

References getNumberNonZero().

Referenced by sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset().

◆ getColumn()

void sgpp::base::DataMatrix::getColumn ( size_t  col,
DataVector vec 
) const

Copies the values of a column to the DataVector vec.

Parameters
colThe column
vecDataVector into which the data is written

References sgpp::base::DataVector::getSize(), and python.utils.statsfile2gnuplot::j.

Referenced by sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::optimization::OperationMultipleHierarchisationModBspline::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModLinear::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModWavelet::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBspline::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationWavelet::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationWaveletBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBsplineBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinear::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinearBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModBsplineClenshawCurtis::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBsplineClenshawCurtis::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinearClenshawCurtis::doDehierarchisation(), sgpp::base::OperationEval::eval(), sgpp::base::OperationEvalGradient::evalGradient(), sgpp::base::OperationEvalHessian::evalHessian(), sgpp::base::OperationEvalPartialDerivative::evalPartialDerivative(), set(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::optimization::sle_solver::GaussianElimination::solve(), sgpp::optimization::sle_solver::Eigen::solve(), sgpp::optimization::sle_solver::Armadillo::solve(), sgpp::optimization::sle_solver::UMFPACK::solve(), and sgpp::optimization::sle_solver::SLESolver::solve().

◆ getNcols()

size_t sgpp::base::DataMatrix::getNcols ( ) const
inline

Returns the number of columns of the DataMatrix.

Returns
Number of columns

References normalizeDimension(), toFile(), and toString().

Referenced by sgpp::datadriven::ClusteringOCL::OperationClusteringOCL< T >::calculate_clusters(), sgpp::datadriven::Harmonica::calculateConstrainedSpace(), sgpp::datadriven::DBMatDMSChol::choleskyBackwardSolve(), sgpp::datadriven::DBMatDMSChol::choleskyForwardSolve(), sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::datadriven::DBMatDMSChol::choleskyUpdateLambda(), sgpp::datadriven::DBMatOnlineDE::computeDensityFunction(), sgpp::datadriven::DataBasedRefinementFunctor::computeH(), sgpp::datadriven::DataBasedRefinementFunctor::computeHkl(), sgpp::datadriven::DBMatOnlineDE::computeL2Error(), sgpp::base::PrecisionConverter::convertDataMatrixSPToDataMatrix(), sgpp::base::PrecisionConverter::convertDataMatrixToDataMatrixSP(), sgpp::datadriven::DensityEstimator::corrcoef(), sgpp::datadriven::KernelDensityEstimator::cov(), sgpp::datadriven::DensityEstimator::crossEntropy(), sgpp::datadriven::DBMatOnlineDE::DBMatOnlineDE(), sgpp::datadriven::DBMatOfflineDenseIChol::decomposeMatrix(), sgpp::optimization::OperationMultipleHierarchisationBspline::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBsplineBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinear::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinearBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModBspline::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModLinear::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModWavelet::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationWavelet::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationWaveletBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBsplineClenshawCurtis::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinearClenshawCurtis::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModBsplineClenshawCurtis::doDehierarchisation(), sgpp::base::OperationFirstMomentLinearBoundary::doQuadrature(), sgpp::base::OperationFirstMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationFirstMomentLinear::doQuadrature(), sgpp::base::OperationFirstMomentModBspline::doQuadrature(), sgpp::base::OperationFirstMomentBspline::doQuadrature(), sgpp::base::OperationFirstMomentModLinear::doQuadrature(), sgpp::base::OperationFirstMomentModPoly::doQuadrature(), sgpp::base::OperationFirstMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPoly::doQuadrature(), sgpp::base::OperationFirstMomentPolyBoundary::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentBspline::doQuadrature(), sgpp::base::OperationSecondMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBspline::doQuadrature(), sgpp::base::OperationSecondMomentModLinear::doQuadrature(), sgpp::base::OperationSecondMomentModPoly::doQuadrature(), sgpp::base::OperationSecondMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPoly::doQuadrature(), sgpp::base::OperationSecondMomentPolyBoundary::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationSecondMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentLinearBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::datadriven::OperationCovariance::doQuadrature(), sgpp::base::OperationSecondMomentLinear::doQuadrature(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), 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::OperationEvalPolyNaive::eval(), sgpp::base::OperationEvalPolyBoundaryNaive::eval(), sgpp::base::OperationEvalLinearNaive::eval(), sgpp::base::OperationEvalModLinearNaive::eval(), sgpp::base::OperationEvalLinearBoundaryNaive::eval(), sgpp::base::OperationEval::eval(), sgpp::base::OperationEvalWaveletBoundaryNaive::eval(), sgpp::base::OperationEvalWaveletNaive::eval(), sgpp::base::OperationEvalNakBsplineBoundaryCombigridNaive::eval(), sgpp::base::OperationEvalModWaveletNaive::eval(), sgpp::base::OperationEvalModBsplineNaive::eval(), sgpp::base::OperationEvalBsplineClenshawCurtisNaive::eval(), sgpp::base::OperationEvalModFundamentalSplineNaive::eval(), sgpp::base::OperationEvalBsplineBoundaryNaive::eval(), sgpp::base::OperationEvalFundamentalSplineNaive::eval(), sgpp::base::OperationEvalModBsplineClenshawCurtisNaive::eval(), sgpp::base::OperationEvalBsplineNaive::eval(), sgpp::base::OperationEvalGradient::evalGradient(), sgpp::base::OperationEvalGradientWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientModWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientWaveletBoundaryNaive::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::OperationEvalHessian::evalHessian(), sgpp::base::OperationEvalHessianModWaveletNaive::evalHessian(), sgpp::base::OperationEvalHessianWaveletNaive::evalHessian(), sgpp::base::OperationEvalHessianWaveletBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianModBsplineNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::OperationEvalHessianFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianModBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::OperationEvalPartialDerivative::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeModWaveletNaive::evalPartialDerivative(), sgpp::base::OperationEvalPartialDerivativeWaveletBoundaryNaive::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::ModelFittingClassification::evaluate(), sgpp::datadriven::ModelFittingDensityEstimationOnOff::fit(), sgpp::datadriven::ModelFittingDensityEstimationCG::fit(), sgpp::base::ForwardSelectorRefinementIndicator::ForwardSelectorRefinementIndicator(), fromString(), sgpp::datadriven::LearnerSVM::getError(), sgpp::quadrature::SampleGenerator::getSamples(), sgpp::datadriven::LearnerSGD::initialize(), sgpp::datadriven::LearnerSGDE::initialize(), sgpp::datadriven::LearnerSVM::initialize(), sgpp::datadriven::KernelDensityEstimator::initialize(), sgpp::datadriven::SparseGridDensityEstimator::initialize(), sgpp::datadriven::DBMatOfflineOrthoAdapt::invert_symmetric_tridiag(), sgpp::datadriven::LearnerSGD::LearnerSGD(), main(), sgpp::datadriven::OperationMultiEvalStreaming::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPeriodic::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPoly::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyBoundary::mult(), sgpp::base::OperationMultipleEvalInterModLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineBoundary::mult(), sgpp::pde::OperationLaplaceExplicitBspline::mult(), sgpp::pde::OperationLaplaceExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPoly::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBsplineClenshawCurtis::mult(), sgpp::pde::OperationLaplaceExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModifiedLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::mult(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult(), sgpp::base::AlgorithmDGEMV< BASIS >::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult_transpose(), sgpp::base::AlgorithmDGEMV< BASIS >::mult_transposed(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::multImpl(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::multImpl(), sgpp::datadriven::OperationMultiEvalMPI::multSlave(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::base::OperationMultipleEvalInterModLinear::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::multTranspose(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::multTransposeImpl(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::multTransposeImpl(), sgpp::pde::OperationLaplaceExplicitLinear::OperationLaplaceExplicitLinear(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::OperationMultiEvalStreamingBSplineOCL(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::OperationMultiEvalStreamingModOCLFastMultiPlatform(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::OperationMultiEvalStreamingModOCLMaskMultiPlatform(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::OperationMultiEvalStreamingModOCLOpt(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::OperationMultiEvalStreamingModOCLUnified(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::OperationMultiEvalStreamingOCLMultiPlatform(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::OperationMultipleEvalSubspaceCombined(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::OperationMultipleEvalSubspaceSimple(), sgpp::datadriven::DataBasedRefinementFunctor::operator()(), sgpp::base::HierarchisationModFundamentalSpline::operator()(), sgpp::base::DehierarchisationFundamentalSpline::operator()(), sgpp::base::HierarchisationFundamentalSpline::operator()(), sgpp::base::DehierarchisationModFundamentalSpline::operator()(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::LearnerSVM::predict(), sgpp::datadriven::LearnerSGDE::predict(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::prepare(), sgpp::datadriven::DBMatOffline::printMatrix(), sgpp::datadriven::SortedDataset::restoreOrder(), sgpp::datadriven::MPIMethods::sendSystemMatrixDecomposition(), sgpp::combigrid::CombigridMultiOperation::setParameters(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::datadriven::DBMatDMSChol::solve(), sgpp::datadriven::DBMatDMSOrthoAdapt::solve(), sgpp::optimization::sle_solver::Eigen::solve(), sgpp::optimization::sle_solver::Armadillo::solve(), sgpp::optimization::sle_solver::UMFPACK::solve(), sgpp::optimization::sle_solver::SLESolver::solve(), sgpp::datadriven::DBMatOnlineDEChol::solveSLE(), sgpp::datadriven::DatasetTools::splitset(), sgpp::datadriven::DBMatOffline::store(), sgpp::datadriven::LearnerSGD::storeResults(), sgpp::datadriven::LearnerSVM::storeResults(), sgpp::datadriven::LearnerSGDE::storeResults(), sgpp::datadriven::test_dataset(), sgpp::datadriven::test_dataset_mse(), sgpp::datadriven::test_datasetWithCharacteristicNumber(), sgpp::datadriven::LearnerSGD::train(), sgpp::datadriven::LearnerSVM::train(), sgpp::datadriven::LearnerSGDE::train(), sgpp::datadriven::SparseGridDensityEstimator::train(), sgpp::datadriven::BayesianOptimization::updateGP(), sgpp::datadriven::SortedDataset::usePermutation(), and sgpp::optimization::file_io::writeMatrix().

◆ getNrows()

size_t sgpp::base::DataMatrix::getNrows ( ) const
inline

Returns the number of rows of the DataMatrix.

Returns
Number of rows

Referenced by sgpp::datadriven::PrimalDualSVM::add(), sgpp::datadriven::AlgorithmAdaBoostBase::AlgorithmAdaBoostBase(), sgpp::datadriven::ClusteringOCL::OperationClusteringOCL< T >::calculate_clusters(), sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::DBMatDMSChol::choleskyDowndate(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatOfflineDenseIChol::choleskyModification(), sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::datadriven::DBMatOfflineChol::choleskyPermutation(), sgpp::datadriven::DBMatDMSChol::choleskyUpdate(), sgpp::datadriven::AlgorithmAdaBoostBase::classif(), sgpp::datadriven::DBMatOnlineDE::computeDensityFunction(), sgpp::datadriven::SparseGridDensityEstimator::computeDensitySystemMatrix(), sgpp::datadriven::DataBasedRefinementFunctor::computeH(), sgpp::datadriven::DataBasedRefinementFunctor::computeHkl(), sgpp::datadriven::DBMatOnlineDE::computeL2Error(), sgpp::base::PrecisionConverter::convertDataMatrixSPToDataMatrix(), sgpp::base::PrecisionConverter::convertDataMatrixToDataMatrixSP(), sgpp::datadriven::KernelDensityEstimator::cov(), sgpp::datadriven::DensityEstimator::crossEntropy(), sgpp::datadriven::BayesianOptimization::decomposeCholesky(), sgpp::datadriven::DBMatOfflineDenseIChol::decomposeMatrix(), sgpp::datadriven::DBMatOfflineChol::decomposeMatrix(), sgpp::datadriven::DBMatOfflineOrthoAdapt::decomposeMatrix(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::base::OperationFirstMomentLinearBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBspline::doQuadrature(), sgpp::base::OperationSecondMomentModLinear::doQuadrature(), sgpp::base::OperationSecondMomentModPoly::doQuadrature(), sgpp::base::OperationSecondMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPoly::doQuadrature(), sgpp::base::OperationSecondMomentPolyBoundary::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentLinear::doQuadrature(), sgpp::base::OperationFirstMomentBspline::doQuadrature(), sgpp::base::OperationFirstMomentModBspline::doQuadrature(), sgpp::base::OperationFirstMomentModPoly::doQuadrature(), sgpp::base::OperationFirstMomentModLinear::doQuadrature(), sgpp::base::OperationFirstMomentModPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPoly::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationFirstMomentPolyBoundary::doQuadrature(), sgpp::base::OperationSecondMomentBspline::doQuadrature(), sgpp::base::OperationSecondMomentBsplineBoundary::doQuadrature(), sgpp::base::OperationSecondMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationFirstMomentModBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationFirstMomentPolyClenshawCurtisBoundary::doQuadrature(), sgpp::base::OperationFirstMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentBsplineClenshawCurtis::doQuadrature(), sgpp::base::OperationSecondMomentLinearBoundary::doQuadrature(), sgpp::datadriven::OperationCovariance::doQuadrature(), sgpp::base::OperationSecondMomentLinear::doQuadrature(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation(), sgpp::combigrid::PolynomialChaosExpansion::eval(), sgpp::combigrid::PolynomialStochasticCollocation::eval(), sgpp::base::OperationEval::eval(), sgpp::base::OperationEvalGradient::evalGradient(), sgpp::base::OperationEvalHessian::evalHessian(), sgpp::base::OperationEvalPartialDerivative::evalPartialDerivative(), sgpp::datadriven::ModelFittingClassification::evaluate(), sgpp::pde::PDESolver::evaluateCuboid(), sgpp::base::ForwardSelectorRefinementIndicator::ForwardSelectorRefinementIndicator(), fromString(), sgpp::datadriven::LearnerSGD::getAccuracy(), sgpp::datadriven::LearnerSVM::getAccuracy(), sgpp::datadriven::LearnerBase::getAccuracy(), sgpp::datadriven::LearnerSGDE::getAccuracy(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracy(), sgpp::datadriven::AlgorithmAdaBoostBase::getAccuracyBL(), sgpp::datadriven::LearnerSGD::getBatchError(), sgpp::datadriven::LearnerBase::getCassificatorQuality(), sgpp::optimization::FullSLE::getDimension(), sgpp::datadriven::LearnerSGD::getError(), sgpp::datadriven::LearnerSVM::getError(), sgpp::datadriven::DBMatOffline::getGridSize(), sgpp::datadriven::PiecewiseConstantRegression::Node::getMSE(), sgpp::datadriven::AbstractOperationMultipleEvalSubspace::getPaddedDatasetSize(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::getPaddedDatasetSize(), sgpp::datadriven::AlgorithmAdaBoostBase::getROC(), sgpp::quadrature::SampleGenerator::getSamples(), sgpp::datadriven::DBMatOfflineOrthoAdapt::hessenberg_decomposition(), sgpp::optimization::math::hessenbergForm(), sgpp::datadriven::OperationPiecewiseConstantRegression::hierarchize(), sgpp::optimization::math::householderTransformation(), sgpp::datadriven::DBMatOfflineDenseIChol::ichol(), sgpp::datadriven::KernelDensityEstimator::initialize(), sgpp::datadriven::DBMatOfflineOrthoAdapt::invert_symmetric_tridiag(), sgpp::datadriven::MetaLearner::learnAndCompareString(), sgpp::datadriven::MetaLearner::learnAndTestString(), main(), sgpp::base::OperationMultipleEvalLinearBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalPolyBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalLinearNaive::mult(), sgpp::base::OperationMultipleEvalModBsplineClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalModPolyClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalBsplineBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalPolyNaive::mult(), sgpp::base::OperationMultipleEvalBsplineClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalModLinearClenshawCurtisNaive::mult(), sgpp::base::OperationMultipleEvalModBsplineNaive::mult(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisBoundaryNaive::mult(), sgpp::base::OperationMultipleEvalBsplineNaive::mult(), sgpp::datadriven::OperationMultiEvalHPX::mult(), sgpp::datadriven::OperationMultiEvalMPI::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPeriodic::mult(), sgpp::base::OperationMultipleEvalInterModLinear::mult(), sgpp::pde::OperationLaplaceExplicitBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyBoundary::mult(), sgpp::pde::OperationLaplaceExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPoly::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPoly::mult(), sgpp::pde::OperationLaplaceExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModifiedLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::mult(), sgpp::datadriven::DMSystemMatrix::mult(), sgpp::base::OperationMultipleEvalBsplineClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalModPolyClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalModLinearClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearNaive::multTranspose(), sgpp::base::OperationMultipleEvalModBsplineClenshawCurtisNaive::multTranspose(), sgpp::base::OperationMultipleEvalBsplineBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalLinearClenshawCurtisBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalPolyClenshawCurtisBoundaryNaive::multTranspose(), sgpp::base::OperationMultipleEvalModBsplineNaive::multTranspose(), sgpp::base::OperationMultipleEvalBsplineNaive::multTranspose(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::base::OperationMultipleEvalInterModLinear::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::OperationMultiEvalStreamingBSplineOCL(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::OperationMultiEvalStreamingModOCLFastMultiPlatform(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::OperationMultiEvalStreamingModOCLMaskMultiPlatform(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::OperationMultiEvalStreamingModOCLOpt(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::OperationMultiEvalStreamingModOCLUnified(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::OperationMultiEvalStreamingOCLMultiPlatform(), sgpp::base::ImpurityRefinementIndicator::operator()(), sgpp::base::PredictiveRefinementIndicator::operator()(), sgpp::optimization::optimizer::LogBarrier::optimize(), sgpp::optimization::optimizer::MultiStart::optimize(), sgpp::optimization::optimizer::AugmentedLagrangian::optimize(), sgpp::optimization::optimizer::SquaredPenalty::optimize(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::KernelDensityEstimator::pdf(), sgpp::datadriven::LearnerLeastSquaresIdentity::postProcessing(), sgpp::datadriven::LearnerLeastSquaresIdentity::predict(), sgpp::datadriven::ClassificationLearner::predict(), sgpp::datadriven::LearnerSVM::predict(), sgpp::datadriven::LearnerSGD::predict(), sgpp::datadriven::RegressionLearner::predict(), sgpp::datadriven::LearnerBase::predict(), sgpp::datadriven::LearnerSGDE::predict(), sgpp::datadriven::LearnerSGDEOnOffParallel::predict(), sgpp::datadriven::ClassificationLearner::predictWithCertainty(), sgpp::datadriven::OperationMultiEvalCuda::prepare(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::prepare(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::prepare(), sgpp::datadriven::DBMatOffline::printMatrix(), sgpp::datadriven::LearnerSGD::pushToBatch(), sgpp::optimization::math::QRDecomposition(), sgpp::optimization::math::schurDecomposition(), sgpp::datadriven::MPIMethods::sendSystemMatrixDecomposition(), sgpp::combigrid::CombigridMultiOperation::setParameters(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::datadriven::DBMatDMSOrthoAdapt::solve(), sgpp::datadriven::DatasetTools::splitset(), sgpp::datadriven::DBMatOffline::store(), sgpp::datadriven::LearnerSGD::storeResults(), sgpp::datadriven::LearnerSVM::storeResults(), sgpp::datadriven::LearnerSGDE::storeResults(), sgpp::datadriven::SystemMatrixLeastSquaresIdentity::SystemMatrixLeastSquaresIdentity(), sgpp::datadriven::test_calculateROCcurve(), sgpp::datadriven::test_dataset(), sgpp::datadriven::test_dataset_mse(), sgpp::datadriven::test_datasetWithCharacteristicNumber(), sgpp::datadriven::LearnerLeastSquaresIdentity::testRegular(), sgpp::datadriven::LearnerSGD::train(), sgpp::datadriven::LearnerSVM::train(), sgpp::datadriven::LearnerBase::train(), sgpp::datadriven::RegressionLearner::train(), sgpp::base::BoundingBox::transformPointsToBoundingBox(), sgpp::base::BoundingBox::transformPointsToUnitCube(), sgpp::datadriven::ModelFittingClassification::update(), sgpp::datadriven::ModelFittingDensityEstimationCG::update(), sgpp::base::ForwardSelectorRefinementIndicator::update(), sgpp::base::ImpurityRefinementIndicator::update(), sgpp::pde::UpDownOneOpDimEnhanced::updown(), and sgpp::optimization::file_io::writeMatrix().

◆ getNumberNonZero()

size_t sgpp::base::DataMatrix::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 getAdditionallyReservedRows().

◆ getPointer() [1/2]

double * sgpp::base::DataMatrix::getPointer ( )

Returns pointer to double array containing underlying data.

Returns
Pointer to data

References python.statsfileInfo::data.

Referenced by sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::DBMatDMSChol::choleskyDowndate(), sgpp::datadriven::DBMatOfflineChol::choleskyPermutation(), sgpp::datadriven::DBMatDMSChol::choleskyUpdate(), sgpp::datadriven::DBMatOfflineOrthoAdapt::DBMatOfflineOrthoAdapt(), sgpp::datadriven::DBMatOfflineChol::decomposeMatrix(), sgpp::datadriven::DensityOCLMultiPlatform::OperationDensityOCLMultiPlatform< T >::generateb(), sgpp::datadriven::DBMatOfflineOrthoAdapt::hessenberg_decomposition(), sgpp::datadriven::DensityOCLMultiPlatform::OperationDensityOCLMultiPlatform< T >::initialize_dataset(), sgpp::pde::OperationMatrixLTwoDotExplicitPeriodic::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPoly::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPoly::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyBoundary::mult(), sgpp::pde::OperationLaplaceExplicitBspline::mult(), sgpp::pde::OperationLaplaceExplicitModBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBspline::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModifiedLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModLinear::mult(), sgpp::pde::OperationLaplaceExplicitLinear::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitModPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtis::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary::mult(), sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::mult(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::multImpl(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::multTransposeImpl(), sgpp::datadriven::DensityOCLMultiPlatform::OperationCreateGraphOCLSingleDevice< T >::OperationCreateGraphOCLSingleDevice(), sgpp::datadriven::DensityOCLMultiPlatform::OperationPruneGraphOCLMultiPlatform< T >::OperationPruneGraphOCLMultiPlatform(), sgpp::pde::LaplaceEnhancedUpBBLinearBoundary::operator()(), sgpp::pde::LaplaceEnhancedDownBBLinearBoundary::operator()(), sgpp::pde::LaplaceEnhancedUpBBLinear::operator()(), sgpp::pde::LaplaceEnhancedDownBBLinear::operator()(), set(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::datadriven::DBMatDMSOrthoAdapt::solve(), sgpp::optimization::sle_solver::Armadillo::solve(), sgpp::datadriven::DBMatOfflineOrthoAdapt::store(), sgpp::datadriven::DBMatOffline::store(), and sgpp::optimization::file_io::writeMatrix().

◆ getPointer() [2/2]

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

Returns const pointer to double array containing underlying data.

Returns
Const pointer to data

References python.statsfileInfo::data.

◆ getRow() [1/2]

void sgpp::base::DataMatrix::getRow ( size_t  row,
DataVector vec 
) const

Copies the values of a row to the DataVector vec.

Parameters
rowThe row
vecDataVector into which the data is written

References sgpp::base::DataVector::getSize(), and python.statsfileInfo::i.

Referenced by sgpp::datadriven::LearnerSGDEOnOffParallel::assembleNextBatchData(), sgpp::datadriven::DataBasedRefinementFunctor::computeHkl(), sgpp::datadriven::DBMatOnlineDE::computeL2Error(), sgpp::datadriven::DensityEstimator::crossEntropy(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::quadrature::OperationQuadratureMCAdvanced::doQuadratureFunc(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::ModelFittingClassification::evaluate(), sgpp::base::ForwardSelectorRefinementIndicator::ForwardSelectorRefinementIndicator(), sgpp::datadriven::LearnerSVM::getError(), sgpp::datadriven::PiecewiseConstantRegression::Node::getMSE(), sgpp::datadriven::PiecewiseConstantRegression::Node::getSupportIndizes(), sgpp::datadriven::RosenblattTransformation::initialize(), sgpp::datadriven::KernelDensityEstimator::initialize(), sgpp::base::OperationMultipleEvalInterModLinear::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult(), sgpp::base::AlgorithmDGEMV< BASIS >::mult(), sgpp::base::AlgorithmMultipleEvaluation< BASIS >::mult_transpose(), sgpp::base::AlgorithmDGEMV< BASIS >::mult_transposed(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::multImpl(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::base::OperationMultipleEvalInterModLinear::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::datadriven::OperationMultipleEvalSubspaceSimple::multTransposeImpl(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::LearnerSVM::predict(), sgpp::datadriven::LearnerSGDE::predict(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::prepare(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::prepare(), set(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::datadriven::LearnerSGDEOnOffParallel::splitBatchIntoClasses(), sgpp::datadriven::DatasetTools::splitset(), sgpp::datadriven::LearnerSGD::storeResults(), sgpp::datadriven::LearnerSVM::storeResults(), sgpp::datadriven::LearnerSGDE::storeResults(), sgpp::datadriven::test_dataset(), sgpp::datadriven::test_dataset_mse(), sgpp::datadriven::test_datasetWithCharacteristicNumber(), sgpp::datadriven::LearnerSGD::train(), sgpp::datadriven::LearnerSVM::train(), and sgpp::datadriven::ModelFittingClassification::update().

◆ getRow() [2/2]

void sgpp::base::DataMatrix::getRow ( size_t  row,
std::vector< double > &  vec 
) const

Copies the values of a row to the std::vector vec.

Parameters
rowThe row
vecstd::vector into which the data is written

References python.statsfileInfo::i.

◆ getSize()

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

Returns the total number of (used) elements, i.e., getNrows()*getNCols()

Returns
Number of elements stored in the matrix

Referenced by python.uq.uq_setting.UQSetting.UQSetting::convert(), sgpp::datadriven::DensityOCLMultiPlatform::OperationDensityOCLMultiPlatform< T >::generateb(), python.uq.uq_setting.UQSetting.UQSetting::getTimeDependentResults(), sgpp::datadriven::DBMatOfflineDenseIChol::ichol(), sgpp::datadriven::DensityOCLMultiPlatform::OperationDensityOCLMultiPlatform< T >::initialize_dataset(), sgpp::datadriven::DensityOCLMultiPlatform::OperationCreateGraphOCLSingleDevice< T >::OperationCreateGraphOCLSingleDevice(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::OperationMultiEvalStreamingBSplineOCL(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::OperationMultiEvalStreamingModOCLFastMultiPlatform(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::OperationMultiEvalStreamingModOCLMaskMultiPlatform(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::OperationMultiEvalStreamingModOCLOpt(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::OperationMultiEvalStreamingModOCLUnified(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::OperationMultiEvalStreamingOCLMultiPlatform(), sgpp::datadriven::DensityOCLMultiPlatform::OperationPruneGraphOCLMultiPlatform< T >::OperationPruneGraphOCLMultiPlatform(), python.uq.uq_setting.UQSetting.UQSetting::runSamples(), and python.uq.uq_setting.UQSetting.UQSetting::runSamples_withoutDistribution().

◆ max() [1/2]

double sgpp::base::DataMatrix::max ( size_t  col) const

Returns the maximum value of column col.

Parameters
colNumber of the column
Returns
Maximum value

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

◆ max() [2/2]

double sgpp::base::DataMatrix::max ( ) const

Returns the maximum over all entries.

Returns
Maximal value of all entries

References python.statsfileInfo::i.

Referenced by max(), and set().

◆ min() [1/2]

double sgpp::base::DataMatrix::min ( size_t  col) const

Returns the minimum value of column col.

Parameters
colNumber of the column
Returns
Minimum value

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

◆ min() [2/2]

double sgpp::base::DataMatrix::min ( ) const

Returns the minimum over all entries.

Returns
Minimal value of all entries

References python.statsfileInfo::i.

Referenced by min(), and set().

◆ minmax() [1/2]

void sgpp::base::DataMatrix::minmax ( size_t  col,
double *  min,
double *  max 
) const

Determines minimum and maximum of column col.

Parameters
colNumber of the column
minReference variable for the minimum
maxReference variable for the maximum

References python.statsfileInfo::i.

Referenced by normalizeDimension(), and set().

◆ minmax() [2/2]

void sgpp::base::DataMatrix::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.

◆ mult() [1/2]

◆ mult() [2/2]

void sgpp::base::DataMatrix::mult ( const DataVector x,
DataVector y 
)

Multiplies the matrix with a vector x and stores the result in another vector y.

Parameters
[in]xvector to be multiplied
[out]yvector in which the result should be stored

References sgpp::base::DataVector::getSize(), python.statsfileInfo::i, and python.utils.statsfile2gnuplot::j.

◆ normalizeDimension() [1/2]

void sgpp::base::DataMatrix::normalizeDimension ( size_t  d)

Normalizes the d-th dimension (entries in the d-th column) to \([0,1]\).

Considers contents of DataMatrix as a d-dimensional dataset, one data point per row.

Parameters
dThe dimension (column) that should be normalized (starting with 0)

Referenced by sgpp::datadriven::Friedman2Generator::createData(), sgpp::datadriven::Friedman3Generator::createData(), and getNcols().

◆ normalizeDimension() [2/2]

void sgpp::base::DataMatrix::normalizeDimension ( size_t  d,
double  border 
)

Normalizes the d-th dimension (entries in the d-th column) to \([border,1-border]\).

Considers contents of DataMatrix as a d-dimensional dataset, one data point per row.

Parameters
dThe dimension (column) that should be normalized (starting with 0)
borderWidth of the border

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

◆ operator()() [1/2]

double& sgpp::base::DataMatrix::operator() ( size_t  row,
size_t  col 
)
inline

Returns the value of the element at position [row,col].

Parameters
rowRow
colColumn
Returns
reference to the element

◆ operator()() [2/2]

const double& sgpp::base::DataMatrix::operator() ( size_t  row,
size_t  col 
) const
inline

Returns the value of the element at position [row,col].

Parameters
rowRow
colColumn
Returns
constant reference to the element

◆ operator=()

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

Move constructor.

Copy assignment operator

Referenced by resizeQuadratic(), resizeToSubMatrix(), and transpose().

◆ reserveAdditionalRows()

void sgpp::base::DataMatrix::reserveAdditionalRows ( size_t  inc_nrows)

Reserves memory for potentially inc_nrows new rows; the actual number of rows remains unchanged.

Corresponds to a resize to nrows+inc_nrows new rows while leaving the current matrix' size unchanged.

Parameters
inc_nrowsNumber of additional rows for which storage is to be reserved.

Referenced by sgpp::datadriven::LearnerSGD::LearnerSGD(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::PrimalDualSVM::PrimalDualSVM(), and resizeToSubMatrix().

◆ resize() [1/2]

void sgpp::base::DataMatrix::resize ( size_t  nrows)

Resizes the DataMatrix to nrows rows.

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

Deprecated:
use resizeRows
Parameters
nrowsNew number of rows of the DataMatrix

References resizeRows().

Referenced by sgpp::datadriven::DataBasedRefinementFunctor::computeH(), sgpp::datadriven::KernelDensityEstimator::cov(), sgpp::datadriven::Friedman1Generator::createData(), sgpp::datadriven::Friedman2Generator::createData(), sgpp::datadriven::Friedman3Generator::createData(), sgpp::datadriven::OperationCovariance::doQuadrature(), sgpp::base::OperationEvalGradient::evalGradient(), sgpp::base::OperationEvalGradientWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientModWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientWaveletBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineClenshawCurtisNaive::evalGradient(), sgpp::base::OperationEvalGradientModFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineClenshawCurtisNaive::evalGradient(), sgpp::base::OperationEvalHessian::evalHessian(), 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(), fromString(), sgpp::base::HashGridStorage::getCoordinateArrays(), sgpp::base::EvalCuboidGenerator::getEvaluationCuboid(), sgpp::base::EvalCuboidGeneratorForStretching::getEvaluationCuboid(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::getMaxInversionError(), sgpp::optimization::math::hessenbergForm(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::optimization::optimizer::CMAES::optimize(), sgpp::optimization::optimizer::AdaptiveGradientDescent::optimize(), sgpp::optimization::optimizer::Rprop::optimize(), sgpp::optimization::optimizer::BFGS::optimize(), sgpp::optimization::optimizer::GradientDescent::optimize(), sgpp::optimization::optimizer::NelderMead::optimize(), sgpp::optimization::optimizer::LogBarrier::optimize(), sgpp::optimization::optimizer::DifferentialEvolution::optimize(), sgpp::optimization::optimizer::NLCG::optimize(), sgpp::optimization::optimizer::MultiStart::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(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::prepare(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::prepare(), sgpp::optimization::math::QRDecomposition(), sgpp::optimization::file_io::readMatrix(), sgpp::optimization::math::schurDecomposition(), sgpp::optimization::sle_solver::Eigen::solve(), sgpp::optimization::sle_solver::Armadillo::solve(), sgpp::optimization::sle_solver::UMFPACK::solve(), sgpp::optimization::sle_solver::SLESolver::solve(), and sgpp::datadriven::test_calculateROCcurve().

◆ resize() [2/2]

void sgpp::base::DataMatrix::resize ( size_t  nrows,
size_t  ncols 
)

Resizes the DataMatrix to nrows rows and ncols columns.

All new additional entries are uninitialized. If nrows*ncols is smaller than the current number of entries, all superfluous entries are removed.

Deprecated:
use resizeRowsCols
Parameters
nrowsNew number of rows of the DataMatrix
ncolsNew number of columns of the DataMatrix

References resizeRowsCols().

◆ resizeQuadratic()

void sgpp::base::DataMatrix::resizeQuadratic ( size_t  size)

Resizes the quadratic DataMatrix to size rows and size columns.

All new additional entries are uninitialized. If size is smaller than the current size of the quadratic DataMatrix, all superfluous entries are removed.

Parameters
sizeNew dimension of quadratic data DataMatrix

References python.statsfileInfo::i, and operator=().

Referenced by sgpp::datadriven::DBMatOfflineOrthoAdapt::buildMatrix(), sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::datadriven::DBMatDMSDenseIChol::DBMatDMSDenseIChol(), and sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt().

◆ resizeRows()

void sgpp::base::DataMatrix::resizeRows ( size_t  nrows)

Resizes the DataMatrix to nrows rows.

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

Parameters
nrowsNew number of rows of the DataMatrix

Referenced by resize(), and resizeZero().

◆ resizeRowsCols()

void sgpp::base::DataMatrix::resizeRowsCols ( size_t  nrows,
size_t  ncols 
)

Resizes the DataMatrix to nrows rows and ncols columns.

All new additional entries are uninitialized. If nrows*ncols is smaller than the current number of entries, all superfluous entries are removed.

Parameters
nrowsNew number of rows of the DataMatrix
ncolsNew number of columns of the DataMatrix

Referenced by sgpp::datadriven::MPIMethods::receiveGridComponentsUpdate(), resize(), and resizeZero().

◆ resizeToSubMatrix()

void sgpp::base::DataMatrix::resizeToSubMatrix ( size_t  row_1,
size_t  col_1,
size_t  row_2,
size_t  col_2 
)

Resize current matrix to the submatrix Mat[row_1:row_2, col_1:col_2].

Parameters
row_1,col_1corresponding to left upper index of desired submatrix
row_2,col_2corresponding to right lower index of desired submatrix

References operator=(), and reserveAdditionalRows().

Referenced by sgpp::datadriven::DBMatOfflineChol::choleskyModification().

◆ resizeZero() [1/2]

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

Resizes the DataMatrix to nrows rows.

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

Deprecated:
use resizeRows
Parameters
nrowsNew number of rows of the DataMatrix

References resizeRows().

◆ resizeZero() [2/2]

void sgpp::base::DataMatrix::resizeZero ( size_t  nrows,
size_t  ncols 
)

Resizes the DataMatrix to nrows rows and ncols columns.

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

Deprecated:
use resizeRowsCols
Parameters
nrowsNew number of rows of the DataMatrix
ncolsNew number of columns of the DataMatrix

References resizeRowsCols().

◆ set()

void sgpp::base::DataMatrix::set ( size_t  row,
size_t  col,
double  value 
)
inline

Sets the element at position [row,col] to value.

Parameters
rowRow
colColumn
valueNew value for element

References abs(), add(), addReduce(), componentwise_div(), componentwise_mult(), expand(), getColumn(), getPointer(), getRow(), max(), min(), minmax(), mult(), setColumn(), setRow(), sqr(), sqrt(), sub(), and sum().

Referenced by BSplineCoefficientGridFunction(), BSplineTensorCoefficientGridFunction(), sgpp::datadriven::DBMatOfflineGE::buildMatrix(), sgpp::datadriven::DBMatDMSDenseIChol::choleskyForwardSolve(), sgpp::datadriven::DBMatOfflineDenseIChol::choleskyModification(), sgpp::datadriven::DBMatOfflineChol::choleskyModification(), sgpp::base::PrecisionConverter::convertDataMatrixSPToDataMatrix(), sgpp::datadriven::DensityEstimator::corrcoef(), sgpp::datadriven::KernelDensityEstimator::cov(), sgpp::datadriven::Friedman1Generator::createData(), sgpp::datadriven::Friedman2Generator::createData(), sgpp::datadriven::Friedman3Generator::createData(), sgpp::datadriven::BayesianOptimization::decomposeCholesky(), sgpp::datadriven::DBMatOfflineChol::decomposeMatrix(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::OperationCovariance::doQuadrature(), sgpp::base::OperationQuadratureMC::doQuadrature(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationDensitySamplingLinear::doSampling(), sgpp::datadriven::OperationDensityRejectionSamplingLinear::doSampling(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::combigrid::FullGridPCESummationStrategy< V >::eval(), sgpp::base::HashGridStorage::getLevelForIntegral(), sgpp::base::HashGridStorage::getLevelIndexArraysForEval(), sgpp::base::HashGridStorage::getLevelIndexMaskArraysForModEval(), sgpp::datadriven::DBMatOfflineDenseIChol::ichol(), sgpp::datadriven::DBMatOfflineOrthoAdapt::invert_symmetric_tridiag(), sgpp::datadriven::OperationMultiEvalMPI::multSlave(), sgpp::pde::OperationLaplaceExplicitBspline::OperationLaplaceExplicitBspline(), sgpp::pde::OperationLaplaceExplicitModBspline::OperationLaplaceExplicitModBspline(), sgpp::pde::OperationMatrixLTwoDotExplicitBspline::OperationMatrixLTwoDotExplicitBspline(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineBoundary::OperationMatrixLTwoDotExplicitBsplineBoundary(), sgpp::pde::OperationMatrixLTwoDotExplicitBsplineClenshawCurtis::OperationMatrixLTwoDotExplicitBsplineClenshawCurtis(), sgpp::pde::OperationMatrixLTwoDotExplicitLinear::OperationMatrixLTwoDotExplicitLinear(), sgpp::pde::OperationMatrixLTwoDotExplicitModBspline::OperationMatrixLTwoDotExplicitModBspline(), sgpp::pde::OperationMatrixLTwoDotExplicitModBsplineClenshawCurtis::OperationMatrixLTwoDotExplicitModBsplineClenshawCurtis(), sgpp::pde::OperationMatrixLTwoDotExplicitModifiedLinear::OperationMatrixLTwoDotExplicitModifiedLinear(), sgpp::pde::OperationMatrixLTwoDotExplicitModLinear::OperationMatrixLTwoDotExplicitModLinear(), sgpp::pde::OperationMatrixLTwoDotExplicitModPoly::OperationMatrixLTwoDotExplicitModPoly(), sgpp::pde::OperationMatrixLTwoDotExplicitModPolyClenshawCurtis::OperationMatrixLTwoDotExplicitModPolyClenshawCurtis(), sgpp::pde::OperationMatrixLTwoDotExplicitPeriodic::OperationMatrixLTwoDotExplicitPeriodic(), sgpp::pde::OperationMatrixLTwoDotExplicitPoly::OperationMatrixLTwoDotExplicitPoly(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyBoundary::OperationMatrixLTwoDotExplicitPolyBoundary(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtis::OperationMatrixLTwoDotExplicitPolyClenshawCurtis(), sgpp::pde::OperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary::OperationMatrixLTwoDotExplicitPolyClenshawCurtisBoundary(), sgpp::base::HierarchisationModFundamentalSpline::operator()(), sgpp::base::DehierarchisationFundamentalSpline::operator()(), sgpp::base::HierarchisationFundamentalSpline::operator()(), sgpp::base::DehierarchisationModFundamentalSpline::operator()(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::prepare(), sgpp::datadriven::ARFFTools::readARFF(), sgpp::datadriven::CSVTools::readCSV(), sgpp::datadriven::Harmonica::setParameters(), sgpp::datadriven::BayesianOptimization::setScales(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::datadriven::test_calculateROCcurve(), and sgpp::datadriven::BayesianOptimization::updateGP().

◆ setAll()

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

Sets all entries of DataMatrix to value.

Parameters
valueNew value for all entries

References python.statsfileInfo::i.

Referenced by BSplineTensorCoefficientGridFunction(), sgpp::datadriven::DBMatOfflineGE::buildMatrix(), sgpp::datadriven::KernelDensityEstimator::cov(), sgpp::datadriven::OperationCovariance::doQuadrature(), sgpp::datadriven::AlgorithmAdaBoostBase::eval(), sgpp::base::OperationEvalGradientWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientWaveletBoundaryNaive::evalGradient(), sgpp::base::OperationEvalGradientModWaveletNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientFundamentalSplineNaive::evalGradient(), sgpp::base::OperationEvalGradientModBsplineNaive::evalGradient(), sgpp::base::OperationEvalGradientBsplineBoundaryNaive::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::OperationEvalHessianBsplineClenshawCurtisNaive::evalHessian(), sgpp::base::OperationEvalHessianBsplineBoundaryNaive::evalHessian(), sgpp::base::OperationEvalHessianModFundamentalSplineNaive::evalHessian(), sgpp::base::OperationEvalHessianFundamentalSplineNaive::evalHessian(), and sgpp::base::OperationEvalHessianModBsplineClenshawCurtisNaive::evalHessian().

◆ setColumn()

void sgpp::base::DataMatrix::setColumn ( size_t  col,
const DataVector vec 
)

Sets a column of the DataMatrix to the values of a DataVector vec.

Parameters
colThe column which is to be overwritten
vecDataVector containing the data of the column

References sgpp::base::DataVector::get(), sgpp::base::DataVector::getSize(), and python.utils.statsfile2gnuplot::j.

Referenced by sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::DataBasedRefinementFunctor::computeH(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostR2(), sgpp::datadriven::AlgorithmAdaBoostBase::doAdaBoostRT(), sgpp::optimization::OperationMultipleHierarchisationModBspline::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModLinear::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModWavelet::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBspline::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationWavelet::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationWaveletBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBsplineBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinear::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinearBoundary::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationModBsplineClenshawCurtis::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationBsplineClenshawCurtis::doDehierarchisation(), sgpp::optimization::OperationMultipleHierarchisationLinearClenshawCurtis::doDehierarchisation(), sgpp::datadriven::AlgorithmAdaBoostBase::doDiscreteAdaBoost(), sgpp::datadriven::AlgorithmAdaBoostBase::doRealAdaBoost(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::getMaxInversionError(), sgpp::pde::OperationLaplaceExplicitLinear::OperationLaplaceExplicitLinear(), sgpp::optimization::optimizer::CMAES::optimize(), set(), sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt(), sgpp::optimization::sle_solver::Armadillo::solve(), sgpp::optimization::sle_solver::Eigen::solve(), sgpp::optimization::sle_solver::UMFPACK::solve(), sgpp::optimization::sle_solver::SLESolver::solve(), and sgpp::pde::OperationMatrixLTwoDotExplicitLinearBoundary::~OperationMatrixLTwoDotExplicitLinearBoundary().

◆ setRow()

void sgpp::base::DataMatrix::setRow ( size_t  row,
const DataVector vec 
)

Sets a row of the DataMatrix to the values of a DataVector vec.

Parameters
rowThe row which is to be overwritten
vecDataVector containing the data of the row

References sgpp::base::DataVector::get(), sgpp::base::DataVector::getSize(), and python.statsfileInfo::i.

Referenced by sgpp::datadriven::LearnerSGDEOnOffParallel::assembleNextBatchData(), sgpp::datadriven::DBMatOfflineChol::choleskyAddPoint(), sgpp::datadriven::OperationDensityRejectionSamplingLinear::doSampling(), sgpp::datadriven::OperationRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doShuffledTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBspline::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPoly::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPoly::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineBoundary::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationLinear::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBspline::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtis::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationModBsplineClenshawCurtis::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationPolyClenshawCurtisBoundary::doTransformation(), sgpp::datadriven::OperationRosenblattTransformationKDE::doTransformation(), sgpp::datadriven::OperationInverseRosenblattTransformationKDE::doTransformation(), sgpp::base::OperationEvalGradient::evalGradient(), sgpp::base::OperationEvalHessian::evalHessian(), sgpp::base::ForwardSelectorRefinementIndicator::ForwardSelectorRefinementIndicator(), sgpp::base::HashGridStorage::getCoordinateArrays(), sgpp::base::EvalCuboidGenerator::getEvaluationCuboid(), sgpp::base::EvalCuboidGeneratorForStretching::getEvaluationCuboid(), sgpp::quadrature::SampleGenerator::getSamples(), sgpp::datadriven::OperationMakePositive::makeCurrentNodalValuesPositive(), sgpp::datadriven::OperationMultiEvalStreaming::multTranspose(), sgpp::datadriven::OperationMultiEvalModMaskStreaming::multTranspose(), sgpp::datadriven::OperationMultipleEvalSubspaceCombined::padDataset(), sgpp::datadriven::PrimalDualSVM::predictRaw(), sgpp::datadriven::OperationMultiEvalStreamingBSplineOCL< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLUnified< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLFastMultiPlatform< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLOpt< T >::prepare(), sgpp::datadriven::OperationMultiEvalStreamingModOCLMaskMultiPlatform< T >::prepare(), sgpp::datadriven::StreamingOCLMultiPlatform::OperationMultiEvalStreamingOCLMultiPlatform< T >::prepare(), sgpp::datadriven::LearnerSGD::pushToBatch(), sgpp::datadriven::CSVFileSampleProvider::readString(), sgpp::datadriven::ArffFileSampleProvider::readString(), set(), and sgpp::datadriven::DBMatOnlineDEOrthoAdapt::sherman_morrison_adapt().

◆ sqr()

void sgpp::base::DataMatrix::sqr ( )

Squares all elements of the DataMatrix.

References python.statsfileInfo::i.

Referenced by set().

◆ sqrt()

void sgpp::base::DataMatrix::sqrt ( )

Takes the square root of all elements of the DataMatrix.

References python.statsfileInfo::i.

Referenced by set().

◆ sub()

void sgpp::base::DataMatrix::sub ( const DataMatrix matr)

Subtracts the values from another DataMatrix of the current values.

Modifies the current values.

Parameters
matrThe DataMatrix which is subtracted from the current values

References python.statsfileInfo::i.

Referenced by set().

◆ sum()

double sgpp::base::DataMatrix::sum ( ) const

Returns the sum of all elements.

Returns
The sum of all elements

References python.statsfileInfo::i.

Referenced by set().

◆ toFile()

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

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

Referenced by getNcols().

◆ toString() [1/2]

◆ toString() [2/2]

◆ transpose()


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