NeoPZ
|
Defines the behaviour of all geometric elements. GeometryTPZGeoEl is the common denominator for all geometric elements. More...
#include <pzgeoel.h>
Public Member Functions | |
TPZGeoEl * | EldestAncestor () const |
virtual void | HDivDirectionsMaster (TPZFMatrix< REAL > &directions)=0 |
virtual void | HDivDirections (TPZVec< REAL > &pt, TPZFMatrix< REAL > &directions, int RestrainedFace)=0 |
virtual void | SetNeighbourInfo (int side, TPZGeoElSide &neigh, TPZTransform< REAL > &trans)=0 |
int | NumInterfaces () |
Returns number of TPZInterfaceElement pointing to this. More... | |
int | IncrementNumInterfaces () |
Increments number of TPZInterfaceElement pointing to this. More... | |
int | DecrementNumInterfaces () |
Decrement number of TPZInterfaceElement pointing to this. More... | |
virtual void | GetPermutation (const int &i, TPZVec< int > &permutation) const =0 |
virtual TPZIntPoints * | CreateSideIntegrationRule (int side, int order)=0 |
Creates an integration rule for the topology of the corresponding side and able to integrate a polynom of order exactly. More... | |
void | Shape1d (REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi) |
Computes the values of the "num" one dimensional shapefunctions and derivatives at point x, using lagrangian interpolation. More... | |
void | ShapePhi1d (REAL x, int num, TPZFMatrix< REAL > &phi) |
Computes the values of the "num" one dimensional shapefunctions at point x, using lagrangian interpolation. More... | |
TPZGeoEl (int64_t id, int materialindex, TPZGeoMesh &mesh) | |
Constructor. More... | |
TPZGeoEl (int materialindex, TPZGeoMesh &mesh) | |
This constructor generates a unique Id. More... | |
TPZGeoEl (int materialindex, TPZGeoMesh &mesh, int64_t &index) | |
This constructor generates a unique Id. More... | |
TPZGeoEl (const TPZGeoEl &el) | |
Copy constructor. More... | |
TPZGeoEl (TPZGeoMesh &DestMesh, const TPZGeoEl &cp) | |
Copy constructor with elements in different meshes. More... | |
TPZGeoEl (TPZGeoMesh &DestMesh, const TPZGeoEl &cp, std::map< int64_t, int64_t > &org2clnMap) | |
Copy constructor to a patch mesh. More... | |
TPZGeoEl () | |
virtual void | Initialize () |
int | ClassId () const override |
Define the class id associated with the class. More... | |
void | Read (TPZStream &str, void *context) override |
read objects from the stream More... | |
void | Write (TPZStream &str, int withclassid) const override |
Writes this object to the TPZStream buffer. Include the classid if withclassid = true. More... | |
virtual TPZGeoEl * | Clone (TPZGeoMesh &DestMesh) const =0 |
void | GetNodeIndices (TPZVec< int64_t > &nodeindices) |
void | GetNodeIndices (std::set< int64_t > &nodeindices) |
void More... | |
virtual TPZGeoEl * | ClonePatchEl (TPZGeoMesh &DestMesh, std::map< int64_t, int64_t > &gl2lcNdIdx, std::map< int64_t, int64_t > &gl2lcElIdx) const =0 |
Creates a clone of this element into a new patch mesh. More... | |
virtual | ~TPZGeoEl () |
Destructor. More... | |
void | RemoveConnectivities () |
It removes the connectivities of the element. More... | |
virtual TPZCompEl * | CreateBCCompEl (int side, int bc, TPZCompMesh &cmesh) |
Method which creates a computational boundary condition element based on the current geometric element, a side and a boundary condition number. More... | |
virtual TPZGeoEl * | CreateGeoElement (MElementType type, TPZVec< int64_t > &nodeindexes, int matid, int64_t &index)=0 |
Creates a geometric element according to the type of the father element. More... | |
virtual TPZGeoEl * | CreateBCGeoEl (int side, int bc)=0 |
Method which creates a geometric element on the side of an existing element. More... | |
int | WhichSide (TPZVec< int64_t > &SideNodeIds) |
Returns the side number which is connected to the SideNodes returns -1 if no side is found. More... | |
int | NeighbourExists (int side, const TPZGeoElSide &gel) |
Returns 1 if gel is a neighbour of the element along side. More... | |
void | SetMaterialId (int id) |
Sets the material index of the element. More... | |
virtual void | SetNodeIndex (int i, int64_t nodeindex)=0 |
Initializes the node i of the element. More... | |
virtual void | SetSideDefined (int side)=0 |
Flags the side as defined, this means no neighbouring element was found. More... | |
virtual TPZGeoElSide | Neighbour (int side)=0 |
Returns a pointer to the neighbour and the neighbourside along side of the current element. More... | |
virtual int64_t | NeighbourIndex (int side) const =0 |
Returns the neighbour index for a given side. More... | |
virtual void | SetNeighbour (int side, const TPZGeoElSide &neighbour)=0 |
Fill in the data structure for the neighbouring information. More... | |
virtual void | Print (std::ostream &out=std::cout) |
Print all relevant data of the element to cout. More... | |
virtual void | PrintTopologicalInfo (std::ostream &out=std::cout) |
Prints the coordinates of all nodes (geometric) More... | |
void | SetReference (TPZCompEl *elp) |
Make the current element reference to the computational element. More... | |
virtual void | SetSubElement (int i, TPZGeoEl *gel)=0 |
Sets the subelement of index i. More... | |
virtual void | SetSubElementConnectivities () |
Initializes the external connectivities of the subelements. More... | |
void | ResetReference () |
Reset the element referenced by the geometric element to NULL. More... | |
virtual void | Divide (TPZVec< TPZGeoEl *> &pv) |
Divides the element and puts the resulting elements in the vector. More... | |
virtual void | RandomPoint (TPZVec< REAL > &pt)=0 |
Generates a random point in the master domain. More... | |
virtual int | HasSubElement () const =0 |
Return 1 if the element has subelements. More... | |
virtual TPZTransform< REAL > | SideToSideTransform (int sidefrom, int sideto)=0 |
Compute the transformation between the master element space of one side of an element to the master element space of a higher dimension side. More... | |
virtual void | ProjectPoint (int sidefrom, TPZVec< REAL > &ptin, int sideto, TPZVec< REAL > &ptout) |
Project the point from one side to another. The dimension of the points needs to be configured properly. More... | |
TPZTransform< REAL > | Projection (int side) |
Compute the projection of the point within the interior of the element to the side of the element. More... | |
void | SetIndex (int64_t index) |
void | SetId (int64_t elId) |
int | GetTransformId2dQ (TPZVec< int > &idfrom, TPZVec< int > &idto) |
Get the transform id the face to face. More... | |
int | GetTransformId2dT (TPZVec< int > &idfrom, TPZVec< int > &idto) |
Get the transform id the face to face. More... | |
virtual TPZTransform< REAL > | GetTransform (int side, int son)=0 |
void | SetFather (TPZGeoEl *father) |
Sets the father element. More... | |
virtual void | SetFatherIndex (int64_t fatherindex) |
Sets the father element index This method is not called SetFather in order to avoid implicit conversions from nullptr to int. More... | |
bool | IsSibling (TPZGeoEl *gel) |
return true is gel is an ancestor of the current element More... | |
virtual TPZGeoEl * | SubElement (int is) const =0 |
Returns a pointer to the subelement is. More... | |
virtual void | ResetSubElements ()=0 |
Reset all subelements to NULL. More... | |
int | Level () |
Returns the number of ancestors. More... | |
virtual int | SideDimension (int side) const =0 |
Return the dimension of side. More... | |
virtual int | Dimension () const =0 |
Returns the dimension of the element. More... | |
virtual void | AllHigherDimensionSides (int side, int targetdimension, TPZStack< TPZGeoElSide > &elsides)=0 |
virtual void | LowerDimensionSides (int side, TPZStack< int > &smallsides) const =0 |
void | Jacobian (TPZVec< REAL > &qsi, TPZFMatrix< REAL > &jac, TPZFMatrix< REAL > &axes, REAL &detjac, TPZFMatrix< REAL > &jacinv) const |
Compute a decomposition of the gradient of the mapping function, as a rotation matrix (Jacobian) and orthonormal basis (axes) More... | |
void | JacobianXYZ (TPZVec< REAL > &qsi, TPZFMatrix< REAL > &jac, TPZFMatrix< REAL > &axes, REAL &detjac, TPZFMatrix< REAL > &jacinv) const |
Compute a decomposition of the gradient of the mapping function, as a rotation matrix (Jacobian) and orthonormal basis (axes) More... | |
virtual void | X (TPZVec< REAL > &qsi, TPZVec< REAL > &result) const =0 |
Return the coordinate in real space of the point coordinate in the master element space. More... | |
virtual void | GradX (TPZVec< REAL > &qsi, TPZFMatrix< REAL > &gradx) const =0 |
Return the gradient of the transformation at the given coordinate. More... | |
int | ElementExists (TPZGeoEl *elem, int64_t id) |
To test continuity. More... | |
data access methods | |
Methods which allow to access the internal data structure of the element | |
TPZGeoMesh * | Mesh () const |
Returns the mesh to which the element belongs. More... | |
int64_t | Id () const |
Returns the Id of the element. More... | |
virtual int | NNodes () const =0 |
Returns the number of nodes of the element. More... | |
virtual int | NCornerNodes () const =0 |
Returns the number of corner nodes of the element. More... | |
virtual int | NPermutations () const =0 |
TPZGeoNode * | NodePtr (int i) const |
Returns a pointer to the ith node of the element. More... | |
TPZGeoNode & | Node (int i) const |
Returns the ith node of the element. More... | |
virtual int64_t | NodeIndex (int i) const =0 |
Returns the index of the ith node the index is the location of the node in the nodevector of the mesh. More... | |
int | MaterialId () const |
Returns the material index of the element. More... | |
TPZCompEl * | Reference () const |
Return a pointer to the element referenced by the geometric element. More... | |
virtual void | GetHigherSubElements (TPZVec< TPZGeoEl *> &unrefinedSons) |
virtual MElementType | Type () const =0 |
Returns the element type acording to pzeltype.h. More... | |
virtual MElementType | Type (int side) const =0 |
Returns the element type of a side acording to pzeltype.h. More... | |
virtual std::string | TypeName () const |
Returns the type of the element as a string. More... | |
virtual bool | IsLinearMapping () const |
virtual bool | IsLinearMapping (int side) const =0 |
virtual bool | IsGeoBlendEl () const |
virtual bool | IsGeoElMapped () const |
Returns if is a TPZGeoElMapped< T > element. More... | |
virtual int | NSides () const =0 |
Returns the number of connectivities of the element. More... | |
virtual int | NSideNodes (int side) const =0 |
Returns the number of nodes for a particular side. More... | |
virtual TPZGeoNode * | SideNodePtr (int side, int nodenum) const |
Returns the pointer to the nodenum node of side. More... | |
virtual void | MidSideNodeIndex (int side, int64_t &index) const =0 |
Returns the midside node index along a side of the element. More... | |
virtual void | MidSideNodeIndices (int side, TPZVec< int64_t > &indices) const |
Returns the midside node indices along a side of the element. More... | |
virtual int64_t | SideNodeIndex (int side, int nodenum) const =0 |
Returns the index of the nodenum node of side. More... | |
virtual int | SideNodeLocIndex (int side, int nodenum) const =0 |
Returns the local index of a node on a side. More... | |
virtual void | HDivPermutation (int side, TPZVec< int > &permutegather) |
Computes the permutation for an HDiv side. More... | |
virtual int | SideIsUndefined (int side)=0 |
Returns 1 if the side has not been defined by buildconnectivity. More... | |
virtual int | NSubElements () const =0 |
Returns the number of subelements of the element independent of the fact whether the element has already been refined or not. More... | |
virtual int | NSideSubElements (int side) const =0 |
Returns the number of subelements as returned by GetSubElements2(side) More... | |
TPZGeoEl * | Father () const |
Computes the normal vectors needed for forming HDiv vector valued shape functions. More... | |
TPZGeoEl * | LowestFather () |
Returns a pointer to the higher level father. More... | |
int64_t | FatherIndex () |
void | BuildBlendConnectivity () |
Set connectivity information elements with blend geometric map. More... | |
virtual bool | ResetBlendConnectivity (const int64_t &side, const int64_t &index)=0 |
void | SetNeighbourForBlending (int side) |
TPZGeoBlend need to find a non-linear neighbour. 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 | |
Static Public Member Functions | |
static int | StaticClassId () |
static void | Jacobian (const TPZFMatrix< REAL > &gradx, TPZFMatrix< REAL > &jac, TPZFMatrix< REAL > &axes, REAL &detjac, TPZFMatrix< REAL > &jacinv) |
Compute a QR facotrization of the gradient of the mapping function, Q = Jacobian and R = axes. More... | |
static void | JacobianXYZ (const TPZFMatrix< REAL > &gradx, TPZFMatrix< REAL > &jac, TPZFMatrix< REAL > &axesXYZ, REAL &detjac, TPZFMatrix< REAL > &jacinv) |
Compute Jacobian matrix for afine mappings. 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) |
Protected Attributes | |
TPZGeoMesh * | fMesh |
Pointer to the mesh to which the element belongs. More... | |
int64_t | fId |
Traditional element number or element id. More... | |
int | fMatId |
Material index. More... | |
TPZCompEl * | fReference |
Reference to the element currently loaded. Pointer is given as this->Mesh()->Reference()->ElementVec()[fReference]. More... | |
int64_t | fFatherIndex |
Index of the element from which the element is a subelement. More... | |
int64_t | fIndex |
Index of the element in the element vector. More... | |
int | fNumInterfaces |
A counter to indicate how many interface elements are pointing to it. More... | |
Static Protected Attributes | |
static TPZFMatrix< REAL > | gGlobalAxes |
3x3 unit matrix to be copied to the axes if the geometric element does not have a particular orientation More... | |
Friends | |
std::ostream & | operator<< (std::ostream &s, TPZGeoEl &el) |
Equivalent to Print. More... | |
reftopology | |
Methods which will implement the declaration of a refinemnt topology | |
virtual TPZGeoElSide | Father2 (int side) const |
Returns the father/side of the father which contains the side of the sub element. More... | |
virtual int | FatherSide (int side, int son) |
virtual TPZTransform< REAL > | BuildTransform2 (int side, TPZGeoEl *father, TPZTransform< REAL > &t) |
Returns the transformation which maps the parameter side of the element/side into the parameter space of the father element/side. More... | |
int | WhichSide (TPZVec< REAL > &pt) |
Returns the side number which is connected to the point pt. More... | |
virtual void | CenterPoint (int side, TPZVec< REAL > &masscent) const =0 |
It returns the coordinates from the center of the side of the element in the element coordinate space. More... | |
virtual void | GetSubElements2 (int side, TPZStack< TPZGeoElSide > &subel) const |
This method will return a partition of the side of the current element as the union of sub elements/side which are put in the stack. More... | |
virtual void | GetAllSiblings (TPZStack< TPZGeoEl *> &unrefinedSons) |
[deprecated] use YoungestChildren More... | |
virtual void | YoungestChildren (TPZStack< TPZGeoEl *> &unrefinedSons) |
This method will return all children at the bottom of the refinement tree of the element. i.e. all children that have no subelements. More... | |
void | GetSubElements2 (int side, TPZStack< TPZGeoElSide > &subel, int dimension) const |
This method will return a partition of the side of the current element as the union of sub elements/side which are put in the stack. More... | |
int | WhichSubel () const |
Returns the son number of the sub element gel. More... | |
void | CheckSubelDataStructure () |
Checks the structure of the Father() and GetSubelement2() More... | |
void | NodesCoordinates (TPZFMatrix< REAL > &cooridnates) |
Computes nodes coordinates of the element. More... | |
bool | ComputeXInverse (TPZVec< REAL > &XD, TPZVec< REAL > &ksi, REAL Tol) |
Computes the XInverse and returns true if ksi belongs to master element domain. More... | |
void | TransformSonToFather (TPZGeoEl *ancestor, TPZVec< REAL > &ksiSon, TPZVec< REAL > &ksiAncestor) |
Compute the map of a paramenter point in the subelement to a parameter point in the super element. More... | |
TPZTransform< REAL > | ComputeParamTrans (TPZGeoEl *fat, int fatside, int sideson) |
REAL | Volume () |
Return the volume of the element. More... | |
virtual REAL | RefElVolume ()=0 |
Volume of the master element. More... | |
virtual REAL | SideArea (int side) |
Returns the area from the face. More... | |
virtual REAL | ElementRadius () |
virtual REAL | CharacteristicSize () |
Computes the set of normals for defining HDiv approximation spaces. More... | |
virtual REAL | SmallerEdge () |
void | ComputePermutationNormals (int side, TPZVec< int > &indexfrom) |
Compute the set of normals along a side for defining HDiv approximation spaces. More... | |
int | NormalOrientation (int side) |
Determine the orientation of the normal vector comparing the ids of the neighbouring elements. More... | |
virtual void | SetRefPattern (TPZAutoPointer< TPZRefPattern >) |
Defines the refinement pattern. It's used only in TPZGeoElRefPattern objects. More... | |
virtual TPZAutoPointer< TPZRefPattern > | GetRefPattern () const |
Returns the refinement pattern associated with the element. More... | |
bool | VerifyNodeCoordinates (REAL tol=1e-1) |
Verify coordinate of element nodes checking if they are coincident to the X mapping of the corner nodes of parametric elements. More... | |
virtual bool | IsInParametricDomain (const TPZVec< REAL > &pt, REAL tol=1.e-2)=0 |
Verifies if the parametric point pt is in the element parametric domain. More... | |
virtual int | ProjectInParametricDomain (TPZVec< REAL > &qsi, TPZVec< REAL > &qsiInDomain)=0 |
Ortogonal projection from given qsi to a qsiInDomain (all in the element parametric domain) More... | |
virtual int | ProjectBissectionInParametricDomain (TPZVec< REAL > &qsi, TPZVec< REAL > &qsiInDomain)=0 |
Projection from given qsi to a qsiInDomain (in the element boundary) using bissection method from given qsi to element center. More... | |
int64_t | Index () const |
Returns the index of the element within the element vector of the mesh. More... | |
static REAL | QuadArea (TPZVec< TPZGeoNode *> &nodes) |
Returns the area from a quadrilateral face. More... | |
static REAL | TriangleArea (TPZVec< TPZGeoNode *> &nodes) |
Returns the area from the triangular face. More... | |
static REAL | Distance (TPZVec< REAL > ¢el, TPZVec< REAL > ¢face) |
void | InitializeNeighbours () |
To be used after the buid connectivity. If some neighbour isn't initialized. More... | |
Defines the behaviour of all geometric elements. Geometry
TPZGeoEl is the common denominator for all geometric elements.
TPZGeoEl::TPZGeoEl | ( | int64_t | id, |
int | materialindex, | ||
TPZGeoMesh & | mesh | ||
) |
Constructor.
id | is the number of the element |
materialindex | is the material index |
mesh | is a pointer to the mesh to which the element belongs |
Definition at line 80 of file pzgeoel.cpp.
References TPZRefPattern::fId, and TPZGeoMesh::SetElementIdUsed().
TPZGeoEl::TPZGeoEl | ( | int | materialindex, |
TPZGeoMesh & | mesh | ||
) |
This constructor generates a unique Id.
materialindex | is the material index |
mesh | is a pointer to the mesh to which the element belongs |
Definition at line 116 of file pzgeoel.cpp.
References TPZAdmChunkVector< T, EXP >::AllocateNewElement(), TPZGeoMesh::CreateUniqueElementId(), TPZGeoMesh::ElementVec(), fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, fReference, and Mesh().
TPZGeoEl::TPZGeoEl | ( | int | materialindex, |
TPZGeoMesh & | mesh, | ||
int64_t & | index | ||
) |
This constructor generates a unique Id.
materialindex | is the material index |
mesh | is a pointer to the mesh to which the element belongs |
index | index of the new element in the element vector |
Definition at line 104 of file pzgeoel.cpp.
References TPZAdmChunkVector< T, EXP >::AllocateNewElement(), TPZGeoMesh::CreateUniqueElementId(), TPZGeoMesh::ElementVec(), fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, and fReference.
TPZGeoEl::TPZGeoEl | ( | const TPZGeoEl & | el | ) |
Copy constructor.
Definition at line 93 of file pzgeoel.cpp.
References TPZAdmChunkVector< T, EXP >::AllocateNewElement(), TPZGeoMesh::CreateUniqueElementId(), TPZGeoMesh::ElementVec(), fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, and fReference.
TPZGeoEl::TPZGeoEl | ( | TPZGeoMesh & | DestMesh, |
const TPZGeoEl & | cp | ||
) |
Copy constructor with elements in different meshes.
Definition at line 1674 of file pzgeoel.cpp.
References TPZGeoMesh::ElementVec(), fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, and fReference.
TPZGeoEl::TPZGeoEl | ( | TPZGeoMesh & | DestMesh, |
const TPZGeoEl & | cp, | ||
std::map< int64_t, int64_t > & | org2clnMap | ||
) |
Copy constructor to a patch mesh.
Definition at line 1685 of file pzgeoel.cpp.
References DebugStop, TPZGeoMesh::ElementVec(), fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, fReference, and LOGPZ_ERROR.
|
inline |
Definition at line 173 of file pzgeoel.h.
Referenced by DecrementNumInterfaces().
|
virtual |
Destructor.
Definition at line 49 of file pzgeoel.cpp.
References DebugStop, and TPZRefPattern::fId.
Referenced by Initialize().
|
pure virtual |
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZInterpolatedElement::CheckElementConsistency(), TPZCheckGeom::CheckInternalTransforms(), ConjugateSide(), and IsSibling().
void TPZGeoEl::BuildBlendConnectivity | ( | ) |
Set connectivity information elements with blend geometric map.
Definition at line 1959 of file pzgeoel.cpp.
References IsGeoBlendEl(), NNodes(), NSides(), and SetNeighbourForBlending().
Referenced by TPZGeoMesh::BuildConnectivity(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), and FatherIndex().
|
virtual |
Returns the transformation which maps the parameter side of the element/side
into the parameter space of the father element/side.
Definition at line 386 of file pzgeoel.cpp.
References PZError.
Referenced by TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZCompMesh::BuildTransferMatrix(), TPZGeoElRefLess< TGeo >::BuildTransform2(), TPZCheckGeom::CheckSubFatherTransform(), TPZInterpolationSpace::InterpolateSolution(), IsSibling(), and TransformSonToFather().
|
pure virtual |
It returns the coordinates from the center of the side of the element in the element coordinate space.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElDisc::CenterPoint(), TPZInterfaceElement::ComputeCenterNormal(), TPZMultiphysicsInterfaceElement::ComputeCenterNormal(), TPZInterfaceElement::ComputeNormal(), TPZInterpolationSpace::ComputeNormal(), TPZRefPattern::ComputeTransforms(), ComputeXInverse(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZBuildSBFem::CreateElementCenterNodes(), ElementRadius(), TPZGenSpecialGrid::GeneratePolygonalSphereFromOctahedron(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZInterfaceElement::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), IsSibling(), TPZFlowCompMesh::MaxVelocityOfMesh(), TPZGeoElSide::Normal(), TPZCondensedCompEl::Print(), TPZCompEl::Print(), TPZMultiphysicsCompEl< TGeometry >::Print(), TPZVTKGeoMesh::PrintPOrderPoints(), TPZAnalysis::PrintVectorByElement(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZCompElDisc::SetFalseUseQsiEta(), TPZCompElDisc::SetTrueUseQsiEta(), SubStructure(), VerifyNodeCoordinates(), and Volume().
|
virtual |
Computes the set of normals for defining HDiv approximation spaces.
normals | normal associated with each side |
vectorsides | side associated with each normal vector |
Definition at line 604 of file pzgeoel.cpp.
References TPZGeoNode::GetCoordinates(), Max(), Min(), NNodes(), NodePtr(), sqrt, and rdt::values.
Referenced by ComputeXInverse(), and IsSibling().
void TPZGeoEl::CheckSubelDataStructure | ( | ) |
Checks the structure of the Father() and GetSubelement2()
Definition at line 503 of file pzgeoel.cpp.
References Divide(), TPZGeoElSide::Element(), TPZRefPattern::Element(), Father2(), GetSubElements2(), Id(), TPZGeoElSide::Neighbour(), TPZVec< T >::NElements(), NSides(), and TPZGeoElSide::Side().
Referenced by IsSibling().
|
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
Implements TPZSavable.
Reimplemented in TPZGeoElRefPattern< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefLess< TGeo >.
Definition at line 2562 of file pzgeoel.cpp.
References StaticClassId().
Referenced by TPZGeoElRefLess< TGeo >::ClassId(), and Initialize().
|
pure virtual |
Implemented in TPZGeoElRefPattern< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefLess< TGeo >.
Referenced by Initialize().
|
pure virtual |
Creates a clone of this element into a new patch mesh.
DestMesh | destination patch mesh |
gl2lcNdIdx | map between node indexes in original and patch mesh |
gl2lcElIdx | map between element indexes in original and patch mesh This method differs from the above by the patch mesh does not include all elements and nodes. Therefore, a map between node indexes in both meshes are required |
Implemented in TPZGeoElRefPattern< TGeo >, TPZGeoElRefLess< TGeo >, and TPZGeoElement< TGeo, TRef >.
Referenced by TPZRefPatternTools::GenerateGMeshFromElementVec(), and Initialize().
TPZTransform TPZGeoEl::ComputeParamTrans | ( | TPZGeoEl * | fat, |
int | fatside, | ||
int | sideson | ||
) |
para o canto do pai n�o existe transformac�o definida
basta repassar sendo ik>ij
o seguinte passo n�o � preciso dado que fat = elemento mestre
Definition at line 845 of file pzgeoel.cpp.
References TPZTransform< T >::Apply(), ComputeXInverse(), CreateSideIntegrationRule(), DebugStop, Dimension(), ELU, TPZIntPoints::NPoints(), NSides(), TPZIntPoints::Point(), PZError, TPZTransform< T >::SetMatrix(), TPZIntPoints::SetOrder(), SideDimension(), SideToSideTransform(), TPZMatrix< TVar >::SolveDirect(), X(), and ZeroTolerance().
Referenced by TPZCheckRestraint::CheckRestraint(), TPZCheckGeom::CheckSubFatherTransform(), and IsSibling().
void TPZGeoEl::ComputePermutationNormals | ( | int | side, |
TPZVec< int > & | indexfrom | ||
) |
Compute the set of normals along a side for defining HDiv approximation spaces.
side | |
normals | normal associated with each side |
vectorsides | side associated with each normal vector the normal vectors are initially ordered according to the return of LowerDimensionSides and then permuted according to the node id's Compute the permutation needed to order the normal vectors in a consistent way This permutation needs to be applied to the shape functions |
Referenced by IsSibling().
Computes the XInverse and returns true if ksi belongs to master element domain.
Definition at line 686 of file pzgeoel.cpp.
References TPZTransform< T >::Apply(), CenterPoint(), CharacteristicSize(), Dimension(), ELU, error(), fabs, fIndex, TPZGeoNode::GetCoordinates(), GradX(), Id(), IsInParametricDomain(), Jacobian(), LOGPZ_ERROR, TPZMatrix< TVar >::Multiply(), NCornerNodes(), TPZVec< T >::NElements(), NNodes(), NodePtr(), Norm(), NSides(), TPZGeoNode::Print(), Print(), PZError, TPZVec< T >::Resize(), TPZFMatrix< TVar >::Resize(), SideToSideTransform(), TPZMatrix< TVar >::SolveDirect(), TPZFMatrix< TVar >::Transpose(), rdt::values, and X().
Referenced by ComputeParamTrans(), TPZGeoMesh::FindApproxElement(), TPZGeoMesh::FindElementCaju(), TPZGeoMesh::FindSubElement(), IsSibling(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZRefPattern::SetRefPatternMeshToMasterDomain(), TPZRefPatternTools::TransformationTest(), and TransformSonToFather().
|
virtual |
Method which creates a computational boundary condition element based on the current geometric element,
a side and a boundary condition number.
Definition at line 1092 of file pzgeoel.cpp.
References CreateBCGeoEl(), and TPZCompMesh::CreateCompEl().
Referenced by FatherIndex().
|
pure virtual |
Method which creates a geometric element on the side of an existing element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZBuildSBFem::AddSkeletonElements(), TPZBuildMultiphysicsMesh::AddWrap(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), CreateBCCompEl(), TPZMultiphysicsElement::CreateInterface(), TPZInterpolationSpace::CreateInterface(), TPZMHMeshControl::CreateInterfaceElements(), FatherIndex(), TPZCreateApproximationSpace::Hybridize(), and TPZGeoElBC::TPZGeoElBC().
|
pure virtual |
Creates a geometric element according to the type of the father element.
Implemented in TPZGeoElRefLess< TGeo >, and TPZGeoElement< TGeo, TRef >.
Referenced by pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefTetrahedra::Divide(), and FatherIndex().
|
pure virtual |
Creates an integration rule for the topology of the corresponding side and able to integrate a polynom of order exactly.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElDisc::AccumulateIntegrationRule(), TPZCompElDisc::BuildTransferMatrix(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZInterfaceElement::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZInterpolatedElement::CheckElementConsistency(), TPZCheckGeom::CheckNeighbourMap(), TPZCheckRestraint::CheckRestraint(), TPZCheckGeom::CheckSideTransform(), TPZCheckGeom::CheckSubFatherTransform(), CompareFluxes(), ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZRefPatternTools::ConstJacobian(), TPZCompElDisc::CreateIntegrationRule(), TPZMultiphysicsInterfaceElement::CreateIntegrationRule(), DecrementNumInterfaces(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZInterfaceElement::InitializeIntegrationRule(), TPZSBFemVolume::InitializeIntegrationRule(), TPZMathTools::IntegrateFunction(), TPZInterfaceElement::IntegrateInterface(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZCompEl::IntegrateSolution(), TPZCompElDisc::Read(), TPZInterpolatedElement::RestrainSide(), and TPZRefPatternTools::TransformationTest().
|
inline |
Decrement number of TPZInterfaceElement pointing to this.
Definition at line 105 of file pzgeoel.h.
References CreateSideIntegrationRule(), fNumInterfaces, GetPermutation(), Shape1d(), ShapePhi1d(), and TPZGeoEl().
Referenced by TPZMHMeshControl::CreateSkeletonElements(), and TPZInterfaceElement::~TPZInterfaceElement().
|
pure virtual |
Returns the dimension of the element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZMHMeshControl::AddBoundaryElements(), TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZMHMeshControl::AddElementBoundaries(), TPZBuildSBFem::AddSkeletonElements(), TPZBuildMultiphysicsMesh::AddWrap(), TPZMHMixedHybridMeshControl::AdjustBoundaryConditionsOfFractures(), TPZCompMeshTools::AdjustFluxPolynomialOrders(), TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), TPZGeoMesh::Area(), TPZBuildSBFem::BuildComputationalMeshFromSkeleton(), TPZBuildSBFem::BuildComputationMesh(), BuildElementGroups(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZCreateApproximationSpace::BuildMesh(), TPZRefPattern::BuildSideMesh(), TPZMHMeshControl::BuildWrapMesh(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZCheckGeom::CheckInternalTransforms(), TPZMHMixedHybridMeshControl::CheckMeshConsistency(), TPZCheckGeom::CheckSideTransform(), TPZCheckGeom::CheckSubFatherTransform(), TPZDohrStructMatrix::ClusterIslands(), Hdiv2dPaper201504::CMeshPressure(), hdivCurvedJCompAppMath::CMeshPressure(), Hdiv3dPaper201504::CMeshPressure(), TPZMultiphysicsInterfaceElement::ComputeCenterNormal(), TPZSBFemVolume::ComputeKMatrices(), TPZInterfaceElement::ComputeNormal(), TPZInterpolationSpace::ComputeNormal(), ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZMultiphysicsElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZRefPattern::ComputeTransforms(), ComputeXInverse(), TPZBuildSBFem::Configure(), TPZMHMeshControl::ConnectedElements(), TPZCompMesh::ConvertDiscontinuous2Continuous(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TCedricTest::CreateCondensedElements(), TPZBuildSBFem::CreateElementCenterNodes(), TPZBuildSBFem::CreateElementGroups(), TPZMultiphysicsInterfaceElement::CreateGraphicalElement(), TPZMultiphysicsCompEl< TGeometry >::CreateGraphicalElement(), TPZSBFemVolume::CreateGraphicalElement(), TPZMHMixedMeshControl::CreateHDivMHMMesh(), TPZHybridizeHDiv::CreateInterfaceElements(), TPZMHMeshControl::CreateInterfaceElements(), TPZMHMixedHybridMeshControl::CreateInternalAxialFluxes(), TPZMHMixedHybridMeshControl::CreateInternalFluxElements(), TPZMHMeshControl::CreateLagrangeMultiplierMesh(), TPZMHMixedHybridMeshControl::CreateLowerDimensionPressureElements(), TPZRefPattern::CreateMidSideNodes(), TPZMHMixedHybridMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedMeshControl::CreateMultiPhysicsInterfaceElements(), CreateNoElement(), TPZMHMixedMeshControl::CreatePressureMHMMesh(), TPZMHMixedMeshControl::CreateRotationMesh(), TPZMHMeshControl::CreateSkeletonElements(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZMHMeshControl::CriaMalhaTemporaria(), TPZMHMeshControl::DefinePartition(), TPZSBFemVolume::Dimension(), TPZMultiphysicsInterfaceElement::Dimension(), TPZInterfaceElement::Dimension(), TPZCompElDisc::Dimension(), TPZBuildSBFem::DivideSkeleton(), ElementRadius(), Hdiv2dPaper201504::ErrorH1(), hdivCurvedJCompAppMath::ErrorH1(), Hdiv3dPaper201504::ErrorH1(), Hdiv2dPaper201504::ErrorPrimalDual(), hdivCurvedJCompAppMath::ErrorPrimalDual(), Hdiv3dPaper201504::ErrorPrimalDual(), TPZElementGroup::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZSBFemVolume::ExtendShapeFunctions(), TPZGeoMesh::FindApproxElement(), TPZMHMixedHybridMeshControl::FindConnectedElements(), TPZGeoMesh::FindElementCaju(), TPZGraphMesh::FindFirstInterpolatedElement(), TPZGeoMesh::FindSubElement(), TPZRefPattern::GeneratePermutations(), GetSubElements2(), TPZCompMeshTools::GroupElements(), TPZMHMixedHybridMeshControl::GroupElements(), TPZMHMeshControl::HasWrapNeighbour(), HDivPermutation(), TPZHybridizeHDiv::HybridizeInternalSides(), TPZDohrStructMatrix::IdentifyExternalConnectIndexes(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZMathTools::IntegrateFunction(), TPZInterfaceElement::IntegrateInterface(), TPZCompEl::IntegrateSolution(), TPZHyperPlaneIntersect::Intersect(), IsSibling(), TPZMathTools::JacobianConv(), ConvTest::JacobianConv(), TPZCompMeshTools::LoadSolution(), TPZCreateApproximationSpace::MakeRaviartThomas(), MalhaCubo(), TPZFlowCompMesh::MaxVelocityOfMesh(), TPZInterfaceElement::NeighbourSolution(), TPZGeoElSide::Normal(), NormalOrientation(), TPZRefPattern::operator==(), TPZRefPatternTools::PerfectMatchRefPattern(), TPZAnalysis::PostProcess(), TPZCondensedCompEl::Print(), TPZMultiphysicsInterfaceElement::Print(), TPZInterfaceElement::Print(), TPZMHMeshControl::PrintBoundaryInfo(), TPZMHMixedHybridMeshControl::PrintFriendly(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintPOrderPoints(), TPZAnalysis::PrintVectorByElement(), PYBIND11_MODULE(), TPZRefPattern::ReadAndCreateRefinementPattern(), RefinamentoUniforme(), TPZInterpolatedElement::RemoveSideRestraintsII(), TPZHybridizeHDiv::RightElement(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZSBFemVolume::SetIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::SetIntegrationRule(), TPZInterfaceElement::SetLeftRightElements(), TPZCompMeshTools::SetPressureOrders(), TPZRefPattern::SetRefPatternMeshToMasterDomain(), TPZCompElDisc::SetTrueUseQsiEta(), TPZInterpolationSpace::SideShapeFunction(), TPZCompElDisc::SizeOfElement(), TPZHybridizeHDiv::SplitConnects(), SubStructure(), TPZGeoElMapped< TBase >::TGradX(), TPZCompElHDiv< TSHAPE >::TPZCompElHDiv(), TPZCompElHDivPressureBound< TSHAPE >::TPZCompElHDivPressureBound(), TPZMeshSolution::TPZMeshSolution(), TPZRefPatternTools::TransformationTest(), TransformSonToFather(), TPZCreateApproximationSpace::UndoMakeRaviartThomas(), TPZGenSubStruct::UniformRefine(), UniformRefinement(), TPZGenSpecialGrid::UniformRefinement(), VerifyNodeCoordinates(), TPZHybridizeHDiv::VerifySolutionConsistency(), WhichSide(), TPZMHMeshControl::WrapMaterialId(), TPZCompElHDiv< TSHAPE >::~TPZCompElHDiv(), and TPZCompElHDivBound2< TSHAPE >::~TPZCompElHDivBound2().
Definition at line 936 of file pzgeoel.cpp.
References TPZVec< T >::NElements(), PZError, and sqrt.
Referenced by TPZGradientReconstruction::TPZGradientData::ComputeWeights(), TPZCompMesh::DeltaX(), ElementRadius(), IsSibling(), TPZCompEl::LesserEdgeOfEl(), TPZCompEl::MaximumRadiusOfEl(), TPZGradientReconstruction::TPZGradientData::NodeCloserCenterX(), and TPZCompElDisc::SizeOfElement().
Divides the element and puts the resulting elements in the vector.
Reimplemented in TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Definition at line 742 of file pzgeoel.h.
References PZError.
Referenced by CheckSubelDataStructure(), Hdiv3dPaper201504::CreateOneCubo(), TPZCompElDisc::Divide(), TPZInterpolatedElement::Divide(), TPZCheckGeom::DivideandCheck(), TPZMHMeshControl::DivideBoundarySkeletonElements(), TPZBuildSBFem::DivideSkeleton(), TPZMHMeshControl::DivideSkeletonElements(), TPZMHMeshControl::DivideWrap(), Hdiv2dPaper201504::GMesh(), hdivCurvedJCompAppMath::GMeshCilindricalMesh(), Hdiv3dPaper201504::GMeshWithPrism(), hdivCurvedJCompAppMath::MakeCircle(), hdivCurvedJCompAppMath::MakeSphereFromQuadrilateral(), MalhaCubo(), MalhaGeom(), RefinamentoUniforme(), TPZRefPatternTools::RefineDirectional(), TPZRefPatternTools::RefineUniformIfNeighMat(), ResetReference(), TPZMGAnalysis::UniformlyRefineMesh(), TPZNonLinMultGridAnalysis::UniformlyRefineMesh(), TPZCheckGeom::UniformRefine(), TPZGenSubStruct::UniformRefine(), UniformRefinement(), and TPZGenSpecialGrid::UniformRefinement().
TPZGeoEl * TPZGeoEl::EldestAncestor | ( | ) | const |
Returns the eldest ancestor of this geoel
Definition at line 1981 of file pzgeoel.cpp.
References Father().
int TPZGeoEl::ElementExists | ( | TPZGeoEl * | elem, |
int64_t | id | ||
) |
To test continuity.
Definition at line 361 of file pzgeoel.cpp.
References TPZGeoMesh::ElementVec(), fMesh, Id(), TPZChunkVector< T, EXP >::NElements(), and PZError.
Referenced by IsSibling().
|
virtual |
Definition at line 949 of file pzgeoel.cpp.
References CenterPoint(), Dimension(), dist(), Distance(), NSides(), PZError, and X().
Referenced by TPZInterfaceElement::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZInterpolationSpace::InnerRadius(), and IsSibling().
TPZGeoEl * TPZGeoEl::Father | ( | ) | const |
Computes the normal vectors needed for forming HDiv vector valued shape functions.
Returns a pointer to the father
Definition at line 2574 of file pzgeoel.cpp.
References TPZGeoMesh::ElementVec(), fFatherIndex, and Mesh().
Referenced by TPZBuildMultiphysicsMesh::AddElements(), TPZMultiphysicsCompMesh::AddElements(), TPZMHMixedMeshControl::BuildMultiPhysicsMesh(), TPZCompMesh::BuildTransferMatrix(), TPZGeoElRefLess< TGeo >::BuildTransform2(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZCompMesh::Coarsen(), TPZMHMeshControl::DefinePartitionbyCoarseIndices(), EldestAncestor(), TPZGeoElRefLess< TGeo >::Father2(), TPZCompEl::GetRefElPatch(), TPZGeoElRefPattern< TGeo >::GetSubElements2(), IsAncestor(), IsGeoElMapped(), TPZMHMeshControl::IsSibling(), IsSibling(), Level(), TPZAgglomerateElement::ListOfGroupings(), LowestFather(), TPZGeoElSide::LowestFatherSide(), Print(), SetAllMatid(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZGeoElMapped< TBase >::TGradX(), TransformSonToFather(), TPZGeoElMapped< TBase >::TX(), and WhichSubel().
|
virtual |
Returns the father/side of the father which contains the side of the sub element.
Reimplemented in TPZGeoElRefLess< TGeo >.
Definition at line 376 of file pzgeoel.cpp.
References PZError.
Referenced by CheckSubelDataStructure(), TPZCheckGeom::CheckSubFatherTransform(), TPZGeoMesh::FindElement(), IsSibling(), TPZGeoElSide::LowestFatherSide(), and TPZCheckRestraint::Print().
|
inline |
Definition at line 349 of file pzgeoel.h.
References bc, BuildBlendConnectivity(), CreateBCCompEl(), CreateBCGeoEl(), CreateGeoElement(), fFatherIndex, NeighbourExists(), ResetBlendConnectivity(), SetNeighbourForBlending(), and WhichSide().
Referenced by TPZGeoMesh::CleanUp().
|
virtual |
Reimplemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Definition at line 381 of file pzgeoel.cpp.
References PZError.
Referenced by TPZGeoElRefLess< TGeo >::Father2(), and IsSibling().
[deprecated] use YoungestChildren
Definition at line 410 of file pzgeoel.cpp.
References DebugStop, GetAllSiblings(), HasSubElement(), NSubElements(), TPZStack< T, NumExtAlloc >::Push(), PZError, and SubElement().
Referenced by TPZGeoMesh::FindSubElement(), GetAllSiblings(), and IsSibling().
Definition at line 2488 of file pzgeoel.cpp.
References GetHigherSubElements(), HasSubElement(), TPZVec< T >::NElements(), NSubElements(), TPZVec< T >::Resize(), and SubElement().
Referenced by GetHigherSubElements(), and MaterialId().
void TPZGeoEl::GetNodeIndices | ( | TPZVec< int64_t > & | nodeindices | ) |
Definition at line 2526 of file pzgeoel.cpp.
References NNodes(), NodeIndex(), and TPZVec< T >::Resize().
Referenced by Initialize().
void TPZGeoEl::GetNodeIndices | ( | std::set< int64_t > & | nodeindices | ) |
|
pure virtual |
This method gets the ith valid permutation of its topology
i | number of the permutation to get |
permutation | vector contained the permuted sides |
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by DecrementNumInterfaces(), and TPZRefPattern::GeneratePermutations().
|
virtual |
Returns the refinement pattern associated with the element.
Reimplemented in TPZGeoElRefPattern< TGeo >.
Definition at line 1716 of file pzgeoel.cpp.
Referenced by TPZRefPatternTools::DragModelPatNodes(), TPZRefPatternTools::GetCompatibleRefPatterns(), IsSibling(), TPZRefPatternTools::ModelRefPattern(), and TPZRefPatternTools::SidesToRefine().
|
virtual |
This method will return a partition of the side of the current element
as the union of sub elements/side which are put in the stack.
Reimplemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Definition at line 392 of file pzgeoel.cpp.
References PZError.
Referenced by TPZCheckGeom::CheckRefinement(), CheckSubelDataStructure(), GetSubElements2(), InitializeNeighbours(), IsSibling(), and SetSubElementConnectivities().
void TPZGeoEl::GetSubElements2 | ( | int | side, |
TPZStack< TPZGeoElSide > & | subel, | ||
int | dimension | ||
) | const |
This method will return a partition of the side of the current element
as the union of sub elements/side which are put in the stack.
Only element/sides of the given dimension are put on the stack
Definition at line 397 of file pzgeoel.cpp.
References Dimension(), GetSubElements2(), TPZVec< T >::NElements(), and TPZStack< T, NumExtAlloc >::Push().
|
pure virtual |
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by TPZGeoElRefLess< TGeo >::BuildTransform2(), and SetId().
Get the transform id the face to face.
Definition at line 330 of file pzgeoel.cpp.
Referenced by SetId().
Get the transform id the face to face.
Definition at line 347 of file pzgeoel.cpp.
Referenced by SetId().
|
pure virtual |
Return the gradient of the transformation at the given coordinate.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by ComputeXInverse(), IsSibling(), Jacobian(), JacobianXYZ(), TPZGeoElMapped< TBase >::TGradX(), and Volume().
|
pure virtual |
Return 1 if the element has subelements.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by TPZMHMeshControl::AddBoundaryElements(), TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZGeoMesh::Area(), TPZCompMesh::AutoBuildContDisc(), TPZPostProcAnalysis::AutoBuildDisc(), TPZCreateApproximationSpace::BuildMesh(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZCheckGeom::CheckRefinement(), TPZGeoMesh::CleanUp(), TPZMHMeshControl::CreateInternalElements(), TPZMHMixedHybridMeshControl::CreateInternalFluxElements(), TPZMHMixedMeshControl::CreateInternalFluxElements(), TPZRefPattern::CreateNewNodes(), Hdiv3dPaper201504::CreateOneCubo(), TPZMHMixedHybridMeshControl::CreatePressureInterfaces(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZMHMeshControl::DefinePartition(), TPZGeoMesh::DeleteElement(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), TPZMHMeshControl::DivideBoundarySkeletonElements(), TPZBuildSBFem::DivideSkeleton(), TPZExtendGridDimension::ExtendedMesh(), TPZGeoMesh::FindSubElement(), TPZGenSpecialGrid::GeneratePolygonalSphereFromOctahedron(), GetAllSiblings(), TPZRefPatternTools::GetCompatibleRefPatterns(), GetHigherSubElements(), pzrefine::TPZRefCube::GetSubElements(), pzrefine::TPZRefPrism::GetSubElements(), pzrefine::TPZRefTriangle::GetSubElements(), pzrefine::TPZRefLinear::GetSubElements(), pzrefine::TPZRefQuad::GetSubElements(), pzrefine::TPZRefPyramid::GetSubElements(), pzrefine::TPZRefTetrahedra::GetSubElements(), pzrefine::TPZRefPoint::GetSubElements(), Hdiv2dPaper201504::GMesh(), hdivCurvedJCompAppMath::GMeshCilindricalMesh(), Hdiv3dPaper201504::GMeshWithPrism(), InitializeNeighbours(), TPZHyperPlaneIntersect::Intersect(), hdivCurvedJCompAppMath::MakeCircle(), hdivCurvedJCompAppMath::MakeSphereFromQuadrilateral(), MalhaCubo(), pzrefine::TPZRefTriangle::MidSideNodeIndex(), pzrefine::TPZRefCube::MidSideNodeIndex(), pzrefine::TPZRefPrism::MidSideNodeIndex(), pzrefine::TPZRefLinear::MidSideNodeIndex(), pzrefine::TPZRefQuad::MidSideNodeIndex(), pzrefine::TPZRefPyramid::MidSideNodeIndex(), pzrefine::TPZRefTetrahedra::MidSideNodeIndex(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZRefPatternTools::RefineDirectional(), ResetReference(), TPZGenGrid::SetBC(), TPZVTKGeoMesh::SetMaterialVTK(), TPZRefPatternTools::SidesToRefine(), TPZCheckGeom::UniformRefine(), TPZGenSubStruct::UniformRefine(), UniformRefinement(), TPZGenSpecialGrid::UniformRefinement(), and YoungestChildren().
|
pure virtual |
Returns the directions of this geoel
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElHDiv< TSHAPE >::ComputeRequiredData().
|
pure virtual |
Returns the directions of this geoel Returns the directions of master element
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElHDiv< TSHAPE >::ComputeRequiredData().
|
virtual |
Computes the permutation for an HDiv side.
Reimplemented in TPZGeoElRefLess< TGeo >.
Definition at line 2509 of file pzgeoel.cpp.
References DebugStop, dimension, Dimension(), LOGPZ_ERROR, pztopology::sidedimension, and SideDimension().
Referenced by TPZCompElHDiv< TSHAPE >::IndexShapeToVec2(), and IsGeoElMapped().
|
inline |
Returns the Id of the element.
Definition at line 223 of file pzgeoel.h.
References fId, NCornerNodes(), NNodes(), Node(), NodeIndex(), NodePtr(), and NPermutations().
Referenced by TPZGeoMesh::BuildElementsAroundNode(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuadratic(), CheckSubelDataStructure(), TPZCheckGeom::CheckUniqueId(), TPZRefPattern::ComputePartition(), ComputeXInverse(), ElementExists(), TPZGeoMesh::FindElement(), TPZGeoMesh::GetBoundaryElements(), TPZGeoElRefPattern< TGeo >::GetSubElements2(), pzgeom::TPZGeoBlend< TGeo >::GradX(), TPZAnalysisError::HPAdapt(), TPZInterfaceElement::InitMaterialData(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZAgglomerateElement::ListOfGroupings(), NormalOrientation(), TPZMultiphysicsInterfaceElement::Print(), TPZInterfaceElement::Print(), TPZRefPattern::PrintVTK(), TPZRefPatternTools::RefineDirectional(), TPZGeoElSide::SideToSideTransform(), TPZRefPatternTools::TransformationTest(), and pzgeom::TPZGeoBlend< TGeo >::X().
|
inline |
Increments number of TPZInterfaceElement pointing to this.
Definition at line 99 of file pzgeoel.h.
References fNumInterfaces.
Referenced by TPZInterfaceElement::TPZInterfaceElement(), and TPZMultiphysicsInterfaceElement::TPZMultiphysicsInterfaceElement().
|
inline |
Returns the index of the element within the element vector of the mesh.
Definition at line 730 of file pzgeoel.h.
References fIndex, and InitializeNeighbours().
Referenced by TPZMHMeshControl::AddElementBoundaries(), TPZBuildSBFem::AddSkeletonElements(), TPZGeoMesh::Area(), TPZMHMixedMeshControl::BuildMultiPhysicsMesh(), CompareFluxes(), TPZMHMeshControl::ConnectedElements(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TPZBuildSBFem::CreateElementGroups(), TPZMHMixedHybridMeshControl::CreateHDivWrappers(), TPZMHMeshControl::CreateInterfaceElements(), TPZMHMixedHybridMeshControl::CreateLowerDimensionPressureElements(), TPZMHMixedHybridMeshControl::CreatePressureInterfaces(), TPZMHMixedMeshControl::CreatePressureMHMMesh(), TPZMHMixedMeshControl::CreateRotationMesh(), TPZMHMixedHybridMeshControl::CreateSkeletonAxialFluxes(), TPZMHMeshControl::CreateSkeletonElements(), TPZMHMeshControl::DefinePartition(), TPZMHMeshControl::DefinePartitionbyCoarseIndices(), TPZGeoMesh::DeleteElement(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), TPZGeoElRefPattern< TGeo >::Divide(), TPZInterpolatedElement::Divide(), TPZGeoMesh::ElementIndex(), TPZGeoMesh::FindApproxElement(), TPZGeoMesh::FindCloseElement(), TPZGeoMesh::FindElement(), TPZGeoMesh::FindElementCaju(), TPZGeoMesh::FindSubElement(), TPZRefPatternTools::GenerateGMeshFromElementVec(), TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec(), HasNeighbour(), TPZMHMixedMeshChannelControl::HideTheElements(), TPZMHMixedMeshControl::HideTheElements(), TPZMHMeshControl::HybridizeSkeleton(), TPZMHMeshControl::IsSibling(), NormalOrientation(), TPZRefPatternTools::PerfectMatchRefPattern(), TPZAnalysis::PostProcessErrorSerial(), TPZCompElHDiv< TSHAPE >::PRefine(), TPZInterpolatedElement::PRefine(), TPZElementGroup::Print(), TPZCondensedCompEl::Print(), TPZMultiphysicsInterfaceElement::Print(), TPZCompElDisc::Print(), TPZMultiphysicsCompEl< TGeometry >::Print(), TPZCompMesh::Print(), TPZInterfaceElement::Print(), Print(), TPZMHMeshControl::PrintBoundaryInfo(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZMHMeshControl::PrintSubdomain(), PrintTopologicalInfo(), TPZAnalysis::PrintVectorByElement(), TPZRefPattern::ReadAndCreateRefinementPattern(), TPZRefPatternTools::RefineDirectional(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZGeoElSideIndex::SetElement(), SetFather(), TPZMHMeshControl::SetSubdomain(), TPZGeoElRefPattern< TGeo >::SetSubElement(), TPZGeoElement< TGeo, TRef >::SetSubElement(), TPZHybridizeHDiv::SplitConnects(), TPZMHMixedHybridMeshControl::SplitFluxElementsAroundFractures(), TPZDohrStructMatrix::SubStructure(), SubStructure(), TPZMHMeshControl::SubStructure(), TPZCompEl::TPZCompEl(), TPZCondensedCompEl::TPZCondensedCompEl(), TPZGeoElRefLess< TGeo >::TPZGeoElRefLess(), and TPZGeoElSideIndex::TPZGeoElSideIndex().
|
inlinevirtual |
Reimplemented in TPZGeoElRefLess< TGeo >.
Definition at line 176 of file pzgeoel.h.
References ClassId(), Clone(), ClonePatchEl(), GetNodeIndices(), Read(), RemoveConnectivities(), StaticClassId(), Write(), and ~TPZGeoEl().
Referenced by TPZGeoElRefLess< TGeo >::CreateBCGeoBlendEl(), TPZGeoElRefLess< TGeo >::CreateBCGeoEl(), and TPZGeoElMapped< TBase >::CreateBCGeoEl().
|
private |
To be used after the buid connectivity. If some neighbour isn't initialized.
It will be initialized as the TPZGeoElSide (this, thisside)
Definition at line 1117 of file pzgeoel.cpp.
References TPZGeoElSide::Element(), GetSubElements2(), HasSubElement(), InitializeNeighbours(), Neighbour(), TPZVec< T >::NElements(), NSides(), SetNeighbour(), and TPZGeoElSide::Side().
Referenced by Index(), InitializeNeighbours(), and SetSubElementConnectivities().
|
inlinevirtual |
Reimplemented in TPZGeoElRefLess< TGeo >.
Definition at line 275 of file pzgeoel.h.
Referenced by BuildBlendConnectivity(), TPZInterpolationSpace::CreateInterface(), Print(), and SetNeighbourForBlending().
|
inlinevirtual |
Returns if is a TPZGeoElMapped< T > element.
It is necessary due to the lack of dynamic cast for these elements
Definition at line 282 of file pzgeoel.h.
References Father(), HDivPermutation(), MidSideNodeIndex(), MidSideNodeIndices(), NSideNodes(), NSides(), NSideSubElements(), NSubElements(), SideIsUndefined(), SideNodeIndex(), SideNodeLocIndex(), and SideNodePtr().
Referenced by SetNeighbourForBlending().
|
pure virtual |
Verifies if the parametric point pt is in the element parametric domain.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by ComputeXInverse(), and IsSibling().
|
inlinevirtual |
Definition at line 268 of file pzgeoel.h.
References NSides().
Referenced by pzgeom::TPZChangeEl::ChangeToQuarterPoint(), TPZGeoElRefLess< TGeo >::CreateGeoElement(), TPZInterpolationSpace::CreateInterface(), TPZGenGrid::MergeGeoMesh(), TPZInterfaceElement::Normal(), Print(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), SetNeighbourForBlending(), and TPZGeoElRefLess< TGeo >::TypeName().
|
pure virtual |
Implemented in TPZGeoElRefLess< TGeo >.
|
inline |
return true is gel is an ancestor of the current element
Definition at line 496 of file pzgeoel.h.
References AllHigherDimensionSides(), BuildTransform2(), CenterPoint(), CharacteristicSize(), CheckSubelDataStructure(), ComputeParamTrans(), ComputePermutationNormals(), ComputeXInverse(), dimension, Dimension(), Distance(), ElementExists(), ElementRadius(), Father(), Father2(), FatherSide(), fMesh, GetAllSiblings(), GetRefPattern(), GetSubElements2(), GradX(), IsInParametricDomain(), IsSibling(), Jacobian(), JacobianXYZ(), Level(), LowerDimensionSides(), NodesCoordinates(), NormalOrientation(), ProjectBissectionInParametricDomain(), ProjectInParametricDomain(), QuadArea(), RefElVolume(), ResetSubElements(), SetRefPattern(), SideArea(), SideDimension(), SmallerEdge(), SubElement(), pzgeom::tol, TransformSonToFather(), TriangleArea(), VerifyNodeCoordinates(), Volume(), WhichSide(), WhichSubel(), X(), and YoungestChildren().
Referenced by IsSibling().
void TPZGeoEl::Jacobian | ( | TPZVec< REAL > & | qsi, |
TPZFMatrix< REAL > & | jac, | ||
TPZFMatrix< REAL > & | axes, | ||
REAL & | detjac, | ||
TPZFMatrix< REAL > & | jacinv | ||
) | const |
Compute a decomposition of the gradient of the mapping function, as a rotation matrix (Jacobian) and orthonormal basis (axes)
Definition at line 1144 of file pzgeoel.cpp.
References GradX(), LOGPZ_DEBUG, and TPZMatrix< TVar >::Print().
Referenced by TPZCompElDisc::AccumulateIntegrationRule(), TPZInterpolationSpace::BuildTransferMatrix(), TPZInterpolatedElement::BuildTransferMatrix(), TPZCompElDisc::BuildTransferMatrix(), TPZInterpolatedElement::CalcIntegral(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZInterfaceElement::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), CheckElement(), TPZInterpolatedElement::CompareElement(), TPZSBFemVolume::ComputeKMatrices(), TPZInterfaceElement::ComputeNormal(), TPZReducedSpace::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZCompElHDivBound2< TSHAPE >::ComputeShape(), TPZInterpolationSpace::ComputeShape(), TPZCompElPostProc< TCOMPEL >::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZSBFemVolume::ComputeShape(), TPZInterpolatedElement::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), ComputeXInverse(), TPZMGAnalysis::ElementError(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZMathTools::IntegrateFunction(), TPZInterfaceElement::IntegrateInterface(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZInterpolationSpace::IntegrateSolution(), TPZCompEl::IntegrateSolution(), IsSibling(), TPZMathTools::JacobianConv(), ConvTest::JacobianConv(), TPZInterpolatedElement::MeanSolution(), TPZSBFemVolume::Shape(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), and Volume().
|
static |
Compute a QR facotrization of the gradient of the mapping function, Q = Jacobian and R = axes.
Definitions: v1 -> is the xi_direction of the Gradient
Definitions: v1 -> is the xi_direction of the Gradient, v2 -> is the eta_direction of the Gradient
Definitions: v_1_til and v_2_til -> asscoiated orthonormal vectors to v_1 and v_2
Definition at line 1166 of file pzgeoel.cpp.
References TPZMatrix< TVar >::Cols(), DebugStop, TPZFMatrix< TVar >::GetVal(), IsZero(), LOGPZ_ERROR, TPZFMatrix< TVar >::Resize(), TPZMatrix< TVar >::Rows(), sqrt, TPZFMatrix< TVar >::Zero(), and ZeroTolerance().
void TPZGeoEl::JacobianXYZ | ( | TPZVec< REAL > & | qsi, |
TPZFMatrix< REAL > & | jac, | ||
TPZFMatrix< REAL > & | axes, | ||
REAL & | detjac, | ||
TPZFMatrix< REAL > & | jacinv | ||
) | const |
Compute a decomposition of the gradient of the mapping function, as a rotation matrix (Jacobian) and orthonormal basis (axes)
Definition at line 1159 of file pzgeoel.cpp.
References GradX().
Referenced by IsSibling().
|
static |
Compute Jacobian matrix for afine mappings.
Definition at line 1357 of file pzgeoel.cpp.
References TPZMatrix< TVar >::Cols(), DebugStop, TPZFMatrix< TVar >::GetVal(), IsZero(), LOGPZ_ERROR, TPZFMatrix< TVar >::Resize(), TPZMatrix< TVar >::Rows(), TPZFMatrix< TVar >::Zero(), and ZeroTolerance().
int TPZGeoEl::Level | ( | ) |
Returns the number of ancestors.
Definition at line 319 of file pzgeoel.cpp.
References Father().
Referenced by IsSibling(), TPZAgglomerateElement::ListOfGroupings(), TPZGenSubStruct::SubStructure(), and TPZGenSubStruct::UniformRefine().
|
pure virtual |
|
inline |
Returns a pointer to the higher level father.
Definition at line 337 of file pzgeoel.h.
References Father().
Referenced by TPZGeoMesh::FindElementCaju().
|
inline |
Returns the material index of the element.
Definition at line 250 of file pzgeoel.h.
References fMatId, GetHigherSubElements(), Reference(), and Type().
Referenced by TPZMHMeshControl::AddBoundaryElements(), TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZBuildMultiphysicsMesh::AddElements(), TPZMultiphysicsCompMesh::AddElements(), TPZMHMixedHybridMeshControl::AdjustBoundaryConditionsOfFractures(), TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), TPZGeoMesh::Area(), TPZPostProcAnalysis::AutoBuildDisc(), TPZBuildSBFem::BuildComputationalMeshFromSkeleton(), TPZBuildSBFem::BuildComputationMesh(), BuildElementGroups(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZCreateApproximationSpace::BuildMesh(), TPZMHMixedMeshControl::BuildMultiPhysicsMesh(), TPZRefPattern::BuildSideMesh(), TPZMHMeshControl::BuildWrapMesh(), TPZInterpolationSpace::CalcStiff(), TPZElementGroup::CalcStiff(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZMHMixedHybridMeshControl::CheckMeshConsistency(), Hdiv2dPaper201504::CMeshMixed(), hdivCurvedJCompAppMath::CMeshMixed(), Hdiv3dPaper201504::CMeshMixed(), TPZSBFemVolume::ComputeKMatrices(), TPZSBFemElementGroup::ComputeMatrices(), TPZInterfaceElement::ComputeNormal(), TPZInterpolationSpace::ComputeNormal(), TPZHybridizeHDiv::ComputePeriferalMaterialIds(), TPZSBFemVolume::ComputeSolution(), TPZMHMeshControl::ConnectedElements(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TPZMHMixedHybridMeshControl::CreateHDivWrappers(), TPZMHMeshControl::CreateInterfaceElements(), TPZCreateApproximationSpace::CreateInterfaces(), TPZMHMixedHybridMeshControl::CreateInternalAxialFluxes(), TPZMHMeshControl::CreateLagrangeMultiplierMesh(), TPZMHMixedHybridMeshControl::CreateLowerDimensionPressureElements(), TPZInterpolatedElement::CreateMidSideConnect(), TPZMHMixedHybridMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedHybridMeshControl::CreatePressureInterfaces(), TPZMHMixedMeshControl::CreatePressureMHMMesh(), TPZMHMixedMeshControl::CreateRotationMesh(), TPZMHMixedHybridMeshControl::CreateSkeletonAxialFluxes(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZMHMeshControl::CreateWrap(), TPZMHMeshControl::CriaMalhaTemporaria(), TPZMHMeshControl::DefinePartition(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), TPZGeoElRefPattern< TGeo >::Divide(), TPZBuildSBFem::DivideSkeleton(), TPZExtendGridDimension::ExtendedMesh(), TPZMHMixedHybridMeshControl::FindConnectedElements(), TPZRefPattern::GeneratePermutations(), TPZCompEl::HasMaterial(), HasNeighbour(), TPZMHMeshControl::HasWrapNeighbour(), TPZMHMixedMeshControl::HybridizeSkeleton(), TPZMHMeshControl::HybridizeSkeleton(), TPZAnalysis::Integrate(), TPZCompMesh::Integrate(), TPZCompEl::Material(), TPZAnalysisError::MathematicaPlot(), TPZGenGrid::MergeGeoMesh(), TPZCompEl::NeedsComputing(), TPZMHMixedHybridMeshControl::NeedsHDivWrapper(), TPZStructMatrixCS::ThreadData::NextElement(), TPZCondensedCompEl::Print(), TPZMultiphysicsInterfaceElement::Print(), TPZCompElDisc::Print(), TPZInterfaceElement::Print(), TPZMHMeshControl::PrintBoundaryInfo(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZMHMeshControl::PrintSubdomain(), TPZAnalysis::PrintVectorByElement(), TPZRefPattern::PrintVTK(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZRefPatternTools::RefineDirectional(), TPZStructMatrixOR::Serial_Assemble(), hdivCurvedJCompAppMath::SetupDisconnectedHdivboud(), TPZSBFemVolume::Solution(), TPZMHMixedHybridMeshControl::SplitFluxElementsAroundFractures(), TPZStructMatrixOR::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWork(), TPZStructMatrixCS::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWorkResidual(), TPZIntelGen< TSHAPE >::TPZIntelGen(), TPZMultiphysicsInterfaceElement::TPZMultiphysicsInterfaceElement(), TPZGenSubStruct::UniformRefine(), UniformRefinement(), TPZGenSpecialGrid::UniformRefinement(), and TPZMHMeshControl::WrapMaterialId().
|
inline |
Returns the mesh to which the element belongs.
Definition at line 220 of file pzgeoel.h.
References fMesh.
Referenced by TPZGeoElement< TGeo, TRef >::Clone(), TPZGeoElRefPattern< TGeo >::Clone(), CompareFluxes(), TPZSBFemVolume::ComputeKMatrices(), TPZGeoElRefLess< TGeo >::CreateBCGeoBlendEl(), TPZGeoElRefLess< TGeo >::CreateBCGeoEl(), TPZGeoElement< TGeo, TRef >::CreateGeoElement(), TPZGeoElRefLess< TGeo >::CreateGeoElement(), TPZRefPattern::CreateMidSideNodes(), TPZMHMeshControl::CreateWrap(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefPoint::Divide(), Father(), TPZRefPattern::GeneratePermutations(), pzgeom::TPZGeoBlend< TGeo >::GradX(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZGeoElRefPattern< TGeo >::MidSideNodeIndex(), TPZGeoElRefLess< TGeo >::Neighbour(), TPZGeoElRefLess< TGeo >::NeighbourIndex(), pzrefine::TPZRefPrism::NewMidSideNode(), pzrefine::TPZRefTriangle::NewMidSideNode(), pzrefine::TPZRefCube::NewMidSideNode(), pzrefine::TPZRefQuad::NewMidSideNode(), pzrefine::TPZRefPyramid::NewMidSideNode(), pzrefine::TPZRefLinear::NewMidSideNode(), pzrefine::TPZRefTetrahedra::NewMidSideNode(), TPZCompElDisc::NormalizeConst(), TPZRefPatternTools::PerfectMatchRefPattern(), TPZInterpolatedElement::PRefine(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZVTKGeoMesh::SetMaterialVTK(), SideArea(), SmallerEdge(), TPZGeoElRefPattern< TGeo >::SubElement(), TPZGeoElement< TGeo, TRef >::SubElement(), TPZGeoEl(), TPZGeoElRefLess< TGeo >::TPZGeoElRefLess(), WhichSubel(), TPZMHMeshControl::WrapMaterialId(), pzgeom::TPZGeoBlend< TGeo >::X(), and TPZInterfaceElement::~TPZInterfaceElement().
|
pure virtual |
Returns the midside node index along a side of the element.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by IsGeoElMapped(), MidSideNodeIndices(), pzrefine::TPZRefCube::NewMidSideNode(), pzrefine::TPZRefPrism::NewMidSideNode(), pzrefine::TPZRefTriangle::NewMidSideNode(), pzrefine::TPZRefLinear::NewMidSideNode(), pzrefine::TPZRefPyramid::NewMidSideNode(), pzrefine::TPZRefQuad::NewMidSideNode(), pzrefine::TPZRefTetrahedra::NewMidSideNode(), and pzrefine::TPZRefPoint::NewMidSideNode().
|
virtual |
Returns the midside node indices along a side of the element.
THIS METHOD SHOULD SUBSTITUTE MidSideNodeIndex in the future as it is ready for Refinement patterns
whereas the former is not
Reimplemented in TPZGeoElRefPattern< TGeo >.
Definition at line 1137 of file pzgeoel.cpp.
References MidSideNodeIndex(), and TPZVec< T >::Resize().
Referenced by IsGeoElMapped().
|
pure virtual |
Returns the number of corner nodes of the element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompMesh::AdjustBoundaryElements(), TPZGeoMesh::BuildConnectivity(), TPZRefPatternTools::BuildRefPatternModelName(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuarterPoint(), TPZMHMixedHybridMeshControl::CheckMeshConsistency(), ComputeXInverse(), TPZBuildSBFem::CreateElementGroups(), TPZGradientReconstruction::TPZGradientData::CreateGhostsNeighbors(), TPZRefPattern::CreateNewNodes(), TPZGeoElRefPattern< TGeo >::Divide(), TPZGeoMesh::FindCloseElement(), TPZGeoMesh::FindElement(), TPZRefPatternTools::GenerateGMeshFromElementVec(), TPZRefPatternTools::GetCompatibleRefPatterns(), TPZInterpolationSpace::GetSideOrient(), TPZMHMixedHybridMeshControl::GroupElements(), TPZAnalysisError::h_Parameter(), TPZHybridizeHDiv::HybridizeInternalSides(), Id(), TPZDohrStructMatrix::IdentifyCornerNodes(), TPZGradientReconstruction::TPZGradientData::InitializeGradData(), pzgeom::TPZQuadraticPrism::InsertExampleElement(), pzgeom::TPZQuadraticPyramid::InsertExampleElement(), pzgeom::TPZQuadraticCube::InsertExampleElement(), pzgeom::TPZQuadraticTetra::InsertExampleElement(), pzgeom::TPZQuadraticTrig::InsertExampleElement(), pzgeom::TPZQuadraticQuad::InsertExampleElement(), TCedricTest::InterpolationError(), TPZHyperPlaneIntersect::Intersect(), TCedricTest::LoadInterpolation(), TPZCompMeshTools::LoadSolution(), TPZGradientReconstruction::TPZGradientData::NodeCloserCenterX(), TPZRefPatternTools::PerfectMatchRefPattern(), TPZInterpolatedElement::Print(), Print(), TPZMHMixedHybridMeshControl::PrintFriendly(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZRefPatternTools::RefineDirectional(), Input::SetPointBC(), SetPointBC(), TPZGenGrid::SetPointBC(), SetSubElementConnectivities(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), TPZRefPatternTools::SidesToRefine(), TPZBuildMultiphysicsMesh::UniformRefineCompEl(), and VerifyNodeCoordinates().
|
pure virtual |
Returns a pointer to the neighbour and the neighbourside along side of the current element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoMesh::BuildConnectivityOld(), TPZGeoMesh::BuildElementsAroundNode(), TPZInterpolationSpace::ComputeNormal(), TPZDohrStructMatrix::CorrectNeighbourDomainIndex(), TPZGeoElRefPattern< TGeo >::Divide(), TPZGeoMesh::FindElement(), TPZGeoMesh::FindElementCaju(), InitializeNeighbours(), NeighbourExists(), pzrefine::TPZRefTriangle::NewMidSideNode(), pzrefine::TPZRefCube::NewMidSideNode(), pzrefine::TPZRefPrism::NewMidSideNode(), pzrefine::TPZRefQuad::NewMidSideNode(), pzrefine::TPZRefLinear::NewMidSideNode(), pzrefine::TPZRefPyramid::NewMidSideNode(), pzrefine::TPZRefTetrahedra::NewMidSideNode(), pzrefine::TPZRefPoint::NewMidSideNode(), Print(), PYBIND11_MODULE(), SetMaterialId(), and SetSubElementConnectivities().
int TPZGeoEl::NeighbourExists | ( | int | side, |
const TPZGeoElSide & | gel | ||
) |
Returns 1 if gel is a neighbour of the element along side.
Definition at line 226 of file pzgeoel.cpp.
References TPZGeoElSide::Exists(), TPZGeoElSide::Neighbour(), and Neighbour().
Referenced by TPZCompMesh::AdjustBoundaryElements(), TPZGeoMesh::BuildConnectivityOld(), FatherIndex(), and SetSubElementConnectivities().
|
pure virtual |
Returns the neighbour index for a given side.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by SetMaterialId().
|
pure virtual |
Returns the number of nodes of the element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElDisc::AccumulateVertices(), BuildBlendConnectivity(), TPZGeoMesh::BuildConnectivityOld(), TPZGeoMesh::BuildElementsAroundNode(), CharacteristicSize(), TPZRefPatternTools::CompareTopologies(), ComputeXInverse(), TPZHierarquicalGrid::CreateGeometricElement(), TPZRefPatternTools::DragModelPatNodes(), TPZExtendGridDimension::ExtendedMesh(), TPZGeoMesh::FindApproxElement(), TPZRefPattern::GeneratePermutations(), GetNodeIndices(), Id(), pzgeom::TPZQuadraticPrism::InsertExampleElement(), pzgeom::TPZQuadraticPyramid::InsertExampleElement(), pzgeom::TPZQuadraticCube::InsertExampleElement(), pzgeom::TPZQuadraticTetra::InsertExampleElement(), pzgeom::TPZQuadraticTrig::InsertExampleElement(), pzgeom::TPZQuadraticQuad::InsertExampleElement(), TPZHyperPlaneIntersect::Intersect(), TPZCompEl::LesserEdgeOfEl(), TPZCompEl::MaximumRadiusOfEl(), TPZGenGrid::MergeGeoMesh(), TPZRefPatternTools::ModelRefPattern(), TPZCompElDisc::NCornerConnects(), pzgeom::TPZChangeEl::NearestNode(), NodesCoordinates(), TPZCompElDisc::NormalizeConst(), TPZRefPattern::operator==(), TPZRefPattern::PermuteMesh(), TPZCompElHDiv< TSHAPE >::PRefine(), Print(), PrintTopologicalInfo(), TPZRefPattern::PrintVTK(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZVTKGeoMesh::SetMaterialVTK(), TPZCompElHDivBound2< TSHAPE >::Shape(), SmallerEdge(), TPZDXGraphMesh::TPZDXGraphMesh(), and XMin().
TPZGeoNode & TPZGeoEl::Node | ( | int | i | ) | const |
Returns the ith node of the element.
Definition at line 2570 of file pzgeoel.cpp.
References fMesh, NodeIndex(), and TPZGeoMesh::NodeVec().
Referenced by TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), TPZMHMixedHybridMeshControl::CheckMeshConsistency(), TPZHierarquicalGrid::CreateGeometricElement(), Id(), TPZGradientReconstruction::TPZGradientData::NodeCloserCenterX(), NodesCoordinates(), TPZMHMixedHybridMeshControl::PrintFriendly(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), and TPZCompElHDiv< TSHAPE >::SideShapeFunction().
|
pure virtual |
Returns the index of the ith node the index is the location of the node in the nodevector of the mesh.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoMesh::BuildConnectivity(), TPZGeoMesh::BuildConnectivityOld(), TPZGeoMesh::BuildElementsAroundNode(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuadratic(), pzgeom::TPZChangeEl::ChangeToQuarterPoint(), TPZRefPatternTools::CompareTopologies(), TPZRefPattern::ComputePartition(), TPZBuildSBFem::CreateElementGroups(), Hdiv3dPaper201504::CreateOneCuboWithTetraedrons(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), TPZGeoElRefPattern< TGeo >::Divide(), TPZExtendGridDimension::ExtendedMesh(), TPZRefPatternTools::GenerateGMeshFromElementVec(), TPZRefPattern::GeneratePermutations(), TPZRefPatternTools::GetGelPermutations(), GetNodeIndices(), Id(), TPZDohrStructMatrix::IdentifyCornerNodes(), pzgeom::TPZGeoBlend< TGeo >::InsertExampleElement(), malha_predio(), MalhaCubo(), Input::MalhaCubo(), MalhaPredio(), TPZGenGrid::MergeGeoMesh(), TPZGeoElRefPattern< TGeo >::MidSideNodeIndices(), pzgeom::TPZChangeEl::NearestNode(), pzrefine::TPZRefTriangle::NewMidSideNode(), pzrefine::TPZRefCube::NewMidSideNode(), pzrefine::TPZRefPrism::NewMidSideNode(), pzrefine::TPZRefPyramid::NewMidSideNode(), pzrefine::TPZRefQuad::NewMidSideNode(), pzrefine::TPZRefLinear::NewMidSideNode(), pzrefine::TPZRefTetrahedra::NewMidSideNode(), pzrefine::TPZRefPoint::NewMidSideNode(), Node(), NodePtr(), TPZCompElDisc::NormalizeConst(), TPZRefPattern::operator==(), TPZRefPattern::PermuteMesh(), Print(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZRefPattern::PrintVTK(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZVTKGeoMesh::SetMaterialVTK(), and TPZCompElDisc::SizeOfElement().
TPZGeoNode * TPZGeoEl::NodePtr | ( | int | i | ) | const |
Returns a pointer to the ith node of the element.
Definition at line 2566 of file pzgeoel.cpp.
References fMesh, NodeIndex(), and TPZGeoMesh::NodeVec().
Referenced by TPZCompElDisc::AccumulateVertices(), CharacteristicSize(), ComputeXInverse(), TPZGeoElRefLess< TGeo >::CornerCoordinates(), TPZCompMesh::DeltaX(), TPZGeoMesh::FindApproxElement(), TPZGeoMesh::FindCloseElement(), TPZMHMixedHybridMeshControl::FindConnectedElements(), TPZRefPatternTools::GenerateGMeshFromElementVec(), TPZAnalysisError::h_Parameter(), TPZGeoElRefLess< TGeo >::HDivPermutation(), Id(), TPZCompElHDiv< TSHAPE >::IndexShapeToVec2(), pzgeom::TPZArc3D::Initialize(), TPZCompElHDiv< TSHAPE >::InitMaterialData(), pzgeom::TPZQuadraticPrism::InsertExampleElement(), pzgeom::TPZQuadraticPyramid::InsertExampleElement(), pzgeom::TPZQuadraticCube::InsertExampleElement(), pzgeom::TPZQuadraticTetra::InsertExampleElement(), pzgeom::TPZQuadraticLine::InsertExampleElement(), pzgeom::TPZQuadraticTrig::InsertExampleElement(), pzgeom::TPZQuadraticQuad::InsertExampleElement(), TCedricTest::InterpolationError(), TPZHyperPlaneIntersect::Intersect(), TPZCompEl::LesserEdgeOfEl(), TCedricTest::LoadInterpolation(), TPZCompMeshTools::LoadSolution(), TPZAnalysisError::MathematicaPlot(), TPZCompEl::MaximumRadiusOfEl(), TPZCompElHDiv< TSHAPE >::NConnectShapeF(), pzgeom::TPZChangeEl::NearestNode(), TPZInterpolatedElement::Print(), TPZGeoElRefLess< TGeo >::PrintTopologicalInfo(), PrintTopologicalInfo(), Input::SetPointBC(), SetPointBC(), TPZGenGrid::SetPointBC(), TPZIntelGen< TSHAPE >::Shape(), TPZCompElHDivBound2< TSHAPE >::Shape(), TPZCompElHDiv< TSHAPE >::Shape(), TPZIntelGen< TSHAPE >::SideShapeFunction(), VerifyNodeCoordinates(), and XMin().
void TPZGeoEl::NodesCoordinates | ( | TPZFMatrix< REAL > & | cooridnates | ) |
Computes nodes coordinates of the element.
void
cooridnates | xyz coorinates of each node that belongs to element |
Definition at line 2543 of file pzgeoel.cpp.
References co, TPZGeoNode::GetCoordinates(), NNodes(), Node(), TPZFMatrix< TVar >::Resize(), and TPZFMatrix< TVar >::Zero().
Referenced by IsSibling().
int TPZGeoEl::NormalOrientation | ( | int | side | ) |
Determine the orientation of the normal vector comparing the ids of the neighbouring elements.
Definition at line 2370 of file pzgeoel.cpp.
References DebugStop, TPZGeoElSide::Dimension(), Dimension(), TPZGeoElSide::Element(), TPZGeoElSide::Exists(), TPZGeoElSide::Father2(), pzrefine::fatherside, Id(), TPZCompEl::Index(), Index(), LOGPZ_DEBUG, LOGPZ_ERROR, TPZGeoElSide::Neighbour(), Reference(), and SideDimension().
Referenced by TPZInterpolationSpace::GetSideOrient(), IsSibling(), and TPZCompElHDiv< TSHAPE >::TPZCompElHDiv().
|
pure virtual |
Get the number of valid permutations among the element nodes
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZRefPattern::GeneratePermutations(), and Id().
|
pure virtual |
Returns the number of nodes for a particular side.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoElSide::BuildConnectivities(), TPZGeoMesh::BuildConnectivityOld(), TPZRefPattern::BuildSideMesh(), TPZRefPattern::ComputePartition(), TPZBuildSBFem::CreateElementGroups(), GetGeoNodeIds(), IsGeoElMapped(), PYBIND11_MODULE(), SideArea(), and WhichSide().
|
pure virtual |
Returns the number of connectivities of the element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElDisc::AccumulateIntegrationRule(), TCedricTest::AddBoundaryElements(), TPZAcademicGeoMesh::AddBoundaryElements(), TPZAcademicGeoMesh::AddBoundaryElementsByCoord(), TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZMultiphysicsCompEl< TGeometry >::AddElement(), TPZMHMeshControl::AddElementBoundaries(), TPZBuildMultiphysicsMesh::AddElements(), TPZMultiphysicsCompMesh::AddElements(), TPZBuildSBFem::AddSkeletonElements(), TPZBuildMultiphysicsMesh::AddWrap(), TPZCompMesh::AdjustBoundaryElements(), TPZCompMeshTools::AdjustFluxPolynomialOrders(), TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), TPZGeoMesh::Area(), BuildBlendConnectivity(), TPZGeoMesh::BuildConnectivity(), TPZGeoMesh::BuildConnectivityOld(), BuildElementGroups(), TPZGeoMesh::BuildElementsAroundNode(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZRefPatternTools::BuildRefPatternModelName(), TPZCompElDisc::BuildTransferMatrix(), TPZCompMesh::BuildTransferMatrix(), TPZMHMeshControl::BuildWrapMesh(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZInterfaceElement::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZCompElDisc::CenterPoint(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuadratic(), pzgeom::TPZChangeEl::ChangeToQuarterPoint(), TPZAcademicGeoMesh::CheckConsistency(), TCedricTest::CheckConsistency(), TPZInterpolatedElement::CheckConstraintConsistency(), TPZInterpolatedElement::CheckElementConsistency(), TPZCheckGeom::CheckInternalTransforms(), TPZCheckGeom::CheckNeighbourMap(), TPZCheckGeom::CheckRefinement(), TPZCheckGeom::CheckSideTransform(), CheckSubelDataStructure(), TPZCheckGeom::CheckSubFatherTransform(), TPZDohrStructMatrix::ClusterIslands(), Hdiv2dPaper201504::CMeshMixed(), hdivCurvedJCompAppMath::CMeshMixed(), Hdiv3dPaper201504::CMeshMixed(), CompareFluxes(), TPZRefPatternTools::CompareTopologies(), TPZInterfaceElement::ComputeCenterNormal(), TPZMultiphysicsInterfaceElement::ComputeCenterNormal(), TPZSBFemVolume::ComputeKMatrices(), TPZInterfaceElement::ComputeNormal(), TPZInterpolationSpace::ComputeNormal(), ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZRefPattern::ComputePartition(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeSideTransform(), TPZInterfaceElement::ComputeSideTransform(), TPZFlowCompMesh::ComputeTimeStep(), TPZRefPattern::ComputeTransforms(), ComputeXInverse(), TPZMHMeshControl::ConnectedElements(), TPZDohrStructMatrix::CorrectNeighbourDomainIndex(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TPZGeoElRefLess< TGeo >::CreateBCGeoBlendEl(), TPZGeoElMapped< TBase >::CreateBCGeoEl(), TCedricTest::CreateCondensedElements(), TPZBuildSBFem::CreateElementCenterNodes(), TPZGradientReconstruction::TPZGradientData::CreateGhostsNeighbors(), TPZReducedSpace::CreateGraphicalElement(), TPZMultiphysicsInterfaceElement::CreateGraphicalElement(), TPZMultiphysicsCompEl< TGeometry >::CreateGraphicalElement(), TPZCompElDisc::CreateGraphicalElement(), TPZMHMixedMeshControl::CreateHDivMHMMesh(), TPZMHMixedHybridMeshControl::CreateHDivWrappers(), TPZCompElDisc::CreateIntegrationRule(), TPZMultiphysicsInterfaceElement::CreateIntegrationRule(), TPZHybridizeHDiv::CreateInterfaceElements(), TPZMHMeshControl::CreateInterfaceElements(), TPZMultiphysicsElement::CreateInterfaces(), TPZInterpolationSpace::CreateInterfaces(), TPZMHMixedHybridMeshControl::CreateInternalAxialFluxes(), TPZMHMixedHybridMeshControl::CreateLowerDimensionPressureElements(), TPZCompElDisc::CreateMidSideConnect(), TPZMHMixedHybridMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedMeshControl::CreateMultiPhysicsInterfaceElements(), TPZRefPattern::CreateNewNodes(), TPZMHMixedHybridMeshControl::CreatePressureInterfaces(), TPZMHMixedMeshControl::CreateSkeleton(), TPZMHMeshControl::CreateSkeleton(), TPZMHMixedHybridMeshControl::CreateSkeletonAxialFluxes(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZMHMeshControl::CriaMalhaTemporaria(), TPZMHMeshControl::DefinePartition(), TPZGeoElRefPattern< TGeo >::Divide(), TPZInterpolatedElement::Divide(), TPZMHMeshControl::DivideWrap(), TPZRefPatternTools::DragModelPatNodes(), ElementRadius(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZGeoMesh::FindCloseElement(), TPZCheckMesh::FindElement(), TPZGeoMesh::FindElement(), TPZGeoMesh::FindElementCaju(), FindPressureSkeleton(), TPZInterfaceElement::FreeInterface(), TPZRefPattern::GeneratePermutations(), TPZRefPattern::GenerateSideRefPatterns(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZRefPatternTools::GetCompatibleRefPatterns(), TPZCompEl::GetRefElPatch(), TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec(), TPZInterpolationSpace::GetSideOrient(), TPZCompMeshTools::GroupElements(), TPZMHMixedHybridMeshControl::GroupElements(), TPZAnalysisError::HPAdapt(), TPZCreateApproximationSpace::Hybridize(), TPZHybridizeHDiv::HybridizeInternalSides(), TPZMHMixedMeshControl::HybridizeSkeleton(), TPZMHMeshControl::HybridizeSkeleton(), TPZDohrStructMatrix::IdentifyExternalConnectIndexes(), TPZIdentifyRefPattern::IdentifySide(), TPZGradientReconstruction::TPZGradientData::InitializeGradData(), TPZInterfaceElement::InitializeIntegrationRule(), TPZSBFemVolume::InitializeIntegrationRule(), InitializeNeighbours(), TPZInterfaceElement::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), pzgeom::TPZQuadraticPrism::InsertExampleElement(), pzgeom::TPZQuadraticPyramid::InsertExampleElement(), pzgeom::TPZQuadraticCube::InsertExampleElement(), pzgeom::TPZQuadraticTetra::InsertExampleElement(), pzgeom::TPZQuadraticLine::InsertExampleElement(), pzgeom::TPZQuadraticTrig::InsertExampleElement(), pzgeom::TPZQuadraticQuad::InsertExampleElement(), TPZMathTools::IntegrateFunction(), TPZInterfaceElement::IntegrateInterface(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZInterpolationSpace::IntegrateSolution(), TPZCompEl::IntegrateSolution(), TPZInterpolationSpace::InterpolateSolution(), TPZHyperPlaneIntersect::Intersect(), IsGeoElMapped(), IsLinearMapping(), TPZInterfaceElement::main(), TPZCreateApproximationSpace::MakeRaviartThomas(), TPZFlowCompMesh::MaxVelocityOfMesh(), TPZRefPatternTools::ModelRefPattern(), TPZMHMixedHybridMeshControl::NeedsHDivWrapper(), TPZGeoElSide::Normal(), TPZAgglomerateElement::NSides(), TPZCompElDisc::NSides(), TPZRefPatternTools::PerfectMatchRefPattern(), TPZCondensedCompEl::Print(), TPZInterpolatedElement::Print(), Print(), TPZMHMeshControl::PrintBoundaryInfo(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbourhood(), TPZVTKGeoMesh::PrintPOrderPoints(), TPZAnalysis::PrintVectorByElement(), Projection(), PYBIND11_MODULE(), TPZCompElDisc::Read(), TPZRefPatternTools::RefineDirectional(), TPZRefPatternTools::RefineUniformIfNeighMat(), RemoveConnectivities(), TPZMultiphysicsElement::RemoveInterfaces(), TPZInterpolationSpace::RemoveInterfaces(), TPZInterpolatedElement::RemoveSideRestraintsII(), TPZGeoMesh::ResetConnectivities(), TPZDohrStructMatrix::SeparateUnconnected(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZCompMeshTools::SetPressureOrders(), SetSubElementConnectivities(), TPZCompElDisc::SetTrueUseQsiEta(), hdivCurvedJCompAppMath::SetupDisconnectedHdivboud(), TPZRefPattern::ShortPrint(), SideArea(), TPZInterpolationSpace::SideShapeFunction(), TPZRefPatternTools::SidesToRefine(), TPZCompElDisc::SizeOfElement(), SmallerEdge(), TPZHybridizeHDiv::SplitConnects(), TPZMHMixedHybridMeshControl::SplitFluxElementsAroundFractures(), SubStructure(), TPZGenSubStruct::SubStructure(), TPZGeoElSide::TPZGeoElSide(), TPZGraphEl::TPZGraphEl(), TPZMHMeshControl::TransferToMultiphysics(), TPZRefPattern::Transform(), TPZRefPatternTools::TransformationTest(), TransformSonToFather(), TPZCreateApproximationSpace::UndoMakeRaviartThomas(), TPZBuildMultiphysicsMesh::UniformRefineCompEl(), TPZHybridizeHDiv::VerifySolutionConsistency(), Volume(), WhichSide(), and TPZRefPattern::WritePattern().
|
pure virtual |
Returns the number of subelements as returned by GetSubElements2(side)
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by IsGeoElMapped(), TPZRefPatternTools::SidesToRefine(), and TPZGeoElSide::StrictFather().
|
pure virtual |
Returns the number of subelements of the element independent of the fact
whether the element has already been refined or not.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZCheckGeom::CheckRefinement(), TPZCompMesh::Coarsen(), TPZMHMeshControl::ConnectedElements(), TPZGeoMesh::DeleteElement(), TPZCompElDisc::Divide(), TPZInterpolatedElement::Divide(), GetAllSiblings(), GetHigherSubElements(), IsGeoElMapped(), TPZMHMixedHybridMeshControl::NeedsHDivWrapper(), Print(), TPZVTKGeoMesh::SetMaterialVTK(), SetSubElementConnectivities(), SetSubMatid(), UniformRefinement(), WhichSubel(), and YoungestChildren().
|
inline |
Returns number of TPZInterfaceElement pointing to this.
Definition at line 94 of file pzgeoel.h.
References fNumInterfaces.
Referenced by TPZCompMesh::AutoBuildContDisc(), TPZCreateApproximationSpace::BuildMesh(), CreateCubeEl(), TPZPostProcAnalysis::CreateCubeEl(), CreateCubeElWithMem(), TPZCompElDisc::CreateDisc(), CreateLinearEl(), TPZPostProcAnalysis::CreateLinearEl(), CreateLinearElWithMem(), CreatePointEl(), TPZPostProcAnalysis::CreatePointEl(), CreatePointElWithMem(), CreatePrismEl(), TPZPostProcAnalysis::CreatePrismEl(), CreatePrismElWithMem(), CreatePyramEl(), TPZPostProcAnalysis::CreatePyramEl(), CreatePyramElWithMem(), CreateQuadEl(), TPZPostProcAnalysis::CreateQuadEl(), CreateQuadElWithMem(), TPZMHMeshControl::CreateSkeletonElements(), CreateTetraEl(), TPZPostProcAnalysis::CreateTetraEl(), CreateTetraElWithMem(), CreateTriangleEl(), TPZPostProcAnalysis::CreateTriangleEl(), CreateTriangleElWithMem(), TPZMultiphysicsElement::RemoveInterface(), TPZInterpolationSpace::RemoveInterface(), and TPZInterfaceElement::~TPZInterfaceElement().
|
virtual |
Print all relevant data of the element to cout.
Reimplemented in TPZGeoElRefLess< TGeo >, and TPZGeoElRefPattern< TGeo >.
Definition at line 238 of file pzgeoel.cpp.
References TPZGeoElSide::Element(), TPZGeoElSide::Exists(), Father(), fId, fIndex, fMatId, fNumInterfaces, fReference, TPZCompEl::Index(), Index(), IsGeoBlendEl(), IsLinearMapping(), NCornerNodes(), TPZGeoElSide::Neighbour(), Neighbour(), NNodes(), NodeIndex(), NSides(), NSubElements(), Reference(), TPZGeoElSide::Side(), and SubElement().
Referenced by TPZCompMesh::AutoBuildContDisc(), TPZPostProcAnalysis::AutoBuildDisc(), TPZCreateApproximationSpace::BuildMesh(), TPZCheckGeom::CheckRefinement(), TPZCheckGeom::CheckSideTransform(), ComputeXInverse(), TPZCompEl::Connect(), TPZInterpolationSpace::CreateInterface(), TPZRefPattern::CreateMidSideNodes(), TPZCompEl::GetRefElPatch(), TPZStructMatrixCS::ThreadData::NextElement(), operator<<(), TPZCheckRestraint::Print(), TPZGeoElRefLess< TGeo >::Print(), TPZRefPatternTools::RefineDirectional(), TPZHyperPlaneIntersect::Reorder(), TPZGeoElSide::SetConnectivity(), SetMaterialId(), pzgeom::TPZGeoBlend< TGeo >::SetNeighbourInfo(), TPZGeoElSide::SideTransform3(), TPZStructMatrixOR::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWork(), TPZStructMatrixCS::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWorkResidual(), VerifyNodeCoordinates(), WhichSubel(), and XMin().
|
virtual |
Prints the coordinates of all nodes (geometric)
out | Indicates the device where the coordinates will be printed |
Reimplemented in TPZGeoElRefLess< TGeo >.
Definition at line 300 of file pzgeoel.cpp.
References TPZGeoNode::Coord(), Index(), NNodes(), and NodePtr().
Referenced by SetMaterialId().
|
pure virtual |
Projection from given qsi to a qsiInDomain (in the element boundary) using bissection method from given qsi to element center.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoMesh::FindElementCaju(), and IsSibling().
|
pure virtual |
Ortogonal projection from given qsi to a qsiInDomain (all in the element parametric domain)
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoMesh::FindApproxElement(), TPZGeoMesh::FindElementCaju(), TPZGeoMesh::FindSubElement(), IsSibling(), and TPZRefPattern::SetRefPatternMeshToMasterDomain().
TPZTransform TPZGeoEl::Projection | ( | int | side | ) |
Compute the projection of the point within the interior of the element to the side of the element.
Definition at line 1970 of file pzgeoel.cpp.
References TPZTransform< T >::Multiply(), NSides(), and SideToSideTransform().
Referenced by ProjectPoint(), and TPZGeoElMapped< TBase >::SetFatherIndex().
|
inlinevirtual |
Project the point from one side to another. The dimension of the points needs to be configured properly.
Definition at line 453 of file pzgeoel.h.
References TPZTransform< T >::Apply(), Projection(), and SideToSideTransform().
Referenced by TPZInterpolationSpace::SideShapeFunction().
|
static |
Returns the area from a quadrilateral face.
Definition at line 1032 of file pzgeoel.cpp.
References TPZVec< T >::NElements(), PZError, TPZVec< T >::Resize(), and TriangleArea().
Referenced by IsSibling(), and SideArea().
|
pure virtual |
Generates a random point in the master domain.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by ResetReference().
|
overridevirtual |
read objects from the stream
Reimplemented from TPZSavable.
Reimplemented in TPZGeoElRefPattern< TGeo >, TPZGeoElRefLess< TGeo >, and TPZGeoElement< TGeo, TRef >.
Definition at line 1652 of file pzgeoel.cpp.
References fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, fReference, TPZPersistenceManager::GetInstance(), gGlobalAxes, TPZStream::Read(), and TPZFMatrix< TVar >::Read().
Referenced by Initialize(), and TPZGeoElRefLess< TGeo >::Read().
|
pure virtual |
Volume of the master element.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), IsSibling(), and Volume().
|
inline |
Return a pointer to the element referenced by the geometric element.
Definition at line 750 of file pzgeoel.h.
References fReference.
Referenced by TPZBuildMultiphysicsMesh::AddElements(), TPZMultiphysicsCompMesh::AddElements(), TPZPostProcAnalysis::AutoBuildDisc(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZCreateApproximationSpace::BuildMesh(), TPZCompMesh::BuildTransferMatrix(), Hdiv2dPaper201504::CMeshMixed(), hdivCurvedJCompAppMath::CMeshMixed(), Hdiv3dPaper201504::CMeshMixed(), TPZInterpolatedElement::CompareElement(), TPZGradientReconstruction::TPZGradientData::ComputeWeights(), TPZDohrStructMatrix::CorrectNeighbourDomainIndex(), CreateCubeEl(), TPZPostProcAnalysis::CreateCubeEl(), CreateCubeElWithMem(), TPZCompElDisc::CreateDisc(), TPZBuildSBFem::CreateElementGroups(), TPZHybridizeHDiv::CreateInterfaceElements(), TPZMHMeshControl::CreateInterfaceElements(), CreateLinearEl(), TPZPostProcAnalysis::CreateLinearEl(), CreateLinearElWithMem(), TPZMHMixedHybridMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedMeshControl::CreateMultiPhysicsInterfaceElements(), CreatePointEl(), TPZPostProcAnalysis::CreatePointEl(), CreatePointElWithMem(), CreatePrismEl(), TPZPostProcAnalysis::CreatePrismEl(), CreatePrismElWithMem(), CreatePyramEl(), TPZPostProcAnalysis::CreatePyramEl(), CreatePyramElWithMem(), CreateQuadEl(), TPZPostProcAnalysis::CreateQuadEl(), CreateQuadElWithMem(), TPZMHMeshControl::CreateSkeletonElements(), CreateTetraEl(), TPZPostProcAnalysis::CreateTetraEl(), CreateTetraElWithMem(), CreateTriangleEl(), TPZPostProcAnalysis::CreateTriangleEl(), CreateTriangleElWithMem(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZAnalysis::DefineElementTable(), TPZCompMesh::Discontinuous2Continuous(), TPZMeshSolution::Execute(), FindCapElement(), TPZMHMixedHybridMeshControl::GroupElements(), TPZMHMixedMeshControl::HybridizeSkeleton(), TPZMHMeshControl::HybridizeSkeleton(), TCedricTest::LoadInterpolation(), TPZCompMeshReferred::LoadReferred(), MaterialId(), TPZAnalysisError::MathematicaPlot(), TPZGradientReconstruction::TPZGradientData::NodeCloserCenterX(), NormalOrientation(), Print(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZMultiphysicsElement::RemoveInterface(), TPZInterpolationSpace::RemoveInterface(), TPZInterpolatedElement::RemoveSideRestraintsII(), TPZNonLinMultGridAnalysis::ResetReference(), TPZDohrStructMatrix::SeparateUnconnected(), TPZCompMeshTools::SetPressureOrders(), TPZPlacaOrthotropic::TPZPlacaOrthotropic(), TPZMHMeshControl::TransferToMultiphysics(), TPZCompEl::~TPZCompEl(), TPZCompElDisc::~TPZCompElDisc(), TPZCompElHDiv< TSHAPE >::~TPZCompElHDiv(), TPZCompElHDivBound2< TSHAPE >::~TPZCompElHDivBound2(), TPZCompElHDivPressure< TSHAPE >::~TPZCompElHDivPressure(), and TPZIntelGen< TSHAPE >::~TPZIntelGen().
void TPZGeoEl::RemoveConnectivities | ( | ) |
It removes the connectivities of the element.
Definition at line 1098 of file pzgeoel.cpp.
References TPZGeoElSide::Element(), fIndex, TPZGeoElSide::Neighbour(), NSides(), TPZGeoElSide::RemoveConnectivity(), TPZGeoElSide::ResetBlendConnectivity(), SetNeighbourForBlending(), and TPZGeoElSide::Side().
Referenced by TPZGeoMesh::DeleteElement(), Initialize(), and TPZInterfaceElement::~TPZInterfaceElement().
|
pure virtual |
If the element is a TPZGeoBlend element, this method will ensure that if the side side is connected to the element with index index, its blend connectivity is erased (for instance, this element may have been deleted). If it is not a TPZGeoBlend element, the method will just return false.
side | side in which to seek for connectivities |
index | index of the element that will be disconnected from this |
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by FatherIndex().
|
inline |
Reset the element referenced by the geometric element to NULL.
Definition at line 431 of file pzgeoel.h.
References Divide(), HasSubElement(), operator<<, RandomPoint(), and SideToSideTransform().
Referenced by TPZMHMeshControl::AddBoundaryElements(), TPZPostProcAnalysis::AutoBuildDisc(), BuildElementGroups(), TPZCompMesh::Coarsen(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TPZMHMixedHybridMeshControl::CreateHDivWrappers(), TPZInterpolatedElement::CreateMidSideConnect(), TPZMHMixedHybridMeshControl::CreatePressureInterfaces(), TPZMHMixedMeshControl::CreateSkeleton(), TPZMHMeshControl::CreateSkeleton(), TPZCompMesh::Discontinuous2Continuous(), TPZCompElDisc::Divide(), TPZInterpolatedElement::Divide(), TPZCreateApproximationSpace::Hybridize(), TPZHybridizeHDiv::HybridizeInternalSides(), TPZMHMixedMeshControl::HybridizeSkeleton(), TPZInterpolatedElement::RemoveSideRestraintsII(), TPZGeoMesh::ResetReference(), TPZHybridizeHDiv::SplitConnects(), TPZBuildMultiphysicsMesh::UniformRefineCompMesh(), TPZCondensedCompEl::Unwrap(), TPZCompElDisc::~TPZCompElDisc(), TPZCompElHDiv< TSHAPE >::~TPZCompElHDiv(), TPZCompElHDivBound2< TSHAPE >::~TPZCompElHDivBound2(), TPZCompElHDivPressure< TSHAPE >::~TPZCompElHDivPressure(), TPZIntelGen< TSHAPE >::~TPZIntelGen(), TPZInterfaceElement::~TPZInterfaceElement(), TPZMultiphysicsElement::~TPZMultiphysicsElement(), TPZMultiphysicsInterfaceElement::~TPZMultiphysicsInterfaceElement(), and TPZSBFemVolume::~TPZSBFemVolume().
|
pure virtual |
Reset all subelements to NULL.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by TPZGeoMesh::CleanUp(), TPZGenSpecialGrid::GeneratePolygonalSphereFromOctahedron(), and IsSibling().
|
inline |
Sets the father element.
Definition at line 481 of file pzgeoel.h.
References Index().
Referenced by TPZRefPattern::BuildSideMesh(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZRefPattern::CreateRefinementPattern(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTetrahedra::Divide(), and TPZRefPattern::ReadAndCreateRefinementPattern().
|
inlinevirtual |
Sets the father element index This method is not called SetFather in order to avoid implicit conversions from nullptr to int.
Definition at line 490 of file pzgeoel.h.
Referenced by TPZGeoMesh::CleanUp(), TPZRefPattern::CreateRefinementPattern(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTetrahedra::Divide(), TPZGenSpecialGrid::GeneratePolygonalSphereFromOctahedron(), TPZRefPattern::ReadAndCreateRefinementPattern(), TPZGeoElRefPattern< TGeo >::ResetSubElements(), and TPZGeoElement< TGeo, TRef >::ResetSubElements().
|
inline |
Definition at line 467 of file pzgeoel.h.
References GetTransform(), GetTransformId2dQ(), and GetTransformId2dT().
|
inline |
Sets the material index of the element.
Definition at line 395 of file pzgeoel.h.
References Neighbour(), NeighbourIndex(), Print(), PrintTopologicalInfo(), SetNeighbour(), SetNodeIndex(), SetReference(), SetSideDefined(), SetSubElement(), and SetSubElementConnectivities().
Referenced by TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), TPZGradientReconstruction::ChangeMaterialIdIntoCompElement(), TPZMHMixedHybridMeshControl::CreateSkeletonAxialFluxes(), TPZMHMeshControl::CreateSkeletonElements(), TPZMHMeshControl::HybridizeSkeleton(), TPZRefPatternTools::RefineDirectional(), SetAllMatid(), TPZVTKGeoMesh::SetMaterialVTK(), and SetSubMatid().
|
pure virtual |
Fill in the data structure for the neighbouring information.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuadratic(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefTetrahedra::Divide(), TPZGeoElRefPattern< TGeo >::Divide(), InitializeNeighbours(), TPZGeoMesh::ResetConnectivities(), and SetMaterialId().
void TPZGeoEl::SetNeighbourForBlending | ( | int | side | ) |
TPZGeoBlend need to find a non-linear neighbour.
Although TPZGeoElMapped have non-linear mapping they are less suitable than self non-linear elements
Definition at line 1913 of file pzgeoel.cpp.
References TPZGeoElSide::Dimension(), TPZGeoElSide::Element(), TPZGeoElSide::Exists(), IsGeoBlendEl(), IsGeoElMapped(), IsLinearMapping(), TPZGeoElSide::IsRelative(), TPZGeoElSide::Neighbour(), SetNeighbourInfo(), and TPZGeoElSide::SideTransform3().
Referenced by BuildBlendConnectivity(), FatherIndex(), and RemoveConnectivities().
|
pure virtual |
Returns the eldest ancestor of this geoel
Referenced by SetNeighbourForBlending().
|
pure virtual |
Initializes the node i of the element.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGenGrid::MergeGeoMesh(), TPZRefPattern::PermuteMesh(), TPZGenGrid::ReadAndMergeGeoMesh(), and SetMaterialId().
|
inline |
Make the current element reference to the computational element.
Definition at line 746 of file pzgeoel.h.
References fReference.
Referenced by TPZInterpolatedElement::CreateMidSideConnect(), TPZCompEl::LoadElementReference(), TPZInterpolatedElement::RemoveSideRestraintsII(), TPZNonLinMultGridAnalysis::ResetReference(), TPZGeoMesh::RestoreReference(), SetMaterialId(), TPZNonLinMultGridAnalysis::SetReference(), TPZCompElDisc::TPZCompElDisc(), TPZCompElHDiv< TSHAPE >::TPZCompElHDiv(), TPZCompElHDivBound2< TSHAPE >::TPZCompElHDivBound2(), TPZIntelGen< TSHAPE >::TPZIntelGen(), TPZInterfaceElement::TPZInterfaceElement(), TPZMultiphysicsInterfaceElement::TPZMultiphysicsInterfaceElement(), and TPZCondensedCompEl::Unwrap().
|
virtual |
Defines the refinement pattern. It's used only in TPZGeoElRefPattern objects.
Defines the refinement pattern. It's used only in TPZGeoElRefPattern objects.
Reimplemented in TPZGeoElRefPattern< TGeo >.
Definition at line 1647 of file pzgeoel.cpp.
References DebugStop, and PZError.
Referenced by TPZMHMeshControl::DivideSkeletonElements(), TPZMHMeshControl::DivideWrap(), IsSibling(), TPZRefPatternTools::RefineDirectional(), and TPZRefPatternTools::RefineUniformIfNeighMat().
|
pure virtual |
Flags the side as defined, this means no neighbouring element was found.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoMesh::BuildConnectivity(), TPZGeoMesh::BuildConnectivityOld(), pzgeom::TPZQuadraticPrism::InsertExampleElement(), pzgeom::TPZQuadraticPyramid::InsertExampleElement(), pzgeom::TPZQuadraticCube::InsertExampleElement(), pzgeom::TPZQuadraticTetra::InsertExampleElement(), pzgeom::TPZQuadraticLine::InsertExampleElement(), pzgeom::TPZQuadraticTrig::InsertExampleElement(), pzgeom::TPZQuadraticQuad::InsertExampleElement(), and SetMaterialId().
|
pure virtual |
Sets the subelement of index i.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by pzgeom::TPZChangeEl::ChangeToQuadratic(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), and SetMaterialId().
|
virtual |
Initializes the external connectivities of the subelements.
Definition at line 563 of file pzgeoel.cpp.
References TPZGeoElSide::BuildConnectivities(), TPZGeoElSide::Exists(), TPZGeoElSide::GetSubElements2(), GetSubElements2(), TPZGeoElSide::HasSubElement(), InitializeNeighbours(), NCornerNodes(), TPZGeoElSide::Neighbour(), Neighbour(), NeighbourExists(), TPZVec< T >::NElements(), NSides(), TPZGeoElSide::NSubElements(), NSubElements(), and SubElement().
Referenced by pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), TPZGeoElRefPattern< TGeo >::Divide(), and SetMaterialId().
void TPZGeoEl::Shape1d | ( | REAL | x, |
int | num, | ||
TPZFMatrix< REAL > & | phi, | ||
TPZFMatrix< REAL > & | dphi | ||
) |
Computes the values of the "num" one dimensional shapefunctions and derivatives at point x, using lagrangian interpolation.
x | point at which the shapefunction is computed |
num | number of shapefunctions |
phi | values of the shapefunctions |
dphi | values of the derivatives of the shapefunctions |
Definition at line 128 of file pzgeoel.cpp.
References PZError.
Referenced by DecrementNumInterfaces().
void TPZGeoEl::ShapePhi1d | ( | REAL | x, |
int | num, | ||
TPZFMatrix< REAL > & | phi | ||
) |
Computes the values of the "num" one dimensional shapefunctions at point x, using lagrangian interpolation.
x | point at which the shapefunction is computed |
num | number of shapefunctions |
phi | values of the shapefunctions |
Definition at line 149 of file pzgeoel.cpp.
References PZError.
Referenced by DecrementNumInterfaces().
|
virtual |
Returns the area from the face.
Definition at line 1064 of file pzgeoel.cpp.
References TPZGeoElSide::Area(), Mesh(), TPZGeoMesh::NodeVec(), NSideNodes(), NSides(), PZError, QuadArea(), SideDimension(), SideNodeIndex(), and TriangleArea().
Referenced by TPZGeoMesh::Area(), TPZMHMeshControl::HybridizeSkeleton(), IsSibling(), and TPZCompElDisc::SizeOfElement().
|
pure virtual |
Return the dimension of side.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZMHMeshControl::AddElementBoundaries(), TPZBuildSBFem::AddSkeletonElements(), TPZBuildMultiphysicsMesh::AddWrap(), TPZCompMesh::AdjustBoundaryElements(), TPZInterpolatedElement::AdjustPreferredSideOrder(), BuildElementGroups(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZMHMeshControl::BuildWrapMesh(), TPZCheckGeom::CheckInternalTransforms(), TPZCheckGeom::CheckNeighbourMap(), TPZCheckRestraint::CheckRestraint(), TPZCheckGeom::CheckSideTransform(), TPZCheckGeom::CheckSubFatherTransform(), TPZDohrStructMatrix::ClusterIslands(), TPZInterpolatedElement::CompareShapeF(), TPZSBFemVolume::ComputeKMatrices(), ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZRefPattern::ComputePartition(), ConjugateSide(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TCedricTest::CreateCondensedElements(), TPZMHMixedHybridMeshControl::CreateHDivWrappers(), TPZMultiphysicsElement::CreateInterfaces(), TPZInterpolationSpace::CreateInterfaces(), TPZBuildSBFem::CreateVolumetricElements(), TPZMHMeshControl::CriaMalhaTemporaria(), TPZRefPattern::GenerateSideRefPatterns(), TPZCompEl::GetRefElPatch(), HDivPermutation(), TPZHybridizeHDiv::HybridizeInternalSides(), TPZIdentifyRefPattern::IdentifySide(), TPZInterpolatedElement::IdentifySideOrder(), TPZHyperPlaneIntersect::Intersect(), IsSibling(), TPZInterfaceElement::main(), TPZCreateApproximationSpace::MakeRaviartThomas(), NormalOrientation(), TPZVTKGeoMesh::PrintPOrderPoints(), PYBIND11_MODULE(), TPZRefPatternTools::RefineDirectional(), TPZInterpolatedElement::RemoveSideRestraintWithRespectTo(), TPZDohrStructMatrix::SeparateUnconnected(), TPZRefPattern::ShortPrint(), SideArea(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), TPZCompElHDiv< TSHAPE >::SideShapeFunction(), TPZMHMixedHybridMeshControl::SplitFluxElementsAroundFractures(), TPZRefPatternTools::TransformationTest(), TPZCreateApproximationSpace::UndoMakeRaviartThomas(), TPZHybridizeHDiv::VerifySolutionConsistency(), WhichSide(), and TPZCompElHDiv< TSHAPE >::~TPZCompElHDiv().
|
pure virtual |
Returns 1 if the side has not been defined by buildconnectivity.
After construction the side is undefined. The buildconnectivity method loops over all elements
and tries to identify neighbours along their uninitialized sides
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoMesh::BuildConnectivity(), TPZGeoMesh::BuildConnectivityOld(), pzgeom::TPZGeoBlend< TGeo >::Initialize(), IsGeoElMapped(), and TPZGeoElBC::TPZGeoElBC().
|
pure virtual |
Returns the index of the nodenum node of side.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZGeoElSide::BuildConnectivities(), TPZGeoMesh::BuildConnectivityOld(), TPZRefPattern::BuildSideMesh(), TPZRefPattern::ComputePartition(), TPZBuildSBFem::CreateElementGroups(), TPZGeoMesh::FindElement(), TPZGeoMesh::GetBoundaryElements(), TPZHyperPlaneIntersect::Intersect(), IsGeoElMapped(), TPZGeoElSide::NeighbourSideTransform(), PYBIND11_MODULE(), SideArea(), SideNodePtr(), and WhichSide().
|
pure virtual |
Returns the local index of a node on a side.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by IsGeoElMapped(), and TPZRefPatternTools::RefineDirectional().
|
virtual |
Returns the pointer to the nodenum node of side.
Definition at line 2578 of file pzgeoel.cpp.
References fMesh, TPZGeoMesh::NodeVec(), and SideNodeIndex().
Referenced by GetGeoNodeIds(), and IsGeoElMapped().
|
pure virtual |
Compute the transformation between the master element space of one side of an element to the master element space of a higher dimension side.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZMultiphysicsInterfaceElement::CalcStiff(), CheckElement(), TPZCheckGeom::CheckSideTransform(), TPZCheckGeom::CheckSubFatherTransform(), CompareFluxes(), TPZSBFemVolume::ComputeKMatrices(), ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), ComputeXInverse(), TPZRefPatternTools::DragModelPatNodes(), TPZRefPatternTools::ModelRefPattern(), Projection(), ProjectPoint(), ResetReference(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZRefPatternTools::TransformationTest(), and WhichSide().
|
virtual |
Definition at line 639 of file pzgeoel.cpp.
References TPZGeoElSide::Dimension(), Mesh(), Min(), NNodes(), TPZGeoMesh::NodeVec(), NSides(), TPZGeoElSide::SideNodeIndex(), and sqrt.
Referenced by IsSibling().
|
static |
Definition at line 2558 of file pzgeoel.cpp.
References Hash().
Referenced by ClassId(), and Initialize().
|
pure virtual |
Returns a pointer to the subelement is.
Implemented in TPZGeoElRefLess< TGeo >, TPZGeoElement< TGeo, TRef >, and TPZGeoElRefPattern< TGeo >.
Referenced by TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZCheckGeom::CheckRefinement(), TPZMHMeshControl::ConnectedElements(), TPZGeoMesh::DeleteElement(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), GetAllSiblings(), GetHigherSubElements(), pzrefine::TPZRefCube::GetSubElements(), pzrefine::TPZRefPrism::GetSubElements(), pzrefine::TPZRefTriangle::GetSubElements(), pzrefine::TPZRefLinear::GetSubElements(), pzrefine::TPZRefPyramid::GetSubElements(), pzrefine::TPZRefQuad::GetSubElements(), pzrefine::TPZRefTetrahedra::GetSubElements(), pzrefine::TPZRefPoint::GetSubElements(), IsSibling(), pzrefine::TPZRefCube::MidSideNodeIndex(), pzrefine::TPZRefPrism::MidSideNodeIndex(), pzrefine::TPZRefTriangle::MidSideNodeIndex(), pzrefine::TPZRefPyramid::MidSideNodeIndex(), pzrefine::TPZRefLinear::MidSideNodeIndex(), pzrefine::TPZRefQuad::MidSideNodeIndex(), pzrefine::TPZRefTetrahedra::MidSideNodeIndex(), TPZMHMixedHybridMeshControl::NeedsHDivWrapper(), Print(), TPZVTKGeoMesh::SetMaterialVTK(), SetSubElementConnectivities(), SetSubMatid(), WhichSubel(), and YoungestChildren().
void TPZGeoEl::TransformSonToFather | ( | TPZGeoEl * | ancestor, |
TPZVec< REAL > & | ksiSon, | ||
TPZVec< REAL > & | ksiAncestor | ||
) |
Compute the map of a paramenter point in the subelement to a parameter point in the super element.
ancestor | ancestor element of subelement |
ksiSon | paramenter point in the subelement |
ksiAncestor | receives the paramenter point in the ancestor element |
Definition at line 816 of file pzgeoel.cpp.
References TPZTransform< T >::Apply(), BuildTransform2(), ComputeXInverse(), DebugStop, Dimension(), Father(), TPZVec< T >::NElements(), NSides(), PZError, TPZVec< T >::Resize(), X(), and ZeroTolerance().
Referenced by IsSibling().
|
static |
Returns the area from the triangular face.
Definition at line 1009 of file pzgeoel.cpp.
References TPZVec< T >::NElements(), PZError, TPZVec< T >::Resize(), and sqrt.
Referenced by IsSibling(), QuadArea(), and SideArea().
|
pure virtual |
Returns the element type acording to pzeltype.h.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZBuildMultiphysicsMesh::AddWrap(), TPZRefPattern::BuildSideMesh(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), pzgeom::TPZChangeEl::ChangeToQuadratic(), pzgeom::TPZChangeEl::ChangeToQuarterPoint(), TPZRefPatternTools::CompareTopologies(), TPZCreateApproximationSpace::CreateCompEl(), TPZBuildSBFem::CreateElementGroups(), TPZHierarquicalGrid::CreateGeometricElement(), TPZSBFemVolume::CreateGraphicalElement(), TPZRefPattern::CreateRefinementPattern(), TPZExtendGridDimension::ExtendedMesh(), TPZRefPattern::GeneratePermutations(), TPZRefPatternTools::GetCompatibleRefPatterns(), TPZRefPatternTools::GetGelPermutations(), TPZIdentifyRefPattern::GetRefPattern(), TPZInterpolationSpace::GetSideOrient(), TPZIdentifyRefPattern::GetSideRefPattern(), TPZIdentifyRefPattern::GetUniform(), TPZVTKGeoMesh::GetVTK_ElType(), TPZRefPattern::InsertPermuted(), TPZRefPatternDataBase::InsertRefPattern(), TPZCompMeshTools::LoadSolution(), MaterialId(), TPZGenGrid::MergeGeoMesh(), TPZRefPatternTools::ModelRefPattern(), TPZRefPattern::operator==(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZRefPattern::PrintVTK(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZRefPatternDataBase::ReadRefPatternDBase(), TPZRefPatternTools::RefineDirectional(), TPZRefPatternTools::RefineUniformIfNeighMat(), and TPZRefPattern::Type().
|
pure virtual |
Returns the element type of a side acording to pzeltype.h.
Implemented in TPZGeoElRefLess< TGeo >.
|
inlinevirtual |
Returns the type of the element as a string.
Reimplemented in TPZGeoElRefLess< TGeo >.
Definition at line 262 of file pzgeoel.h.
Referenced by TPZCompMesh::AdjustBoundaryElements(), TPZRefPatternTools::BuildRefPatternModelName(), TPZRefPatternTools::RefineDirectional(), and TPZRefPattern::ShortPrint().
bool TPZGeoEl::VerifyNodeCoordinates | ( | REAL | tol = 1e-1 | ) |
Verify coordinate of element nodes checking if they are coincident to the X mapping of the corner nodes of parametric elements.
Definition at line 1722 of file pzgeoel.cpp.
References CenterPoint(), ConjugateSide(), TPZGeoNode::Coord(), DebugStop, Dimension(), error(), LOGPZ_ERROR, NCornerNodes(), NodePtr(), Normalize(), NormalVector(), Print(), PZError, sqrt, and X().
Referenced by TPZGeoMesh::BuildConnectivity(), and IsSibling().
REAL TPZGeoEl::Volume | ( | ) |
Return the volume of the element.
Definition at line 1052 of file pzgeoel.cpp.
References CenterPoint(), GradX(), Jacobian(), NSides(), and RefElVolume().
Referenced by IsSibling(), UniformRefinement(), TPZCompEl::VolumeOfEl(), and TPZCompElDisc::VolumeOfEl().
int TPZGeoEl::WhichSide | ( | TPZVec< int64_t > & | SideNodeIds | ) |
Returns the side number which is connected to the SideNodes returns -1 if no side is found.
Definition at line 165 of file pzgeoel.cpp.
References DebugStop, TPZVec< T >::NElements(), NSideNodes(), NSides(), PZError, and SideNodeIndex().
Referenced by TPZGeoMesh::BuildConnectivityOld(), TPZCheckGeom::CheckSubFatherTransform(), TPZGeoElSide::ComputeNeighbours(), TPZRefPattern::ComputeTransforms(), Hdiv3dPaper201504::CreateOneCuboWithTetraedrons(), FatherIndex(), IsSibling(), malha_predio(), MalhaCubo(), Input::MalhaCubo(), MalhaPredio(), TPZGeoElMapped< TBase >::SetFatherIndex(), and TPZRefPatternTools::TransformationTest().
int TPZGeoEl::WhichSide | ( | TPZVec< REAL > & | pt | ) |
Returns the side number which is connected to the point pt.
pt | coordinates of the point in parameter space |
Definition at line 478 of file pzgeoel.cpp.
References TPZTransform< T >::Apply(), Dimension(), NSides(), SideDimension(), SideToSideTransform(), sqrt, and pzgeom::tol.
int TPZGeoEl::WhichSubel | ( | ) | const |
Returns the son number of the sub element gel.
Definition at line 448 of file pzgeoel.cpp.
References DebugStop, Father(), fFatherIndex, LOGPZ_ERROR, Mesh(), nsub, NSubElements(), TPZGeoMesh::Print(), Print(), PZError, and SubElement().
Referenced by TPZGeoElRefLess< TGeo >::BuildTransform2(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZCheckGeom::CheckSubFatherTransform(), TPZGeoElRefLess< TGeo >::Father2(), and IsSibling().
|
overridevirtual |
Writes this object to the TPZStream buffer. Include the classid if withclassid = true.
Writes this object to the TPZStream buffer. Include the classid if withclassid = true
Reimplemented from TPZSavable.
Reimplemented in TPZGeoElRefPattern< TGeo >, TPZGeoElRefLess< TGeo >, and TPZGeoElement< TGeo, TRef >.
Definition at line 1663 of file pzgeoel.cpp.
References fFatherIndex, fId, fIndex, fMatId, fMesh, fNumInterfaces, fReference, gGlobalAxes, TPZStream::Write(), TPZFMatrix< TVar >::Write(), and TPZPersistenceManager::WritePointer().
Referenced by Initialize(), and TPZGeoElRefLess< TGeo >::Write().
Return the coordinate in real space of the point coordinate in the master element space.
Implemented in TPZGeoElRefLess< TGeo >.
Referenced by TPZCompElDisc::AccumulateIntegrationRule(), TPZInterpolationSpace::BuildTransferMatrix(), TPZInterpolatedElement::BuildTransferMatrix(), TPZCompElDisc::BuildTransferMatrix(), TPZInterpolatedElement::CalcIntegral(), TPZInterfaceElement::CheckConsistencyOfMappedQsi(), TPZCheckGeom::CheckSideTransform(), TPZCheckGeom::CheckSubFatherTransform(), TPZSBFemVolume::ComputeKMatrices(), TPZInterfaceElement::ComputeNormal(), TPZInterpolationSpace::ComputeNormal(), ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZCompElPostProc< TCOMPEL >::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZRefPattern::ComputeTransforms(), ComputeXInverse(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZBuildSBFem::CreateElementCenterNodes(), TPZRefPattern::CreateMidSideNodes(), TPZMGAnalysis::ElementError(), ElementRadius(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZGeoMesh::FindApproxElement(), TPZGeoMesh::FindElement(), TPZGenSpecialGrid::GeneratePolygonalSphereFromOctahedron(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZAnalysisError::HPAdapt(), TPZInterfaceElement::InitMaterialData(), TPZMathTools::IntegrateFunction(), IsSibling(), TPZMathTools::JacobianConv(), ConvTest::JacobianConv(), pzrefine::TPZRefPrism::NewMidSideNode(), pzrefine::TPZRefTriangle::NewMidSideNode(), pzrefine::TPZRefCube::NewMidSideNode(), pzrefine::TPZRefQuad::NewMidSideNode(), pzrefine::TPZRefPyramid::NewMidSideNode(), pzrefine::TPZRefLinear::NewMidSideNode(), pzrefine::TPZRefTetrahedra::NewMidSideNode(), TPZGeoElSide::Normal(), TPZCondensedCompEl::Print(), TPZCompElDisc::Print(), TPZCompEl::Print(), TPZMultiphysicsCompEl< TGeometry >::Print(), TPZCompEl::PrintCoordinate(), TPZVTKGeoMesh::PrintPOrderPoints(), TPZAnalysis::PrintVectorByElement(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZCompElDisc::SetFalseUseQsiEta(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZCompElDisc::Shape(), TPZCompElHDivPressure< TSHAPE >::Solution(), TPZMultiphysicsCompEl< TGeometry >::Solution(), TPZInterpolationSpace::Solution(), TPZSBFemVolume::Solution(), SubStructure(), TPZRefPatternTools::TransformationTest(), TransformSonToFather(), TPZGeoElMapped< TBase >::TX(), and VerifyNodeCoordinates().
This method will return all children at the bottom of the refinement tree of the element. i.e. all children that have no subelements.
Definition at line 431 of file pzgeoel.cpp.
References HasSubElement(), NSubElements(), TPZStack< T, NumExtAlloc >::Push(), SubElement(), and YoungestChildren().
Referenced by IsSibling(), and YoungestChildren().
|
friend |
Equivalent to Print.
Definition at line 314 of file pzgeoel.cpp.
Referenced by ResetReference().
|
protected |
Index of the element from which the element is a subelement.
Definition at line 60 of file pzgeoel.h.
Referenced by Father(), FatherIndex(), Read(), TPZGeoEl(), WhichSubel(), and Write().
|
protected |
Traditional element number or element id.
Definition at line 51 of file pzgeoel.h.
Referenced by Id(), Print(), TPZGeoElRefLess< TGeo >::PrintTopologicalInfo(), Read(), TPZGeoEl(), and Write().
|
protected |
Index of the element in the element vector.
Definition at line 63 of file pzgeoel.h.
Referenced by ComputeXInverse(), TPZGeoElRefPattern< TGeo >::Divide(), Index(), Print(), Read(), RemoveConnectivities(), TPZGeoEl(), and Write().
|
protected |
Material index.
Definition at line 54 of file pzgeoel.h.
Referenced by MaterialId(), Print(), Read(), TPZGeoEl(), and Write().
|
protected |
Pointer to the mesh to which the element belongs.
Definition at line 48 of file pzgeoel.h.
Referenced by ElementExists(), IsSibling(), Mesh(), Node(), NodePtr(), Read(), SideNodePtr(), TPZGeoEl(), and Write().
|
protected |
A counter to indicate how many interface elements are pointing to it.
Definition at line 69 of file pzgeoel.h.
Referenced by DecrementNumInterfaces(), IncrementNumInterfaces(), NumInterfaces(), Print(), Read(), TPZGeoEl(), and Write().
|
protected |
Reference to the element currently loaded. Pointer is given as this->Mesh()->Reference()->ElementVec()[fReference].
Definition at line 57 of file pzgeoel.h.
Referenced by Print(), Read(), Reference(), SetReference(), TPZGeoEl(), and Write().
|
staticprotected |