![]() |
v0.14.0 |
#include <src/finite_elements/ForcesAndSourcesCore.hpp>
Public Types | |
enum | OpType { OPROW = 1 << 0 , OPCOL = 1 << 1 , OPROWCOL = 1 << 2 , OPSPACE = 1 << 3 , OPLAST = 1 << 3 } |
Controls loop over entities on element. More... | |
![]() | |
using | DoWorkLhsHookFunType = boost::function< MoFEMErrorCode(DataOperator *op_ptr, int row_side, int col_side, EntityType row_type, EntityType col_type, EntitiesFieldData::EntData &row_data, EntitiesFieldData::EntData &col_data)> |
using | DoWorkRhsHookFunType = boost::function< MoFEMErrorCode(DataOperator *op_ptr, int side, EntityType type, EntitiesFieldData::EntData &data)> |
Public Member Functions | |
UserDataOperator (const FieldSpace space, const char type=OPSPACE, const bool symm=true) | |
UserDataOperator (const std::string field_name, const char type, const bool symm=true) | |
UserDataOperator (const std::string row_field_name, const std::string col_field_name, const char type, const bool symm=true) | |
boost::shared_ptr< const NumeredEntFiniteElement > | getNumeredEntFiniteElementPtr () const |
Return raw pointer to NumeredEntFiniteElement. More... | |
EntityHandle | getFEEntityHandle () const |
Return finite element entity handle. More... | |
int | getFEDim () const |
Get dimension of finite element. More... | |
EntityType | getFEType () const |
Get dimension of finite element. More... | |
boost::weak_ptr< SideNumber > | getSideNumberPtr (const int side_number, const EntityType type) |
Get the side number pointer. More... | |
EntityHandle | getSideEntity (const int side_number, const EntityType type) |
Get the side entity. More... | |
int | getNumberOfNodesOnElement () const |
Get the number of nodes on finite element. More... | |
MoFEMErrorCode | getProblemRowIndices (const std::string filed_name, const EntityType type, const int side, VectorInt &indices) const |
Get row indices. More... | |
MoFEMErrorCode | getProblemColIndices (const std::string filed_name, const EntityType type, const int side, VectorInt &indices) const |
Get col indices. More... | |
const FEMethod * | getFEMethod () const |
Return raw pointer to Finite Element Method object. More... | |
int | getOpType () const |
Get operator types. More... | |
void | setOpType (const OpType type) |
Set operator type. More... | |
void | addOpType (const OpType type) |
Add operator type. More... | |
int | getNinTheLoop () const |
get number of finite element in the loop More... | |
int | getLoopSize () const |
get size of elements in the loop More... | |
std::string | getFEName () const |
Get name of the element. More... | |
ForcesAndSourcesCore * | getPtrFE () const |
ForcesAndSourcesCore * | getSidePtrFE () const |
ForcesAndSourcesCore * | getRefinePtrFE () const |
Accessing KSP | |
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 |
Accessing SNES | |
Vec | getSNESf () const |
Vec | getSNESx () const |
Mat | getSNESA () const |
Mat | getSNESB () const |
Accessing TS | |
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 |
Base funtions and integration points | |
MatrixDouble & | getGaussPts () |
matrix of integration (Gauss) points for Volume Element More... | |
auto | getFTensor0IntegrationWeight () |
Get integration weights. More... | |
Coordinates and access to internal data | |
MatrixDouble & | getCoordsAtGaussPts () |
Gauss points and weight, matrix (nb. of points x 3) More... | |
auto | getFTensor1CoordsAtGaussPts () |
Get coordinates at integration points assuming linear geometry. More... | |
Measures (area, volume, length, etc.) | |
double | getMeasure () const |
get measure of element More... | |
double & | getMeasure () |
get measure of element More... | |
![]() | |
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. More... | |
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. More... | |
virtual MoFEMErrorCode | opRhs (EntitiesFieldData &data, const bool error_if_no_base=false) |
bool | getSymm () const |
Get if operator uses symmetry of DOFs or not. More... | |
void | setSymm () |
set if operator is executed taking in account symmetry More... | |
void | unSetSymm () |
unset if operator is executed for non symmetric problem More... | |
Public Attributes | |
char | opType |
std::string | rowFieldName |
std::string | colFieldName |
FieldSpace | sPace |
![]() | |
DoWorkLhsHookFunType | doWorkLhsHook |
DoWorkRhsHookFunType | doWorkRhsHook |
bool | sYmm |
If true assume that matrix is symmetric structure. More... | |
std::array< bool, MBMAXTYPE > | doEntities |
If true operator is executed for entity. More... | |
bool & | doVertices |
\deprectaed If false skip vertices More... | |
bool & | doEdges |
\deprectaed If false skip edges More... | |
bool & | doQuads |
\deprectaed More... | |
bool & | doTris |
\deprectaed More... | |
bool & | doTets |
\deprectaed More... | |
bool & | doPrisms |
\deprectaed More... | |
Static Public Attributes | |
static const char *const | OpTypeNames [] |
Protected Member Functions | |
virtual MoFEMErrorCode | setPtrFE (ForcesAndSourcesCore *ptr) |
Protected Attributes | |
ForcesAndSourcesCore * | ptrFE |
Friends | |
class | ForcesAndSourcesCore |
class | EdgeElementForcesAndSourcesCore |
class | FaceElementForcesAndSourcesCore |
class | ContactPrismElementForcesAndSourcesCore |
Loops | |
} | |
using | AdjCache = std::map< EntityHandle, std::vector< boost::weak_ptr< NumeredEntFiniteElement > > > |
MoFEMErrorCode | loopSide (const string &fe_name, ForcesAndSourcesCore *side_fe, const size_t dim, const EntityHandle ent_for_side=0, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy, AdjCache *adj_cache=nullptr) |
User call this function to loop over elements on the side of face. This function calls finite element with is operator to do calculations. More... | |
MoFEMErrorCode | loopThis (const string &fe_name, ForcesAndSourcesCore *parent_fe, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
User call this function to loop over parent elements. This function calls finite element with is operator to do calculations. More... | |
MoFEMErrorCode | loopParent (const string &fe_name, ForcesAndSourcesCore *parent_fe, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
User call this function to loop over parent elements. This function calls finite element with is operator to do calculations. More... | |
MoFEMErrorCode | loopChildren (const string &fe_name, ForcesAndSourcesCore *child_fe, const int verb=QUIET, const LogManager::SeverityLevel sev=Sev::noisy) |
User call this function to loop over parent elements. This function calls finite element with is operator to do calculations. More... | |
Definition at line 546 of file ForcesAndSourcesCore.hpp.
using MoFEM::ForcesAndSourcesCore::UserDataOperator::AdjCache = std::map<EntityHandle, std::vector<boost::weak_ptr<NumeredEntFiniteElement> >> |
Definition at line 899 of file ForcesAndSourcesCore.hpp.
enum MoFEM::ForcesAndSourcesCore::UserDataOperator::OpType |
Controls loop over entities on element.
For typical problem like Bubnov-Galerkin OPROW and OPCOL are the same. In more general case for example for non-square matrices columns and rows could have different numeration and/or different set of fields.
Enumerator | |
---|---|
OPROW | operator doWork function is executed on FE rows |
OPCOL | operator doWork function is executed on FE columns |
OPROWCOL | operator doWork is executed on FE rows &columns |
OPSPACE | operator do Work is execute on space data |
OPLAST |
|
Definition at line 563 of file ForcesAndSourcesCore.hpp.
ForcesAndSourcesCore::UserDataOperator::UserDataOperator | ( | const FieldSpace | space, |
const char | type = OPSPACE , |
||
const bool | symm = true |
||
) |
This Constructor is used typically when some modification base shape functions on some approx. space is applied. Operator is run for all data on space.
User has no access to field data from this operator.
Definition at line 1942 of file ForcesAndSourcesCore.cpp.
ForcesAndSourcesCore::UserDataOperator::UserDataOperator | ( | const std::string | field_name, |
const char | type, | ||
const bool | symm = true |
||
) |
Definition at line 1947 of file ForcesAndSourcesCore.cpp.
ForcesAndSourcesCore::UserDataOperator::UserDataOperator | ( | const std::string | row_field_name, |
const std::string | col_field_name, | ||
const char | type, | ||
const bool | symm = true |
||
) |
Definition at line 1952 of file ForcesAndSourcesCore.cpp.
|
inline |
Add operator type.
Definition at line 1047 of file ForcesAndSourcesCore.hpp.
|
inline |
Gauss points and weight, matrix (nb. of points x 3)
Column 0-2 integration points coordinate x, y and z, respectively. At rows are integration points.
Definition at line 1260 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1064 of file ForcesAndSourcesCore.hpp.
|
inline |
Get dimension of finite element.
Definition at line 1003 of file ForcesAndSourcesCore.hpp.
|
inline |
Return finite element entity handle.
Definition at line 999 of file ForcesAndSourcesCore.hpp.
|
inline |
Return raw pointer to Finite Element Method object.
Definition at line 1037 of file ForcesAndSourcesCore.hpp.
|
inline |
Get name of the element.
Definition at line 1059 of file ForcesAndSourcesCore.hpp.
|
inline |
Get dimension of finite element.
Definition at line 1007 of file ForcesAndSourcesCore.hpp.
|
inline |
Get integration weights.
Definition at line 1235 of file ForcesAndSourcesCore.hpp.
|
inline |
Get coordinates at integration points assuming linear geometry.
Definition at line 1264 of file ForcesAndSourcesCore.hpp.
|
inline |
matrix of integration (Gauss) points for Volume Element
For triangle: columns 0,1 are x,y coordinates respectively and column 2 is a weight value for example getGaussPts()(1,13) returns y coordinate of 13th Gauss point on particular volume element
For tetrahedron: columns 0,1,2 are x,y,z coordinates respectively and column 3 is a weight value for example getGaussPts()(1,13) returns y coordinate of 13th Gauss point on particular volume element
Definition at line 1231 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1091 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1099 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1069 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1083 of file ForcesAndSourcesCore.hpp.
|
inline |
get size of elements in the loop
Definition at line 1055 of file ForcesAndSourcesCore.hpp.
|
inline |
get measure of element
Definition at line 1274 of file ForcesAndSourcesCore.hpp.
|
inline |
get measure of element
Definition at line 1270 of file ForcesAndSourcesCore.hpp.
|
inline |
get number of finite element in the loop
Definition at line 1051 of file ForcesAndSourcesCore.hpp.
|
inline |
Get the number of nodes on finite element.
Definition at line 1033 of file ForcesAndSourcesCore.hpp.
|
inline |
Return raw pointer to NumeredEntFiniteElement.
Definition at line 995 of file ForcesAndSourcesCore.hpp.
|
inline |
Get operator types.
Definition at line 1041 of file ForcesAndSourcesCore.hpp.
MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::getProblemColIndices | ( | const std::string | filed_name, |
const EntityType | type, | ||
const int | side, | ||
VectorInt & | indices | ||
) | const |
Get col indices.
Field could be or not declared for this element but is declared for problem
field_name | |
type | entity type |
side | side number, any number if type is MBVERTEX |
NOTE: Using those indices to assemble matrix will result in error if new non-zero values need to be created.
Definition at line 1637 of file ForcesAndSourcesCore.cpp.
MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::getProblemRowIndices | ( | const std::string | filed_name, |
const EntityType | type, | ||
const int | side, | ||
VectorInt & | indices | ||
) | const |
Get row indices.
Field could be or not declared for this element but is declared for problem
field_name | |
type | entity type |
side | side number, any number if type is MBVERTEX |
NOTE: Using those indices to assemble matrix will result in error if new non-zero values need to be created.
Definition at line 1620 of file ForcesAndSourcesCore.cpp.
|
inline |
Definition at line 1246 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1256 of file ForcesAndSourcesCore.hpp.
|
inline |
Get the side entity.
side_number | |
type |
Definition at line 1025 of file ForcesAndSourcesCore.hpp.
|
inline |
Get the side number pointer.
side_number | |
type |
Definition at line 1012 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1251 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1123 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1131 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1074 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1107 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1115 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1171 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1211 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1221 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1179 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1079 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1163 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1187 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1195 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1203 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1139 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1147 of file ForcesAndSourcesCore.hpp.
|
inline |
Definition at line 1155 of file ForcesAndSourcesCore.hpp.
MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::loopChildren | ( | const string & | fe_name, |
ForcesAndSourcesCore * | child_fe, | ||
const int | verb = QUIET , |
||
const LogManager::SeverityLevel | sev = Sev::noisy |
||
) |
User call this function to loop over parent elements. This function calls finite element with is operator to do calculations.
fe_name | |
child_fe | |
verb | |
sev |
Definition at line 1839 of file ForcesAndSourcesCore.cpp.
MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::loopParent | ( | const string & | fe_name, |
ForcesAndSourcesCore * | parent_fe, | ||
const int | verb = QUIET , |
||
const LogManager::SeverityLevel | sev = Sev::noisy |
||
) |
User call this function to loop over parent elements. This function calls finite element with is operator to do calculations.
fe_name | |
parent_fe | |
verb | |
sev |
Definition at line 1789 of file ForcesAndSourcesCore.cpp.
MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::loopSide | ( | const string & | fe_name, |
ForcesAndSourcesCore * | side_fe, | ||
const size_t | dim, | ||
const EntityHandle | ent_for_side = 0 , |
||
const int | verb = QUIET , |
||
const LogManager::SeverityLevel | sev = Sev::noisy , |
||
AdjCache * | adj_cache = nullptr |
||
) |
User call this function to loop over elements on the side of face. This function calls finite element with is operator to do calculations.
fe_name | name of the side element |
side_fe | pointer to the side element instance |
dim | dimension the of side element |
ent_for_side | entity handle for which adjacent volume or face will be accessed |
verb | |
sev |
Definition at line 1668 of file ForcesAndSourcesCore.cpp.
MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::loopThis | ( | const string & | fe_name, |
ForcesAndSourcesCore * | parent_fe, | ||
const int | verb = QUIET , |
||
const LogManager::SeverityLevel | sev = Sev::noisy |
||
) |
User call this function to loop over parent elements. This function calls finite element with is operator to do calculations.
fe_name | |
parent_fe | |
verb | |
sev |
Definition at line 1757 of file ForcesAndSourcesCore.cpp.
|
inline |
Set operator type.
Operator | type |
Definition at line 1043 of file ForcesAndSourcesCore.hpp.
|
protectedvirtual |
Reimplemented in MoFEM::EdgeElementForcesAndSourcesCore::UserDataOperator, MoFEM::FaceElementForcesAndSourcesCore::UserDataOperator, MoFEM::FaceElementForcesAndSourcesCoreOnSide::UserDataOperator, MoFEM::FatPrismElementForcesAndSourcesCore::UserDataOperator, MoFEM::FlatPrismElementForcesAndSourcesCore::UserDataOperator, MoFEM::VertexElementForcesAndSourcesCore::UserDataOperator, MoFEM::VolumeElementForcesAndSourcesCore::UserDataOperator, and MoFEM::VolumeElementForcesAndSourcesCoreOnSide::UserDataOperator.
Definition at line 1991 of file ForcesAndSourcesCore.cpp.
|
friend |
Definition at line 988 of file ForcesAndSourcesCore.hpp.
|
friend |
Definition at line 986 of file ForcesAndSourcesCore.hpp.
|
friend |
Definition at line 987 of file ForcesAndSourcesCore.hpp.
|
friend |
Definition at line 985 of file ForcesAndSourcesCore.hpp.
std::string MoFEM::ForcesAndSourcesCore::UserDataOperator::colFieldName |
Definition at line 575 of file ForcesAndSourcesCore.hpp.
char MoFEM::ForcesAndSourcesCore::UserDataOperator::opType |
Definition at line 573 of file ForcesAndSourcesCore.hpp.
|
static |
Definition at line 571 of file ForcesAndSourcesCore.hpp.
|
protected |
Definition at line 980 of file ForcesAndSourcesCore.hpp.
std::string MoFEM::ForcesAndSourcesCore::UserDataOperator::rowFieldName |
Definition at line 574 of file ForcesAndSourcesCore.hpp.
FieldSpace MoFEM::ForcesAndSourcesCore::UserDataOperator::sPace |
Definition at line 576 of file ForcesAndSourcesCore.hpp.