FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <FEI_Implementation.hpp>
Public Member Functions | |
FEI_Implementation (fei::SharedPtr< LibraryWrapper > libWrapper, MPI_Comm comm, int masterRank=0) | |
virtual | ~FEI_Implementation () |
int | parameters (int numParams, const char *const *paramStrings) |
int | setIDLists (int numMatrices, const int *matrixIDs, int numRHSs, const int *rhsIDs) |
int | setSolveType (int solveType) |
int | initFields (int numFields, const int *fieldSizes, const int *fieldIDs, const int *fieldTypes=NULL) |
int | initElemBlock (GlobalID elemBlockID, int numElements, int numNodesPerElement, const int *numFieldsPerNode, const int *const *nodalFieldIDs, int numElemDofFieldsPerElement, const int *elemDOFFieldIDs, int interleaveStrategy) |
int | initElem (GlobalID elemBlockID, GlobalID elemID, const GlobalID *elemConn) |
int | initSlaveVariable (GlobalID slaveNodeID, int slaveFieldID, int offsetIntoSlaveField, int numMasterNodes, const GlobalID *masterNodeIDs, const int *masterFieldIDs, const double *weights, double rhsValue) |
int | deleteMultCRs () |
int | initSharedNodes (int numSharedNodes, const GlobalID *sharedNodeIDs, const int *numProcsPerNode, const int *const *sharingProcIDs) |
int | initCRMult (int numCRNodes, const GlobalID *CRNodes, const int *CRFields, int &CRID) |
int | initCRPen (int numCRNodes, const GlobalID *CRNodes, const int *CRFields, int &CRID) |
int | initComplete () |
int | setCurrentMatrix (int matID) |
int | setCurrentRHS (int rhsID) |
int | resetSystem (double s=0.0) |
int | resetMatrix (double s=0.0) |
int | resetRHSVector (double s=0.0) |
int | resetInitialGuess (double s=0.0) |
int | loadNodeBCs (int numNodes, const GlobalID *nodeIDs, int fieldID, const int *offsetsIntoField, const double *prescribedValues) |
int | loadElemBCs (int numElems, const GlobalID *elemIDs, int fieldID, const double *const *alpha, const double *const *beta, const double *const *gamma) |
int | sumInElem (GlobalID elemBlockID, GlobalID elemID, const GlobalID *elemConn, const double *const *elemStiffness, const double *elemLoad, int elemFormat) |
int | sumInElemMatrix (GlobalID elemBlockID, GlobalID elemID, const GlobalID *elemConn, const double *const *elemStiffness, int elemFormat) |
int | sumInElemRHS (GlobalID elemBlockID, GlobalID elemID, const GlobalID *elemConn, const double *elemLoad) |
int | loadCRMult (int CRID, int numCRNodes, const GlobalID *CRNodes, const int *CRFields, const double *CRWeights, double CRValue) |
int | loadCRPen (int CRID, int numCRNodes, const GlobalID *CRNodes, const int *CRFields, const double *CRWeights, double CRValue, double penValue) |
int | putIntoRHS (int IDType, int fieldID, int numIDs, const GlobalID *IDs, const double *rhsEntries) |
int | sumIntoRHS (int IDType, int fieldID, int numIDs, const GlobalID *IDs, const double *rhsEntries) |
int | sumIntoMatrixDiagonal (int IDType, int fieldID, int numIDs, const GlobalID *IDs, const double *coefficients) |
int | setMatScalars (int numScalars, const int *IDs, const double *scalars) |
int | setRHSScalars (int numScalars, const int *IDs, const double *scalars) |
int | loadComplete (bool applyBCs=true, bool globalAssemble=true) |
int | residualNorm (int whichNorm, int numFields, int *fieldIDs, double *norms) |
int | solve (int &status) |
int | iterations (int &itersTaken) const |
int | version (const char *&versionString) |
int | cumulative_cpu_times (double &initTime, double &loadTime, double &solveTime, double &solnReturnTime) |
int | getBlockNodeSolution (GlobalID elemBlockID, int numNodes, const GlobalID *nodeIDs, int *offsets, double *results) |
int | getNodalSolution (int numNodes, const GlobalID *nodeIDs, int *offsets, double *results) |
int | getBlockFieldNodeSolution (GlobalID elemBlockID, int fieldID, int numNodes, const GlobalID *nodeIDs, double *results) |
int | getBlockElemSolution (GlobalID elemBlockID, int numElems, const GlobalID *elemIDs, int &numElemDOFPerElement, double *results) |
int | getNumCRMultipliers (int &numMultCRs) |
int | getCRMultIDList (int numMultCRs, int *multIDs) |
int | getCRMultipliers (int numCRs, const int *CRIDs, double *multipliers) |
int | putBlockNodeSolution (GlobalID elemBlockID, int numNodes, const GlobalID *nodeIDs, const int *offsets, const double *estimates) |
int | putBlockFieldNodeSolution (GlobalID elemBlockID, int fieldID, int numNodes, const GlobalID *nodeIDs, const double *estimates) |
int | putBlockElemSolution (GlobalID elemBlockID, int numElems, const GlobalID *elemIDs, int dofPerElem, const double *estimates) |
int | putCRMultipliers (int numMultCRs, const int *CRIDs, const double *multEstimates) |
int | getBlockNodeIDList (GlobalID elemBlockID, int numNodes, GlobalID *nodeIDs) |
int | getBlockElemIDList (GlobalID elemBlockID, int numElems, GlobalID *elemIDs) |
int | getNumSolnParams (GlobalID nodeID, int &numSolnParams) const |
int | getNumElemBlocks (int &numElemBlocks) const |
int | getNumBlockActNodes (GlobalID blockID, int &numNodes) const |
int | getNumBlockActEqns (GlobalID blockID, int &numEqns) const |
int | getNumNodesPerElement (GlobalID blockID, int &nodesPerElem) const |
int | getNumEqnsPerElement (GlobalID blockID, int &numEqns) const |
int | getNumBlockElements (GlobalID blockID, int &numElems) const |
int | getNumBlockElemDOF (GlobalID blockID, int &DOFPerElem) const |
int | getParameters (int &numParams, char **¶mStrings) |
int | getFieldSize (int fieldID, int &numScalars) |
int | getEqnNumbers (GlobalID ID, int idType, int fieldID, int &numEqns, int *eqnNumbers) |
int | getNodalFieldSolution (int fieldID, int numNodes, const GlobalID *nodeIDs, double *results) |
int | getNumLocalNodes (int &numNodes) |
int | getLocalNodeIDList (int &numNodes, GlobalID *nodeIDs, int lenNodeIDs) |
int | putNodalFieldData (int fieldID, int numNodes, const GlobalID *nodeIDs, const double *nodeData) |
const SNL_FEI_Structure & | getProblemStructure () const |
SNL_FEI_Structure & | getProblemStructure () |
Public Member Functions inherited from FEI | |
virtual | ~FEI () |
Private Member Functions | |
FEI_Implementation (const FEI_Implementation &src) | |
FEI_Implementation & | operator= (const FEI_Implementation &src) |
void | deleteIDs () |
void | deleteRHSScalars () |
int | allocateInternalFEIs () |
void | debugOut (const char *msg) |
void | debugOut (const char *msg, int whichFEI) |
void | buildLinearSystem () |
int | aggregateSystem () |
void | messageAbort (const char *msg) |
void | notAllocatedAbort (const char *name) |
void | needParametersAbort (const char *name) |
void | badParametersAbort (const char *name) |
void | setDebugOutput (const char *path, const char *name) |
This is the (C++) user's point of interaction with the FEI implementation. The user will declare an instance of this class in their code, and call the public FEI functions on that instance. The functions implemented by this class are those in the abstract FEI declaration, plus possibly others. i.e., the functions provided by this class are a superset of those in the FEI specification.
This class takes, as a constructor argument, a 'LibraryWrapper' object which is a shell containing only an instance of a LinearSystemCore implementation or a FiniteElementData implementation. These are the abstract interfaces through which solver libraries may be coupled to this FEI implementation.
As of August 2001, the following solver implementations of these interfaces exist:
Definition at line 50 of file FEI_Implementation.hpp.
FEI_Implementation::FEI_Implementation | ( | fei::SharedPtr< LibraryWrapper > | libWrapper, |
MPI_Comm | comm, | ||
int | masterRank = 0 |
||
) |
constructor.
libWrapper | Simple container that holds either a LinearSystemCore or FiniteElementData instance. |
comm | MPI_Comm communicator |
masterRank | The "master" mpi rank. Defaults to 0 if not supplied. This is not an important parameter, simply determining which processor will produce screen output if the parameter "outputLevel" is set to a value greater than 0 via a call to the parameters function. |
Definition at line 39 of file FEI_Implementation.cpp.
References comm_, LibraryWrapper::getLinearSystemCore(), SNL_FEI_Structure::getNodeCommMgr(), haveFEData_, LibraryWrapper::haveFiniteElementData(), LibraryWrapper::haveLinearSystemCore(), haveLinSysCore_, linSysCore_, fei::localProc(), localRank_, lscArray_, matrixIDs_, messageAbort(), numInternalFEIs_, fei::numProcs(), numProcs_, numRHSIDs_, problemStructure_, NodeCommMgr::PROC_WITH_LOCAL_ELEM, rhsIDs_, rhsScalars_, NodeCommMgr::setSharedOwnershipRule(), and wrapper_.
|
virtual |
Destructor.
Definition at line 128 of file FEI_Implementation.cpp.
References dbgFileOpened_, dbgFStreamPtr_, dbgOStreamPtr_, debugOutput_, deleteIDs(), deleteRHSScalars(), LinearSystemCore::destroyMatrixData(), LinearSystemCore::destroyVectorData(), FEI_ENDL, filter_, internalFEIsAllocated_, linSysCore_, numInternalFEIs_, numParams_, paramStrings_, problemStructure_, soln_fei_matrix_, and soln_fei_vector_.
|
private |
|
virtual |
Set parameters associated with solver choice, etc. This function may be called at any time after the FEI object is instantiated. This function may be called repeatedly with different parameters, which will accumulate those parameters into an internal 'master'-list of parameters.
numParams | Number of parameters being supplied. |
paramStrings | List of 'numParams' strings. Each string usually contains a key-value pair, separated by a space. |
Implements FEI.
Definition at line 811 of file FEI_Implementation.cpp.
References CHK_ERR, debugOut(), debugOutput_, FEI_ENDL, filter_, LibraryWrapper::getFiniteElementData(), snl_fei::getIntParamValue(), snl_fei::getParamValue(), haveFEData_, haveLinSysCore_, internalFEIsAllocated_, linSysCore_, snl_fei::mergeStringLists(), numInternalFEIs_, numParams_, outputLevel_, FiniteElementData::parameters(), SNL_FEI_Structure::parameters(), LinearSystemCore::parameters(), paramStrings_, problemStructure_, setDebugOutput(), and wrapper_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Specify matrixIDs and rhsIDs to be used in cases where multiple matrices and/or rhs vectors are being assembled. This function does not need to be called if only one matrix and rhs are being assembled. Note: the values of the matrix and rhs identifiers must be non-negative. Important Note: If this function is called, it must be called BEFORE setSolveType is called. setSolveType must then be called with the parameter FEI_AGGREGATE_SUM (eigen-solves and product-solves aren't supported yet).
numMatrices | length of matrixIDs parameter |
matrixIDs | list of user-defined identifiers for separate matrices to be assembled |
numRHSs | length of rhsIDs parameter |
rhsIDs | list of user-defined identifiers for separate rhs vectors to be assembled |
Implements FEI.
Definition at line 299 of file FEI_Implementation.cpp.
References dbgOStreamPtr_, debugOutput_, deleteIDs(), deleteRHSScalars(), FEI_ENDL, FEI_OSTREAM, matrixIDs_, numInternalFEIs_, numRHSIDs_, rhsIDs_, and rhsScalars_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Set the type of solve to be performed. This distinguishes between a 'standard' single solve of Ax=b, an eigen-solve (not yet supported), an 'aggregate-sum' solve (a linear-combination of several separate A's and b's), and an 'aggregate-product' solve (not supported).
solveType | currently supported values for this are: FEI_SINGLE_SOLVE, FEI_AGGREGATE_SUM |
Implements FEI.
Definition at line 267 of file FEI_Implementation.cpp.
References debugOutput_, FEI_AGGREGATE_PRODUCT, FEI_AGGREGATE_SUM, FEI_EIGEN_SOLVE, FEI_ENDL, FEI_SINGLE_SYSTEM, matrixIDs_, messageAbort(), and solveType_.
|
virtual |
Identify all the fields present in the analysis. A field may be a scalar such as temperature or pressure, or a 3-vector for velocity, etc. Non-solution fields may be denoted by a negative fieldID. This allows for situations where the application wants to pass data that the FEI doesn't need, through to the underlying linear algebra library. (This may be done via the various put*Solution functions.) An example of this could be supplying geometric coordinates to a solver that needs them.
numFields | Global number of fields in the entire problem, on all processors. (This is the length of the fieldSizes and fieldIDs lists.) |
fieldSizes | Number of scalars contained in each field. |
fieldIDs | User-supplied identifiers for each field. |
Implements FEI.
Definition at line 367 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initFields(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Initialize the description of an element-block. This function informs the fei implementation of the defining characteristics for a block of elements. An element-block must be homogeneous – all elements in the block must have the same number of nodes, same number of solution fields per node, etc.
elemBlockID | The user-defined identifier for this element-block. |
numElements | The number of elements in this block. |
numNodesPerElement | Length of the numFieldsPerNode list. |
numFieldsPerNode | Lengths of the rows of the nodalFieldIDs table. |
nodalFieldIDs | Table where row 'i' is the list of field ids for the ith node on every element in this element-block. |
numElemDofFieldsPerElement | Length of the elemDOFFieldIDs list. |
elemDOFFieldIDs | list of field identifiers for the element- centered degrees-of-freedom in the elements in this block. |
interleaveStrategy | Indicates the ordering of solution-components in the element-wise (e.g., stiffness) contribution arrays. Valid values are FEI_NODE_MAJOR (all field-components for first node are followed by all field-components for second node, ...) or FEI_FIELD_MAJOR (first-field for all nodes, then second-field for all nodes, ...) |
Implements FEI.
Definition at line 378 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initElemBlock(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Initialize an element's connectivity. Provide a nodal connectivity list for inclusion in the sparse matrix structure being constructed.
elemBlockID | Which element-block this element belongs to. |
elemID | A user-provided identifier for this element. |
elemConn | List of nodeIDs connected to this element. Length of this list must be 'numNodesPerElement' provided to the function 'initElemBlock' for this elemBlockID. |
Implements FEI.
Definition at line 400 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initElem(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Advise the FEI that a nodal variable is slaved to a linear combination of other variables, plus a right-hand-side value (note that the rhsValue will often be zero). Since a field may contain more than one scalar component, the particular scalar equation that's being slaved must be specified by not only a nodeID and fieldID, but also an offset into the slave field.
The general form of the dependency being specified is: seqn = sum ( weight_i * meqn_i ) + rhsValue where 'seqn' means slave-equation and 'meqn' means master equation.
Example: to specify that a slave-equation is the average of two master- equations: seqn = 0.5*meqn_1 + 0.5*meqn_2 + 0.0 (Where 0.0 is the rhsValue in this case.)
The list of weights supplied will be assumed to be of length sum(masterFieldSizes). i.e., the slave equation may be dependent on more than one component of the specified master field. In cases where a master field contains more than one scalar component, but only one of those components is relevant to the dependency being specified, then positions in the weights list corresponding to the non-relevant field-components should contain zeros.
This mechanism can also be used as an alternative way to specify essential boundary conditions, where the rhsValue will be the boundary condition value, with no master nodes or weights.
Note: This is a new and experimental capability, and is not compatible with all other FEI capabilities. In particular, the following precaution should be taken: Don't identify both slave variables and constraint-relations for the same degree of freedom. They are mutually exclusive.
slaveNodeID | Node identifier of the node containing the slave eqn. |
slaveFieldID | Field identifier corresponding to the slave eqn. |
offsetIntoSlaveField | Denotes location, within the field, of the slave eqn. |
numMasterNodes | Number of nodes containing variables on which the slave depends. |
masterNodeIDs | Node identifiers of the master nodes. |
masterFieldIDs | List, length numMasterNodes, of the field at each master-node which contains the scalar variable(s) on which the slave depends. |
weights | List, length sum-of-master-field-sizes, containing the weighting coefficients described above. |
rhsValue |
Implements FEI.
Definition at line 410 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initSlaveVariable(), and problemStructure_.
|
virtual |
Request that any existing Lagrange-Multiplier constraints be deleted. (Intended to be called in preparation for loading new/different constraints.)
Implements FEI.
Definition at line 428 of file FEI_Implementation.cpp.
References CHK_ERR, debugOut(), Filter::deleteMultCRs(), SNL_FEI_Structure::deleteMultCRs(), filter_, index_current_filter_, internalFEIsAllocated_, and problemStructure_.
|
virtual |
identify sets of shared nodes
Implements FEI.
Definition at line 443 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initSharedNodes(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Constraint relation initialization, Lagrange Multiplier formulation.
numCRNodes | Length of the CRNodeIDs and CRFieldIDs lists. |
CRNodes | Nodes involved in this constraint relation. |
CRFields | List of the the field being constrained at each node. |
CRID | Output. An identifier by which this constraint relation may be referred to later, when loading its weight data and recovering its Lagrange Multiplier after the solve. |
Implements FEI.
Definition at line 461 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initCRMult(), and problemStructure_.
|
virtual |
Constraint relation initialization, Penalty function formulation .
numCRNodes | Length of the CRNodeIDs and CRFieldIDs lists. |
CRNodes | Nodes involved in this constraint relation. |
CRFields | List of the the field being constrained at each node. |
CRID | Output. An identifier by which this constraint relation may be referred to later, when loading its weight data and penalty value. |
Implements FEI.
Definition at line 481 of file FEI_Implementation.cpp.
References CHK_ERR, SNL_FEI_Structure::initCRPen(), and problemStructure_.
|
virtual |
indicate that overall initialization sequence is complete
Implements FEI.
Definition at line 500 of file FEI_Implementation.cpp.
References allocateInternalFEIs(), CHK_ERR, SNL_FEI_Structure::destroyMatIndices(), filter_, haveFEData_, SNL_FEI_Structure::initComplete(), initPhaseIsComplete_, numInternalFEIs_, and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
direct data to a specific internal data structure
i.e., set the current matrix 'context'.
Implements FEI.
Definition at line 197 of file FEI_Implementation.cpp.
References fei::console_out(), debugOut(), debugOutput_, FEI_ENDL, index_current_filter_, matrixIDs_, and numInternalFEIs_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
direct data to a specific internal data structure i.e., set the current RHS 'context'.
Implements FEI.
Definition at line 236 of file FEI_Implementation.cpp.
References CHK_ERR, fei::console_out(), debugOut(), debugOutput_, ERReturn, FEI_ENDL, filter_, index_current_rhs_row_, numInternalFEIs_, numRHSIDs_, rhsIDs_, and fei::searchList().
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
set a value (usually zeros) throughout the linear system
Implements FEI.
Definition at line 523 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, and internalFEIsAllocated_.
|
virtual |
set a value (usually zeros) throughout the matrix or rhs-vector separately
Implements FEI.
Definition at line 536 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, and internalFEIsAllocated_.
|
virtual |
Set a value (usually zero) througout the rhs vector.
s | The value to be written into the rhs vector. |
Implements FEI.
Definition at line 546 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, and internalFEIsAllocated_.
|
virtual |
Set a value (usually, if not always, 0.0) throughout the initial guess (solution) vector.
s | Input. Scalar value to use in filling the solution vector. |
Implements FEI.
Definition at line 556 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, and internalFEIsAllocated_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Load nodal boundary condition data. This allows the application to specify a boundary condition (dirichlet) on a list of nodes.
The boundary condition specified via this function applies to the same solution field on all nodes in the nodeIDs list.
The i-th entry in the offsetsIntoField array specifies which component of the specified field will be prescribed by the i-th entry in the prescribedValues array.
numNodes | Length of the nodeIDs list. |
nodeIDs | List of nodes upon which a boundary condition is to be imposed. |
fieldID | The solution field that will receive the boundary condition. |
offsetsIntoField | Array, length numNodes. |
prescribedValues | Array, length numNodes. |
Implements FEI.
Definition at line 566 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, index_soln_filter_, internalFEIsAllocated_, notAllocatedAbort(), and solveType_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Load boundary condition data for element-dof.
numElems | Length of the elemIDs list. |
elemIDs | List of elements for which a boundary condition is to be specified. |
fieldID | The solution field for which to apply the boundary condition. |
alpha | Table, as in 'loadNodeBCs', but with 'numElems' number-of- rows. |
beta | Table, same dimensions as alpha. |
gamma | Table, same dimensions as alpha. |
Implements FEI.
Definition at line 586 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, index_soln_filter_, internalFEIsAllocated_, notAllocatedAbort(), and solveType_.
|
virtual |
Element-stiffness/load data loading. This function accumulates element stiffness and load data into the underlying matrix and rhs vector.
elemBlockID | Which element-block this element belongs to. |
elemID | User-supplied identifier for this element. |
elemConn | Connectivity list of nodes that are connected to this element. |
elemStiffness | Table of element-stiffness data. Dimensions of this table defined by the sum of the sizes of the fields associated with this element. (This information supplied earlier via 'initElemBlock'.) |
elemLoad | Element-load vector. |
elemFormat | Designates the way in which the 'elemStiffness' stiffness-matrix data is laid out. Valid values for this parameter can be found in the file fei_defs.h. |
Implements FEI.
Definition at line 607 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
Element-stiffness data loading. This function is the same as 'sumInElem' but only accepts stiffness data, not the load data for the rhs.
elemBlockID | Which element-block this element belongs to. |
elemID | User-supplied identifier for this element. |
elemConn | Connectivity list of nodes that are connected to this element. |
elemStiffness | Table of element-stiffness data. Dimensions of this table defined by the sum of the sizes of the fields associated with this element. (This information supplied earlier via 'initElemBlock'.) |
elemFormat | Designates the way in which the 'elemStiffness' stiffness-matrix data is laid out. Valid values for this parameter can be found in the file fei_defs.h. |
Implements FEI.
Definition at line 628 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
Element-load data loading. This function is the same as 'sumInElem', but only accepts the load for the rhs, not the stiffness matrix.
elemBlockID | Which element-block this element belongs to. |
elemID | User-supplied identifier for this element. |
elemConn | Connectivity list of nodes that are connected to this element. |
elemLoad | Element-load vector. |
Implements FEI.
Definition at line 648 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_rhs_row_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
Load weight/value data for a Lagrange Multiplier constraint relation.
CRID | Identifier returned from an earlier call to 'initCRMult'. |
numCRNodes | Length of CRNodeIDs and CRFieldIDs lists. |
CRNodes | List of nodes in this constraint relation. |
CRFields | List of fields, one per node, to be constrained. |
CRWeights | Weighting coefficients. This length of this list is the sum of the sizes associated with the fields identified in CRFieldIDs. |
CRValue | The constraint's rhs value. Often (always?) zero. |
Implements FEI.
Definition at line 665 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
Load weight/value data for a Penalty constraint relation.
CRID | Identifier returned from an earlier call to 'initCRPen'. |
numCRNodes | Length of CRNodeIDs and CRFieldIDs lists. |
CRNodes | List of nodes in this constraint relation. |
CRFields | List of fields, one per node, to be constrained. |
CRWeights | Weighting coefficients. This length of this list is the sum of the sizes associated with the fields identified in CRFieldIDs. |
CRValue | The constraint's rhs value. Often (always?) zero. |
penValue | The penalty value. |
Implements FEI.
Definition at line 685 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
Put a copy of coefficient data into the rhs vector.
Implements FEI.
Definition at line 741 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_rhs_row_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Sum a copy of coefficient data into the rhs vector.
Implements FEI.
Definition at line 707 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_rhs_row_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
Reimplemented from FEI.
Definition at line 724 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, index_current_filter_, internalFEIsAllocated_, newMatrixDataLoaded_, and notAllocatedAbort().
|
virtual |
set scalar coefficients for forming aggregate (linear-combination) system of matrices.
Implements FEI.
Definition at line 758 of file FEI_Implementation.cpp.
References aggregateSystemFormed_, fei::console_out(), FEI_ENDL, matrixIDs_, matScalars_, and matScalarsSet_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
set scalar coefficients for aggregating RHS vectors.
Implements FEI.
Definition at line 782 of file FEI_Implementation.cpp.
References aggregateSystemFormed_, fei::console_out(), FEI_ENDL, numInternalFEIs_, numRHSIDs_, rhsIDs_, rhsScalars_, rhsScalarsSet_, and fei::searchList().
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
indicate that the matrix/vectors can be finalized now. e.g., boundary- conditions enforced, etc., etc.
Implements FEI.
Definition at line 910 of file FEI_Implementation.cpp.
References buildLinearSystem().
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
get residual norms
Implements FEI.
Definition at line 922 of file FEI_Implementation.cpp.
References buildLinearSystem(), filter_, index_soln_filter_, Filter::residualNorm(), and solveTime_.
|
virtual |
launch underlying solver
Implements FEI.
Definition at line 938 of file FEI_Implementation.cpp.
References buildLinearSystem(), filter_, index_soln_filter_, Filter::solve(), and solveTime_.
|
virtual |
Query number of iterations taken for last solve.
itersTaken | Iterations performed during any previous solve. |
Implements FEI.
Definition at line 952 of file FEI_Implementation.cpp.
References filter_, index_soln_filter_, and Filter::iterations().
|
virtual |
Return a version string. This string is owned by the FEI implementation, the calling application should not delete/free it. This string will contain the FEI implementation's version number, and if possible, a build time/date.
versionString | Output reference to a char*. The C interface will have a char** here. This function is simply setting versionString to point to the internal version string. |
Implements FEI.
Definition at line 958 of file FEI_Implementation.cpp.
References fei::utils::version().
Referenced by setDebugOutput().
|
virtual |
query for some accumulated timing information.
Implements FEI.
Definition at line 965 of file FEI_Implementation.cpp.
References initTime_, loadTime_, solnReturnTime_, and solveTime_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
return all nodal solution params on a block-by-block basis
Implements FEI.
Definition at line 979 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
|
virtual |
return all nodal solution params for an arbitrary list of nodes
Implements FEI.
Definition at line 994 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
return nodal solution for one field on a block-by-block basis
Implements FEI.
Definition at line 1008 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
|
virtual |
return element solution params on a block-by-block basis
Implements FEI.
Definition at line 1048 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
|
virtual |
Query number of lagrange-multiplier constraints on local processor
Implements FEI.
Definition at line 1075 of file FEI_Implementation.cpp.
References SNL_FEI_Structure::getNumMultConstRecords(), and problemStructure_.
|
virtual |
Obtain list of lagrange-multiplier IDs
Implements FEI.
Definition at line 1082 of file FEI_Implementation.cpp.
References SNL_FEI_Structure::getMultConstRecords(), SNL_FEI_Structure::getNumMultConstRecords(), and problemStructure_.
|
virtual |
get Lagrange Multipliers
Implements FEI.
Definition at line 1100 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
|
virtual |
put nodal-based solution guess on a block-by-block basis
Implements FEI.
Definition at line 1022 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
|
virtual |
put nodal-based guess for one field on a block-by-block basis
Implements FEI.
Definition at line 1035 of file FEI_Implementation.cpp.
References filter_, index_soln_filter_, and Filter::putBlockFieldNodeSolution().
|
virtual |
put element-based solution guess on a block-by-block basis
Implements FEI.
Definition at line 1062 of file FEI_Implementation.cpp.
References CHK_ERR, filter_, and index_soln_filter_.
|
virtual |
put Lagrange solution to FE analysis on a constraint-set basis
Implements FEI.
Definition at line 1110 of file FEI_Implementation.cpp.
References filter_, and index_soln_filter_.
|
virtual |
return info associated with blocked nodal solution
Implements FEI.
Definition at line 1150 of file FEI_Implementation.cpp.
References FEI_SUCCESS, NodeDescriptor::getGlobalNodeID(), SNL_FEI_Structure::getIndexOfBlock(), NodeDatabase::getNodeAtIndex(), SNL_FEI_Structure::getNodeDatabase(), SNL_FEI_Structure::getNumActiveNodes(), NodeDescriptor::hasBlockIndex(), and problemStructure_.
|
virtual |
return info associated with blocked element solution
Implements FEI.
Definition at line 1127 of file FEI_Implementation.cpp.
References fei::copyKeysToArray(), ConnectivityTable::elemIDs, FEI_SUCCESS, and problemStructure_.
|
virtual |
Query number of degrees-of-freedom for specified node
Implements FEI.
Definition at line 1204 of file FEI_Implementation.cpp.
References ERReturn, SNL_FEI_Structure::getNodeDatabase(), NodeDatabase::getNodeWithID(), NodeDescriptor::getNumNodalDOF(), and problemStructure_.
|
virtual |
Query number of element-blocks on local processor
Implements FEI.
Definition at line 1221 of file FEI_Implementation.cpp.
References SNL_FEI_Structure::getNumElemBlocks(), and problemStructure_.
|
virtual |
return the number of active nodes in a given element block
Implements FEI.
Definition at line 1231 of file FEI_Implementation.cpp.
References CHK_ERR, FEI_SUCCESS, SNL_FEI_Structure::getBlockDescriptor(), BlockDescriptor::getNumActiveNodes(), and problemStructure_.
Referenced by test_FEI_Implementation::test2().
|
virtual |
return the number of active equations in a given element block
Implements FEI.
Definition at line 1244 of file FEI_Implementation.cpp.
References CHK_ERR, FEI_SUCCESS, SNL_FEI_Structure::getBlockDescriptor(), BlockDescriptor::getTotalNumEqns(), and problemStructure_.
|
virtual |
return the number of nodes associated with elements of a given block ID
Implements FEI.
Definition at line 1176 of file FEI_Implementation.cpp.
References CHK_ERR, FEI_SUCCESS, SNL_FEI_Structure::getBlockDescriptor(), BlockDescriptor::getNumNodesPerElement(), and problemStructure_.
|
virtual |
return the number of equations (including element eqns) associated with elements of a given block ID
Implements FEI.
Definition at line 1190 of file FEI_Implementation.cpp.
References CHK_ERR, FEI_SUCCESS, SNL_FEI_Structure::getBlockDescriptor(), BlockDescriptor::getNumEqnsPerElement(), and problemStructure_.
|
virtual |
return the number of elements associated with this blockID
Implements FEI.
Definition at line 1258 of file FEI_Implementation.cpp.
References CHK_ERR, FEI_SUCCESS, SNL_FEI_Structure::getBlockDescriptor(), BlockDescriptor::getNumElements(), and problemStructure_.
|
virtual |
return the number of elements eqns for elems w/ this blockID
Implements FEI.
Definition at line 1270 of file FEI_Implementation.cpp.
References CHK_ERR, FEI_SUCCESS, SNL_FEI_Structure::getBlockDescriptor(), BlockDescriptor::getNumElemDOFPerElement(), and problemStructure_.
int FEI_Implementation::getParameters | ( | int & | numParams, |
char **& | paramStrings | ||
) |
return the parameters that have been set so far. The caller should NOT delete the paramStrings pointer.
Definition at line 228 of file FEI_Implementation.cpp.
References numParams_, and paramStrings_.
Referenced by FEDataFilter::FEDataFilter(), and LinSysCoreFilter::LinSysCoreFilter().
|
virtual |
Query the size of a field. This info is supplied to the FEI (initFields) by the application, but may not be easily obtainable on the app side at all times. Thus, it would be nice if the FEI could answer this query.
Implements FEI.
Definition at line 1285 of file FEI_Implementation.cpp.
References SNL_FEI_Structure::getFieldSize(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Since the ultimate intent for matrix-access is to bypass the FEI and go straight to the underlying data objects, we need a translation function to map between the IDs that the FEI deals in, and equation numbers that linear algebra objects deal in.
ID | Identifier of either a node or an element. |
idType | Can take either of the values FEI_NODE or FEI_ELEMENT. |
fieldID | Identifies a particular field at this [node||element]. |
numEqns | Output. Number of equations associated with this node/field (or element/field) pair. |
eqnNumbers | Caller-allocated array. On exit, this is filled with the above-described equation-numbers. They are global 0-based numbers. |
Implements FEI.
Definition at line 1297 of file FEI_Implementation.cpp.
References SNL_FEI_Structure::getEqnNumbers(), and problemStructure_.
|
virtual |
Get the solution data for a particular field, on an arbitrary set of nodes.
fieldID | Input. field identifier for which solution data is being requested. |
numNodes | Input. Length of the nodeIDs list. |
nodeIDs | Input. List specifying the nodes on which solution data is being requested. |
results | Allocated by caller, but contents are output. Solution data for the i-th node/element starts in position i*fieldSize, where fieldSize is the number of scalar components that make up 'fieldID'. |
Implements FEI.
Definition at line 1310 of file FEI_Implementation.cpp.
References filter_, and index_soln_filter_.
|
virtual |
Get the number of nodes that are local to this processor (includes nodes that are shared by other processors).
numNodes | Output. Number of local nodes. |
Implements FEI.
Definition at line 1320 of file FEI_Implementation.cpp.
References SNL_FEI_Structure::getNodeDatabase(), NodeDatabase::getNodeIDs(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Get a list of the nodeIDs that are local to this processor (includes nodes that are shared by other processors).
numNodes | Output. Same as the value output by 'getNumLocalNodes'. |
nodeIDs | Caller-allocated array, contents to be filled by this function. |
lenNodeIDs | Input. Length of the caller-allocated nodeIDs array. If lenNodeIDs is less than numNodes, then only 'lenNodeIDs' nodeIDs are provided, of course. If lenNodeIDs is greater than numNodes, then only 'numNodes' positions of the nodeIDs array are referenced. |
Implements FEI.
Definition at line 1327 of file FEI_Implementation.cpp.
References fei::copyKeysToArray(), SNL_FEI_Structure::getNodeDatabase(), NodeDatabase::getNodeIDs(), and problemStructure_.
Referenced by test_FEI_Implementation::test1(), and test_FEI_Implementation::test2().
|
virtual |
Pass nodal data for a specified field through to the solver. Example
is geometric coordinates, etc.
fieldID | field identifier for the data to be passed. This is probably not one of the 'solution-field' identifiers. It should be an identifier that the solver is expecting and knows how to handle. This field id must previously have been provided to the fei implementation via the normal initFields method. |
numNodes | number of nodes for which data is being provided |
nodeIDs | List of length numNodes, giving node-identifiers for which data is being provided. |
nodeData | List of length fieldSize*numNodes, where fieldSize is the size which was associated with fieldID when initFields was called. The data for nodeIDs[i] begins in position i*fieldSize of this array. |
Implements FEI.
Definition at line 1343 of file FEI_Implementation.cpp.
References filter_, and index_soln_filter_.
|
inline |
Definition at line 715 of file FEI_Implementation.hpp.
References problemStructure_.
|
inline |
Definition at line 718 of file FEI_Implementation.hpp.
References problemStructure_.
|
private |
|
private |
Definition at line 177 of file FEI_Implementation.cpp.
References matrixIDs_, numRHSIDs_, and rhsIDs_.
Referenced by setIDLists(), and ~FEI_Implementation().
|
private |
Definition at line 188 of file FEI_Implementation.cpp.
References rhsScalars_.
Referenced by allocateInternalFEIs(), setIDLists(), and ~FEI_Implementation().
|
private |
Definition at line 1481 of file FEI_Implementation.cpp.
References LinearSystemCore::clone(), comm_, fei::console_out(), dbgOStreamPtr_, debugOutput_, deleteRHSScalars(), ERReturn, FEI_ENDL, FEI_OSTRINGSTREAM, filter_, fei::SharedPtr< T >::get(), haveFEData_, haveLinSysCore_, IDsAllocated_, index_current_filter_, index_soln_filter_, internalFEIsAllocated_, linSysCore_, lscArray_, masterRank_, matScalars_, needParametersAbort(), numInternalFEIs_, numParams_, numRHSIDs_, Filter::parameters(), LinearSystemCore::parameters(), paramStrings_, problemStructure_, rhsIDs_, rhsScalars_, Filter::setLogStream(), Filter::setNumRHSVectors(), LinearSystemCore::setNumRHSVectors(), and wrapper_.
Referenced by initComplete().
|
private |
Definition at line 1588 of file FEI_Implementation.cpp.
References debugOutput_, and FEI_ENDL.
Referenced by aggregateSystem(), buildLinearSystem(), deleteMultCRs(), parameters(), setCurrentMatrix(), and setCurrentRHS().
|
private |
Definition at line 1593 of file FEI_Implementation.cpp.
References debugOutput_, and FEI_ENDL.
|
private |
Definition at line 1353 of file FEI_Implementation.cpp.
References aggregateSystem(), aggregateSystemFormed_, comm_, debugOut(), Filter::exchangeRemoteEquations(), FEI_COUT, FEI_ENDL, filter_, index_soln_filter_, Filter::loadComplete(), matScalarsSet_, MPI_SUCCESS, newMatrixDataLoaded_, numInternalFEIs_, numProcs_, rhsScalarsSet_, solveType_, and voidERReturn.
Referenced by loadComplete(), residualNorm(), and solve().
|
private |
Definition at line 1412 of file FEI_Implementation.cpp.
References aggregateSystemFormed_, CHK_ERR, debugOut(), ERReturn, Data::getDataPtr(), Data::getTypeName(), haveLinSysCore_, index_soln_filter_, lscArray_, matScalars_, numInternalFEIs_, numRHSIDs_, rhsIDs_, rhsScalars_, Data::setDataPtr(), Data::setTypeName(), soln_fei_matrix_, and soln_fei_vector_.
Referenced by buildLinearSystem().
|
private |
Definition at line 1600 of file FEI_Implementation.cpp.
References comm_, fei::console_out(), FEI_ENDL, and MPI_Abort.
Referenced by FEI_Implementation(), and setSolveType().
|
private |
Definition at line 1607 of file FEI_Implementation.cpp.
References comm_, fei::console_out(), FEI_ENDL, and MPI_Abort.
Referenced by loadCRMult(), loadCRPen(), loadElemBCs(), loadNodeBCs(), putIntoRHS(), sumInElem(), sumInElemMatrix(), sumInElemRHS(), sumIntoMatrixDiagonal(), and sumIntoRHS().
|
private |
Definition at line 1618 of file FEI_Implementation.cpp.
References comm_, fei::console_out(), FEI_ENDL, and MPI_Abort.
Referenced by allocateInternalFEIs().
|
private |
Definition at line 1629 of file FEI_Implementation.cpp.
References comm_, fei::console_out(), FEI_ENDL, and MPI_Abort.
|
private |
Definition at line 865 of file FEI_Implementation.cpp.
References fei::console_out(), dbgFileOpened_, dbgFStreamPtr_, dbgOStreamPtr_, debugOutput_, FEI_ENDL, FEI_OFSTREAM, FEI_OSTRINGSTREAM, filter_, internalFEIsAllocated_, IOS_APP, IOS_FLOATFIELD, IOS_SCIENTIFIC, localRank_, numInternalFEIs_, numProcs_, problemStructure_, SNL_FEI_Structure::setDbgOut(), Filter::setLogStream(), and version().
Referenced by parameters().
|
private |
Definition at line 748 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), FEI_Implementation(), and parameters().
|
private |
Definition at line 749 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), FEI_Implementation(), parameters(), and ~FEI_Implementation().
|
private |
Definition at line 750 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), and FEI_Implementation().
|
private |
Definition at line 751 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), FEI_Implementation(), and parameters().
|
private |
Definition at line 752 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), FEI_Implementation(), initComplete(), and parameters().
|
private |
Definition at line 753 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), deleteMultCRs(), FEI_Implementation(), getBlockElemIDList(), getBlockNodeIDList(), getCRMultIDList(), getEqnNumbers(), getFieldSize(), getLocalNodeIDList(), getNumBlockActEqns(), getNumBlockActNodes(), getNumBlockElemDOF(), getNumBlockElements(), getNumCRMultipliers(), getNumElemBlocks(), getNumEqnsPerElement(), getNumLocalNodes(), getNumNodesPerElement(), getNumSolnParams(), getProblemStructure(), initComplete(), initCRMult(), initCRPen(), initElem(), initElemBlock(), initFields(), initSharedNodes(), initSlaveVariable(), parameters(), setDebugOutput(), and ~FEI_Implementation().
|
private |
Definition at line 754 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), buildLinearSystem(), deleteMultCRs(), getBlockElemSolution(), getBlockFieldNodeSolution(), getBlockNodeSolution(), getCRMultipliers(), getNodalFieldSolution(), getNodalSolution(), initComplete(), iterations(), loadCRMult(), loadCRPen(), loadElemBCs(), loadNodeBCs(), parameters(), putBlockElemSolution(), putBlockFieldNodeSolution(), putBlockNodeSolution(), putCRMultipliers(), putIntoRHS(), putNodalFieldData(), resetInitialGuess(), resetMatrix(), resetRHSVector(), resetSystem(), residualNorm(), setCurrentRHS(), setDebugOutput(), solve(), sumInElem(), sumInElemMatrix(), sumInElemRHS(), sumIntoMatrixDiagonal(), sumIntoRHS(), and ~FEI_Implementation().
|
private |
Definition at line 756 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), buildLinearSystem(), FEI_Implementation(), initComplete(), parameters(), setCurrentMatrix(), setCurrentRHS(), setDebugOutput(), setIDLists(), setRHSScalars(), and ~FEI_Implementation().
|
private |
Definition at line 757 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), deleteMultCRs(), loadCRMult(), loadCRPen(), loadElemBCs(), loadNodeBCs(), parameters(), putIntoRHS(), resetInitialGuess(), resetMatrix(), resetRHSVector(), resetSystem(), setDebugOutput(), sumInElem(), sumInElemMatrix(), sumInElemRHS(), sumIntoMatrixDiagonal(), sumIntoRHS(), and ~FEI_Implementation().
|
private |
Definition at line 759 of file FEI_Implementation.hpp.
Referenced by deleteIDs(), FEI_Implementation(), setCurrentMatrix(), setIDLists(), setMatScalars(), and setSolveType().
|
private |
Definition at line 760 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), deleteIDs(), FEI_Implementation(), setCurrentRHS(), setIDLists(), and setRHSScalars().
|
private |
Definition at line 761 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), deleteIDs(), FEI_Implementation(), setCurrentRHS(), setIDLists(), and setRHSScalars().
|
private |
Definition at line 763 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs().
|
private |
Definition at line 765 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), and setMatScalars().
|
private |
Definition at line 766 of file FEI_Implementation.hpp.
Referenced by buildLinearSystem(), and setMatScalars().
|
private |
Definition at line 767 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), deleteRHSScalars(), FEI_Implementation(), setIDLists(), and setRHSScalars().
|
private |
Definition at line 768 of file FEI_Implementation.hpp.
Referenced by buildLinearSystem(), and setRHSScalars().
|
private |
Definition at line 770 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), allocateInternalFEIs(), buildLinearSystem(), getBlockElemSolution(), getBlockFieldNodeSolution(), getBlockNodeSolution(), getCRMultipliers(), getNodalFieldSolution(), getNodalSolution(), iterations(), loadElemBCs(), loadNodeBCs(), putBlockElemSolution(), putBlockFieldNodeSolution(), putBlockNodeSolution(), putCRMultipliers(), putNodalFieldData(), residualNorm(), and solve().
|
private |
Definition at line 771 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), deleteMultCRs(), loadCRMult(), loadCRPen(), loadElemBCs(), loadNodeBCs(), resetInitialGuess(), resetMatrix(), resetRHSVector(), resetSystem(), setCurrentMatrix(), sumInElem(), sumInElemMatrix(), and sumIntoMatrixDiagonal().
|
private |
Definition at line 772 of file FEI_Implementation.hpp.
Referenced by putIntoRHS(), setCurrentRHS(), sumInElemRHS(), and sumIntoRHS().
|
private |
Definition at line 774 of file FEI_Implementation.hpp.
Referenced by buildLinearSystem(), loadElemBCs(), loadNodeBCs(), and setSolveType().
|
private |
Definition at line 776 of file FEI_Implementation.hpp.
|
private |
Definition at line 777 of file FEI_Implementation.hpp.
Referenced by initComplete().
|
private |
Definition at line 779 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), buildLinearSystem(), setMatScalars(), and setRHSScalars().
|
private |
Definition at line 780 of file FEI_Implementation.hpp.
Referenced by buildLinearSystem(), loadCRMult(), loadCRPen(), putIntoRHS(), sumInElem(), sumInElemMatrix(), sumInElemRHS(), sumIntoMatrixDiagonal(), and sumIntoRHS().
|
private |
Definition at line 782 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), and ~FEI_Implementation().
|
private |
Definition at line 783 of file FEI_Implementation.hpp.
Referenced by aggregateSystem(), and ~FEI_Implementation().
|
private |
Definition at line 785 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), badParametersAbort(), buildLinearSystem(), FEI_Implementation(), messageAbort(), needParametersAbort(), and notAllocatedAbort().
|
private |
Definition at line 787 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs().
|
private |
Definition at line 788 of file FEI_Implementation.hpp.
Referenced by FEI_Implementation(), and setDebugOutput().
|
private |
Definition at line 789 of file FEI_Implementation.hpp.
Referenced by buildLinearSystem(), FEI_Implementation(), and setDebugOutput().
|
private |
Definition at line 791 of file FEI_Implementation.hpp.
Referenced by parameters().
|
private |
Definition at line 793 of file FEI_Implementation.hpp.
|
private |
Definition at line 794 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), debugOut(), parameters(), setCurrentMatrix(), setCurrentRHS(), setDebugOutput(), setIDLists(), setSolveType(), and ~FEI_Implementation().
|
private |
Definition at line 796 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), setDebugOutput(), setIDLists(), and ~FEI_Implementation().
|
private |
Definition at line 800 of file FEI_Implementation.hpp.
Referenced by setDebugOutput(), and ~FEI_Implementation().
|
private |
Definition at line 802 of file FEI_Implementation.hpp.
Referenced by setDebugOutput(), and ~FEI_Implementation().
|
private |
Definition at line 807 of file FEI_Implementation.hpp.
Referenced by cumulative_cpu_times().
|
private |
Definition at line 807 of file FEI_Implementation.hpp.
Referenced by cumulative_cpu_times().
|
private |
Definition at line 807 of file FEI_Implementation.hpp.
Referenced by cumulative_cpu_times(), residualNorm(), and solve().
|
private |
Definition at line 807 of file FEI_Implementation.hpp.
Referenced by cumulative_cpu_times().
|
private |
Definition at line 809 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), getParameters(), parameters(), and ~FEI_Implementation().
|
private |
Definition at line 810 of file FEI_Implementation.hpp.
Referenced by allocateInternalFEIs(), getParameters(), parameters(), and ~FEI_Implementation().