NeoPZ
Public Member Functions | Private Member Functions | Private Attributes | List of all members

Class which implements an element which condenses the internal connects. More...

#include <pzcondensedcompel.h>

Inheritance diagram for TPZCondensedCompEl:
[legend]
Collaboration diagram for TPZCondensedCompEl:
[legend]

Public Member Functions

 TPZCondensedCompEl (TPZCompEl *ref, bool keepmatrix=true)
 
 TPZCondensedCompEl (const TPZCondensedCompEl &copy, TPZCompMesh &mesh)
 create a copy of the condensed computational element in the other mesh More...
 
virtual ~TPZCondensedCompEl ()
 
virtual void Print (std::ostream &out=std::cout) const override
 Prints element data. More...
 
void Unwrap ()
 unwrap the condensed element from the computational element and delete the condensed element More...
 
virtual void SetConnectIndex (int inode, int64_t index) override
 Set the index i to node inode. More...
 
virtual int NConnects () const override
 Returns the number of nodes of the element. More...
 
virtual int64_t ConnectIndex (int i) const override
 Returns the index of the ith connectivity of the element. More...
 
TPZCompElReferenceCompEl ()
 
virtual bool NeedsComputing (const std::set< int > &materialids) override
 return true if the element has a variational statement associated with the material ids More...
 
virtual void LoadElementReference () override
 Loads the geometric element reference. More...
 
virtual void BuildCornerConnectList (std::set< int64_t > &connectindexes) const override
 adds the connect indexes associated with base shape functions to the set More...
 
void SetKeepMatrix (bool keep)
 Set the flag that determines whether the matrix needs to be kept or not. More...
 
virtual int Dimension () const override
 Dimension of the element. More...
 
virtual TPZCompElClone (TPZCompMesh &mesh) const override
 Method for creating a copy of the element. More...
 
virtual void LoadSolution () override
 Loads the solution within the internal data structure of the element. More...
 
virtual void TransferMultiphysicsElementSolution () override
 
virtual TPZCompElClonePatchEl (TPZCompMesh &mesh, std::map< int64_t, int64_t > &gl2lcConMap, std::map< int64_t, int64_t > &gl2lcElMap) const override
 Method for creating a copy of the element in a patch mesh. More...
 
virtual void ComputeSolution (TPZVec< REAL > &qsi, TPZMaterialData &data) override
 Computes solution and its derivatives in the local coordinate qsi. More...
 
virtual TPZVec< STATE > IntegrateSolution (const std::string &varname, const std::set< int > &matids) override
 Compute the integral of a variable defined by the string if the material id is included in matids. More...
 
virtual TPZVec< STATE > IntegrateSolution (int var) const override
 Compute the integral of a variable defined by the string if the material id is included in matids. More...
 
virtual void ComputeSolution (TPZVec< REAL > &qsi, TPZVec< REAL > &normal, TPZSolVec &leftsol, TPZGradSolVec &dleftsol, TPZFMatrix< REAL > &leftaxes, TPZSolVec &rightsol, TPZGradSolVec &drightsol, TPZFMatrix< REAL > &rightaxes) override
 Computes solution and its derivatives in the local coordinate qsi.
This method will function for both volumetric and interface elements. More...
 
virtual void ComputeSolution (TPZVec< REAL > &qsi, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphix, const TPZFMatrix< REAL > &axes, TPZSolVec &sol, TPZGradSolVec &dsol) override
 Computes solution and its derivatives in local coordinate qsi. More...
 
virtual void Assemble () override
 Assemble the stiffness matrix in locally kept datastructure. More...
 
virtual void CalcStiff (TPZElementMatrix &ek, TPZElementMatrix &ef) override
 Computes the element stifness matrix and right hand side. More...
 
virtual void CalcResidual (TPZElementMatrix &ef) override
 Computes the element right hand side. More...
 
virtual bool HasMaterial (const std::set< int > &materialids) const override
 Verifies if the material associated with the element is contained in the set. More...
 
void EvaluateError (std::function< void(const TPZVec< REAL > &loc, TPZVec< STATE > &val, TPZFMatrix< STATE > &deriv)> func, TPZVec< REAL > &errors, bool store_errors) override
 Performs an error estimate on the elemen. More...
 
virtual void CreateGraphicalElement (TPZGraphMesh &graphmesh, int dimension) override
 Creates corresponding graphical element(s) if the dimension matches graphical elements are used to generate output files. More...
 
int ComputeIntegrationOrder () const override
 
virtual int ClassId () const override
 Define the class id associated with the class. More...
 
- Public Member Functions inherited from TPZCompEl
 TPZCompEl ()
 Simple Constructor. More...
 
virtual ~TPZCompEl ()
 Simple destructor. More...
 
 TPZCompEl (TPZCompMesh &mesh, const TPZCompEl &copy)
 Put a copy of the element in the referred mesh. More...
 
 TPZCompEl (TPZCompMesh &mesh, const TPZCompEl &copy, std::map< int64_t, int64_t > &gl2lcElMap)
 Put a copy of the element in the patch mesh. More...
 
 TPZCompEl (TPZCompMesh &mesh, const TPZCompEl &copy, int64_t &index)
 Copy of the element in the new mesh returning allocated index. More...
 
 TPZCompEl (TPZCompMesh &mesh, TPZGeoEl *gel, int64_t &index)
 Creates a computational element within mesh. Inserts the element within the data structure of the mesh. More...
 
virtual void SetCreateFunctions (TPZCompMesh *mesh)
 Sets create function in TPZCompMesh to create elements of this type. More...
 
virtual REAL VolumeOfEl ()
 Returns the volume of the geometric element associated. More...
 
virtual REAL CompareElement (int var, char *matname)
 This method computes the norm of the difference of a post processed variable with @ the same post processed variable of the element pointed to by the geometric element. More...
 
virtual void Divide (int64_t index, TPZVec< int64_t > &subindex, int interpolate=0)
 Divide the computational element. If interpolate = 1, the solution is interpolated to the sub elements. More...
 
virtual void ProjectFlux (TPZElementMatrix &ek, TPZElementMatrix &ef)
 Projects the flux function on the finite element space. More...
 
virtual void ComputeError (int errorid, TPZVec< REAL > &error)
 ComputeError computes the element error estimator. More...
 
virtual void Integrate (int variable, TPZVec< STATE > &value)
 Integrates a variable over the element. More...
 
virtual void GetMemoryIndices (TPZVec< int64_t > &indices) const
 Get the indices of the vector of element memory associated with the integration points. More...
 
virtual void SetMemoryIndices (TPZVec< int64_t > &indices)
 Set the indices of the vector of element memory associated with the integration points. More...
 
virtual void PrepareIntPtIndices ()
 Prepare the vector of the material withmem with the correct integration point indexes. More...
 
virtual void ForcePrepareIntPtIndices ()
 PrepareIntPtIndices initializes the material damage varibles memory in the proper material class. More...
 
virtual void SetFreeIntPtIndices ()
 Frees the material damage varibles memory in the proper material class. More...
 
virtual int NumberOfCompElementsInsideThisCompEl ()
 Return the size of the elementvec in multiphysics, if it is not multiphysics, just return 1. More...
 
virtual void SetMultiphysicsElementSolution ()
 
virtual void AddShapeRestraint (TPZOneShapeRestraint restraint)
 Add a shape restraint (meant to fit the pyramid to restraint. More...
 
virtual std::list< TPZOneShapeRestraintGetShapeRestraints () const
 Return a list with the shape restraints. More...
 
virtual void ResetShapeRestraints ()
 Return a list with the shape restraints. More...
 
virtual void Solution (TPZVec< REAL > &qsi, int var, TPZVec< STATE > &sol)
 Calculates the solution - sol - for the variable var at point qsi, where qsi is expressed in terms of the master element coordinates. More...
 
virtual void BuildConnectList (std::set< int64_t > &indepconnectlist, std::set< int64_t > &depconnectlist)
 Builds the list of all connectivities related to the element including the connects pointed to by dependent connects. More...
 
virtual void BuildConnectList (TPZStack< int64_t > &connectlist) const
 Builds the list of all connectivities related to the element including the connects pointed to by dependent connects. More...
 
virtual void BuildConnectList (std::set< int64_t > &connectlist)
 Builds the list of all connectivities related to the element including the connects pointed to by dependent connects. More...
 
virtual int HasDependency ()
 Returns 1 if the element has at least one dependent node. Returns 0 otherwise. More...
 
virtual int PressureConnectIndex () const
 Returns the index of the pressure connect. More...
 
virtual void ReduceInternalNodes ()
 Domain Decomposition.
This method will eliminate the nodes which are internal to the element from the datastructure of the grid
After calling this method, the superelement will statically condense the internal equations. More...
 
virtual void CalcBlockDiagonal (TPZStack< int64_t > &connectlist, TPZBlockDiagonal< STATE > &block)
 Calculates the diagonal block. More...
 
REAL MaximumRadiusOfEl ()
 Will return the maximum distance between the nodes of the reference element. More...
 
REAL LesserEdgeOfEl ()
 Will return the smallest distance between two nodes of the reference element. More...
 
void Write (TPZStream &buf, int withclassid) const override
 Save the element data to a stream. More...
 
void Read (TPZStream &buf, void *context) override
 Read the element data from a stream. More...
 
virtual void InitializeIntegrationRule ()
 
virtual void SetIntegrationRule (TPZIntPoints *intrule)
 Method to set a dynamically allocated integration rule. More...
 
virtual void SetIntegrationRule (int order)
 
virtual const TPZIntPointsGetIntegrationRule () const
 
virtual MElementType Type ()
 Return the type of the element. More...
 
virtual int IsInterface ()
 
TPZGeoElReference () const
 Return a pointer to the corresponding geometric element if such exists, return 0 otherwise. More...
 
void SetReference (int64_t referenceindex)
 
virtual int NEquations ()
 Returns the number of equations of the element. More...
 
int64_t Index () const
 Returns element index of the mesh fELementVec list. More...
 
void SetIndex (int64_t index)
 Sets element index of the mesh fELementVec list. More...
 
virtual TPZConnectConnect (int i) const
 Returns a pointer to the ith node. More...
 
virtual TPZMaterialMaterial () const
 Identify the material object associated with the element. More...
 
TPZGeoElGetRefElPatch ()
 Returns the reference geometric element patch.
Look for a geometric element which refers to a computational element and is neighbour of the current element AND is larger than the current element. More...
 
void SetMesh (TPZCompMesh *mesh)
 Sets the grid of the element. More...
 
TPZCompMeshMesh () const
 Return a pointer to the grid of the element. More...
 
virtual void PrintSolution (TPZVec< REAL > &point, const char *VarName, std::ostream &out)
 Prints the solution - sol - for the variable "VarName" at point specified in terms of the master element coordinates. More...
 
virtual void PrintCoordinate (TPZVec< REAL > &point, int CoordinateIndex, std::ostream &out)
 Prints one coordinate index corresponding to the point to the output stream. More...
 
virtual void PrintTitle (const char *VarName, std::ostream &out)
 Prints the variables names associated with the element material. More...
 
- Public Member Functions inherited from TPZSavable
 TPZSavable ()
 
virtual ~TPZSavable ()
 
virtual std::list< std::map< std::string, uint64_t > > VersionHistory () const
 
virtual std::pair< std::string, uint64_t > Version () const
 
virtual bool Compare (TPZSavable *copy, bool override=false)
 Compares the object for identity with the object pointed to, eventually copy the object. More...
 
virtual bool Compare (TPZSavable *copy, bool override=false) const
 Compares the object for identity with the object pointed to, eventually copy the object. More...
 
- Public Member Functions inherited from TPZRegisterClassId
template<typename T >
 TPZRegisterClassId (int(T::*)() const)
 
 TPZRegisterClassId ()=default
 

Private Member Functions

void Resequence ()
 
virtual void ComputeSolution (TPZVec< REAL > &qsi, TPZSolVec &sol, TPZGradSolVec &dsol, TPZFMatrix< REAL > &axes) override
 Computes solution and its derivatives in the local coordinate qsi. More...
 

Private Attributes

int64_t fNumInternalEqs
 
int64_t fNumTotalEqs
 
TPZMatRed< STATE, TPZFMatrix< STATE > > fCondensed
 
TPZCompElfReferenceCompEl
 
TPZManVector< int64_t, 27 > fIndexes
 
bool fKeepMatrix
 

Additional Inherited Members

- Static Public Member Functions inherited from TPZCompEl
static int StaticClassId ()
 
static void SetgOrder (int order)
 Sets the value of the default interpolation order. More...
 
static int GetgOrder ()
 Set the default value of the interpolation order. More...
 
static void SetOrthogonalFunction (void(*orthogonal)(REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi))
 Sets the orthogonal function which will be used throughout the program by default this function is the Chebyshev function. More...
 
static void Chebyshev (REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi)
 Implements of the orthogonal Chebyshev functions. More...
 
- Static Public Member Functions inherited from TPZSavable
static std::set< TPZRestoreClassBase * > & RestoreClassSet ()
 This static function guarantees that the gMap object is available when needed. More...
 
static std::map< int, TPZRestore_t > & ClassIdMap ()
 This static function guarantees that the gMap object is available when needed. More...
 
static std::pair< std::string, uint64_t > NeoPZVersion ()
 
static void Register (TPZRestoreClassBase *restore)
 
static void RegisterClassId (int classid, TPZRestore_t fun)
 
static TPZSavableCreateInstance (const int &classId)
 
- Protected Attributes inherited from TPZCompEl
TPZCompMeshfMesh
 Computational mesh to which the element belongs. More...
 
int64_t fIndex
 Element index into mesh element vector. More...
 
TPZIntPointsfIntegrationRule
 Integration rule established by the user. More...
 

Detailed Description

Class which implements an element which condenses the internal connects.

Author
Philippe Devloo

Definition at line 32 of file pzcondensedcompel.h.

Constructor & Destructor Documentation

◆ TPZCondensedCompEl() [1/2]

TPZCondensedCompEl::TPZCondensedCompEl ( TPZCompEl ref,
bool  keepmatrix = true 
)

◆ TPZCondensedCompEl() [2/2]

TPZCondensedCompEl::TPZCondensedCompEl ( const TPZCondensedCompEl copy,
TPZCompMesh mesh 
)

◆ ~TPZCondensedCompEl()

TPZCondensedCompEl::~TPZCondensedCompEl ( )
virtual

Member Function Documentation

◆ Assemble()

virtual void TPZCondensedCompEl::Assemble ( )
overridevirtual

Assemble the stiffness matrix in locally kept datastructure.

Reimplemented from TPZCompEl.

Referenced by IntegrateSolution().

◆ BuildCornerConnectList()

void TPZCondensedCompEl::BuildCornerConnectList ( std::set< int64_t > &  connectindexes) const
overridevirtual

adds the connect indexes associated with base shape functions to the set

Implements TPZCompEl.

Definition at line 728 of file pzcondensedcompel.cpp.

References TPZCompEl::BuildCornerConnectList(), TPZCompEl::Connect(), ConnectIndex(), fReferenceCompEl, TPZConnect::HasDependency(), TPZConnect::IsCondensed(), and NConnects().

Referenced by LoadElementReference().

◆ CalcResidual()

void TPZCondensedCompEl::CalcResidual ( TPZElementMatrix ef)
overridevirtual

◆ CalcStiff()

void TPZCondensedCompEl::CalcStiff ( TPZElementMatrix ek,
TPZElementMatrix ef 
)
overridevirtual

Computes the element stifness matrix and right hand side.

Parameters
ekelement stiffness matrix
efelement load vector

Reimplemented from TPZCompEl.

Definition at line 292 of file pzcondensedcompel.cpp.

References TPZCompEl::CalcStiff(), TPZMatrix< TVar >::Cols(), TPZCompEl::Connect(), ConnectIndex(), DebugStop, TPZMatRed< TVar, TSideMatrix >::Dim0(), TPZMatRed< TVar, TSideMatrix >::Dim1(), ELDLt, EMathematicaInput, TPZMatRed< TVar, TSideMatrix >::F0(), TPZMatRed< TVar, TSideMatrix >::F1(), fCondensed, TPZElementMatrix::fConnect, fIndexes, fKeepMatrix, TPZElementMatrix::fMat, fNumInternalEqs, fNumTotalEqs, fReferenceCompEl, TPZFMatrix< TVar >::GetVal(), TPZCompEl::Index(), TPZMatRed< TVar, TSideMatrix >::K00(), TPZMatRed< TVar, TSideMatrix >::K01(), TPZMatRed< TVar, TSideMatrix >::K10(), TPZMatRed< TVar, TSideMatrix >::K11(), TPZMatRed< TVar, TSideMatrix >::K11Reduced(), LOGPZ_DEBUG, TPZCompEl::Mesh(), NConnects(), Norm(), TPZElementMatrix::PermuteGather(), Print(), TPZMatRed< TVar, TSideMatrix >::Print(), TPZConnect::Print(), TPZMatrix< TVar >::Print(), TPZMatRed< TVar, TSideMatrix >::Redim(), TPZFMatrix< TVar >::Redim(), TPZMatrix< TVar >::Redim(), TPZMatrix< TVar >::Rows(), TPZMatRed< TVar, TSideMatrix >::SetF(), TPZMatRed< TVar, TSideMatrix >::SetF0IsComputed(), TPZMatrix< TVar >::SetIsDecomposed(), TPZMatRed< TVar, TSideMatrix >::SetK01IsComputed(), TPZMatRed< TVar, TSideMatrix >::SetReduced(), TPZMatrix< TVar >::SolveDirect(), and TPZMatRed< TVar, TSideMatrix >::Zero().

Referenced by IntegrateSolution().

◆ ClassId()

int TPZCondensedCompEl::ClassId ( ) const
overridevirtual

Define the class id associated with the class.

This id has to be unique for all classes A non unique id is flagged at the startup of the program

Reimplemented from TPZCompEl.

Definition at line 744 of file pzcondensedcompel.cpp.

References TPZCompEl::ClassId(), and Hash().

Referenced by ComputeIntegrationOrder().

◆ Clone()

virtual TPZCompEl* TPZCondensedCompEl::Clone ( TPZCompMesh mesh) const
inlineoverridevirtual

Method for creating a copy of the element.

Implements TPZCompEl.

Definition at line 125 of file pzcondensedcompel.h.

References LoadSolution(), and TPZCondensedCompEl().

◆ ClonePatchEl()

TPZCompEl * TPZCondensedCompEl::ClonePatchEl ( TPZCompMesh mesh,
std::map< int64_t, int64_t > &  gl2lcConMap,
std::map< int64_t, int64_t > &  gl2lcElMap 
) const
overridevirtual

Method for creating a copy of the element in a patch mesh.

Parameters
meshPatch clone mesh
gl2lcConMapmap the connects indexes from global element (original) to the local copy.
gl2lcElMapmap the computational elements Otherwise of the previous clone function, this method don't copy entire mesh. Therefore it needs to map the connect index from the both meshes - original and patch

Implements TPZCompEl.

Definition at line 123 of file pzcondensedcompel.cpp.

References TPZCompEl::ClonePatchEl(), fCondensed, fIndexes, fReferenceCompEl, and TPZCondensedCompEl().

Referenced by TransferMultiphysicsElementSolution().

◆ ComputeIntegrationOrder()

int TPZCondensedCompEl::ComputeIntegrationOrder ( ) const
inlineoverridevirtual

Reimplemented from TPZCompEl.

Definition at line 260 of file pzcondensedcompel.h.

References ClassId(), and DebugStop.

◆ ComputeSolution() [1/4]

void TPZCondensedCompEl::ComputeSolution ( TPZVec< REAL > &  qsi,
TPZSolVec sol,
TPZGradSolVec dsol,
TPZFMatrix< REAL > &  axes 
)
overrideprivatevirtual

Computes solution and its derivatives in the local coordinate qsi.

Parameters
qsimaster element coordinate
solfinite element solution
dsolsolution derivatives
axesaxes associated with the derivative of the solution

Reimplemented from TPZCompEl.

Definition at line 141 of file pzcondensedcompel.cpp.

References TPZCompEl::ComputeSolution(), and fReferenceCompEl.

Referenced by IntegrateSolution(), and TransferMultiphysicsElementSolution().

◆ ComputeSolution() [2/4]

void TPZCondensedCompEl::ComputeSolution ( TPZVec< REAL > &  qsi,
TPZMaterialData data 
)
overridevirtual

Computes solution and its derivatives in the local coordinate qsi.

Parameters
qsi[in] master element coordinate
data[in] stores all input data

Reimplemented from TPZCompEl.

Definition at line 147 of file pzcondensedcompel.cpp.

References TPZCompEl::ComputeSolution(), and fReferenceCompEl.

◆ ComputeSolution() [3/4]

void TPZCondensedCompEl::ComputeSolution ( TPZVec< REAL > &  qsi,
TPZVec< REAL > &  normal,
TPZSolVec leftsol,
TPZGradSolVec dleftsol,
TPZFMatrix< REAL > &  leftaxes,
TPZSolVec rightsol,
TPZGradSolVec drightsol,
TPZFMatrix< REAL > &  rightaxes 
)
overridevirtual

Computes solution and its derivatives in the local coordinate qsi.
This method will function for both volumetric and interface elements.

Parameters
qsimaster element coordinate of the interface element
normalvector
leftsolfinite element solution
dleftsolsolution derivatives
leftaxesaxes associated with the left solution
rightsolfinite element solution
drightsolsolution derivatives
rightaxesaxes associated with the right solution

Reimplemented from TPZCompEl.

Definition at line 164 of file pzcondensedcompel.cpp.

References TPZCompEl::ComputeSolution(), and fReferenceCompEl.

◆ ComputeSolution() [4/4]

void TPZCondensedCompEl::ComputeSolution ( TPZVec< REAL > &  qsi,
TPZFMatrix< REAL > &  phi,
TPZFMatrix< REAL > &  dphix,
const TPZFMatrix< REAL > &  axes,
TPZSolVec sol,
TPZGradSolVec dsol 
)
overridevirtual

Computes solution and its derivatives in local coordinate qsi.

Parameters
qsimaster element coordinate
phimatrix containing shape functions compute in qsi point
dphixmatrix containing the derivatives of shape functions in the direction of the axes
axes[in] axes indicating the direction of the derivatives
solfinite element solution
dsolsolution derivatives

Reimplemented from TPZCompEl.

Definition at line 181 of file pzcondensedcompel.cpp.

References TPZCompEl::ComputeSolution(), and fReferenceCompEl.

◆ ConnectIndex()

virtual int64_t TPZCondensedCompEl::ConnectIndex ( int  i) const
inlineoverridevirtual

Returns the index of the ith connectivity of the element.

Parameters
iconnectivity index who want knows

Implements TPZCompEl.

Definition at line 79 of file pzcondensedcompel.h.

References TPZCompEl::ConnectIndex().

Referenced by BuildCornerConnectList(), CalcStiff(), LoadSolution(), and Resequence().

◆ CreateGraphicalElement()

virtual void TPZCondensedCompEl::CreateGraphicalElement ( TPZGraphMesh graphmesh,
int  dimension 
)
inlineoverridevirtual

Creates corresponding graphical element(s) if the dimension matches graphical elements are used to generate output files.

Parameters
graphmeshgraphical mesh where the element will be created
dimensiontarget dimension of the graphical element

Reimplemented from TPZCompEl.

Definition at line 254 of file pzcondensedcompel.h.

References TPZCompEl::CreateGraphicalElement().

◆ Dimension()

virtual int TPZCondensedCompEl::Dimension ( ) const
inlineoverridevirtual

Dimension of the element.

Implements TPZCompEl.

Definition at line 120 of file pzcondensedcompel.h.

References TPZCompEl::Dimension().

◆ EvaluateError()

void TPZCondensedCompEl::EvaluateError ( std::function< void(const TPZVec< REAL > &loc, TPZVec< STATE > &val, TPZFMatrix< STATE > &deriv)>  func,
TPZVec< REAL > &  errors,
bool  store_error 
)
inlineoverridevirtual

Performs an error estimate on the elemen.

Parameters
fpfunction pointer which computes the exact solution
errors[out] the L2 norm of the error of the solution
flux[in] value of the interpolated flux values

Reimplemented from TPZCompEl.

Definition at line 243 of file pzcondensedcompel.h.

References TPZCompEl::EvaluateError().

◆ HasMaterial()

bool TPZCondensedCompEl::HasMaterial ( const std::set< int > &  materialids) const
overridevirtual

Verifies if the material associated with the element is contained in the set.

Reimplemented from TPZCompEl.

Definition at line 566 of file pzcondensedcompel.cpp.

References fReferenceCompEl, and TPZCompEl::HasMaterial().

Referenced by IntegrateSolution().

◆ IntegrateSolution() [1/2]

virtual TPZVec<STATE> TPZCondensedCompEl::IntegrateSolution ( const std::string &  varname,
const std::set< int > &  matids 
)
inlineoverridevirtual

Compute the integral of a variable defined by the string if the material id is included in matids.

Reimplemented from TPZCompEl.

Definition at line 184 of file pzcondensedcompel.h.

References TPZCompEl::IntegrateSolution().

◆ IntegrateSolution() [2/2]

virtual TPZVec<STATE> TPZCondensedCompEl::IntegrateSolution ( int  var) const
inlineoverridevirtual

Compute the integral of a variable defined by the string if the material id is included in matids.

Reimplemented from TPZCompEl.

Definition at line 191 of file pzcondensedcompel.h.

References Assemble(), CalcResidual(), CalcStiff(), ComputeSolution(), HasMaterial(), and TPZCompEl::IntegrateSolution().

◆ LoadElementReference()

virtual void TPZCondensedCompEl::LoadElementReference ( )
inlineoverridevirtual

Loads the geometric element reference.

Reimplemented from TPZCompEl.

Definition at line 102 of file pzcondensedcompel.h.

References BuildCornerConnectList(), and TPZCompEl::LoadElementReference().

◆ LoadSolution()

void TPZCondensedCompEl::LoadSolution ( )
overridevirtual

Loads the solution within the internal data structure of the element.

Is used to initialize the solution of connect objects with dependency
Is also used to load the solution within SuperElements

Reimplemented from TPZCompEl.

Definition at line 632 of file pzcondensedcompel.cpp.

References TPZCompMesh::Block(), TPZCompEl::Connect(), ConnectIndex(), DebugStop, TPZMatRed< TVar, TSideMatrix >::Dim1(), fCondensed, TPZCompEl::Index(), TPZConnect::IsCondensed(), TPZMatRed< TVar, TSideMatrix >::K01(), TPZCompEl::LoadSolution(), LOGPZ_DEBUG, TPZCompEl::Mesh(), NConnects(), Norm(), TPZConnect::NShape(), TPZConnect::NState(), TPZMatrix< TVar >::Rows(), TPZConnect::SequenceNumber(), TPZBlock< TVar >::Size(), and TPZMatRed< TVar, TSideMatrix >::UGlobal().

Referenced by Clone().

◆ NConnects()

virtual int TPZCondensedCompEl::NConnects ( ) const
inlineoverridevirtual

Returns the number of nodes of the element.

Implements TPZCompEl.

Definition at line 70 of file pzcondensedcompel.h.

References TPZCompEl::NConnects().

Referenced by BuildCornerConnectList(), CalcStiff(), LoadSolution(), Resequence(), and Unwrap().

◆ NeedsComputing()

virtual bool TPZCondensedCompEl::NeedsComputing ( const std::set< int > &  materialids)
inlineoverridevirtual

return true if the element has a variational statement associated with the material ids

Reimplemented from TPZCompEl.

Definition at line 89 of file pzcondensedcompel.h.

References TPZCompEl::NeedsComputing().

◆ Print()

void TPZCondensedCompEl::Print ( std::ostream &  out = std::cout) const
overridevirtual

◆ ReferenceCompEl()

TPZCompEl* TPZCondensedCompEl::ReferenceCompEl ( )
inline

Definition at line 84 of file pzcondensedcompel.h.

References fReferenceCompEl.

Referenced by ComputeError(), and FillAtomic().

◆ Resequence()

void TPZCondensedCompEl::Resequence ( )
private

◆ SetConnectIndex()

void TPZCondensedCompEl::SetConnectIndex ( int  inode,
int64_t  index 
)
overridevirtual

Set the index i to node inode.

Parameters
inodenode to set index
indexindex to be seted

Implements TPZCompEl.

Definition at line 106 of file pzcondensedcompel.cpp.

References DebugStop, and LOGPZ_ERROR.

◆ SetKeepMatrix()

void TPZCondensedCompEl::SetKeepMatrix ( bool  keep)
inline

Set the flag that determines whether the matrix needs to be kept or not.

Definition at line 114 of file pzcondensedcompel.h.

Referenced by TPZHybridizeHDiv::GroupandCondenseElements().

◆ TransferMultiphysicsElementSolution()

virtual void TPZCondensedCompEl::TransferMultiphysicsElementSolution ( )
inlineoverridevirtual

◆ Unwrap()

void TPZCondensedCompEl::Unwrap ( )

Member Data Documentation

◆ fCondensed

TPZMatRed<STATE, TPZFMatrix<STATE> > TPZCondensedCompEl::fCondensed
private

Definition at line 38 of file pzcondensedcompel.h.

Referenced by CalcResidual(), CalcStiff(), ClonePatchEl(), LoadSolution(), and Resequence().

◆ fIndexes

TPZManVector<int64_t,27> TPZCondensedCompEl::fIndexes
private

◆ fKeepMatrix

bool TPZCondensedCompEl::fKeepMatrix
private

Definition at line 41 of file pzcondensedcompel.h.

Referenced by CalcResidual(), CalcStiff(), Resequence(), and TPZCondensedCompEl().

◆ fNumInternalEqs

int64_t TPZCondensedCompEl::fNumInternalEqs
private

Definition at line 36 of file pzcondensedcompel.h.

Referenced by CalcStiff(), and Resequence().

◆ fNumTotalEqs

int64_t TPZCondensedCompEl::fNumTotalEqs
private

Definition at line 37 of file pzcondensedcompel.h.

Referenced by CalcStiff(), and Resequence().

◆ fReferenceCompEl

TPZCompEl* TPZCondensedCompEl::fReferenceCompEl
private

The documentation for this class was generated from the following files: