NeoPZ
|
Implements the sequence of actions to perform a finite element analysis. Analysis. More...
#include <pzanalysis.h>
Classes | |
struct | ThreadData |
class | TTablePostProcess |
Datastructure which defines postprocessing for one dimensional meshes. More... | |
Public Types | |
enum | EPrecond { EJacobi, EBlockJacobi, EElement, ENodeCentered } |
Preconditioners which can be created by objects of this class. More... | |
Public Member Functions | |
TPZAnalysis (TPZCompMesh *mesh, bool mustOptimizeBandwidth=true, std::ostream &out=std::cout) | |
Create an TPZAnalysis object from one mesh pointer. More... | |
TPZAnalysis (TPZAutoPointer< TPZCompMesh > mesh, bool mustOptimizeBandwidth=true, std::ostream &out=std::cout) | |
Create an TPZAnalysis object from one mesh auto pointer object. More... | |
void | SetGuiInterface (TPZAutoPointer< TPZGuiInterface > gui) |
Defines gui interface object. More... | |
TPZAutoPointer< TPZGuiInterface > | GetGuiInterface () const |
Gets gui interface object. More... | |
bool | AmIKilled () |
Returns if the process was canceled through gui interface. More... | |
virtual void | SetCompMesh (TPZCompMesh *mesh, bool mustOptimizeBandwidth) |
Set the computational mesh of the analysis. More... | |
TPZAnalysis () | |
Create an empty TPZAnalysis object. More... | |
void | Write (TPZStream &buf, int withclassid) const override |
Writes this object to the TPZStream buffer. Include the classid if withclassid = true. More... | |
void | Read (TPZStream &buf, void *context) override |
read objects from the stream More... | |
virtual | ~TPZAnalysis (void) |
Destructor: deletes all protected dynamic allocated objects. More... | |
void | CleanUp () |
deletes all data structures More... | |
void | SetRenumber (TPZAutoPointer< TPZRenumbering > renumber) |
Change the renumbering scheme. More... | |
void | OptimizeBandwidth () |
Sets the computer connection block number from the graphical connections block number otimization. More... | |
int | HighestDimension () |
Returns the dimension of the material which has the highest dimension. More... | |
void | Resequence (int firstel=-1) |
Recompute the node sequence. More... | |
int | ComputeNumberofLoadCases () |
Determine the number of load cases from the material objects and return its value. More... | |
virtual void | Assemble () |
Assemble the stiffness matrix and load vector. More... | |
virtual void | AssembleResidual () |
Assemble the load vector. More... | |
virtual void | Solve () |
Invert the stiffness matrix. More... | |
TPZFMatrix< STATE > & | Rhs () |
Returns the load vector. More... | |
TPZFMatrix< STATE > & | Solution () |
Returns the solution matrix. More... | |
TPZCompMesh * | Mesh () const |
Returns the pointer to the computational mesh. More... | |
TPZAutoPointer< TPZStructMatrix > | StructMatrix () |
Returns a reference to the structural matrix. More... | |
TPZMatrixSolver< STATE > * | BuildPreconditioner (EPrecond preconditioner, bool overlap) |
Define the type of preconditioner used. More... | |
void | SetStep (int step) |
ste the step for post processing More... | |
void | SetThreadsForError (int nthreads) |
int | GetStep () |
void | SetTime (REAL time) |
Sets time will be used in dx files. More... | |
REAL | GetTime () |
Gets time used in dx files. More... | |
void | ShowShape (const std::string &plotfile, TPZVec< int64_t > &equationindices) |
Graphic of the solution as V3DGrap visualization. More... | |
void | ShowShape (const std::string &plotfile, TPZVec< int64_t > &equationindices, int matid, const TPZVec< std::string > &varname) |
Graphic of the solution as V3DGrap visualization. More... | |
void | LoadShape (double dx, double dy, int64_t numelem, TPZConnect *nod) |
Make assembling and clean the load and solution vectors. More... | |
virtual void | Run (std::ostream &out=std::cout) |
Calls the appropriate sequence of methods to build a solution or a time stepping sequence. More... | |
virtual void | DefineGraphMesh (int dimension, const TPZVec< std::string > &scalnames, const TPZVec< std::string > &vecnames, const std::string &plotfile) |
Define GrapMesh as V3D, DX, MV or VTK depending on extension of the file. More... | |
virtual void | DefineGraphMesh (int dimension, const TPZVec< std::string > &scalnames, const TPZVec< std::string > &vecnames, const TPZVec< std::string > &tensnames, const std::string &plotfile) |
Define GrapMesh as VTK with tensorial names depending on extension of the file. More... | |
virtual void | DefineGraphMesh (int dimension, const std::set< int > &matids, const TPZVec< std::string > &scalnames, const TPZVec< std::string > &vecnames, const std::string &plotfile) |
Define GrapMesh as V3D, DX, MV or VTK depending on extension of the file. More... | |
virtual void | DefineGraphMesh (int dimension, const std::set< int > &matids, const TPZVec< std::string > &scalnames, const TPZVec< std::string > &vecnames, const TPZVec< std::string > &tensnames, const std::string &plotfile) |
Define GrapMesh as VTK with tensorial names depending on extension of the file. More... | |
virtual void | CloseGraphMesh () |
Clean the GrapMesh vector. More... | |
TPZGraphMesh * | GraphMesh (int dimension) |
Defines the postprocessing parameters for the graphical grid. More... | |
virtual void | PostProcess (int resolution) |
Draw solution over mesh for all dimensions. More... | |
virtual void | PostProcess (int resolution, int dimension) |
Draw solution over mesh by dimension. More... | |
void | IdentifyPostProcessingMatIds (int dimension, std::set< int > &matids) |
Fill mat ids with materials with provided dimension wich are not boundary conditinos or interface. More... | |
virtual void | LoadSolution () |
Load the solution into the computable grid. More... | |
virtual void | LoadSolution (const TPZFMatrix< STATE > &sol) |
Load the solution into the computable mesh considering sol as Solution vector of the analysis. More... | |
TPZVec< STATE > | Integrate (const std::string &varname, const std::set< int > &matids) |
Integrate the postprocessed variable name over the elements included in the set matids. More... | |
void | SetExact (std::function< void(const TPZVec< REAL > &loc, TPZVec< STATE > &result, TPZFMatrix< STATE > &deriv)> f) |
Sets the pointer of the exact solution function. More... | |
virtual void | PostProcess (TPZVec< REAL > &loc, std::ostream &out=std::cout) |
Compute the local error over all elements and global errors in several norms and print out. More... | |
virtual void | PostProcessError (TPZVec< REAL > &, bool store_error=true, std::ostream &out=std::cout) |
Compute the local error over all elements and global errors in several norms and print out without calculating the errors of the variables for hdiv spaces. More... | |
virtual void | PostProcessErrorSerial (TPZVec< REAL > &, bool store_error=true, std::ostream &out=std::cout) |
virtual void | PostProcessErrorParallel (TPZVec< REAL > &, bool store_error=true, std::ostream &out=std::cout) |
void | CreateListOfCompElsToComputeError (TPZAdmChunkVector< TPZCompEl *> &elvec) |
void | Print (const std::string &name, std::ostream &out) |
Print connect and solution information. More... | |
void | PrintVectorByElement (std::ostream &out, TPZFMatrix< STATE > &vec, REAL tol=1.e-10) |
Print the residual vector for those elements with entry above a given tolerance. More... | |
TPZMatrixSolver< STATE > & | Solver () |
Get the solver matrix. More... | |
void | AnimateRun (int64_t num_iter, int steps, TPZVec< std::string > &scalnames, TPZVec< std::string > &vecnames, const std::string &plotfile) |
Run and print the solution step by step. More... | |
void | SetSolver (TPZMatrixSolver< STATE > &solver) |
Set solver matrix. More... | |
void | SetStructuralMatrix (TPZAutoPointer< TPZStructMatrix > strmatrix) |
Set structural matrix as auto pointer for analysis. More... | |
void | SetStructuralMatrix (TPZStructMatrix &strmatrix) |
Set structural matrix for analysis. More... | |
int | ClassId () const override |
Define the class id associated with the class. More... | |
Related over data structure to post processing | |
virtual void | DefineElementTable (int dimension, TPZVec< int64_t > &GeoElIds, TPZVec< REAL > &points) |
Fill the computational element vector to post processing depending over geometric mesh defined. More... | |
virtual void | SetTableVariableNames (TPZVec< std::string > varnames) |
Sets the names of the variables into the data structure for post processing. More... | |
virtual void | PrePostProcessTable (std::ostream &out_file) |
Prepare data to print post processing and print coordinates. More... | |
virtual void | PostProcessTable (std::ostream &out_file) |
Print the solution related with the computational element vector in post process. More... | |
void | PostProcessTable (TPZFMatrix< REAL > &pos, std::ostream &out=std::cout) |
Compute and print the local error over all elements in data structure of post process, also compute global errors in several norms. 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 | |
Public Attributes | |
std::function< void(const TPZVec< REAL > &loc, TPZVec< STATE > &result, TPZFMatrix< STATE > &deriv)> | fExact |
Pointer to Exact solution function, it is necessary to calculating errors. More... | |
Protected Attributes | |
TPZGeoMesh * | fGeoMesh |
Geometric Mesh. More... | |
TPZCompMesh * | fCompMesh |
Computational mesh. More... | |
TPZGraphMesh * | fGraphMesh [3] |
Graphical mesh. More... | |
TPZFMatrix< STATE > | fRhs |
Load vector. More... | |
TPZFMatrix< STATE > | fSolution |
Solution vector. More... | |
TPZMatrixSolver< STATE > * | fSolver |
Type of solver to be applied. More... | |
TPZVec< std::string > | fScalarNames [3] |
Scalar variables names - to post process. More... | |
TPZVec< std::string > | fVectorNames [3] |
Vectorial variables names - to post process. More... | |
TPZVec< std::string > | fTensorNames [3] |
Tensorial variables names - to post process. More... | |
int | fStep |
Time step. More... | |
REAL | fTime |
Time variable which is used in dx output. More... | |
int | fNthreadsError |
Number of threads to be used for post-processing error. More... | |
TPZAutoPointer< TPZStructMatrix > | fStructMatrix |
Structural matrix. More... | |
TPZAutoPointer< TPZRenumbering > | fRenumber |
Renumbering scheme. More... | |
TPZAutoPointer< TPZGuiInterface > | fGuiInterface |
Pointer for gui interface object. More... | |
TTablePostProcess | fTable |
Private Member Functions | |
TPZMatrixSolver< STATE > * | BuildSequenceSolver (TPZVec< int64_t > &graph, TPZVec< int64_t > &graphindex, int64_t neq, int numcolors, TPZVec< int > &colors) |
Build a sequence solver based on the block graph and its colors. More... | |
Friends | |
struct | ThreadData |
Additional Inherited Members | |
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) |
Implements the sequence of actions to perform a finite element analysis. Analysis.
This class will renumerate the nodes upon construction
Definition at line 32 of file pzanalysis.h.
Preconditioners which can be created by objects of this class.
Enumerator | |
---|---|
EJacobi | |
EBlockJacobi | |
EElement | |
ENodeCentered |
Definition at line 37 of file pzanalysis.h.
TPZAnalysis::TPZAnalysis | ( | TPZCompMesh * | mesh, |
bool | mustOptimizeBandwidth = true , |
||
std::ostream & | out = std::cout |
||
) |
Create an TPZAnalysis object from one mesh pointer.
Definition at line 94 of file pzanalysis.cpp.
References fGraphMesh, and SetCompMesh().
TPZAnalysis::TPZAnalysis | ( | TPZAutoPointer< TPZCompMesh > | mesh, |
bool | mustOptimizeBandwidth = true , |
||
std::ostream & | out = std::cout |
||
) |
Create an TPZAnalysis object from one mesh auto pointer object.
Definition at line 104 of file pzanalysis.cpp.
References fGraphMesh, and SetCompMesh().
TPZAnalysis::TPZAnalysis | ( | ) |
Create an empty TPZAnalysis object.
Definition at line 85 of file pzanalysis.cpp.
References fGraphMesh.
Referenced by AmIKilled().
|
virtual |
Destructor: deletes all protected dynamic allocated objects.
Definition at line 166 of file pzanalysis.cpp.
References CleanUp().
Referenced by AmIKilled().
|
inline |
Returns if the process was canceled through gui interface.
Definition at line 118 of file pzanalysis.h.
References TPZGuiInterface::AmIKilled(), CleanUp(), TPZAnalysis::TTablePostProcess::Read(), SetCompMesh(), TPZAnalysis(), TPZAnalysis::TTablePostProcess::Write(), and ~TPZAnalysis().
Referenced by TPZSubCompMesh::CalcStiff().
void TPZAnalysis::AnimateRun | ( | int64_t | num_iter, |
int | steps, | ||
TPZVec< std::string > & | scalnames, | ||
TPZVec< std::string > & | vecnames, | ||
const std::string & | plotfile | ||
) |
Run and print the solution step by step.
Definition at line 1068 of file pzanalysis.cpp.
References Assemble(), TPZDXGraphMesh::DrawMesh(), TPZDXGraphMesh::DrawSolution(), fCompMesh, fRhs, fSolution, fSolver, HighestDimension(), IdentifyPostProcessingMatIds(), TPZCompMesh::LoadSolution(), TPZCompMesh::NEquations(), TPZMatrix< TVar >::Rows(), TPZDXGraphMesh::SetFileName(), TPZStepSolver< TVar >::SetJacobi(), TPZGraphMesh::SetResolution(), SetSolver(), TPZMatrixSolver< TVar >::ShareMatrix(), TPZSolver< TVar >::Solve(), and Solver().
Referenced by LoadSolution().
|
virtual |
Assemble the stiffness matrix and load vector.
Reimplemented in TPZEulerAnalysis, TPZSubMeshAnalysis, TPZTransientAnalysis< TRANSIENTCLASS >, and TPZPostProcAnalysis.
Definition at line 304 of file pzanalysis.cpp.
References ComputeNumberofLoadCases(), fCompMesh, fGuiInterface, fRhs, fSolver, fStructMatrix, LOGPZ_DEBUG, LOGPZ_ERROR, TPZMatrixSolver< TVar >::Matrix(), TPZCompMesh::NEquations(), PrintVectorByElement(), TPZFMatrix< TVar >::Redim(), TPZMatrix< TVar >::Rows(), TPZMatrixSolver< TVar >::SetMatrix(), TPZMatrixSolver< TVar >::UpdateFrom(), and TPZMatrix< TVar >::Zero().
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), AnimateRun(), TPZSubCompMesh::Assemble(), Input::CreateCuboSkyMatrix(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZNonLinearAnalysis::IterativeProcess(), LoadShape(), main(), PYBIND11_MODULE(), TPZSubMeshFrontalAnalysis::Run(), Run(), and SetRenumber().
|
virtual |
Assemble the load vector.
Definition at line 288 of file pzanalysis.cpp.
References ComputeNumberofLoadCases(), DebugStop, fGuiInterface, fStructMatrix, Mesh(), TPZCompMesh::NEquations(), TPZFMatrix< TVar >::Redim(), and Rhs().
Referenced by TPZElastoPlasticAnalysis::AcceptSolution(), TPZSubCompMesh::CalcResidual(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZNonLinearAnalysis::IterativeProcess(), TPZElastoPlasticAnalysis::IterativeProcessPrecomputedMatrix(), TPZElastoPlasticAnalysis::LineSearch(), TPZNonLinearAnalysis::LineSearch(), main(), PYBIND11_MODULE(), SetRenumber(), and TPZPostProcAnalysis::TransferSolution().
TPZMatrixSolver< STATE > * TPZAnalysis::BuildPreconditioner | ( | EPrecond | preconditioner, |
bool | overlap | ||
) |
Define the type of preconditioner used.
This method will create the stiffness matrix but without assembling
Definition at line 1207 of file pzanalysis.cpp.
References TPZNodesetCompute::AnalyseGraph(), TPZBlockDiagonalStructMatrix::AssembleBlockDiagonal(), TPZCompMesh::Block(), TPZNodesetCompute::BuildElementGraph(), TPZNodesetCompute::BuildNodeGraph(), BuildSequenceSolver(), TPZNodesetCompute::BuildVertexGraph(), TPZNodesetCompute::ColorGraph(), TPZCompMesh::ComputeElGraph(), TPZRenumbering::ConvertGraph(), EBlockJacobi, EElement, EJacobi, ELU, ENodeCentered, TPZNodesetCompute::ExpandGraph(), fCompMesh, fSolver, LOGPZ_DEBUG, TPZMatrixSolver< TVar >::Matrix(), TPZVec< T >::NElements(), TPZCompMesh::NEquations(), TPZCompMesh::NIndependentConnects(), TPZNodesetCompute::Nodegraph(), TPZNodesetCompute::Nodegraphindex(), and TPZStepSolver< TVar >::SetDirect().
Referenced by StructMatrix().
|
private |
Build a sequence solver based on the block graph and its colors.
Definition at line 1303 of file pzanalysis.cpp.
References TPZSequenceSolver< TVar >::AppendSolver(), ELU, fSolver, TPZMatrixSolver< TVar >::Matrix(), and TPZMatrixSolver< TVar >::ShareMatrix().
Referenced by BuildPreconditioner(), and GetStep().
|
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 TPZPostProcAnalysis, and TPZSubMeshAnalysis.
Definition at line 1459 of file pzanalysis.cpp.
References Hash().
Referenced by TPZSubMeshAnalysis::ClassId(), and TPZPostProcAnalysis::ClassId().
void TPZAnalysis::CleanUp | ( | ) |
deletes all data structures
Definition at line 171 of file pzanalysis.cpp.
References fCompMesh, fGeoMesh, fGraphMesh, fGuiInterface, fRenumber, fRhs, fScalarNames, fSolution, fSolver, fStructMatrix, fVectorNames, TPZFMatrix< TVar >::Redim(), and TPZVec< T >::resize().
Referenced by AmIKilled(), TPZPostProcAnalysis::SetCompMesh(), SetCompMesh(), and ~TPZAnalysis().
|
virtual |
Clean the GrapMesh vector.
Definition at line 1022 of file pzanalysis.cpp.
References fGraphMesh.
Referenced by GetStep().
int TPZAnalysis::ComputeNumberofLoadCases | ( | ) |
Determine the number of load cases from the material objects and return its value.
this method will modify the material objects so that they have all the same number of load cases the number of load cases is the maximum value of load cases of all material objects
Definition at line 263 of file pzanalysis.cpp.
References fCompMesh, TPZCompMesh::MaterialVec(), TPZMaterial::MinimumNumberofLoadCases(), test::res, and TPZMaterial::SetNumLoadCases().
Referenced by Assemble(), AssembleResidual(), and SetRenumber().
void TPZAnalysis::CreateListOfCompElsToComputeError | ( | TPZAdmChunkVector< TPZCompEl *> & | elvec | ) |
Definition at line 586 of file pzanalysis.cpp.
References bc, TPZCompMesh::ElementVec(), fCompMesh, TPZCompEl::Material(), TPZChunkVector< T, EXP >::NElements(), TPZCompMesh::NEquations(), and TPZAdmChunkVector< T, EXP >::Resize().
Referenced by LoadSolution(), and PostProcessErrorParallel().
|
virtual |
Fill the computational element vector to post processing depending over geometric mesh defined.
Definition at line 1139 of file pzanalysis.cpp.
References dimension, TPZAnalysis::TTablePostProcess::fCompElPtr, TPZAnalysis::TTablePostProcess::fDimension, TPZAnalysis::TTablePostProcess::fGeoElId, fGeoMesh, TPZGeoMesh::FindElement(), TPZAnalysis::TTablePostProcess::fLocations, fTable, TPZVec< T >::NElements(), numel, TPZGeoEl::Reference(), and TPZVec< T >::Resize().
Referenced by GraphMesh().
|
virtual |
Define GrapMesh as V3D, DX, MV or VTK depending on extension of the file.
Definition at line 952 of file pzanalysis.cpp.
References IdentifyPostProcessingMatIds().
Referenced by DefineGraphMesh(), GetStep(), TPZAnalysisError::PlotLocal(), PosProcessSol(), PYBIND11_MODULE(), TCedricTest::Run(), TPZBuildMultiphysicsMesh::ShowShape(), and ShowShape().
|
virtual |
Define GrapMesh as VTK with tensorial names depending on extension of the file.
Definition at line 959 of file pzanalysis.cpp.
References DefineGraphMesh(), and IdentifyPostProcessingMatIds().
|
virtual |
Define GrapMesh as V3D, DX, MV or VTK depending on extension of the file.
Definition at line 1015 of file pzanalysis.cpp.
References DefineGraphMesh().
|
virtual |
Define GrapMesh as VTK with tensorial names depending on extension of the file.
Definition at line 965 of file pzanalysis.cpp.
References fCompMesh, fGraphMesh, fScalarNames, fVectorNames, TPZGraphMesh::SetFileName(), and TPZVec< T >::size().
|
inline |
|
inline |
Definition at line 205 of file pzanalysis.h.
References BuildSequenceSolver(), CloseGraphMesh(), DefineGraphMesh(), dimension, dx(), fStep, GetTime(), LoadShape(), Run(), SetTime(), and ShowShape().
|
inline |
Gets time used in dx files.
Definition at line 375 of file pzanalysis.h.
References fTime.
Referenced by GetStep().
|
inline |
Defines the postprocessing parameters for the graphical grid.
Definition at line 243 of file pzanalysis.h.
References DefineElementTable(), IdentifyPostProcessingMatIds(), LoadSolution(), PostProcess(), PostProcessTable(), PrePostProcessTable(), and SetTableVariableNames().
int TPZAnalysis::HighestDimension | ( | ) |
Returns the dimension of the material which has the highest dimension.
Definition at line 1099 of file pzanalysis.cpp.
References fCompMesh, and TPZCompMesh::MaterialVec().
Referenced by AnimateRun(), and SetRenumber().
void TPZAnalysis::IdentifyPostProcessingMatIds | ( | int | dimension, |
std::set< int > & | matids | ||
) |
Fill mat ids with materials with provided dimension wich are not boundary conditinos or interface.
Fill mat ids with materials with dimension dim wich are not boundary conditions or interface.
Definition at line 1039 of file pzanalysis.cpp.
References bc, DebugStop, dimension, TPZMaterial::Dimension(), fCompMesh, TPZMaterial::Id(), and TPZCompMesh::MaterialVec().
Referenced by AnimateRun(), DefineGraphMesh(), and GraphMesh().
TPZVec< STATE > TPZAnalysis::Integrate | ( | const std::string & | varname, |
const std::set< int > & | matids | ||
) |
Integrate the postprocessed variable name over the elements included in the set matids.
Definition at line 1335 of file pzanalysis.cpp.
References TPZCompMesh::Element(), fCompMesh, TPZCompEl::IntegrateSolution(), TPZGeoEl::MaterialId(), TPZCompMesh::MaterialVec(), TPZCompMesh::NElements(), and TPZCompEl::Reference().
Referenced by LoadSolution().
void TPZAnalysis::LoadShape | ( | double | dx, |
double | dy, | ||
int64_t | numelem, | ||
TPZConnect * | nod | ||
) |
Make assembling and clean the load and solution vectors.
Definition at line 908 of file pzanalysis.cpp.
References Assemble(), fRhs, fSolution, and TPZFMatrix< TVar >::Zero().
Referenced by GetStep().
|
virtual |
Load the solution into the computable grid.
Reimplemented in TPZElastoPlasticAnalysis, and TPZNonLinearAnalysis.
Definition at line 441 of file pzanalysis.cpp.
References fCompMesh, fSolution, and TPZCompMesh::LoadSolution().
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZMulticamadaOrthotropic::ComputeSolution(), GraphMesh(), TPZSubMeshAnalysis::LoadSolution(), TPZSubMeshFrontalAnalysis::LoadSolution(), TPZNonLinearAnalysis::LoadSolution(), LoadSolution(), TPZSubCompMesh::LoadSolution(), PYBIND11_MODULE(), TPZTransientAnalysis< TRANSIENTCLASS >::RunExplicit(), TPZTransientAnalysis< TRANSIENTCLASS >::RunTransient(), TPZBuildMultiphysicsMesh::ShowShape(), ShowShape(), TPZNonLinMultGridAnalysis::SmoothingSolution(), TPZNonLinMultGridAnalysis::SmoothingSolution2(), and TPZPostProcAnalysis::TransferSolution().
|
inlinevirtual |
Load the solution into the computable mesh considering sol as Solution vector of the analysis.
Reimplemented in TPZNonLinearAnalysis, TPZSubMeshFrontalAnalysis, and TPZSubMeshAnalysis.
Definition at line 278 of file pzanalysis.h.
References AnimateRun(), TPZAnalysis::TTablePostProcess::ClassId(), CreateListOfCompElsToComputeError(), test::f, Integrate(), LoadSolution(), PostProcess(), PostProcessError(), PostProcessErrorParallel(), PostProcessErrorSerial(), Print(), PrintVectorByElement(), SetExact(), SetSolver(), SetStructuralMatrix(), Solver(), and pzgeom::tol.
|
inline |
Returns the pointer to the computational mesh.
Definition at line 180 of file pzanalysis.h.
References fCompMesh.
Referenced by TPZSubMeshAnalysis::Assemble(), AssembleResidual(), TPZPostProcAnalysis::AutoBuildDisc(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeLinearTangentMatrix(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeMassMatrix(), TPZMulticamadaOrthotropic::ComputeSolution(), TPZElastoPlasticAnalysis::ComputeTangent(), TPZAnalysisError::EvaluateError(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZAnalysisError::HPAdapt(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZEulerAnalysis::PrepareDXMesh(), PYBIND11_MODULE(), TPZElastoPlasticAnalysis::Residual(), TPZEulerAnalysis::RunNewton(), TPZTransientAnalysis< TRANSIENTCLASS >::SetAllMaterialsDeltaT(), TPZElastoPlasticAnalysis::SetBiCGStab(), TPZElastoPlasticAnalysis::SetBiCGStab_Jacobi(), TPZTransientAnalysis< TRANSIENTCLASS >::SetCurrentState(), TPZTransientAnalysis< TRANSIENTCLASS >::SetExplicit(), TPZTransientAnalysis< TRANSIENTCLASS >::SetFluxOnly(), TPZEulerAnalysis::SetFrontalSolver(), TPZEulerAnalysis::SetGMResBlock(), TPZEulerAnalysis::SetGMResFront(), TPZTransientAnalysis< TRANSIENTCLASS >::SetImplicit(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolution(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolutionAsZero(), TPZTransientAnalysis< TRANSIENTCLASS >::SetLastState(), TPZElastoPlasticAnalysis::SetLU(), TPZTransientAnalysis< TRANSIENTCLASS >::SetMassMatrix(), TPZPostProcAnalysis::SetPostProcessVariables(), TPZBuildMultiphysicsMesh::ShowShape(), ShowShape(), TPZNonLinMultGridAnalysis::SmoothingSolution(), TPZNonLinMultGridAnalysis::SmoothingSolution2(), TPZNonLinearAnalysis::TPZNonLinearAnalysis(), and TPZPostProcAnalysis::TransferSolution().
void TPZAnalysis::OptimizeBandwidth | ( | ) |
Sets the computer connection block number from the graphical connections block number otimization.
if there are no connects, there is no bandwidth to be optimized
Definition at line 195 of file pzanalysis.cpp.
References TPZCompEl::BuildConnectList(), TPZCompMesh::ComputeElGraph(), TPZCompMesh::ElementVec(), fCompMesh, fRenumber, LOGPZ_DEBUG, TPZCompMesh::NElements(), TPZVec< T >::NElements(), TPZCompMesh::NIndependentConnects(), TPZCompMesh::Permute(), TPZRenumbering::Print(), TPZSloan::Resequence(), TPZRenumbering::Resequence(), TPZCompMesh::SaddlePermute(), TPZRenumbering::SetElementGraph(), and TPZRenumbering::SetElementsNodes().
Referenced by TPZMGAnalysis::AppendMesh(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), SetCompMesh(), and SetRenumber().
|
virtual |
Draw solution over mesh for all dimensions.
Reimplemented in TPZTransientAnalysis< TRANSIENTCLASS >.
Definition at line 1031 of file pzanalysis.cpp.
Referenced by GraphMesh(), LoadSolution(), TPZElastoPlasticAnalysis::ManageIterativeProcess(), TPZAnalysisError::PlotLocal(), PosProcessSol(), TPZTransientAnalysis< TRANSIENTCLASS >::PostProcess(), PYBIND11_MODULE(), TPZPoroElastoPlasticAnalysis::Run(), TCedricTest::Run(), TPZBuildMultiphysicsMesh::ShowShape(), and ShowShape().
|
virtual |
Draw solution over mesh by dimension.
Reimplemented in TPZTransientAnalysis< TRANSIENTCLASS >.
Definition at line 1057 of file pzanalysis.cpp.
References TPZGraphMesh::DrawMesh(), TPZGraphMesh::DrawSolution(), fCompMesh, fGraphMesh, fStep, fTime, TPZGraphMesh::SetCompMesh(), and TPZGraphMesh::SetResolution().
|
virtual |
Compute the local error over all elements and global errors in several norms and print out.
Reimplemented in TPZTransientAnalysis< TRANSIENTCLASS >.
Definition at line 470 of file pzanalysis.cpp.
References TPZCompMesh::Dimension(), TPZGeoEl::Dimension(), TPZCompMesh::ElementVec(), TPZCompEl::EvaluateError(), fCompMesh, fExact, TPZVec< T >::Fill(), fSolution, TPZMaterial::Id(), TPZCompMesh::LoadSolution(), TPZCompEl::Material(), TPZVec< T >::NElements(), TPZChunkVector< T, EXP >::NElements(), TPZCompEl::Reference(), TPZVec< T >::Resize(), sqrt, and rdt::values.
|
virtual |
Compute the local error over all elements and global errors in several norms and print out without calculating the errors of the variables for hdiv spaces.
Definition at line 573 of file pzanalysis.cpp.
References fNthreadsError, PostProcessErrorParallel(), and PostProcessErrorSerial().
Referenced by TPZSubCompMesh::EvaluateError(), TCedricTest::InterpolationError(), LoadSolution(), and TCedricTest::Run().
|
virtual |
Definition at line 652 of file pzanalysis.cpp.
References CreateListOfCompElsToComputeError(), DebugStop, fCompMesh, fExact, TPZVec< T >::Fill(), fNthreadsError, fSolution, TPZAnalysis::ThreadData::ftid, TPZAnalysis::ThreadData::fvalues, TPZCompMesh::LoadSolution(), TPZVec< T >::NElements(), substruct_tst14.test::numthreads, PZ_PTHREAD_CREATE, PZ_PTHREAD_JOIN, PZError, TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::Resize(), sqrt, TPZAnalysis::ThreadData::ThreadWork(), and rdt::values.
Referenced by LoadSolution(), and PostProcessError().
|
virtual |
Definition at line 747 of file pzanalysis.cpp.
References bc, TPZCompMesh::Dimension(), TPZMaterial::Dimension(), TPZCompMesh::ElementVec(), EMathematicaInput, TPZCompEl::EvaluateError(), fCompMesh, fExact, TPZVec< T >::Fill(), fSolution, TPZGeoEl::Index(), TPZCompMesh::LoadSolution(), LOGPZ_DEBUG, TPZCompEl::Material(), TPZGeoMesh::NElements(), TPZVec< T >::NElements(), TPZChunkVector< T, EXP >::NElements(), TPZCompMesh::NEquations(), TPZMatrix< TVar >::Print(), PZError, TPZCompEl::Reference(), TPZCompMesh::Reference(), TPZManVector< T, NumExtAlloc >::Resize(), TPZVec< T >::Resize(), TPZFMatrix< TVar >::Resize(), sqrt, and rdt::values.
Referenced by LoadSolution(), and PostProcessError().
|
virtual |
Print the solution related with the computational element vector in post process.
Definition at line 1185 of file pzanalysis.cpp.
References TPZAnalysis::TTablePostProcess::fCompElPtr, TPZAnalysis::TTablePostProcess::fDimension, TPZAnalysis::TTablePostProcess::fLocations, fTable, TPZAnalysis::TTablePostProcess::fVariableNames, TPZVec< T >::NElements(), numel, and TPZCompEl::PrintSolution().
Referenced by GraphMesh().
void TPZAnalysis::PostProcessTable | ( | TPZFMatrix< REAL > & | pos, |
std::ostream & | out = std::cout |
||
) |
Compute and print the local error over all elements in data structure of post process, also compute global errors in several norms.
Definition at line 823 of file pzanalysis.cpp.
References TPZCompMesh::ElementVec(), fCompMesh, and TPZChunkVector< T, EXP >::NElements().
|
virtual |
Prepare data to print post processing and print coordinates.
Definition at line 1156 of file pzanalysis.cpp.
References TPZAnalysis::TTablePostProcess::fCompElPtr, TPZAnalysis::TTablePostProcess::fDimension, TPZAnalysis::TTablePostProcess::fLocations, fTable, TPZAnalysis::TTablePostProcess::fVariableNames, TPZVec< T >::NElements(), numel, TPZCompEl::PrintCoordinate(), and TPZCompEl::PrintTitle().
Referenced by GraphMesh().
void TPZAnalysis::Print | ( | const std::string & | name, |
std::ostream & | out | ||
) |
Print connect and solution information.
Definition at line 447 of file pzanalysis.cpp.
References TPZCompMesh::ConnectSolution(), TPZCompMesh::ConnectVec(), fCompMesh, fSolution, TPZChunkVector< T, EXP >::NElements(), TPZConnect::Print(), TPZMatrix< TVar >::Print(), and TPZConnect::SequenceNumber().
Referenced by TPZMulticamadaOrthotropic::ComputeSolution(), LoadSolution(), TPZParSkylineStructMatrix::main(), TPZFrontStructMatrix< front >::main(), TPZParFrontStructMatrix< front >::main(), PosProcessSol(), and TPZNonLinMultGridAnalysis::SmoothingSolution2().
void TPZAnalysis::PrintVectorByElement | ( | std::ostream & | out, |
TPZFMatrix< STATE > & | vec, | ||
REAL | tol = 1.e-10 |
||
) |
Print the residual vector for those elements with entry above a given tolerance.
Definition at line 1398 of file pzanalysis.cpp.
References TPZGeoEl::CenterPoint(), TPZCompEl::Connect(), TPZCompEl::ConnectIndex(), ConnectNorm(), ConnectSolution(), TPZCompMesh::ConnectVec(), TPZGeoEl::Dimension(), TPZCompMesh::Element(), fabs, fCompMesh, TPZConnect::HasDependency(), TPZGeoEl::Index(), TPZConnect::IsCondensed(), TPZGeoEl::MaterialId(), TPZCompEl::NConnects(), TPZCompMesh::NElements(), TPZGeoEl::NSides(), TPZCompEl::Reference(), TPZVec< T >::size(), pzgeom::tol, and TPZGeoEl::X().
Referenced by Assemble(), TPZElastoPlasticAnalysis::IterativeProcess(), and LoadSolution().
|
overridevirtual |
read objects from the stream
Reimplemented from TPZSavable.
Reimplemented in TPZPostProcAnalysis.
Definition at line 1491 of file pzanalysis.cpp.
References fCompMesh, fGeoMesh, fGraphMesh, fGuiInterface, fNthreadsError, fRenumber, fRhs, fScalarNames, fSolution, fSolver, fStep, fStructMatrix, fTable, fTensorNames, fTime, fVectorNames, TPZPersistenceManager::GetAutoPointer(), TPZPersistenceManager::GetInstance(), TPZAnalysis::TTablePostProcess::Read(), TPZStream::Read(), and TPZFMatrix< TVar >::Read().
Referenced by TPZPostProcAnalysis::Read().
void TPZAnalysis::Resequence | ( | int | firstel = -1 | ) |
Recompute the node sequence.
Referenced by SetRenumber().
|
inline |
Returns the load vector.
Definition at line 174 of file pzanalysis.h.
References fRhs.
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZSubCompMesh::Assemble(), AssembleResidual(), PYBIND11_MODULE(), TPZNonLinMultGridAnalysis::SmoothingSolution(), TPZPostProcAnalysis::TransferSolution(), and TPZNonLinMultGridAnalysis::TwoGridAlgorithm().
|
virtual |
Calls the appropriate sequence of methods to build a solution or a time stepping sequence.
Reimplemented in TPZEulerAnalysis, TPZSubMeshAnalysis, TPZSubMeshFrontalAnalysis, and TPZPoroElastoPlasticAnalysis.
Definition at line 920 of file pzanalysis.cpp.
References Assemble(), fCompMesh, TPZCompMesh::NEquations(), and Solve().
Referenced by TPZSubCompMesh::CalcStiff(), TPZMulticamadaOrthotropic::ComputeSolution(), GetStep(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZParSkylineStructMatrix::main(), TPBSpStructMatrix::main(), TPZSymetricSpStructMatrix::main(), TPZSpStructMatrix::main(), TPZFrontStructMatrix< front >::main(), TPZParFrontStructMatrix< front >::main(), main(), TPZPoroElastoPlasticAnalysis::Run(), TPZEulerAnalysis::Run(), TCedricTest::Run(), TPZNonLinMultGridAnalysis::SmoothingSolution(), TPZNonLinMultGridAnalysis::SmoothingSolution2(), Hdiv2dPaper201504::SolveSyst(), hdivCurvedJCompAppMath::SolveSyst(), and Hdiv3dPaper201504::SolveSyst().
|
virtual |
Set the computational mesh of the analysis.
Reimplemented in TPZSubMeshAnalysis, and TPZPostProcAnalysis.
Definition at line 115 of file pzanalysis.cpp.
References CleanUp(), ELU, fCompMesh, fGeoMesh, fGraphMesh, fSolution, fSolver, fStep, fStructMatrix, fTime, TPZCompMesh::NEquations(), OptimizeBandwidth(), TPZCompMesh::Reference(), TPZMatrixSolver< TVar >::ResetMatrix(), TPZFMatrix< TVar >::Resize(), TPZStepSolver< TVar >::SetDirect(), SetSolver(), SetStructuralMatrix(), and TPZCompMesh::Solution().
Referenced by AmIKilled(), TPZSubCompMesh::SetAnalysisSkyline(), TPZSubMeshAnalysis::SetCompMesh(), and TPZAnalysis().
|
inline |
Sets the pointer of the exact solution function.
Definition at line 360 of file pzanalysis.h.
References test::f, and fExact.
Referenced by TPZSubCompMesh::EvaluateError(), TCedricTest::InterpolationError(), LoadSolution(), and TCedricTest::Run().
|
inline |
Defines gui interface object.
Definition at line 108 of file pzanalysis.h.
Referenced by TPZSubCompMesh::SetAnalysisFrontal(), and TPZSubCompMesh::SetAnalysisSkyline().
|
inline |
Change the renumbering scheme.
Definition at line 142 of file pzanalysis.h.
References Assemble(), AssembleResidual(), ComputeNumberofLoadCases(), HighestDimension(), OptimizeBandwidth(), Resequence(), and Solve().
Referenced by TPZSubCompMesh::SetAnalysisSkyline().
void TPZAnalysis::SetSolver | ( | TPZMatrixSolver< STATE > & | solver | ) |
Set solver matrix.
Definition at line 1202 of file pzanalysis.cpp.
References TPZSolver< TVar >::Clone(), and fSolver.
Referenced by AnimateRun(), TPZMGAnalysis::AppendMesh(), TPZMulticamadaOrthotropic::ComputeSolution(), Input::CreateCuboSkyMatrix(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), LoadSolution(), TPZParSkylineStructMatrix::main(), TPBSpStructMatrix::main(), TPZSymetricSpStructMatrix::main(), TPZSpStructMatrix::main(), TPZFrontStructMatrix< front >::main(), TPZParFrontStructMatrix< front >::main(), main(), TPZSubCompMesh::main(), TPZNonLinMultGridAnalysis::OneGridAlgorithm(), TPZMGAnalysis::PopMesh(), TPZNonLinMultGridAnalysis::PopMesh(), PYBIND11_MODULE(), TCedricTest::Run(), TPZSubCompMesh::SetAnalysisFrontal(), TPZSubCompMesh::SetAnalysisSkyline(), TPZElastoPlasticAnalysis::SetBiCGStab(), TPZElastoPlasticAnalysis::SetBiCGStab_Jacobi(), SetCompMesh(), TPZEulerAnalysis::SetFrontalSolver(), TPZEulerAnalysis::SetGMResBlock(), TPZEulerAnalysis::SetGMResFront(), TPZElastoPlasticAnalysis::SetLU(), Hdiv2dPaper201504::SolveSyst(), hdivCurvedJCompAppMath::SolveSyst(), Hdiv3dPaper201504::SolveSyst(), TPZNonLinMultGridAnalysis::TPZNonLinMultGridAnalysis(), and TPZNonLinMultGridAnalysis::TwoGridAlgorithm().
|
inline |
ste the step for post processing
Definition at line 195 of file pzanalysis.h.
Referenced by ShowShape().
void TPZAnalysis::SetStructuralMatrix | ( | TPZAutoPointer< TPZStructMatrix > | strmatrix | ) |
Set structural matrix as auto pointer for analysis.
Definition at line 82 of file pzanalysis.cpp.
References TPZStructMatrixOR::Clone().
Referenced by TPZMGAnalysis::AppendMesh(), TPZMulticamadaOrthotropic::ComputeSolution(), Input::CreateCuboSkyMatrix(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), LoadSolution(), TPZParSkylineStructMatrix::main(), TPBSpStructMatrix::main(), TPZSymetricSpStructMatrix::main(), TPZSpStructMatrix::main(), TPZFrontStructMatrix< front >::main(), TPZParFrontStructMatrix< front >::main(), main(), TPZSubCompMesh::main(), TPZNonLinMultGridAnalysis::OneGridAlgorithm(), PYBIND11_MODULE(), TCedricTest::Run(), TPZSubCompMesh::SetAnalysisFrontal(), TPZSubCompMesh::SetAnalysisSkyline(), TPZElastoPlasticAnalysis::SetBiCGStab(), TPZElastoPlasticAnalysis::SetBiCGStab_Jacobi(), SetCompMesh(), TPZEulerAnalysis::SetFrontalSolver(), TPZEulerAnalysis::SetGMResBlock(), TPZEulerAnalysis::SetGMResFront(), TPZElastoPlasticAnalysis::SetLU(), Hdiv2dPaper201504::SolveSyst(), hdivCurvedJCompAppMath::SolveSyst(), Hdiv3dPaper201504::SolveSyst(), and TPZNonLinMultGridAnalysis::TwoGridAlgorithm().
void TPZAnalysis::SetStructuralMatrix | ( | TPZStructMatrix & | strmatrix | ) |
Set structural matrix for analysis.
Definition at line 78 of file pzanalysis.cpp.
References TPZStructMatrixOR::Clone().
|
virtual |
Sets the names of the variables into the data structure for post processing.
Definition at line 1152 of file pzanalysis.cpp.
References fTable, and TPZAnalysis::TTablePostProcess::fVariableNames.
Referenced by GraphMesh().
|
inline |
Definition at line 200 of file pzanalysis.h.
References nthreads.
|
inline |
Sets time will be used in dx files.
Definition at line 371 of file pzanalysis.h.
Referenced by GetStep().
void TPZAnalysis::ShowShape | ( | const std::string & | plotfile, |
TPZVec< int64_t > & | equationindices | ||
) |
Graphic of the solution as V3DGrap visualization.
Definition at line 834 of file pzanalysis.cpp.
References DefineGraphMesh(), TPZCompMesh::Dimension(), fCompMesh, fSolution, TPZCompMesh::GetDefaultOrder(), LoadSolution(), TPZCompMesh::MaterialVec(), Mesh(), TPZMaterial::NStateVariables(), porder, PostProcess(), TPZStack< T, NumExtAlloc >::Push(), SetStep(), TPZVec< T >::size(), TPZCompMesh::TransferMultiphysicsSolution(), and TPZFMatrix< TVar >::Zero().
Referenced by GetStep().
void TPZAnalysis::ShowShape | ( | const std::string & | plotfile, |
TPZVec< int64_t > & | equationindices, | ||
int | matid, | ||
const TPZVec< std::string > & | varname | ||
) |
Graphic of the solution as V3DGrap visualization.
Definition at line 865 of file pzanalysis.cpp.
References DebugStop, DefineGraphMesh(), TPZCompMesh::Dimension(), fCompMesh, TPZCompMesh::FindMaterial(), fSolution, TPZCompMesh::GetDefaultOrder(), LoadSolution(), Mesh(), TPZMaterial::NSolutionVariables(), porder, PostProcess(), TPZStack< T, NumExtAlloc >::Push(), SetStep(), TPZVec< T >::size(), TPZCompMesh::TransferMultiphysicsSolution(), TPZMaterial::VariableIndex(), and TPZFMatrix< TVar >::Zero().
|
inline |
Returns the solution matrix.
Definition at line 177 of file pzanalysis.h.
References fSolution.
Referenced by TPZMulticamadaOrthotropic::ComputeSolution(), TCedricTest::InterpolationError(), TPZSubCompMesh::main(), TPZNonLinMultGridAnalysis::OneGridAlgorithm(), PYBIND11_MODULE(), TPZTransientAnalysis< TRANSIENTCLASS >::SaveCurrentSolutionVec(), TPZBuildMultiphysicsMesh::ShowShape(), TPZNonLinMultGridAnalysis::SmoothingSolution(), TPZNonLinMultGridAnalysis::SmoothingSolution2(), and TPZNonLinMultGridAnalysis::TwoGridAlgorithm().
|
virtual |
Invert the stiffness matrix.
Reimplemented in TPZEulerAnalysis, TPZPostProcAnalysis, and TPZMGAnalysis.
Definition at line 352 of file pzanalysis.cpp.
References DebugStop, fCompMesh, fRhs, fSolution, fSolver, fStructMatrix, TPZMatrix< TVar >::IsDecomposed(), TPZCompMesh::LoadSolution(), LOGPZ_DEBUG, LOGPZ_WARN, TPZMatrixSolver< TVar >::Matrix(), TPZCompMesh::NEquations(), Norm(), TPZMatrix< TVar >::Print(), TPZFMatrix< TVar >::Redim(), TPZMatrix< TVar >::Residual(), TPZMatrix< TVar >::Rows(), TPZStepSolver< TVar >::Singular(), TPZSolver< TVar >::Solve(), and TPZCompMesh::TransferMultiphysicsSolution().
Referenced by TPZElastoPlasticAnalysis::IterativeProcess(), TPZNonLinearAnalysis::IterativeProcess(), TPZElastoPlasticAnalysis::IterativeProcessPrecomputedMatrix(), PYBIND11_MODULE(), Run(), TPZTransientAnalysis< TRANSIENTCLASS >::RunExplicit(), TPZTransientAnalysis< TRANSIENTCLASS >::RunTransient(), SetRenumber(), TPZMGAnalysis::Solve(), TPZEulerAnalysis::Solve(), and TPZNonLinMultGridAnalysis::TwoGridAlgorithm().
|
inline |
Get the solver matrix.
Definition at line 367 of file pzanalysis.h.
Referenced by AnimateRun(), TPZNonLinMultGridAnalysis::CalcResidual(), TPZSubCompMesh::CalcStiff(), Input::CreateCuboSkyMatrix(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), LoadSolution(), main(), TPZElastoPlasticAnalysis::SetBiCGStab(), TPZElastoPlasticAnalysis::SetBiCGStab_Jacobi(), TPZEulerAnalysis::SetGMResBlock(), TPZEulerAnalysis::SetGMResFront(), and TPZElastoPlasticAnalysis::SetLU().
|
inline |
Returns a reference to the structural matrix.
Definition at line 182 of file pzanalysis.h.
References BuildPreconditioner(), DebugStop, and fStructMatrix.
Referenced by TPZSubCompMesh::Assemble(), TPZSubCompMesh::CalcStiff(), TPZStructMatrixBase::SetMaterialIds(), and TPZNonLinMultGridAnalysis::TwoGridAlgorithm().
|
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 TPZPostProcAnalysis.
Definition at line 1463 of file pzanalysis.cpp.
References fCompMesh, fGeoMesh, fGraphMesh, fGuiInterface, fNthreadsError, fRenumber, fRhs, fScalarNames, fSolution, fSolver, fStep, fStructMatrix, fTable, fTensorNames, fTime, fVectorNames, TPZStream::Write(), TPZAnalysis::TTablePostProcess::Write(), TPZFMatrix< TVar >::Write(), and TPZPersistenceManager::WritePointer().
Referenced by TPZPostProcAnalysis::Write().
|
friend |
Definition at line 353 of file pzanalysis.h.
|
protected |
Computational mesh.
Definition at line 44 of file pzanalysis.h.
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZElastoPlasticAnalysis::AcceptSolution(), AnimateRun(), TPZMGAnalysis::AppendMesh(), TPZTransientAnalysis< TRANSIENTCLASS >::Assemble(), TPZSubMeshAnalysis::Assemble(), TPZEulerAnalysis::Assemble(), Assemble(), TPZEulerAnalysis::AssembleRhs(), TPZEulerAnalysis::BufferLastStateAssemble(), BuildPreconditioner(), TPZElastoPlasticAnalysis::CheckConv(), CleanUp(), TPZEulerAnalysis::CompareRhs(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeFluxOnly(), ComputeNumberofLoadCases(), TPZNonLinearAnalysis::ComputeTangent(), TPZElastoPlasticAnalysis::ComputeTangent(), CreateListOfCompElsToComputeError(), DefineGraphMesh(), TPZEulerAnalysis::EvaluateFluxEpsilon(), TPZPoroElastoPlasticAnalysis::FindPorousMaterials(), TPZElastoPlasticAnalysis::GetActiveEquations(), HighestDimension(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZElastoPlasticAnalysis::IdentifyEquationsToZero(), IdentifyPostProcessingMatIds(), Integrate(), TPZNonLinearAnalysis::IterativeProcess(), TPZElastoPlasticAnalysis::IterativeProcess(), LoadSolution(), TPZElastoPlasticAnalysis::ManageIterativeProcess(), TPZAnalysisError::MathematicaPlot(), Mesh(), OptimizeBandwidth(), TPZMGAnalysis::PopMesh(), TPZNonLinMultGridAnalysis::PopMesh(), PostProcess(), PostProcessErrorParallel(), PostProcessErrorSerial(), PostProcessTable(), Print(), PrintVectorByElement(), Read(), TPZNonLinearAnalysis::Residual(), TPZElastoPlasticAnalysis::Residual(), Run(), TPZTransientAnalysis< TRANSIENTCLASS >::RunTransient(), TPZPoroElastoPlasticAnalysis::SetAdvancedState(), TPZEulerAnalysis::SetAdvancedState(), TPZPostProcAnalysis::SetCompMesh(), TPZSubMeshAnalysis::SetCompMesh(), SetCompMesh(), TPZPoroElastoPlasticAnalysis::SetContributionTime(), TPZPoroElastoPlasticAnalysis::SetDeltaT(), TPZPoroElastoPlasticAnalysis::SetLastState(), TPZEulerAnalysis::SetLastState(), TPZElastoPlasticAnalysis::SetUpdateMem(), ShowShape(), TPZMGAnalysis::Solve(), TPZEulerAnalysis::Solve(), Solve(), TPZElastoPlasticAnalysis::TPZElastoPlasticAnalysis(), TPZPoroElastoPlasticAnalysis::TPZPoroElastoPlasticAnalysis(), TPZSubMeshAnalysis::TPZSubMeshAnalysis(), TPZEulerAnalysis::UpdateSolAndRhs(), Write(), and TPZPostProcAnalysis::~TPZPostProcAnalysis().
std::function<void (const TPZVec<REAL> &loc, TPZVec<STATE> &result, TPZFMatrix<STATE> &deriv)> TPZAnalysis::fExact |
Pointer to Exact solution function, it is necessary to calculating errors.
Definition at line 99 of file pzanalysis.h.
Referenced by TPZAnalysisError::EvaluateError(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), PostProcess(), PostProcessErrorParallel(), PostProcessErrorSerial(), SetExact(), and TPZMGAnalysis::TPZMGAnalysis().
|
protected |
Geometric Mesh.
Definition at line 42 of file pzanalysis.h.
Referenced by CleanUp(), DefineElementTable(), Read(), SetCompMesh(), Write(), and TPZEulerAnalysis::WriteCMesh().
|
protected |
Graphical mesh.
Definition at line 46 of file pzanalysis.h.
Referenced by CleanUp(), CloseGraphMesh(), DefineGraphMesh(), PostProcess(), Read(), SetCompMesh(), TPZAnalysis(), and Write().
|
protected |
Pointer for gui interface object.
Definition at line 74 of file pzanalysis.h.
Referenced by TPZSubMeshAnalysis::Assemble(), Assemble(), AssembleResidual(), CleanUp(), GetGuiInterface(), Read(), and Write().
|
protected |
Number of threads to be used for post-processing error.
Definition at line 65 of file pzanalysis.h.
Referenced by PostProcessError(), PostProcessErrorParallel(), Read(), and Write().
|
protected |
Renumbering scheme.
Definition at line 71 of file pzanalysis.h.
Referenced by CleanUp(), OptimizeBandwidth(), Read(), and Write().
|
protected |
Load vector.
Definition at line 48 of file pzanalysis.h.
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZElastoPlasticAnalysis::AcceptSolution(), AnimateRun(), TPZMGAnalysis::AppendMesh(), TPZTransientAnalysis< TRANSIENTCLASS >::Assemble(), TPZSubMeshAnalysis::Assemble(), TPZEulerAnalysis::Assemble(), Assemble(), TPZEulerAnalysis::AssembleRhs(), CleanUp(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeFluxOnly(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeLinearTangentMatrix(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeMassMatrix(), TPZSubMeshFrontalAnalysis::CondensedSolution(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZNonLinearAnalysis::IterativeProcess(), TPZElastoPlasticAnalysis::IterativeProcessPrecomputedMatrix(), TPZElastoPlasticAnalysis::LineSearch(), TPZNonLinearAnalysis::LineSearch(), TPZEulerAnalysis::LineSearch(), LoadShape(), TPZSubMeshFrontalAnalysis::LoadSolution(), Read(), TPZSubMeshAnalysis::ReducedRightHandSide(), Rhs(), TPZSubMeshFrontalAnalysis::Run(), TPZEulerAnalysis::RunNewton(), TPZTransientAnalysis< TRANSIENTCLASS >::RunTransient(), TPZEulerAnalysis::SetGMResFront(), TPZMGAnalysis::Solve(), TPZEulerAnalysis::Solve(), Solve(), TPZEulerAnalysis::UpdateSolAndRhs(), and Write().
|
protected |
Scalar variables names - to post process.
Definition at line 54 of file pzanalysis.h.
Referenced by CleanUp(), DefineGraphMesh(), Read(), and Write().
|
protected |
Solution vector.
Definition at line 50 of file pzanalysis.h.
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZElastoPlasticAnalysis::AcceptSolution(), AnimateRun(), TPZMGAnalysis::AppendMesh(), TPZElastoPlasticAnalysis::CheckConv(), CleanUp(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZNonLinearAnalysis::IterativeProcess(), TPZElastoPlasticAnalysis::IterativeProcessPrecomputedMatrix(), LoadShape(), TPZSubMeshAnalysis::LoadSolution(), TPZSubMeshFrontalAnalysis::LoadSolution(), TPZNonLinearAnalysis::LoadSolution(), LoadSolution(), TPZMGAnalysis::PopMesh(), TPZNonLinMultGridAnalysis::PopMesh(), PostProcess(), PostProcessErrorParallel(), PostProcessErrorSerial(), Print(), Read(), TPZSubMeshFrontalAnalysis::Run(), TPZEulerAnalysis::Run(), TPZSubMeshAnalysis::Run(), TPZTransientAnalysis< TRANSIENTCLASS >::RunExplicit(), TPZTransientAnalysis< TRANSIENTCLASS >::RunTransient(), TPZPoroElastoPlasticAnalysis::SetAdvancedState(), TPZEulerAnalysis::SetAdvancedState(), SetCompMesh(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolution(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolutionAsZero(), TPZPoroElastoPlasticAnalysis::SetLastState(), TPZEulerAnalysis::SetLastState(), ShowShape(), Solution(), TPZNonLinearAnalysis::SolutionNorm(), TPZMGAnalysis::Solve(), Solve(), TPZElastoPlasticAnalysis::TPZElastoPlasticAnalysis(), TPZNonLinearAnalysis::TPZNonLinearAnalysis(), TPZNonLinMultGridAnalysis::TPZNonLinMultGridAnalysis(), TPZPostProcAnalysis::TransferSolution(), TPZElastoPlasticAnalysis::TransferSolution(), TPZEulerAnalysis::UpdateHistory(), TPZEulerAnalysis::UpdateSolAndRhs(), and Write().
|
protected |
Type of solver to be applied.
Definition at line 52 of file pzanalysis.h.
Referenced by AnimateRun(), TPZTransientAnalysis< TRANSIENTCLASS >::Assemble(), TPZSubMeshAnalysis::Assemble(), TPZEulerAnalysis::Assemble(), Assemble(), BuildPreconditioner(), BuildSequenceSolver(), CleanUp(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeFluxOnly(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeLinearTangentMatrix(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeMassMatrix(), TPZSubMeshFrontalAnalysis::LoadSolution(), Read(), TPZSubMeshFrontalAnalysis::Run(), TPZEulerAnalysis::Run(), TPZEulerAnalysis::RunNewton(), SetCompMesh(), SetSolver(), TPZMGAnalysis::Solve(), TPZEulerAnalysis::Solve(), Solve(), TPZElastoPlasticAnalysis::UpdatePrecond(), and Write().
|
protected |
Time step.
Definition at line 60 of file pzanalysis.h.
Referenced by GetStep(), PostProcess(), Read(), SetCompMesh(), and Write().
|
protected |
Structural matrix.
Definition at line 68 of file pzanalysis.h.
Referenced by TPZTransientAnalysis< TRANSIENTCLASS >::Assemble(), TPZSubMeshAnalysis::Assemble(), TPZEulerAnalysis::Assemble(), Assemble(), AssembleResidual(), TPZEulerAnalysis::AssembleRhs(), TPZEulerAnalysis::BufferLastStateAssemble(), CleanUp(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeFluxOnly(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeLinearTangentMatrix(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeMassMatrix(), TPZNonLinearAnalysis::ComputeTangent(), TPZEulerAnalysis::EvaluateFluxEpsilon(), Read(), TPZNonLinearAnalysis::Residual(), SetCompMesh(), Solve(), StructMatrix(), and Write().
|
protected |
Definition at line 94 of file pzanalysis.h.
Referenced by DefineElementTable(), PostProcessTable(), PrePostProcessTable(), Read(), SetTableVariableNames(), and Write().
|
protected |
Tensorial variables names - to post process.
Definition at line 58 of file pzanalysis.h.
|
protected |
Time variable which is used in dx output.
Definition at line 62 of file pzanalysis.h.
Referenced by GetTime(), TPZTransientAnalysis< TRANSIENTCLASS >::PostProcess(), PostProcess(), Read(), SetCompMesh(), and Write().
|
protected |
Vectorial variables names - to post process.
Definition at line 56 of file pzanalysis.h.
Referenced by CleanUp(), DefineGraphMesh(), Read(), and Write().