FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <fei_MatrixTraits_FillableMat.hpp>
Static Public Member Functions | |
static const char * | typeName () |
static double * | getBeginPointer (FillableMat *) |
static int | getOffset (FillableMat *, int, int) |
static int | setValues (FillableMat *mat, double scalar) |
static int | getNumLocalRows (FillableMat *mat, int &numRows) |
static int | getRowLength (FillableMat *mat, int row, int &length) |
static int | copyOutRow (FillableMat *mat, int row, int len, double *coefs, int *indices) |
static int | putValuesIn (FillableMat *mat, int numRows, const int *rows, int numCols, const int *cols, const double *const *values, bool sum_into) |
static int | globalAssemble (FillableMat *mat) |
static int | matvec (FillableMat *mat, fei::Vector *x, fei::Vector *y) |
Specialization for FillableMat.
Definition at line 23 of file fei_MatrixTraits_FillableMat.hpp.
|
inlinestatic |
Return a string type-name for the underlying matrix
Definition at line 26 of file fei_MatrixTraits_FillableMat.hpp.
|
inlinestatic |
Definition at line 29 of file fei_MatrixTraits_FillableMat.hpp.
|
inlinestatic |
Definition at line 34 of file fei_MatrixTraits_FillableMat.hpp.
|
inlinestatic |
Set a specified scalar value throughout the matrix.
Definition at line 41 of file fei_MatrixTraits_FillableMat.hpp.
References fei::FillableMat::setValues().
|
inlinestatic |
Query the number of rows. This is expected to be the number of rows on the local processor.
Definition at line 50 of file fei_MatrixTraits_FillableMat.hpp.
References fei::FillableMat::getNumRows().
|
inlinestatic |
Given a global (zero-based) row number, query the length of that row.
Definition at line 58 of file fei_MatrixTraits_FillableMat.hpp.
References fei::FillableMat::getRow(), and fei::CSVec::size().
|
inlinestatic |
Given a global (zero-based) row number, pass out a copy of the contents of that row.
mat | |
row | |
len | Length of the user-allocated arrays coefs and indices. |
coefs | User-allocated array which will hold matrix coefficients on output. |
indices | User-allocated array which will hold column-indices on output. |
Definition at line 82 of file fei_MatrixTraits_FillableMat.hpp.
References fei::CSVec::coefs(), fei::FillableMat::getRow(), and fei::CSVec::indices().
|
inlinestatic |
Sum a C-style table of coefficient data into the underlying matrix.
Definition at line 106 of file fei_MatrixTraits_FillableMat.hpp.
References fei::FillableMat::putRow(), and fei::FillableMat::sumInRow().
|
inlinestatic |
Perform any necessary internal communications/synchronizations or other operations appropriate at end of data input. For some implementations this will be a no-op, so this "default implementation" will return 0.
Definition at line 131 of file fei_MatrixTraits_FillableMat.hpp.
|
inlinestatic |
Compute the matrix-vector product y = A*x
Definition at line 137 of file fei_MatrixTraits_FillableMat.hpp.
References fei::Vector_Impl< T >::getUnderlyingVector(), and fei::multiply_CSRMat_CSVec().