|
| const EntityHandle * | getConn () |
| | get element connectivity
|
| |
| double | getLength () |
| | get edge length
|
| |
| VectorDouble & | getDirection () |
| | get edge direction
|
| |
| auto | getFTensor1Normal () |
| | get edge normal NOTE: it should be used only in 2D analysis
|
| |
| auto | getFTensor1Normal (const FTensor::Tensor1< double, 3 > &vec) |
| | get ftensor1 edge normal
|
| |
| auto | getFTensor1NormalsAtGaussPts (const FTensor::Tensor1< double, 3 > &vec) |
| |
| auto | getFTensor1NormalsAtGaussPts () |
| | get normal at integration points
|
| |
| VectorDouble & | getCoords () |
| | get edge node coordinates
|
| |
| MatrixDouble & | getTangentAtGaussPts () |
| | get tangent vector to edge curve at integration points
|
| |
| DEPRECATED MatrixDouble & | getTangetAtGaussPts () |
| |
| const EdgeElementForcesAndSourcesCore * | getEdgeFE () |
| | get pointer to this finite element
|
| |
| FTensor::Tensor1< double, 3 > | getFTensor1Direction () |
| |
| FTensor::Tensor1< FTensor::PackPtr< double *, 3 >, 3 > | getFTensor1Coords () |
| | get get coords at gauss points
|
| |
| DEPRECATED FTensor::Tensor1< FTensor::PackPtr< double *, 3 >, 3 > | getTensor1Coords () |
| |
| template<int DIM = 3> |
| FTensor::Tensor1< FTensor::PackPtr< double *, 3 >, DIM > | getFTensor1TangentAtGaussPts () |
| | Get tangent vector at integration points.
|
| |
| MoFEMErrorCode | loopSideFaces (const string fe_name, FaceElementForcesAndSourcesCoreOnSide &fe_side) |
| |
| template<> |
| FTensor::Tensor1< FTensor::PackPtr< double *, 3 >, 3 > | getFTensor1TangentAtGaussPts () |
| |
Public Member Functions inherited from MoFEM::ForcesAndSourcesCore::UserDataOperator |
| | UserDataOperator (const FieldSpace space, const char type=OPSPACE, const bool symm=true) |
| | Constructor for operators working on finite element spaces.
|
| |
| | UserDataOperator (const std::string field_name, const char type, const bool symm=true) |
| | Constructor for operators working on a single field.
|
| |
| | UserDataOperator (const std::string row_field_name, const std::string col_field_name, const char type, const bool symm=true) |
| | Constructor for operators working on two fields (bilinear forms)
|
| |
| boost::shared_ptr< const NumeredEntFiniteElement > | getNumeredEntFiniteElementPtr () const |
| | Return raw pointer to NumeredEntFiniteElement.
|
| |
| EntityHandle | getFEEntityHandle () const |
| | Return finite element entity handle.
|
| |
| int | getFEDim () const |
| | Get dimension of finite element.
|
| |
| EntityType | getFEType () const |
| | Get dimension of finite element.
|
| |
| boost::weak_ptr< SideNumber > | getSideNumberPtr (const int side_number, const EntityType type) |
| | Get the side number pointer.
|
| |
| EntityHandle | getSideEntity (const int side_number, const EntityType type) |
| | Get the side entity.
|
| |
| int | getNumberOfNodesOnElement () const |
| | Get the number of nodes on finite element.
|
| |
| MoFEMErrorCode | getProblemRowIndices (const std::string filed_name, const EntityType type, const int side, VectorInt &indices) const |
| | Get row indices.
|
| |
| MoFEMErrorCode | getProblemColIndices (const std::string filed_name, const EntityType type, const int side, VectorInt &indices) const |
| | Get col indices.
|
| |
| const FEMethod * | getFEMethod () const |
| | Return raw pointer to Finite Element Method object.
|
| |
| int | getOpType () const |
| | Get operator types.
|
| |
| void | setOpType (const OpType type) |
| | Set operator type.
|
| |
| void | addOpType (const OpType type) |
| | Add operator type.
|
| |
| int | getNinTheLoop () const |
| | get number of finite element in the loop
|
| |
| int | getLoopSize () const |
| | get size of elements in the loop
|
| |
| std::string | getFEName () const |
| | Get name of the element.
|
| |
| ForcesAndSourcesCore * | getPtrFE () const |
| |
| ForcesAndSourcesCore * | getSidePtrFE () const |
| |
| ForcesAndSourcesCore * | getRefinePtrFE () const |
| |
| const PetscData::Switches & | getDataCtx () const |
| |
| const KspMethod::KSPContext | getKSPCtx () const |
| |
| const SnesMethod::SNESContext | getSNESCtx () const |
| |
| const TSMethod::TSContext | getTSCtx () const |
| |
| Vec | getKSPf () const |
| |
| Mat | getKSPA () const |
| |
| Mat | getKSPB () const |
| |
| Vec | getSNESf () const |
| |
| Vec | getSNESx () const |
| |
| Mat | getSNESA () const |
| |
| Mat | getSNESB () const |
| |
| Vec | getTSu () const |
| |
| Vec | getTSu_t () const |
| |
| Vec | getTSu_tt () const |
| |
| Vec | getTSf () const |
| |
| Mat | getTSA () const |
| |
| Mat | getTSB () const |
| |
| int | getTSstep () const |
| |
| double | getTStime () const |
| |
| double | getTStimeStep () const |
| |
| double | getTSa () const |
| |
| double | getTSaa () const |
| |
| MatrixDouble & | getGaussPts () |
| | matrix of integration (Gauss) points for Volume Element
|
| |
| auto | getFTensor0IntegrationWeight () |
| | Get integration weights.
|
| |
| MatrixDouble & | getCoordsAtGaussPts () |
| | Gauss points and weight, matrix (nb. of points x 3)
|
| |
| auto | getFTensor1CoordsAtGaussPts () |
| | Get coordinates at integration points assuming linear geometry.
|
| |
| double | getMeasure () const |
| | get measure of element
|
| |
| double & | getMeasure () |
| | get measure of element
|
| |
| MoFEMErrorCode | loopSide (const string &fe_name, ForcesAndSourcesCore *side_fe, const size_t dim, const EntityHandle ent_for_side=0, boost::shared_ptr< Range > fe_range=nullptr, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy, AdjCache *adj_cache=nullptr) |
| | User calls this function to loop over elements on the side of face. This function calls finite element with its operator to do calculations.
|
| |
| MoFEMErrorCode | loopThis (const string &fe_name, ForcesAndSourcesCore *this_fe, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
| | User calls this function to loop over the same element using a different set of integration points. This function calls finite element with its operator to do calculations.
|
| |
| MoFEMErrorCode | loopParent (const string &fe_name, ForcesAndSourcesCore *parent_fe, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
| | User calls this function to loop over parent elements. This function calls finite element with its operator to do calculations.
|
| |
| MoFEMErrorCode | loopChildren (const string &fe_name, ForcesAndSourcesCore *child_fe, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
| | User calls this function to loop over parent elements. This function calls finite element with its operator to do calculations.
|
| |
| MoFEMErrorCode | loopRange (const string &fe_name, ForcesAndSourcesCore *range_fe, boost::shared_ptr< Range > fe_range, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
| | Iterate over range of elements.
|
| |
| | DataOperator (const bool symm=true) |
| |
| virtual | ~DataOperator ()=default |
| |
| virtual MoFEMErrorCode | doWork (int row_side, int col_side, EntityType row_type, EntityType col_type, EntitiesFieldData::EntData &row_data, EntitiesFieldData::EntData &col_data) |
| | Operator for bi-linear form, usually to calculate values on left hand side.
|
| |
| virtual MoFEMErrorCode | opLhs (EntitiesFieldData &row_data, EntitiesFieldData &col_data) |
| |
| virtual MoFEMErrorCode | doWork (int side, EntityType type, EntitiesFieldData::EntData &data) |
| | Operator for linear form, usually to calculate values on right hand side.
|
| |
| virtual MoFEMErrorCode | opRhs (EntitiesFieldData &data, const bool error_if_no_base=false) |
| |
| bool | getSymm () const |
| | Get if operator uses symmetry of DOFs or not.
|
| |
| void | setSymm () |
| | set if operator is executed taking in account symmetry
|
| |
| void | unSetSymm () |
| | unset if operator is executed for non symmetric problem
|
| |