NeoPZ
|
class to create a compute element multiphysics More...
#include <pzmultiphysicscompel.h>
Public Member Functions | |
TPZMultiphysicsCompEl (TPZCompMesh &mesh, TPZGeoEl *gel, int64_t &index) | |
Creates a multiphysic computational element within mesh. More... | |
TPZMultiphysicsCompEl () | |
Default constructor. More... | |
TPZMultiphysicsCompEl (TPZCompMesh &mesh, const TPZMultiphysicsCompEl< TGeometry > ©) | |
Put a copy of the element in the referred mesh. More... | |
TPZMultiphysicsCompEl (TPZCompMesh &mesh, const TPZMultiphysicsCompEl< TGeometry > ©, std::map< int64_t, int64_t > &gl2lcConMap, std::map< int64_t, int64_t > &gl2lcElMap) | |
Constructor used to generate patch mesh... generates a map of connect index from global mesh to clone mesh. More... | |
virtual | ~TPZMultiphysicsCompEl () |
Default destructor. More... | |
virtual TPZManVector< TPZCompElSide, 5 > & | ElementVec () override |
Returns a reference to the element pointers vector. More... | |
virtual void | AffineTransform (TPZVec< TPZTransform<> > &trVec) const override |
Compute the map of a paramenter point in the multiphysic element to a parameter point in the super element. More... | |
virtual void | EvaluateError (std::function< void(const TPZVec< REAL > &loc, TPZVec< STATE > &val, TPZFMatrix< STATE > &deriv)> func, TPZVec< REAL > &errors, bool store_error) override |
Performs an error estimate on the elemen. More... | |
virtual void | EvaluateError (TPZFunction< STATE > &func, TPZVec< STATE > &errors, bool store_error) override |
void | GetReferenceIndexVec (TPZManVector< TPZCompMesh *> cmeshVec, std::set< int64_t > &refIndexVec) |
Method to obtain an reference index set of multiphysics computational elements. More... | |
virtual TPZCompEl * | Clone (TPZCompMesh &mesh) const override |
Method for creating a copy of the element. More... | |
virtual TPZCompEl * | ClonePatchEl (TPZCompMesh &mesh, std::map< int64_t, int64_t > &gl2lcConMap, std::map< int64_t, int64_t > &gl2lcElMap) const override |
Method for creating a copy of the element in a patch mesh. More... | |
virtual int | NConnects () const override |
Returns the number of nodes of the element. More... | |
virtual int64_t | NMeshes () override |
Return the number of meshes associated with the element. More... | |
virtual int64_t | ConnectIndex (int i) const override |
Returns the index of the ith connectivity of the element. More... | |
virtual int64_t | ConnectIndex (int elem, int connect) const |
virtual int | Dimension () const override |
Dimension of the element. More... | |
virtual void | PolynomialOrder (TPZVec< int > &order) const override |
virtual void | Integrate (int variable, TPZVec< STATE > &value) override |
Post processing method which computes the solution for the var post processed variable. More... | |
virtual void | ComputeRequiredData (TPZVec< REAL > &point, TPZVec< TPZTransform<> > &trvec, TPZVec< TPZMaterialData > &datavec) |
Compute and fill data with requested attributes for each of the compels in fElementVec. More... | |
virtual void | ComputeRequiredData (TPZMaterialData &data, TPZVec< REAL > &point) override |
Compute and fill data with requested attributes. More... | |
virtual void | Solution (TPZVec< REAL > &qsi, int var, TPZVec< STATE > &sol) override |
Post processing method which computes the solution for the var post processed variable. More... | |
virtual TPZVec< STATE > | IntegrateSolution (int var) const override |
Compute the integral of a variable. More... | |
virtual void | ComputeSolution (TPZVec< REAL > &qsi, TPZSolVec &sol, TPZGradSolVec &dsol, TPZFMatrix< REAL > &axes) override |
Computes solution and its derivatives in the local coordinate qsi. More... | |
virtual void | ComputeSolution (TPZVec< REAL > &qsi, TPZVec< REAL > &normal, TPZSolVec &leftsol, TPZGradSolVec &dleftsol, TPZFMatrix< REAL > &leftaxes, TPZSolVec &rightsol, TPZGradSolVec &drightsol, TPZFMatrix< REAL > &rightaxes) override |
Computes solution and its derivatives in the local coordinate qsi. This method will function for both volumetric and interface elements. More... | |
virtual void | ComputeSolution (TPZVec< REAL > &qsi, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphix, const TPZFMatrix< REAL > &axes, TPZSolVec &sol, TPZGradSolVec &dsol) override |
Computes solution and its derivatives in local coordinate qsi. More... | |
virtual void | SetConnectIndex (int inode, int64_t index) override |
Set the index i to node inode. More... | |
virtual void | SetCreateFunctions (TPZCompMesh *mesh) override |
Sets create function in TPZCompMesh to create elements of this type. More... | |
virtual void | AddElement (TPZCompEl *cel, int64_t meshindex) override |
add an element to the datastructure More... | |
virtual void | AddElement (const TPZCompElSide &celside, int64_t meshindex) override |
add an element to the datastructure More... | |
virtual TPZCompEl * | Element (int64_t elindex) override |
virtual TPZCompEl * | ReferredElement (int64_t mesh) override |
Returns referred element of this. More... | |
virtual void | SetConnectIndexes (TPZVec< int64_t > &indexes) override |
Sets indexes of the connects of the element. More... | |
virtual void | Print (std::ostream &out=std::cout) const override |
Prints element data. More... | |
virtual void | CalcStiff (TPZElementMatrix &ek, TPZElementMatrix &ef) override |
Computes the element stiffness matrix and right hand side. More... | |
virtual void | CalcResidual (TPZElementMatrix &ef) override |
Computes the element stiffness matrix and right hand side. More... | |
void | InitializeElementMatrix (TPZElementMatrix &ek, TPZElementMatrix &ef) |
Initialize element matrix in which is computed CalcStiff. More... | |
void | InitializeElementMatrix (TPZElementMatrix &ef) |
Initialize element matrix in which is computed CalcStiff. More... | |
void | InitMaterialData (TPZVec< TPZMaterialData > &dataVec, TPZVec< int64_t > *indices=0) override |
Initialize a material data vector and its attributes based on element dimension, number of state variables and material definitions. More... | |
virtual void | CreateGraphicalElement (TPZGraphMesh &grmesh, int dimension) override |
Creates corresponding graphical element(s) if the dimension matches graphical elements are used to generate output files. More... | |
virtual void | SetIntegrationRule (int int_order) override |
virtual void | InitializeIntegrationRule () override |
After adding the elements initialize the integration rule. More... | |
virtual const TPZIntPoints & | GetIntegrationRule () const override |
Returns a reference to an integration rule suitable for integrating the interior of the element. More... | |
virtual TPZIntPoints & | GetIntegrationRule () override |
Returns a reference to an integration rule suitable for integrating the interior of the element. More... | |
virtual int | NumberOfCompElementsInsideThisCompEl () override |
Return the size of the elementvec in multiphysics, if it is not multiphysics, just return 1. More... | |
virtual int | ClassId () const override |
Define the class id associated with the class. More... | |
Public Member Functions inherited from TPZMultiphysicsElement | |
TPZMultiphysicsElement () | |
Default constructor. More... | |
TPZMultiphysicsElement (TPZCompMesh &mesh, TPZGeoEl *ref, int64_t &index) | |
Constructor. More... | |
TPZMultiphysicsElement (TPZCompMesh &mesh, const TPZMultiphysicsElement ©) | |
Put a copy of the element in the referred mesh. More... | |
virtual | ~TPZMultiphysicsElement () |
Default destructor. More... | |
virtual void | ComputeRequiredData (TPZVec< REAL > &point, TPZVec< TPZTransform<> > &trvec, TPZVec< TPZMaterialData > &datavec, TPZVec< int64_t > indices) |
void | CreateInterfaces () |
bool | ExistsInterface (int side) |
TPZMultiphysicsInterfaceElement * | CreateInterface (int side) |
void | RemoveInterfaces () |
void | RemoveInterface (int side) |
virtual int | ComputeIntegrationOrder () const override |
virtual void | BuildCornerConnectList (std::set< int64_t > &connectindexes) const override |
adds the connect indexes associated with base shape functions to the set More... | |
virtual void | TransferMultiphysicsElementSolution () override |
virtual void | SetActiveApproxSpaces (TPZManVector< int, 5 > &active_approx_space) |
Set the active approximation spaces. More... | |
virtual TPZManVector< int, 5 > & | GetActiveApproxSpaces () |
Set the active approximation spaces. More... | |
virtual bool | IsActiveApproxSpaces (int space_index) |
virtual void | AddShapeRestraint (TPZOneShapeRestraint restraint) override |
Add a shape restraint (meant to fit the pyramid to restraint. More... | |
virtual std::list< TPZOneShapeRestraint > | GetShapeRestraints () const override |
Return a list with the shape restraints. More... | |
Public Member Functions inherited from TPZCompEl | |
TPZCompEl () | |
Simple Constructor. More... | |
virtual | ~TPZCompEl () |
Simple destructor. More... | |
TPZCompEl (TPZCompMesh &mesh, const TPZCompEl ©) | |
Put a copy of the element in the referred mesh. More... | |
TPZCompEl (TPZCompMesh &mesh, const TPZCompEl ©, std::map< int64_t, int64_t > &gl2lcElMap) | |
Put a copy of the element in the patch mesh. More... | |
TPZCompEl (TPZCompMesh &mesh, const TPZCompEl ©, int64_t &index) | |
Copy of the element in the new mesh returning allocated index. More... | |
TPZCompEl (TPZCompMesh &mesh, TPZGeoEl *gel, int64_t &index) | |
Creates a computational element within mesh. Inserts the element within the data structure of the mesh. More... | |
virtual REAL | VolumeOfEl () |
Returns the volume of the geometric element associated. More... | |
virtual void | LoadElementReference () |
Loads the geometric element reference. More... | |
virtual REAL | CompareElement (int var, char *matname) |
This method computes the norm of the difference of a post processed variable with @ the same post processed variable of the element pointed to by the geometric element. More... | |
virtual void | Assemble () |
Computes the element stifness matrix and right hand side in an internal data structure. Used for initializing condensed element data structures. More... | |
virtual bool | HasMaterial (const std::set< int > &materialids) const |
Verifies if the material associated with the element is contained in the set. More... | |
virtual void | Divide (int64_t index, TPZVec< int64_t > &subindex, int interpolate=0) |
Divide the computational element. If interpolate = 1, the solution is interpolated to the sub elements. More... | |
virtual void | ProjectFlux (TPZElementMatrix &ek, TPZElementMatrix &ef) |
Projects the flux function on the finite element space. More... | |
virtual void | ComputeError (int errorid, TPZVec< REAL > &error) |
ComputeError computes the element error estimator. More... | |
virtual void | GetMemoryIndices (TPZVec< int64_t > &indices) const |
Get the indices of the vector of element memory associated with the integration points. More... | |
virtual void | SetMemoryIndices (TPZVec< int64_t > &indices) |
Set the indices of the vector of element memory associated with the integration points. More... | |
virtual void | PrepareIntPtIndices () |
Prepare the vector of the material withmem with the correct integration point indexes. More... | |
virtual void | ForcePrepareIntPtIndices () |
PrepareIntPtIndices initializes the material damage varibles memory in the proper material class. More... | |
virtual void | SetFreeIntPtIndices () |
Frees the material damage varibles memory in the proper material class. More... | |
virtual void | SetMultiphysicsElementSolution () |
virtual void | ResetShapeRestraints () |
Return a list with the shape restraints. More... | |
virtual TPZVec< STATE > | IntegrateSolution (const std::string &varname, const std::set< int > &matids) |
Compute the integral of a variable defined by the string if the material id is included in matids. More... | |
virtual void | ComputeSolution (TPZVec< REAL > &qsi, TPZMaterialData &data) |
virtual void | BuildConnectList (std::set< int64_t > &indepconnectlist, std::set< int64_t > &depconnectlist) |
Builds the list of all connectivities related to the element including the connects pointed to by dependent connects. More... | |
virtual void | BuildConnectList (TPZStack< int64_t > &connectlist) const |
Builds the list of all connectivities related to the element including the connects pointed to by dependent connects. More... | |
virtual void | BuildConnectList (std::set< int64_t > &connectlist) |
Builds the list of all connectivities related to the element including the connects pointed to by dependent connects. More... | |
virtual int | HasDependency () |
Returns 1 if the element has at least one dependent node. Returns 0 otherwise. More... | |
virtual int | PressureConnectIndex () const |
Returns the index of the pressure connect. More... | |
virtual void | ReduceInternalNodes () |
Domain Decomposition. This method will eliminate the nodes which are internal to the element from the datastructure of the grid After calling this method, the superelement will statically condense the internal equations. More... | |
virtual void | CalcBlockDiagonal (TPZStack< int64_t > &connectlist, TPZBlockDiagonal< STATE > &block) |
Calculates the diagonal block. More... | |
REAL | MaximumRadiusOfEl () |
Will return the maximum distance between the nodes of the reference element. More... | |
REAL | LesserEdgeOfEl () |
Will return the smallest distance between two nodes of the reference element. More... | |
void | Write (TPZStream &buf, int withclassid) const override |
Save the element data to a stream. More... | |
void | Read (TPZStream &buf, void *context) override |
Read the element data from a stream. More... | |
virtual void | SetIntegrationRule (TPZIntPoints *intrule) |
Method to set a dynamically allocated integration rule. More... | |
virtual MElementType | Type () |
Return the type of the element. More... | |
virtual int | IsInterface () |
TPZGeoEl * | Reference () const |
Return a pointer to the corresponding geometric element if such exists, return 0 otherwise. More... | |
void | SetReference (int64_t referenceindex) |
virtual bool | NeedsComputing (const std::set< int > &materialids) |
return true if the element has a variational statement associated with the material ids More... | |
virtual int | NEquations () |
Returns the number of equations of the element. More... | |
int64_t | Index () const |
Returns element index of the mesh fELementVec list. More... | |
void | SetIndex (int64_t index) |
Sets element index of the mesh fELementVec list. More... | |
virtual TPZConnect & | Connect (int i) const |
Returns a pointer to the ith node. More... | |
virtual TPZMaterial * | Material () const |
Identify the material object associated with the element. More... | |
TPZGeoEl * | GetRefElPatch () |
Returns the reference geometric element patch. Look for a geometric element which refers to a computational element and is neighbour of the current element AND is larger than the current element. More... | |
virtual void | LoadSolution () |
Loads the solution within the internal data structure of the element. More... | |
void | SetMesh (TPZCompMesh *mesh) |
Sets the grid of the element. More... | |
TPZCompMesh * | Mesh () const |
Return a pointer to the grid of the element. More... | |
virtual void | PrintSolution (TPZVec< REAL > &point, const char *VarName, std::ostream &out) |
Prints the solution - sol - for the variable "VarName" at point specified in terms of the master element coordinates. More... | |
virtual void | PrintCoordinate (TPZVec< REAL > &point, int CoordinateIndex, std::ostream &out) |
Prints one coordinate index corresponding to the point to the output stream. More... | |
virtual void | PrintTitle (const char *VarName, std::ostream &out) |
Prints the variables names associated with the element material. More... | |
Public Member Functions inherited from TPZSavable | |
TPZSavable () | |
virtual | ~TPZSavable () |
virtual std::list< std::map< std::string, uint64_t > > | VersionHistory () const |
virtual std::pair< std::string, uint64_t > | Version () const |
virtual bool | Compare (TPZSavable *copy, bool override=false) |
Compares the object for identity with the object pointed to, eventually copy the object. More... | |
virtual bool | Compare (TPZSavable *copy, bool override=false) const |
Compares the object for identity with the object pointed to, eventually copy the object. More... | |
Public Member Functions inherited from TPZRegisterClassId | |
template<typename T > | |
TPZRegisterClassId (int(T::*)() const) | |
TPZRegisterClassId ()=default | |
Protected Attributes | |
TPZManVector< TPZCompElSide,5 > | fElementVec |
List of pointers to computational elements. More... | |
TPZVec< int64_t > | fConnectIndexes |
Indexes of the connects of the element. More... | |
TGeometry::IntruleType | fIntRule |
Integration rule associated with the element. More... | |
Protected Attributes inherited from TPZMultiphysicsElement | |
std::list< TPZOneShapeRestraint > | fRestraints |
list of restraints applied to one shape function More... | |
TPZManVector< int, 5 > | fActiveApproxSpace |
List of active approximation spaces. More... | |
Protected Attributes inherited from TPZCompEl | |
TPZCompMesh * | fMesh |
Computational mesh to which the element belongs. More... | |
int64_t | fIndex |
Element index into mesh element vector. More... | |
TPZIntPoints * | fIntegrationRule |
Integration rule established by the user. More... | |
Additional Inherited Members | |
Static Public Member Functions inherited from TPZCompEl | |
static int | StaticClassId () |
static void | SetgOrder (int order) |
Sets the value of the default interpolation order. More... | |
static int | GetgOrder () |
Set the default value of the interpolation order. More... | |
static void | SetOrthogonalFunction (void(*orthogonal)(REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi)) |
Sets the orthogonal function which will be used throughout the program by default this function is the Chebyshev function. More... | |
static void | Chebyshev (REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi) |
Implements of the orthogonal Chebyshev functions. More... | |
Static Public Member Functions inherited from TPZSavable | |
static std::set< TPZRestoreClassBase * > & | RestoreClassSet () |
This static function guarantees that the gMap object is available when needed. More... | |
static std::map< int, TPZRestore_t > & | ClassIdMap () |
This static function guarantees that the gMap object is available when needed. More... | |
static std::pair< std::string, uint64_t > | NeoPZVersion () |
static void | Register (TPZRestoreClassBase *restore) |
static void | RegisterClassId (int classid, TPZRestore_t fun) |
static TPZSavable * | CreateInstance (const int &classId) |
class to create a compute element multiphysics
Definition at line 22 of file pzmultiphysicscompel.h.
TPZMultiphysicsCompEl< TGeometry >::TPZMultiphysicsCompEl | ( | TPZCompMesh & | mesh, |
TPZGeoEl * | gel, | ||
int64_t & | index | ||
) |
Creates a multiphysic computational element within mesh.
mesh | mesh multiphysic where will be created the element |
gel | geometric element for which the computational element will be created |
index | new elemen index |
Definition at line 71 of file pzmultiphysicscompel.cpp.
TPZMultiphysicsCompEl< TGeometry >::TPZMultiphysicsCompEl | ( | ) |
Default constructor.
Definition at line 41 of file pzmultiphysicscompel.cpp.
TPZMultiphysicsCompEl< TGeometry >::TPZMultiphysicsCompEl | ( | TPZCompMesh & | mesh, |
const TPZMultiphysicsCompEl< TGeometry > & | copy | ||
) |
Put a copy of the element in the referred mesh.
Definition at line 46 of file pzmultiphysicscompel.cpp.
References TPZCompEl::Material(), and PZError.
TPZMultiphysicsCompEl< TGeometry >::TPZMultiphysicsCompEl | ( | TPZCompMesh & | mesh, |
const TPZMultiphysicsCompEl< TGeometry > & | copy, | ||
std::map< int64_t, int64_t > & | gl2lcConMap, | ||
std::map< int64_t, int64_t > & | gl2lcElMap | ||
) |
Constructor used to generate patch mesh... generates a map of connect index from global mesh to clone mesh.
Definition at line 61 of file pzmultiphysicscompel.cpp.
References DebugStop.
|
virtual |
Default destructor.
Definition at line 76 of file pzmultiphysicscompel.cpp.
References TPZCompEl::Connect(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), and TPZConnect::RemoveDepend().
|
inlineoverridevirtual |
add an element to the datastructure
Implements TPZMultiphysicsElement.
Definition at line 218 of file pzmultiphysicscompel.h.
References TPZMultiphysicsElement::fActiveApproxSpace, TPZGeoEl::NSides(), TPZCompEl::Reference(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::resize(), and TPZVec< T >::size().
|
inlineoverridevirtual |
add an element to the datastructure
Implements TPZMultiphysicsElement.
Definition at line 238 of file pzmultiphysicscompel.h.
References TPZMultiphysicsElement::fActiveApproxSpace, TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::resize(), and TPZVec< T >::size().
|
overridevirtual |
Compute the map of a paramenter point in the multiphysic element to a parameter point in the super element.
trVec | Transform |
Implements TPZMultiphysicsElement.
Definition at line 84 of file pzmultiphysicscompel.cpp.
References TPZGeoEl::BuildTransform2(), TPZGeoEl::Dimension(), TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZGeoEl::NSides(), TPZCompEl::Reference(), TPZGeoElSide::SideToSideTransform(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::ElementVec(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::Print(), and TPZMultiphysicsCompEl< TGeometry >::Solution().
|
overridevirtual |
Computes the element stiffness matrix and right hand side.
ek | element matrix |
ef | element right hand side |
Reimplemented from TPZCompEl.
Definition at line 754 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZMaterial::Contribute(), TPZGeoEl::CreateSideIntegrationRule(), DebugStop, TPZMultiphysicsCompEl< TGeometry >::Dimension(), fabs, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZElementMatrix::fMat, TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMaterial::IntegrationRuleOrder(), TPZGeoEl::Jacobian(), TPZCompEl::Material(), TPZInterpolationSpace::MaxOrder(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZIntPoints::NPoints(), TPZGeoEl::NSides(), TPZIntPoints::Point(), PZError, TPZCompEl::Reference(), TPZElementMatrix::Reset(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::resize(), TPZIntPoints::SetOrder(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Computes the element stiffness matrix and right hand side.
ek | element matrix |
ef | element right hand side |
Implements TPZMultiphysicsElement.
Definition at line 673 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZMaterial::Contribute(), TPZGeoEl::CreateSideIntegrationRule(), DebugStop, TPZMultiphysicsCompEl< TGeometry >::Dimension(), fabs, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZElementMatrix::fMat, TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMaterial::IntegrationRuleOrder(), TPZGeoEl::Jacobian(), TPZCompEl::Material(), TPZInterpolationSpace::MaxOrder(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZIntPoints::NPoints(), TPZGeoEl::NSides(), TPZIntPoints::Point(), PZError, TPZCompEl::Reference(), TPZElementMatrix::Reset(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::resize(), TPZIntPoints::SetOrder(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Define the class id associated with the class.
This id has to be unique for all classes A non unique id is flagged at the startup of the program
Reimplemented from TPZCompEl.
Definition at line 1288 of file pzmultiphysicscompel.cpp.
References TPZCompEl::ClassId(), and Hash().
Referenced by TPZMultiphysicsCompEl< TGeometry >::NumberOfCompElementsInsideThisCompEl().
|
overridevirtual |
Method for creating a copy of the element.
Implements TPZCompEl.
Definition at line 299 of file pzmultiphysicscompel.cpp.
References DebugStop, and PZError.
Referenced by TPZMultiphysicsCompEl< TGeometry >::ElementVec().
|
overridevirtual |
Method for creating a copy of the element in a patch mesh.
mesh | Patch clone mesh |
gl2lcConMap | map the connects indexes from global element (original) to the local copy. |
gl2lcElMap | map the computational elements Otherwise of the previous clone function, this method don't copy entire mesh. Therefore it needs to map the connect index from the both meshes - original and patch |
Implements TPZCompEl.
Definition at line 307 of file pzmultiphysicscompel.cpp.
References DebugStop, and PZError.
Referenced by TPZMultiphysicsCompEl< TGeometry >::ElementVec().
|
virtual |
Compute and fill data with requested attributes for each of the compels in fElementVec.
Definition at line 922 of file pzmultiphysicscompel.cpp.
References TPZInterpolationSpace::ComputeRequiredData(), TPZGeoEl::Dimension(), TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZCompEl::Reference(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), and TPZMultiphysicsCompEl< TGeometry >::NMeshes().
|
inlineoverridevirtual |
Compute and fill data with requested attributes.
Reimplemented from TPZMultiphysicsElement.
Definition at line 144 of file pzmultiphysicscompel.h.
References TPZMultiphysicsElement::ComputeRequiredData(), TPZMultiphysicsCompEl< TGeometry >::ComputeSolution(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::SetConnectIndex(), TPZMultiphysicsCompEl< TGeometry >::SetCreateFunctions(), and TPZMultiphysicsCompEl< TGeometry >::Solution().
|
overridevirtual |
Computes solution and its derivatives in the local coordinate qsi.
qsi | master element coordinate |
sol | finite element solution |
dsol | solution derivatives |
axes | axes associated with the derivative of the solution |
Reimplemented from TPZCompEl.
Definition at line 474 of file pzmultiphysicscompel.cpp.
References DebugStop, and PZError.
Referenced by TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData().
|
overridevirtual |
Computes solution and its derivatives in the local coordinate qsi.
This method will function for both volumetric and interface elements.
qsi | master element coordinate of the interface element |
normal | vector |
leftsol | finite element solution |
dleftsol | solution derivatives |
leftaxes | axes associated with the left solution |
rightsol | finite element solution |
drightsol | solution derivatives |
rightaxes | axes associated with the right solution |
Reimplemented from TPZCompEl.
Definition at line 481 of file pzmultiphysicscompel.cpp.
|
overridevirtual |
Computes solution and its derivatives in local coordinate qsi.
qsi | master element coordinate |
phi | matrix containing shape functions compute in qsi point |
dphix | matrix containing the derivatives of shape functions in the direction of the axes |
axes | [in] axes indicating the direction of the derivatives |
sol | finite element solution |
dsol | solution derivatives |
Reimplemented from TPZCompEl.
Definition at line 490 of file pzmultiphysicscompel.cpp.
|
overridevirtual |
Returns the index of the ith connectivity of the element.
i | connectivity index who want knows |
Implements TPZCompEl.
Definition at line 321 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::fConnectIndexes.
Referenced by TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::NMeshes(), and TPZMultiphysicsCompEl< TGeometry >::Print().
|
virtual |
Definition at line 326 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsElement::fActiveApproxSpace, TPZMultiphysicsCompEl< TGeometry >::fConnectIndexes, TPZMultiphysicsCompEl< TGeometry >::fElementVec, substruct_tst15.test::first, and TPZCompEl::NConnects().
|
overridevirtual |
Creates corresponding graphical element(s) if the dimension matches graphical elements are used to generate output files.
graphmesh | graphical mesh where the element will be created |
dimension | target dimension of the graphical element |
Implements TPZMultiphysicsElement.
Definition at line 1308 of file pzmultiphysicscompel.cpp.
References dimension, TPZGeoEl::Dimension(), TPZMaterial::Id(), TPZCompEl::Material(), TPZGraphMesh::Material_Is_PostProcessed(), TPZGeoEl::NSides(), and TPZCompEl::Reference().
Referenced by TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Dimension of the element.
Implements TPZCompEl.
Definition at line 340 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::fElementVec, and TPZVec< T >::NElements().
Referenced by TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::NMeshes(), and TPZMultiphysicsCompEl< TGeometry >::Print().
|
inlineoverridevirtual |
Implements TPZMultiphysicsElement.
Definition at line 248 of file pzmultiphysicscompel.h.
|
inlineoverridevirtual |
Returns a reference to the element pointers vector.
Implements TPZMultiphysicsElement.
Definition at line 60 of file pzmultiphysicscompel.h.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMultiphysicsCompEl< TGeometry >::Clone(), TPZMultiphysicsCompEl< TGeometry >::ClonePatchEl(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), and val().
|
overridevirtual |
Performs an error estimate on the elemen.
fp | function pointer which computes the exact solution |
errors | (output) each norm or true error of the error of the solution at each physics |
flux | (input) value of the interpolated flux values |
Reimplemented from TPZMultiphysicsElement.
Definition at line 1030 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZIntPoints::Clone(), TPZMatrix< TVar >::Cols(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), DebugStop, TPZMultiphysicsCompEl< TGeometry >::Dimension(), TPZCompMesh::Dimension(), TPZMaterialData::EEmpty, TPZCompMesh::ElementSolution(), TPZMaterial::Errors(), fabs, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZVec< T >::Fill(), TPZMultiphysicsCompEl< TGeometry >::GetIntegrationRule(), TPZIntPoints::GetMaxOrder(), TPZIntPoints::GetOrder(), TPZCompEl::Index(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), LOGPZ_INFO, TPZCompEl::Material(), TPZCompEl::Mesh(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZMaterial::NEvalErrors(), TPZMaterial::NFluxes(), TPZIntPoints::NPoints(), TPZMaterial::NStateVariables(), TPZIntPoints::Point(), TPZMultiphysicsCompEl< TGeometry >::Print(), PZError, TPZCompEl::Reference(), TPZVec< T >::Resize(), TPZVec< T >::resize(), TPZIntPoints::SetOrder(), TPZVec< T >::size(), sqrt, and rdt::values.
Referenced by TPZMultiphysicsCompEl< TGeometry >::ElementVec().
|
overridevirtual |
Reimplemented from TPZMultiphysicsElement.
Definition at line 1156 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZIntPoints::Clone(), TPZMatrix< TVar >::Cols(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), DebugStop, TPZMultiphysicsCompEl< TGeometry >::Dimension(), TPZCompMesh::Dimension(), TPZCompMesh::ElementSolution(), TPZMaterial::Errors(), TPZFunction< TVar >::Execute(), fabs, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZVec< T >::Fill(), TPZMultiphysicsCompEl< TGeometry >::GetIntegrationRule(), TPZIntPoints::GetMaxOrder(), TPZIntPoints::GetOrder(), TPZCompEl::Index(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZGeoEl::Jacobian(), LOGPZ_INFO, TPZCompEl::Material(), TPZCompEl::Mesh(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZMaterial::NEvalErrors(), TPZMaterial::NFluxes(), TPZIntPoints::NPoints(), TPZMaterial::NStateVariables(), TPZIntPoints::Point(), TPZMultiphysicsCompEl< TGeometry >::Print(), PZError, TPZCompEl::Reference(), TPZVec< T >::Resize(), TPZVec< T >::resize(), TPZIntPoints::SetOrder(), TPZVec< T >::size(), sqrt, and rdt::values.
|
overridevirtual |
Returns a reference to an integration rule suitable for integrating the interior of the element.
Implements TPZMultiphysicsElement.
Definition at line 1019 of file pzmultiphysicscompel.cpp.
References TPZCompEl::fIntegrationRule, and TPZMultiphysicsCompEl< TGeometry >::fIntRule.
Referenced by TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::Print(), and TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Returns a reference to an integration rule suitable for integrating the interior of the element.
Implements TPZMultiphysicsElement.
Definition at line 1010 of file pzmultiphysicscompel.cpp.
References TPZCompEl::fIntegrationRule, and TPZMultiphysicsCompEl< TGeometry >::fIntRule.
void TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec | ( | TPZManVector< TPZCompMesh *> | cmeshVec, |
std::set< int64_t > & | refIndexVec | ||
) |
Method to obtain an reference index set of multiphysics computational elements.
cmeshVec | Vector of computational meshes |
refIndexVec |
Definition at line 128 of file pzmultiphysicscompel.cpp.
References DebugStop, TPZGeoElSide::HigherLevelCompElementList2(), TPZGeoEl::Index(), LOGPZ_DEBUG, TPZVec< T >::NElements(), TPZGeoEl::NSides(), PZError, TPZCompEl::Reference(), TPZCompMesh::Reference(), TPZGeoMesh::ResetReference(), and TPZManVector< T, NumExtAlloc >::Resize().
Referenced by TPZMultiphysicsCompEl< TGeometry >::ElementVec().
void TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix | ( | TPZElementMatrix & | ek, |
TPZElementMatrix & | ef | ||
) |
Initialize element matrix in which is computed CalcStiff.
improve this logic by consulting the multiphysics material
Definition at line 502 of file pzmultiphysicscompel.cpp.
References TPZCompEl::Connect(), TPZMultiphysicsCompEl< TGeometry >::ConnectIndex(), DebugStop, TPZElementMatrix::EF, TPZElementMatrix::EK, TPZElementMatrix::fBlock, TPZElementMatrix::fConnect, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZElementMatrix::fMat, TPZElementMatrix::fMesh, TPZElementMatrix::fOneRestraints, TPZElementMatrix::fType, TPZMultiphysicsElement::GetShapeRestraints(), TPZCompEl::Material(), TPZCompEl::Mesh(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZConnect::NDof(), TPZConnect::NShape(), TPZConnect::NState(), TPZMaterial::NStateVariables(), TPZMaterial::NumLoadCases(), TPZFMatrix< TVar >::Redim(), TPZManVector< T, NumExtAlloc >::Resize(), TPZBlock< TVar >::Set(), TPZBlock< TVar >::SetNBlocks(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), and TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
void TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix | ( | TPZElementMatrix & | ef | ) |
Initialize element matrix in which is computed CalcStiff.
improve this logic by consulting the multiphysics material
Definition at line 563 of file pzmultiphysicscompel.cpp.
References TPZCompEl::Connect(), TPZMultiphysicsCompEl< TGeometry >::ConnectIndex(), DebugStop, TPZElementMatrix::EF, TPZElementMatrix::fBlock, TPZElementMatrix::fConnect, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZElementMatrix::fMat, TPZElementMatrix::fMesh, TPZElementMatrix::fOneRestraints, TPZElementMatrix::fType, TPZMultiphysicsElement::GetShapeRestraints(), TPZCompEl::Material(), TPZCompEl::Mesh(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZConnect::NDof(), TPZConnect::NShape(), TPZConnect::NState(), TPZMaterial::NStateVariables(), TPZMaterial::NumLoadCases(), TPZFMatrix< TVar >::Redim(), TPZManVector< T, NumExtAlloc >::Resize(), TPZBlock< TVar >::Set(), TPZBlock< TVar >::SetNBlocks(), and TPZVec< T >::size().
|
overridevirtual |
After adding the elements initialize the integration rule.
Implements TPZMultiphysicsElement.
Definition at line 960 of file pzmultiphysicscompel.cpp.
References DebugStop, TPZGeoEl::Dimension(), TPZMultiphysicsElement::fActiveApproxSpace, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZMultiphysicsCompEl< TGeometry >::fIntRule, TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMaterial::IntegrationRuleOrder(), TPZCompEl::Material(), TPZInterpolationSpace::MaxOrder(), TPZVec< T >::NElements(), PZError, TPZCompEl::Reference(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::resize(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Initialize a material data vector and its attributes based on element dimension, number of state variables and material definitions.
it preserves the integrity for old version of multiphycis codes.
Implements TPZMultiphysicsElement.
Definition at line 616 of file pzmultiphysicscompel.cpp.
References DebugStop, TPZMultiphysicsElement::fActiveApproxSpace, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZMaterial::FillDataRequirements(), TPZInterpolationSpace::InitMaterialData(), TPZCompEl::Material(), PZError, TPZManVector< T, NumExtAlloc >::Resize(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), and TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Post processing method which computes the solution for the var post processed variable.
qsi | coordinate of the point in master element space where the solution will be evaluated |
var | variable which will be computed |
sol | (output) solution computed at the given point |
Reimplemented from TPZCompEl.
Definition at line 354 of file pzmultiphysicscompel.cpp.
References DebugStop, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZVec< T >::Fill(), TPZInterpolationSpace::InitMaterialData(), TPZCompEl::Material(), PZError, TPZCompEl::Reference(), TPZVec< T >::resize(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::NMeshes().
|
overridevirtual |
Compute the integral of a variable.
Reimplemented from TPZCompEl.
Definition at line 834 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZGeoEl::CreateSideIntegrationRule(), DebugStop, TPZMultiphysicsCompEl< TGeometry >::Dimension(), fabs, TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMaterial::IntegrationRuleOrder(), TPZGeoEl::Jacobian(), TPZCompEl::Material(), TPZInterpolationSpace::MaxOrder(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZIntPoints::NPoints(), TPZGeoEl::NSides(), TPZMaterial::NSolutionVariables(), TPZIntPoints::Point(), PZError, TPZCompEl::Reference(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::resize(), TPZIntPoints::SetOrder(), TPZVec< T >::size(), and TPZMaterial::Solution().
Referenced by TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData().
|
overridevirtual |
Returns the number of nodes of the element.
Implements TPZCompEl.
Definition at line 316 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::fConnectIndexes, and TPZVec< T >::NElements().
Referenced by TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::ElementVec(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::Print(), and TPZMultiphysicsCompEl< TGeometry >::~TPZMultiphysicsCompEl().
|
inlineoverridevirtual |
Return the number of meshes associated with the element.
Implements TPZMultiphysicsElement.
Definition at line 110 of file pzmultiphysicscompel.h.
References TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZMultiphysicsCompEl< TGeometry >::ConnectIndex(), TPZMultiphysicsCompEl< TGeometry >::Dimension(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZMultiphysicsCompEl< TGeometry >::PolynomialOrder(), and TPZVec< T >::size().
|
inlineoverridevirtual |
Return the size of the elementvec in multiphysics, if it is not multiphysics, just return 1.
Reimplemented from TPZCompEl.
Definition at line 325 of file pzmultiphysicscompel.h.
References TPZMultiphysicsCompEl< TGeometry >::ClassId(), CreateMultiphysicsCubeEl(), CreateMultiphysicsCubeElWithMem(), CreateMultiphysicsLinearEl(), CreateMultiphysicsLinearElWithMem(), CreateMultiphysicsPointEl(), CreateMultiphysicsPointElWithMem(), CreateMultiphysicsPrismEl(), CreateMultiphysicsPrismElWithMem(), CreateMultiphysicsPyramEl(), CreateMultiphysicsPyramElWithMem(), CreateMultiphysicsQuadEl(), CreateMultiphysicsQuadElWithMem(), CreateMultiphysicsTetraEl(), CreateMultiphysicsTetraElWithMem(), CreateMultiphysicsTriangleEl(), CreateMultiphysicsTriangleElWithMem(), and TPZVec< T >::NElements().
|
overridevirtual |
Returns the maximum interpolation order of all connected elements
Implements TPZMultiphysicsElement.
Definition at line 1267 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZInterpolationSpace::MaxOrder(), TPZVec< T >::resize(), and TPZVec< T >::size().
Referenced by TPZMultiphysicsCompEl< TGeometry >::NMeshes().
|
overridevirtual |
Prints element data.
out | Indicates the device where the data will be printed |
Reimplemented from TPZCompEl.
Definition at line 232 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZGeoEl::CenterPoint(), TPZMultiphysicsCompEl< TGeometry >::ConnectIndex(), TPZMultiphysicsCompEl< TGeometry >::Dimension(), TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZMultiphysicsCompEl< TGeometry >::GetIntegrationRule(), TPZMultiphysicsElement::GetShapeRestraints(), TPZMaterial::Id(), TPZGeoEl::Index(), TPZCompEl::Material(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZIntPoints::Print(), TPZCompEl::Print(), TPZCompEl::Reference(), TPZVec< T >::size(), and TPZGeoEl::X().
Referenced by TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), and TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
inlineoverridevirtual |
Returns referred element of this.
Implements TPZMultiphysicsElement.
Definition at line 254 of file pzmultiphysicscompel.h.
References DebugStop, PZError, and TPZVec< T >::size().
|
overridevirtual |
Set the index i to node inode.
inode | node to set index |
index | index to be seted |
Implements TPZCompEl.
Definition at line 497 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::fConnectIndexes.
Referenced by TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData().
|
inlineoverridevirtual |
Sets indexes of the connects of the element.
indexes | List of the connects of the element |
Implements TPZMultiphysicsElement.
Definition at line 272 of file pzmultiphysicscompel.h.
References TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::CreateGraphicalElement(), dimension, TPZMultiphysicsCompEl< TGeometry >::GetIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMultiphysicsCompEl< TGeometry >::Print(), and TPZMultiphysicsCompEl< TGeometry >::SetIntegrationRule().
|
overridevirtual |
Sets create function in TPZCompMesh to create elements of this type.
Reimplemented from TPZCompEl.
Definition at line 387 of file pzmultiphysicscompel.h.
References TPZCompMesh::SetAllCreateFunctionsMultiphysicElem().
Referenced by TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData().
|
overridevirtual |
Reimplemented from TPZCompEl.
Definition at line 941 of file pzmultiphysicscompel.cpp.
References DebugStop, TPZGeoEl::Dimension(), TPZCompEl::fIntegrationRule, TPZMultiphysicsCompEl< TGeometry >::fIntRule, TPZCompEl::Reference(), and TPZIntPoints::SetOrder().
Referenced by TPZMultiphysicsCompEl< TGeometry >::SetConnectIndexes().
|
overridevirtual |
Post processing method which computes the solution for the var post processed variable.
qsi | coordinate of the point in master element space where the solution will be evaluated |
var | variable which will be computed |
sol | (output) solution computed at the given point |
Implements TPZMultiphysicsElement.
Definition at line 414 of file pzmultiphysicscompel.cpp.
References TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZInterpolationSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeShape(), TPZCompEl::ComputeSolution(), TPZMultiphysicsCompEl< TGeometry >::fElementVec, TPZMaterial::FillDataRequirements(), TPZInterpolationSpace::InitMaterialData(), TPZCompEl::Material(), TPZInterpolationSpace::MaxOrder(), TPZCompEl::Reference(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::Resize(), TPZVec< T >::resize(), TPZVec< T >::size(), TPZMaterial::Solution(), TPZCompEl::Solution(), and TPZGeoEl::X().
Referenced by TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData().
|
protected |
Indexes of the connects of the element.
Definition at line 30 of file pzmultiphysicscompel.h.
Referenced by TPZMultiphysicsCompEl< TGeometry >::ConnectIndex(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), and TPZMultiphysicsCompEl< TGeometry >::SetConnectIndex().
|
protected |
List of pointers to computational elements.
Definition at line 27 of file pzmultiphysicscompel.h.
Referenced by TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZMultiphysicsCompEl< TGeometry >::ConnectIndex(), TPZMultiphysicsCompEl< TGeometry >::Dimension(), TPZMultiphysicsCompEl< TGeometry >::ElementVec(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::PolynomialOrder(), TPZMultiphysicsCompEl< TGeometry >::Print(), and TPZMultiphysicsCompEl< TGeometry >::Solution().
|
protected |
Integration rule associated with the element.
Definition at line 33 of file pzmultiphysicscompel.h.
Referenced by TPZMultiphysicsCompEl< TGeometry >::GetIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), and TPZMultiphysicsCompEl< TGeometry >::SetIntegrationRule().