FEI
Version of the Day
|
#include <snl_fei_LinearSystem_General.hpp>
Public Member Functions | |
LinearSystem_General (fei::SharedPtr< fei::MatrixGraph > &matrixGraph) | |
virtual | ~LinearSystem_General () |
int | loadEssentialBCs (int numIDs, const int *IDs, int idType, int fieldID, int offsetIntoField, const double *prescribedValues) |
int | loadEssentialBCs (int numIDs, const int *IDs, int idType, int fieldID, const int *offsetIntoField, const double *prescribedValues) |
int | loadLagrangeConstraint (int constraintID, const double *weights, double rhsValue) |
int | loadPenaltyConstraint (int constraintID, const double *weights, double penaltyValue, double rhsValue) |
int | loadComplete (bool applyBCs=true, bool globalAssemble=true) |
int | parameters (int numParams, const char *const *paramStrings) |
int | parameters (const fei::ParameterSet ¶ms) |
int | setBCValuesOnVector (fei::Vector *vector) |
bool | eqnIsEssentialBC (int globalEqnIndex) const |
void | getEssentialBCs (std::vector< int > &bcEqns, std::vector< double > &bcVals) const |
void | getConstrainedEqns (std::vector< int > &crEqns) const |
Public Member Functions inherited from fei::LinearSystem | |
LinearSystem (fei::SharedPtr< fei::MatrixGraph > &matrixGraph) | |
virtual | ~LinearSystem () |
virtual void | setMatrix (fei::SharedPtr< fei::Matrix > &matrix) |
virtual fei::SharedPtr < fei::Matrix > | getMatrix () |
virtual fei::SharedPtr< const fei::Matrix > | getMatrix () const |
virtual void | setRHS (fei::SharedPtr< fei::Vector > &rhs) |
virtual fei::SharedPtr < fei::Vector > | getRHS () |
virtual fei::SharedPtr< const fei::Vector > | getRHS () const |
virtual void | setSolutionVector (fei::SharedPtr< fei::Vector > &soln) |
virtual fei::SharedPtr < fei::Vector > | getSolutionVector () |
virtual fei::SharedPtr< const fei::Vector > | getSolutionVector () const |
virtual int | putAttribute (const char *name, void *attribute) |
virtual int | getAttribute (const char *name, void *&attribute) |
implementation of fei::LinearSystem interface
Definition at line 27 of file snl_fei_LinearSystem_General.hpp.
snl_fei::LinearSystem_General::LinearSystem_General | ( | fei::SharedPtr< fei::MatrixGraph > & | matrixGraph | ) |
constructor
Definition at line 36 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
denstructor
Definition at line 67 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
Essential (dirichlet) boundary-condition function.
Reimplemented from fei::LinearSystem.
Definition at line 162 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
Essential (dirichlet) boundary-condition function.
Reimplemented from fei::LinearSystem.
Definition at line 180 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
load lagrange-multiplier constraint coefficients
Implements fei::LinearSystem.
Definition at line 849 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
load penalty constraint coefficients
Implements fei::LinearSystem.
Definition at line 898 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
Signal that all boundary-conditions and constraint coefficients have
been loaded, and they may now be applied to the linear system.
Implements fei::LinearSystem.
Definition at line 200 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
Set parameters on this object. Currently two parameters are recognized:
"debugOutput 'path'" where 'path' is the path to the location where debug-log files will be produced.
"name 'string'" where 'string' is an identifier that will be used in debug-log file-names.
Implements fei::LinearSystem.
Definition at line 73 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
parameters implementation
Implements fei::LinearSystem.
Definition at line 128 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
use stored BC values to modify specified vector
Implements fei::LinearSystem.
Definition at line 321 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
query whether specified eqn index has prescribed BC value
Implements fei::LinearSystem.
Definition at line 339 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
Retrieve eqn-indices and values for BC equations
Implements fei::LinearSystem.
Definition at line 349 of file snl_fei_LinearSystem_General.cpp.
|
virtual |
Retrieve eqn-indices for constraints
Implements fei::LinearSystem.
Definition at line 368 of file snl_fei_LinearSystem_General.cpp.