37 static LoggerPtr logger(Logger::getLogger(
"pz.strmatrix.TPZStructMatrixST"));
38 static LoggerPtr loggerel(Logger::getLogger(
"pz.strmatrix.element"));
39 static LoggerPtr loggerel2(Logger::getLogger(
"pz.strmatrix.elementinterface"));
40 static LoggerPtr loggerelmat(Logger::getLogger(
"pz.strmatrix.elementmat"));
41 static LoggerPtr loggerCheck(Logger::getLogger(
"pz.strmatrix.checkconsistency"));
44 #ifdef CHECKCONSISTENCY 62 cout <<
"TPZStructMatrixST::Create should never be called\n";
67 cout <<
"TPZStructMatrixST::Clone should never be called\n";
80 if (stiffness.
Rows() != neqcondense) {
103 if(rhs.
Rows() != neqexpand ||
Norm(rhs) != 0.)
127 #pragma omp parallel for private(ek, ef) schedule(dynamic, 1) 193 if(guiInterface && guiInterface->
AmIKilled()){
201 if(guiInterface && guiInterface->
AmIKilled()){
209 int64_t cols =
MAX(1, rhs.
Cols());
213 if(loggerel->isDebugEnabled()) {
214 std::stringstream sout;
215 stiff->
Print(
"Stiffness matrix",sout);
216 rhs.
Print(
"Right hand side", sout);
int64_t NElements() const
Number of computational elements allocated.
Contains a class to record running statistics on CSV tables.
Contains TPZAnalysis class which implements the sequence of actions to perform a finite element analy...
void Scatter(const TPZFMatrix< TVar > &vsmall, TPZFMatrix< TVar > &vexpand) const
Contains definitions to LOGPZ_DEBUG, LOGPZ_INFO, LOGPZ_WARN, LOGPZ_ERROR and LOGPZ_FATAL, and the implementation of the inline InitializePZLOG(string) function using log4cxx library or not. It must to be called out of "#ifdef LOG4CXX" scope.
TPZEquationFilter fEquationFilter
Object which will determine which equations will be assembled.
Timing class. Absolutely copied from GNU time. Take a look at
Contains declaration of TPZGeoNode class which defines a geometrical node.
void AddFel(TPZFMatrix< TVar > &rhs, TPZVec< int64_t > &destination)
Performs a right hand side assemblage.
TPZFNMatrix< 1000, STATE > fMat
Pointer to a blocked matrix object.
virtual TPZMatrix< STATE > * CreateAssemble(TPZFMatrix< STATE > &rhs, TPZAutoPointer< TPZGuiInterface > guiInterface) override
Contains declaration of TPZCompEl class which defines the interface of a computational element...
Templated vector implementation.
virtual void CalcStiff(TPZElementMatrix &ek, TPZElementMatrix &ef)
Computes the element stifness matrix and right hand side.
virtual void FilterEquations(TPZVec< int64_t > &origindex, TPZVec< int64_t > &destindex) const override
Filter out the equations which are out of the range.
TPZCompMesh * fMesh
Pointer to the computational mesh from which the matrix will be generated.
Declarates the TPZBlock<REAL>class which implements block matrices.
#define MAX(a, b)
Gets maxime value between a and b.
int ClassId() const override
Define the class id associated with the class.
void Write(TPZStream &buf, int withclassid) const override
Writes this object to the TPZStream buffer. Include the classid if withclassid = true.
It is responsible for a interface among Matrix and Finite Element classes. Structural Matrix...
TPZManVector< int64_t > fDestinationIndex
void ComputeDestinationIndices()
virtual TPZStructMatrixST * Clone() override
Contains declaration of TPZElementMatrix struct which associates an element matrix with the coeficien...
static RunStatsTable ass_rhs("-ass_rhs", "Assemble Stiffness")
Contains declaration of TPZMesh class which defines a geometrical mesh and contains a corresponding l...
int64_t NActiveEquations() const
Retorna o numero de equacoes ativas do sistema.
virtual void ExecuteAssemble(TPZMatrix< STATE > *fGlobMatrix, TPZFMatrix< STATE > *fGlobRhs, TPZAutoPointer< TPZGuiInterface > guiInterface)
TVar Norm(const TPZFMatrix< TVar > &A)
Returns the norm of the matrix A.
Contains TPZMatrixclass which implements full matrix (using column major representation).
#define DebugStop()
Returns a message to user put a breakpoint in.
#define LOGPZ_DEBUG(A, B)
Define log for debug info.
Free store vector implementation.
int64_t Rows() const
Returns number of rows.
virtual void Assemble(TPZMatrix< STATE > &mat, TPZFMatrix< STATE > &rhs, TPZAutoPointer< TPZGuiInterface > guiInterface) override
Assemble the global system of equations into the matrix which has already been created.
virtual void AddKel(TPZFMatrix< TVar > &elmat, TPZVec< int64_t > &destinationindex)
Add a contribution of a stiffness matrix.
void Write(TPZStream &buf, int withclassid) const override
Writes this object to the TPZStream buffer. Include the classid if withclassid = true.
int64_t NEqExpand() const
Retorna o numero de equacoes do sistema original.
Implements an interface to check the consistency of two implementations. Utility. ...
TPZManVector< int64_t > fSourceIndex
Contains declaration of TPZCompMesh class which is a repository for computational elements...
int Redim(const int64_t newRows, const int64_t newCols) override
Redimension a matrix and ZERO your elements.
int ClassId() const override
Define the class id associated with the class.
int32_t Hash(std::string str)
This class associates an element matrix with the coeficients of its contribution in the global stiffn...
TPZFNMatrix< 1000, STATE > fConstrMat
Pointer to the constrained matrix object.
void ApplyConstraints()
Apply the constraints applied to the nodes by transforming the tangent matrix and right hand side...
Contains the TPZStructMatrixST class which responsible for a interface among Matrix and Finite Elemen...
Contains declaration of TPZSubCompMesh class which implements a group of computational elements as a ...
virtual void CalcResidual(TPZElementMatrix &ef)
Computes the element right hand side.
Implements computational mesh. Computational Mesh.
TPZAdmChunkVector< TPZCompEl * > & ElementVec()
Returns a reference to the element pointers vector.
void Read(TPZStream &buf, void *context) override
read objects from the stream
Contains declaration of TPZInterpolatedElement class which implements computational element of the in...
virtual TPZMatrix< STATE > * Create() override
int64_t Cols() const
Returns number of cols.
virtual void Print(std::ostream &out) const
Defines the interface for saving and reading data. Persistency.
static RunStatsTable ass_stiff("-ass_stiff", "Assemble Stiffness")
virtual void OnlyAssemble(TPZMatrix< STATE > *mat, TPZFMatrix< STATE > *rhs, TPZAutoPointer< TPZGuiInterface > guiInterface)
Assemble the global system of equations into the matrix which has already been created.
Defines the interface of a computational element. Computational Element.
virtual int HasDependency()
Returns 1 if the element has at least one dependent node. Returns 0 otherwise.
bool HasDependency()
Returns true if the element has at least one dependent node. Returns false otherwise.
void Read(TPZStream &buf, void *context) override
read objects from the stream
Implements an interface to register a class id and a restore function. Persistence.
Contains TPZSFMatrix class which implements a symmetric full matrix.