NeoPZ
Public Types | Public Member Functions | Private Member Functions | Private Attributes | List of all members
TPZSBFemElementGroup Class Reference

#include <TPZSBFemElementGroup.h>

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

Public Types

enum  EComputationMode { EStiff, EOnlyMass, EMass }
 

Public Member Functions

 TPZSBFemElementGroup ()
 
 TPZSBFemElementGroup (TPZCompMesh &mesh, int64_t &index)
 constructor More...
 
virtual void AddElement (TPZCompEl *cel)
 add an element to the element group More...
 
void ComputeMatrices (TPZElementMatrix &E0, TPZElementMatrix &E1, TPZElementMatrix &E2, TPZElementMatrix &M0)
 Computes the element stifness matrix and right hand side. More...
 
virtual void CalcStiff (TPZElementMatrix &ek, TPZElementMatrix &ef)
 Computes the element stifness matrix and right hand side. More...
 
void SetDensity (REAL density)
 set the density or specific heat of the material More...
 
void SetComputeOnlyMassMatrix ()
 Set the element to compute the mass matrix. More...
 
void SetComputeTimeDependent (REAL delt)
 Set the element to compute stiffness plus mass. More...
 
void SetComputeStiff ()
 
virtual void Print (std::ostream &out=std::cout) const
 Prints element data. More...
 
virtual void CalcResidual (TPZElementMatrix &ef)
 Computes the element right hand side. More...
 
virtual void LoadSolution ()
 Loads the solution within the internal data structure of the element. More...
 
virtual void LoadElementReference ()
 Loads the geometric element referece. More...
 
int64_t NumEigenValues ()
 
void LoadEigenVector (int64_t eig)
 Load the coeficients such that we visualize an eigenvector. More...
 
TPZVec< STATE > MultiplyingCoeficients ()
 
TPZVec< std::complex< double > > & EigenValues ()
 
TPZFMatrix< std::complex< double > > & Phi ()
 
TPZFMatrix< std::complex< double > > & PhiInverse ()
 
TPZFMatrix< STATE > & MassMatrix ()
 
TPZFMatrix< std::complex< double > > Coeficients ()
 
TPZFMatrix< double > PhiReal ()
 
TPZManVector< double > EigenvaluesReal ()
 
TPZFMatrix< double > CoeficientsReal ()
 
- Public Member Functions inherited from TPZElementGroup
 TPZElementGroup ()
 
 TPZElementGroup (TPZCompMesh &mesh, int64_t &index)
 
 TPZElementGroup (TPZCompMesh &mesh, const TPZElementGroup &copy)
 create a copy of the condensed computational element in the other mesh More...
 
virtual ~TPZElementGroup ()
 
void Unwrap ()
 put the elements in the element group back in the mesh and delete the element group More...
 
virtual int Dimension () const override
 Dimension of the element. More...
 
bool NeedsComputing (const std::set< int > &matids) override
 Verifies if any element needs to be computed corresponding to the material ids. More...
 
TPZStack< TPZCompEl *, 5 > GetElGroup ()
 
virtual int NConnects () const override
 Returns the number of nodes of the element. More...
 
virtual void BuildCornerConnectList (std::set< int64_t > &connectindexes) const override
 adds the connect indexes associated with base shape functions to the set More...
 
virtual int64_t ConnectIndex (int i) const override
 Returns the index of the ith connectivity of the element. More...
 
virtual TPZCompElClone (TPZCompMesh &mesh) const override
 Method for creating a copy of the element. More...
 
virtual void SetConnectIndex (int inode, int64_t index) override
 Set the index i to node inode. More...
 
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 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 CreateGraphicalElement (TPZGraphMesh &graphmesh, int dimension) override
 Creates corresponding graphical element(s) if the dimension matches graphical elements are used to generate output files. More...
 
virtual void Integrate (int variable, TPZVec< STATE > &value) override
 Integrates a variable over the element. More...
 
virtual void EvaluateError (std::function< void(const TPZVec< REAL > &loc, TPZVec< STATE > &val, TPZFMatrix< STATE > &deriv)> func, TPZVec< REAL > &errors, bool store_error) override
 Performs an error estimate on the elemen. More...
 
virtual bool HasMaterial (const std::set< int > &materialids) const override
 Verifies if the material associated with the element is contained in the set. 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 Assemble ()
 Computes the element stifness matrix and right hand side in an internal data structure. Used for initializing condensed element data structures. More...
 
virtual void Divide (int64_t index, TPZVec< int64_t > &subindex, int interpolate=0)
 Divide the computational element. If interpolate = 1, the solution is interpolated to the sub elements. More...
 
virtual void ProjectFlux (TPZElementMatrix &ek, TPZElementMatrix &ef)
 Projects the flux function on the finite element space. More...
 
virtual void ComputeError (int errorid, TPZVec< REAL > &error)
 ComputeError computes the element error estimator. More...
 
virtual void GetMemoryIndices (TPZVec< int64_t > &indices) const
 Get the indices of the vector of element memory associated with the integration points. More...
 
virtual void SetMemoryIndices (TPZVec< int64_t > &indices)
 Set the indices of the vector of element memory associated with the integration points. More...
 
virtual void PrepareIntPtIndices ()
 Prepare the vector of the material withmem with the correct integration point indexes. More...
 
virtual void ForcePrepareIntPtIndices ()
 PrepareIntPtIndices initializes the material damage varibles memory in the proper material class. More...
 
virtual void SetFreeIntPtIndices ()
 Frees the material damage varibles memory in the proper material class. More...
 
virtual 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 ComputeSolution (TPZVec< REAL > &qsi, TPZMaterialData &data)
 
virtual void ComputeSolution (TPZVec< REAL > &qsi, TPZSolVec &sol, TPZGradSolVec &dsol, TPZFMatrix< REAL > &axes)
 Computes solution and its derivatives in the local coordinate qsi. More...
 
virtual void ComputeSolution (TPZVec< REAL > &qsi, TPZVec< REAL > &normal, TPZSolVec &leftsol, TPZGradSolVec &dleftsol, TPZFMatrix< REAL > &leftaxes, TPZSolVec &rightsol, TPZGradSolVec &drightsol, TPZFMatrix< REAL > &rightaxes)
 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)
 Computes solution and its derivatives in local coordinate qsi. 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 ComputeMassMatrix (TPZElementMatrix &M0)
 Compute the mass matrix based on the value of M0 and the eigenvectors. More...
 

Private Attributes

TPZFMatrix< std::complex< double > > fPhi
 Matrix of eigenvectors which compose the stiffness matrix. More...
 
TPZFMatrix< std::complex< double > > fPhiInverse
 Inverse of the eigenvector matrix (transfers eigenvector coeficients to side shape coeficients) More...
 
TPZManVector< std::complex< double > > fEigenvalues
 Vector of eigenvalues of the SBFem analyis. More...
 
TPZFMatrix< std::complex< double > > fCoef
 Multiplying coefficients of each eigenvector. More...
 
TPZFMatrix< STATE > fMassMatrix
 
EComputationMode fComputationMode
 
REAL fMassDensity
 multiplier to multiply the mass matrix More...
 
REAL fDelt
 timestep coeficient More...
 

Additional Inherited Members

- Static Public Member Functions inherited from TPZCompEl
static int StaticClassId ()
 
static void SetgOrder (int order)
 Sets the value of the default interpolation order. More...
 
static int GetgOrder ()
 Set the default value of the interpolation order. More...
 
static void SetOrthogonalFunction (void(*orthogonal)(REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi))
 Sets the orthogonal function which will be used throughout the program by default this function is the Chebyshev function. More...
 
static void Chebyshev (REAL x, int num, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi)
 Implements of the orthogonal Chebyshev functions. More...
 
- Static Public Member Functions inherited from TPZSavable
static std::set< TPZRestoreClassBase * > & RestoreClassSet ()
 This static function guarantees that the gMap object is available when needed. More...
 
static std::map< int, TPZRestore_t > & ClassIdMap ()
 This static function guarantees that the gMap object is available when needed. More...
 
static std::pair< std::string, uint64_t > NeoPZVersion ()
 
static void Register (TPZRestoreClassBase *restore)
 
static void RegisterClassId (int classid, TPZRestore_t fun)
 
static TPZSavableCreateInstance (const int &classId)
 
- Protected Member Functions inherited from TPZElementGroup
void InitializeElementMatrix (TPZElementMatrix &ek, TPZElementMatrix &ef) const
 Initialize the datastructure of ek and ef based on the connect information. More...
 
void InitializeElementMatrix (TPZElementMatrix &ef) const
 Initialize the datastructure of ef based on the connect information. More...
 
- Protected Attributes inherited from TPZElementGroup
TPZStack< TPZCompEl *, 5 > fElGroup
 
TPZManVector< int64_t, 27 > fConnectIndexes
 
std::map< int64_t, TPZOneShapeRestraintfRestraints
 
- 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

Definition at line 18 of file TPZSBFemElementGroup.h.

Member Enumeration Documentation

◆ EComputationMode

Enumerator
EStiff 
EOnlyMass 
EMass 

Definition at line 22 of file TPZSBFemElementGroup.h.

Constructor & Destructor Documentation

◆ TPZSBFemElementGroup() [1/2]

TPZSBFemElementGroup::TPZSBFemElementGroup ( )
inline

Definition at line 53 of file TPZSBFemElementGroup.h.

◆ TPZSBFemElementGroup() [2/2]

TPZSBFemElementGroup::TPZSBFemElementGroup ( TPZCompMesh mesh,
int64_t &  index 
)
inline

constructor

Definition at line 59 of file TPZSBFemElementGroup.h.

References AddElement(), CalcStiff(), and ComputeMatrices().

Member Function Documentation

◆ AddElement()

void TPZSBFemElementGroup::AddElement ( TPZCompEl cel)
virtual

◆ CalcResidual()

virtual void TPZSBFemElementGroup::CalcResidual ( TPZElementMatrix ef)
inlinevirtual

Computes the element right hand side.

Parameters
efelement load vector(s)

Reimplemented from TPZElementGroup.

Definition at line 161 of file TPZSBFemElementGroup.h.

References CalcStiff(), TPZElementMatrix::EK, LoadSolution(), and TPZCompEl::Mesh().

◆ CalcStiff()

void TPZSBFemElementGroup::CalcStiff ( TPZElementMatrix ek,
TPZElementMatrix ef 
)
virtual

◆ Coeficients()

TPZFMatrix<std::complex<double> > TPZSBFemElementGroup::Coeficients ( )
inline

Definition at line 225 of file TPZSBFemElementGroup.h.

References fCoef.

◆ CoeficientsReal()

TPZFMatrix<double> TPZSBFemElementGroup::CoeficientsReal ( )
inline

◆ ComputeMassMatrix()

void TPZSBFemElementGroup::ComputeMassMatrix ( TPZElementMatrix M0)
private

Compute the mass matrix based on the value of M0 and the eigenvectors.

Definition at line 548 of file TPZSBFemElementGroup.cpp.

References fEigenvalues, fMassMatrix, TPZElementMatrix::fMat, fPhi, fPhiInverse, TPZFMatrix< TVar >::MultAdd(), TPZMatrix< TVar >::Multiply(), TPZFMatrix< TVar >::Redim(), and TPZVec< T >::size().

Referenced by CalcStiff().

◆ ComputeMatrices()

void TPZSBFemElementGroup::ComputeMatrices ( TPZElementMatrix E0,
TPZElementMatrix E1,
TPZElementMatrix E2,
TPZElementMatrix M0 
)

◆ EigenValues()

TPZVec<std::complex<double> >& TPZSBFemElementGroup::EigenValues ( )
inline

Definition at line 205 of file TPZSBFemElementGroup.h.

References fEigenvalues.

◆ EigenvaluesReal()

TPZManVector<double> TPZSBFemElementGroup::EigenvaluesReal ( )
inline

Definition at line 244 of file TPZSBFemElementGroup.h.

References TPZVec< T >::NElements().

◆ LoadEigenVector()

void TPZSBFemElementGroup::LoadEigenVector ( int64_t  eig)

Load the coeficients such that we visualize an eigenvector.

Definition at line 590 of file TPZSBFemElementGroup.cpp.

References DebugStop, fCoef, TPZElementGroup::fElGroup, TPZSBFemVolume::LoadCoef(), TPZVec< T >::size(), and TPZFMatrix< TVar >::Zero().

Referenced by NumEigenValues().

◆ LoadElementReference()

virtual void TPZSBFemElementGroup::LoadElementReference ( )
inlinevirtual

Loads the geometric element referece.

Reimplemented from TPZElementGroup.

Definition at line 176 of file TPZSBFemElementGroup.h.

References TPZElementGroup::fElGroup, and TPZVec< T >::size().

◆ LoadSolution()

void TPZSBFemElementGroup::LoadSolution ( )
virtual

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 TPZElementGroup.

Definition at line 512 of file TPZSBFemElementGroup.cpp.

References TPZCompMesh::Block(), TPZMatrix< TVar >::Cols(), TPZCompEl::Connect(), DebugStop, fCoef, TPZElementGroup::fElGroup, TPZCompEl::fMesh, fPhi, fPhiInverse, TPZSBFemVolume::LoadCoef(), TPZMatrix< TVar >::Multiply(), TPZElementGroup::NConnects(), TPZConnect::NShape(), TPZConnect::NState(), TPZBlock< TVar >::Position(), TPZMatrix< TVar >::Rows(), TPZConnect::SequenceNumber(), TPZVec< T >::size(), and TPZCompMesh::Solution().

Referenced by CalcResidual().

◆ MassMatrix()

TPZFMatrix<STATE>& TPZSBFemElementGroup::MassMatrix ( )
inline

Definition at line 220 of file TPZSBFemElementGroup.h.

References fMassMatrix.

◆ MultiplyingCoeficients()

TPZVec<STATE> TPZSBFemElementGroup::MultiplyingCoeficients ( )
inline

method to compute the stiffness method to compute the solution

Definition at line 195 of file TPZSBFemElementGroup.h.

References fCoef, and TPZMatrix< TVar >::Rows().

◆ NumEigenValues()

int64_t TPZSBFemElementGroup::NumEigenValues ( )
inline

Definition at line 185 of file TPZSBFemElementGroup.h.

References LoadEigenVector(), and TPZVec< T >::size().

◆ Phi()

TPZFMatrix<std::complex<double> >& TPZSBFemElementGroup::Phi ( )
inline

Definition at line 210 of file TPZSBFemElementGroup.h.

References fPhi.

◆ PhiInverse()

TPZFMatrix<std::complex<double> >& TPZSBFemElementGroup::PhiInverse ( )
inline

Definition at line 215 of file TPZSBFemElementGroup.h.

References fPhiInverse.

Referenced by TPZSBFemVolume::Shape().

◆ PhiReal()

TPZFMatrix<double> TPZSBFemElementGroup::PhiReal ( )
inline

◆ Print()

virtual void TPZSBFemElementGroup::Print ( std::ostream &  out = std::cout) const
inlinevirtual

Prints element data.

Parameters
outIndicates the device where the data will be printed

Reimplemented from TPZElementGroup.

Definition at line 110 of file TPZSBFemElementGroup.h.

References TPZCompEl::ConnectIndex(), DebugStop, TPZElementGroup::fElGroup, TPZCompEl::NConnects(), TPZElementGroup::Print(), TPZVec< T >::size(), and TPZSBFemVolume::SkeletonIndex().

◆ SetComputeOnlyMassMatrix()

void TPZSBFemElementGroup::SetComputeOnlyMassMatrix ( )
inline

Set the element to compute the mass matrix.

Definition at line 86 of file TPZSBFemElementGroup.h.

References DebugStop, EOnlyMass, and TPZMatrix< TVar >::Rows().

◆ SetComputeStiff()

void TPZSBFemElementGroup::SetComputeStiff ( )
inline

Definition at line 102 of file TPZSBFemElementGroup.h.

References EStiff.

◆ SetComputeTimeDependent()

void TPZSBFemElementGroup::SetComputeTimeDependent ( REAL  delt)
inline

Set the element to compute stiffness plus mass.

Definition at line 96 of file TPZSBFemElementGroup.h.

References EMass.

◆ SetDensity()

void TPZSBFemElementGroup::SetDensity ( REAL  density)
inline

set the density or specific heat of the material

Definition at line 81 of file TPZSBFemElementGroup.h.

Member Data Documentation

◆ fCoef

TPZFMatrix<std::complex<double> > TPZSBFemElementGroup::fCoef
private

Multiplying coefficients of each eigenvector.

Definition at line 36 of file TPZSBFemElementGroup.h.

Referenced by Coeficients(), CoeficientsReal(), LoadEigenVector(), LoadSolution(), and MultiplyingCoeficients().

◆ fComputationMode

EComputationMode TPZSBFemElementGroup::fComputationMode
private

Definition at line 40 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff().

◆ fDelt

REAL TPZSBFemElementGroup::fDelt
private

timestep coeficient

Definition at line 46 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff().

◆ fEigenvalues

TPZManVector<std::complex<double> > TPZSBFemElementGroup::fEigenvalues
private

Vector of eigenvalues of the SBFem analyis.

Definition at line 33 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff(), ComputeMassMatrix(), and EigenValues().

◆ fMassDensity

REAL TPZSBFemElementGroup::fMassDensity
private

multiplier to multiply the mass matrix

Definition at line 43 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff().

◆ fMassMatrix

TPZFMatrix<STATE> TPZSBFemElementGroup::fMassMatrix
private

Definition at line 38 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff(), ComputeMassMatrix(), and MassMatrix().

◆ fPhi

TPZFMatrix<std::complex<double> > TPZSBFemElementGroup::fPhi
private

Matrix of eigenvectors which compose the stiffness matrix.

Definition at line 27 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff(), ComputeMassMatrix(), LoadSolution(), Phi(), and PhiReal().

◆ fPhiInverse

TPZFMatrix<std::complex<double> > TPZSBFemElementGroup::fPhiInverse
private

Inverse of the eigenvector matrix (transfers eigenvector coeficients to side shape coeficients)

Definition at line 30 of file TPZSBFemElementGroup.h.

Referenced by CalcStiff(), ComputeMassMatrix(), LoadSolution(), and PhiInverse().


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