FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <fei_LinearProblemManager.hpp>
virtual | ~LinearProblemManager () |
virtual void | setRowDistribution (const std::vector< int > &ownedGlobalRows)=0 |
virtual void | setMatrixGraph (fei::SharedPtr< fei::SparseRowGraph > matrixGraph)=0 |
virtual void | setMatrixValues (double scalar)=0 |
virtual int | getLocalNumRows ()=0 |
virtual int | getRowLength (int row)=0 |
virtual int | copyOutMatrixRow (int row, int len, double *coefs, int *indices)=0 |
virtual int | insertMatrixValues (int numRows, const int *rows, int numCols, const int *cols, const double *const *values, bool sum_into)=0 |
virtual void | setVectorValues (double scalar, bool soln_vector)=0 |
virtual int | insertVectorValues (int numValues, const int *globalIndices, const double *values, bool sum_into, bool soln_vector, int vectorIndex=0)=0 |
virtual int | copyOutVectorValues (int numValues, const int *globalIndices, double *values, bool soln_vector, int vectorIndex=0)=0 |
virtual double * | getLocalVectorValuesPtr (bool soln_vector, int vectorIndex=0)=0 |
virtual int | globalAssemble ()=0 |
Linear system assembly and solution manager.
Definition at line 24 of file fei_LinearProblemManager.hpp.
|
inlinevirtual |
Destructor.
Definition at line 29 of file fei_LinearProblemManager.hpp.
|
pure virtual |
Set the linear-system's global row distribution.
ownedGlobalRows | List of row-numbers to be owned by local processor. |
Implemented in LinProbMgr_EpetraBasic.
|
pure virtual |
Set the matrix-graph structure. This is the nonzero structure for locally-owned matrix rows.
Implemented in LinProbMgr_EpetraBasic.
|
pure virtual |
Set a specified scalar value throughout the matrix.
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::MatrixTraits< fei::LinearProblemManager >::setValues().
|
pure virtual |
Query the number of local rows. This is expected to be the number of point-entry rows on the local processor.
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::MatrixTraits< fei::LinearProblemManager >::getNumLocalRows().
|
pure virtual |
Given a locally-owned global row number, query the length (number of nonzeros) of that row.
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::MatrixTraits< fei::LinearProblemManager >::getRowLength().
|
pure virtual |
Given a locally-owned global row number, pass out a copy of the contents of that row.
row | Global row number |
len | Length of user-allocated 'coefs' and 'indices' arrays. if 'len' != 'getRowLength(row)', then the number of coefs/indices returned will be max(len,getRowLength(row)). |
coefs | Output array of matrix coefficients. |
indices | Output array of column-indices. |
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::MatrixTraits< fei::LinearProblemManager >::copyOutRow().
|
pure virtual |
Put a C-style table (array of pointers) of coefficient data into the matrix. This is a rectangular array of coefficients for rows/columns defined by the 'rows' and 'cols' lists. If the sum_into argument is true, values should be added to any that already exist at the specified locations. Otherwise (if sum_into is false) incoming values should overwrite already-existing values.
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::MatrixTraits< fei::LinearProblemManager >::putValuesIn().
|
pure virtual |
Set a specified scalar value throughout the vector.
scalar | Value to be used. |
soln_vector | If true, scalar should be set in solution vector, otherwise set rhs vector. |
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::VectorTraits< fei::LinearProblemManager >::setValues().
|
pure virtual |
Put coefficient data into a vector at the specified global indices. If any specified indices are out of range (negative or too large) the corresponding positions in the values array will not be referenced, and a positive warning code will be returned.
numValues | Length of caller-allocated 'globalIndices' and 'values' arrays. |
globalIndices | List of global-indices specifying the locations in the vector for incoming values to be placed. |
values | List of incoming values. |
sum_into | If true, incoming values should be added to values that may already be in the specified locations. If sum_into is false, then incoming values should overwrite existing values. |
soln_vector | If true, incoming values should be placed in the solution vector. Otherwise, they should be placed in the rhs vector. |
vectorIndex | If the linear system has multiple rhs/soln vectors, then this parameter specifies which vector the incoming values should be put into. |
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::VectorTraits< fei::LinearProblemManager >::putValuesIn().
|
pure virtual |
Copy values for the specified vector indices into the caller-allocated 'values' array.
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::VectorTraits< fei::LinearProblemManager >::copyOut().
|
pure virtual |
Dangerous, high-performance vector access. Return a pointer to local vector values. Implementations that can't support this may return NULL, in which case the caller will revert to using the copyOutVectorValues method.
Implemented in LinProbMgr_EpetraBasic.
|
pure virtual |
Perform any necessary internal communications/synchronizations or other operations appropriate at the end of data input. For some implementations this may be a no-op. (Trilinos/Epetra implementations would call 'FillComplete' on the matrix at this point.)
Implemented in LinProbMgr_EpetraBasic.
Referenced by fei::VectorTraits< fei::LinearProblemManager >::globalAssemble(), and fei::MatrixTraits< fei::LinearProblemManager >::globalAssemble().