83 static LoggerPtr logger(Logger::getLogger(
"pz.mainskeleton"));
90 int main(
int argc,
char *argv[])
102 std::cout <<
"Computational mesh created\n";
111 std::cout <<
"Number of equations " << cmesh->
NEquations() << std::endl;
112 std::cout <<
"Number of elements " << cmesh->
NElements() << std::endl;
126 std::cout <<
"Assembly\n";
128 std::cout <<
"Once\n";
130 std::cout <<
"Finished\n";
141 int ndims = dims.
size();
142 for(ir = 0; ir < nref; ir++ )
147 for (iel = 0; iel < nel; iel++ )
154 for(k = 0; k<ndims; k++)
173 REAL scale =
pow(2, nref);
174 REAL lx = nblocks[0]*scale;
175 REAL ly = nblocks[1]*scale;
184 gengrid.
Read(meshresult2d);
186 gengrid.
SetBC(meshresult2d.operator->(), 4, -1);
187 gengrid.
SetBC(meshresult2d.operator->(), 5, -1);
188 gengrid.
SetBC(meshresult2d.operator->(), 6, -1);
189 gengrid.
SetBC(meshresult2d.operator->(), 7, -1);
207 std::ofstream vtkfile(
"../gmesh.vtk");
227 std::cout <<
"Computational mesh created\n";
228 return cmeshPressure;
235 if (dimension == 3) {
236 int blocksize = ((int)
pow(nelem, 0.33))+1;
240 gmesh =
MalhaGeom(dimension, nblocks, nref);
242 std::cout <<
"Geometric mesh created elements " << gmesh->
NElements() << std::endl;
245 else if (dimension == 2)
248 int blocksize = ((int)
sqrt(nelem))+1;
252 gmesh =
MalhaGeom(dimension, nblocks, nref);
254 std::cout <<
"Geometric mesh created elements " << gmesh->
NElements() << std::endl;
261 if (regular == EUnbalanced) {
int64_t NElements() const
Number of computational elements allocated.
Contains the TPZFrontSym class which implements decomposition process of the frontal matrix (case sym...
This class performs a series of consistency tests on geometric transformations between elements...
Contains TPZAnalysis class which implements the sequence of actions to perform a finite element analy...
Contains the TPZParSkylineStructMatrix class which defines parallel structural matrix for skyline mat...
Contains declaration of TPZGeoElSide class which represents an element and its side, and TPZGeoElSideIndex class which represents an TPZGeoElSide index.
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.
void SetStructuralMatrix(TPZAutoPointer< TPZStructMatrix > strmatrix)
Set structural matrix as auto pointer for analysis.
int64_t NEquations()
This computes the number of equations associated with non-restrained nodes.
clarg::argInt dimension("-d", "Matrices dimension M x M", 1000)
void SetElType(int eltype)
Contains declaration of TPZCompEl class which defines the interface of a computational element...
Templated vector implementation.
Contains the declaration of the TPZElementGroup class, which implements an computational element whic...
Contains declaration of TPZCheckGeom class which performs a series of consistency tests on geometric ...
Defines step solvers class. Solver.
void SetSolver(TPZMatrixSolver< STATE > &solver)
Set solver matrix.
Implements the generation of a multilayered bi-dimensional geometric grid. Getting Data...
Contains the TPZFrontNonSym class which implements storage and decomposition process of the frontal m...
int64_t NElements() const
Number of elements of the mesh.
Contains the TPZStructMatrixOR class which responsible for a interface among Matrix and Finite Elemen...
virtual void Divide(TPZVec< TPZGeoEl *> &pv)
Divides the element and puts the resulting elements in the vector.
void SetDimension(int dim)
Set Dimension.
Contains the TPZMatPoisson3d class.
void UniformRefine(int nDiv)
Uniform refine the geometric mesh.
TPZAutoPointer< TPZGeoMesh > MalhaGeom(int dimension, TPZVec< int > &nblocks, int nref)
malha geometrica de grande porte
Contains the TPZFStructMatrix class which implements Full Structural Matrices.
void SetDefaultOrder(int order)
Implements SkyLine Structural Matrices. Structural Matrix.
TPZGeoMesh * ExtendedMesh()
It reads the mesh since the archive of entrance finemesh, or since the fFineGeoMesh passed in the con...
clarg::argInt porder("-p", "porder", 2)
Contains the TPZBndCond class which implements a boundary condition for TPZMaterial objects...
int64_t size() const
Returns the number of elements of the vector.
Contains the TPZSpStructMatrix class which implements sparse structural matrices. ...
TPZCompEl * Element(int64_t iel)
TPZCreateApproximationSpace & ApproxSpace()
Contains declaration of TPZMesh class which defines a geometrical mesh and contains a corresponding l...
Implements the sequence of actions to perform a finite element analysis. Analysis.
Defines the behaviour of all geometric elements. GeometryTPZGeoEl is the common denominator for all g...
Contains declaration of TPZCompMeshReferred class which implements the structure to allow one mesh to...
virtual void SetBC(TPZGeoMesh *gr, int side, int bc)
Generate boundary geometric elements associated with the side of the rectangular domain.
Contains the TPZBandStructMatrix class which implements Banded Structural Matrices.
Contains TPZMatrixclass which implements full matrix (using column major representation).
#define DebugStop()
Returns a message to user put a breakpoint in.
Contains declaration of TPZInterfaceElement class which computes the contribution over an interface b...
virtual void ExpandSolution()
Adapt the solution vector to new block dimensions.
Contains the TPZElasticityMaterial class which implements a two dimensional elastic material in plane...
int Dimension() const
Returns the dimension of the simulation.
Contains the declaration of the TPZBuildmultiphysicsMesh class.
Generates a three dimensional mesh as an extension of a two dimensional mesh. Getting Data...
virtual void AutoBuild(const std::set< int > *MaterialIDs)
Creates the computational elements, and the degree of freedom nodes.
expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ expr_ sqrt
Contains the TPZGenGrid class which implements the generation of a multilayered geometric grid (two-d...
Contains declaration of TPZGeoElRefPattern class which implements a generic geometric element which i...
void SetAllCreateFunctionsContinuous()
Create continuous approximation spaces.
Contains declaration of the TPZAutoPointer class which has Increment and Decrement actions are mutexe...
Contains the TPZGraphMesh class which represents a graphical mesh used for post processing purposes...
Contains the TPZExtendGridDimension class which generates a three dimensional mesh as an extension of...
Contains the TPZMatPoisson3dReferred class which implements a version of TPZMatPoisson3d (convection...
void SetSymmetric()
Set material elliptic term as the global element method, i.e. the symmetrical formulation.
static void PrintGMeshVTK(TPZGeoMesh *gmesh, std::ofstream &file, bool matColor=true)
Default constructor for graphical mesh with VTK format.
Contains declaration of TPZCompMesh class which is a repository for computational elements...
Contains the TPZRefPattern class which defines the topology of the current refinement pattern to a me...
void SetDimension(int dim)
void SetDimModel(int dim)
Set de dimension of the domain of the problem.
Contains the TPZGeoPoint class which implements the geometry of a point element or 0-D element...
TPZFlopCounter pow(const TPZFlopCounter &orig, const TPZFlopCounter &xp)
Returns the power and increments the counter of the power.
Contains the TPBSpStructMatrix class which assembles on the pair equations.
int InsertMaterialObject(TPZMaterial *mat)
Insert a material object in the datastructure.
void InitializePZLOG()
Initializes log file for log4cxx with commom name log4cxx.cfg.
virtual int Dimension() const =0
Returns the dimension of the element.
Contains the TPZMat1dLin class which implements a one-dimensional linear problem. ...
int Dimension()
Get Dimension.
virtual void AssembleResidual()
Assemble the load vector.
This class implements a geometric mesh for the pz environment. Geometry.
TPZAutoPointer< TPZCompMesh > CreateCompMesh(int dimension, int porder, int64_t nelem, MRegular regular)
TPZAutoPointer< TPZCompMesh > CreatePressureMesh(TPZAutoPointer< TPZGeoMesh > gmesh, int porder)
Implements computational mesh. Computational Mesh.
void PRefine(int order) override
Changes the interpolation order of a side. Updates all constraints and block sizes ...
void RefinamentoUniforme(TPZAutoPointer< TPZGeoMesh > gmesh, int nref, TPZVec< int > dims)
Contains TPZStepSolver class which defines step solvers class.
Contains the TPZMatLaplacian class.
void SetDirect(const DecomposeType decomp)
Contains the TPZElasticityHybridMaterial class which implements a two dimensional elastic material to...
void SetRefpatternElements(bool refpat)
Generate element of type refpattern or uniform refinement.
Defines the interface of a computational element. Computational Element.
Contains the TPZVTKGeoMesh class which implements the graphical mesh to VTK environment to geometric ...
Contains the declaration of the TPZCondensedCompEl class, which implements an computational element w...
virtual short Read(TPZGeoMesh *mesh, int matid=1)
Add nodes and elements to the object mesh.
Implements computational element based on an interpolation space. Computational Element.
TPZAdmChunkVector< TPZGeoEl * > & ElementVec()
Methods for handling pzlists.