66 double coordstore[4][3] = {{0.,0.,0.},{1.,0.,0.},{1.,1.,0.},
73 for (j=0; j<3; j++) coord[j] = coordstore[i][j];
79 gmesh.
NodeVec ()[i].Initialize (i,coord,gmesh);
83 for(el=0; el<1; el++) {
87 for(i=0; i<4; i++) indices[i] = i;
129 ofstream output(
"outputSkyPar.dat");
140 ofstream out(
"cmeshBlock_out.txt");
147 if(seqn < 0)
continue;
149 int64_t lasteq = firsteq+cmesh.
Block().
Size(seqn);
151 int temp = cmesh.
ConnectVec()[ic].NElConnected();
152 for(ind=firsteq;ind<lasteq;ind++) {
153 numelconnected[ind] = temp;
199 an.
Print(
"solution of Skyline solver", output);
Contains TPZAnalysis class which implements the sequence of actions to perform a finite element analy...
int Position(const int block_diagonal) const
Returns the position of first element block dependent on matrix diagonal.
Represents a set of shape functions associated with a computational element/side. Computational Eleme...
Contains the TPZParSkylineStructMatrix class which defines parallel structural matrix for skyline mat...
void SetStructuralMatrix(TPZAutoPointer< TPZStructMatrix > strmatrix)
Set structural matrix as auto pointer for analysis.
virtual TPZStructMatrix * Clone()
void Print(const std::string &name, std::ostream &out)
Print connect and solution information.
virtual TPZGeoEl * CreateGeoElement(MElementType type, TPZVec< int64_t > &cornerindexes, int matid, int64_t &index, int reftype=1)
Generic method for creating a geometric element. Putting this method centrally facilitates the modifi...
Contains the TPZFrontStructMatrix class which responsible for a interface among Finite Element Packag...
Contains TPZSkylParMatrix class which implements a skyline storage format to parallelized process...
int64_t NEquations()
This computes the number of equations associated with non-restrained nodes.
Templated vector implementation.
Defines parallel structural matrix for skyline matrices. Structural Matrix.
Defines step solvers class. Solver.
void FilterSkyline(TPZVec< int64_t > &skyline) const
void SetSolver(TPZMatrixSolver< STATE > &solver)
Set solver matrix.
TPZEquationFilter fEquationFilter
Object which will determine which equations will be assembled.
int64_t NElements() const
Access method to query the number of elements of the vector.
Contains the TPZStructMatrixOR class which responsible for a interface among Matrix and Finite Elemen...
virtual TPZMatrix< STATE > * Create()
Contains the TPZFStructMatrix class which implements Full Structural Matrices.
void SetDefaultOrder(int order)
Implements SkyLine Structural Matrices. Structural Matrix.
Refines geometrical mesh (all the elements) num times.
This abstract class defines the behaviour which each derived class needs to implement.
Contains declaration of TPZElementMatrix struct which associates an element matrix with the coeficien...
TPZCompMesh * fMesh
Pointer to the computational mesh from which the matrix will be generated.
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 declaration of TPZMesh class which defines a geometrical mesh and contains a corresponding l...
int64_t SequenceNumber() const
Returns the Sequence number of the connect object.
Implements the sequence of actions to perform a finite element analysis. Analysis.
virtual void Skyline(TPZVec< int64_t > &skyline)
This method computes the skyline of the system of equations.
int64_t NActiveEquations() const
Retorna o numero de equacoes ativas do sistema.
TPZParSkylineStructMatrix(TPZCompMesh *, int numthreads)
TPZAdmChunkVector< TPZGeoNode > & NodeVec()
virtual void AutoBuild(const std::set< int > *MaterialIDs)
Creates the computational elements, and the degree of freedom nodes.
int64_t Rows() const
Returns number of rows.
int HasDependency() const
Returns whether exist dependecy information.
const TPZBlock< STATE > & Block() const
Access the block structure of the solution vector.
Contains the TPZMat2dLin class which implements a bi-dimensional linear problem.
TPZAdmChunkVector< TPZConnect > & ConnectVec()
Return a reference to the connect pointers vector.
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.
void SetMaterial(TPZFMatrix< STATE > &xkin, TPZFMatrix< STATE > &xcin, TPZFMatrix< STATE > &xfin)
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 Run(std::ostream &out=std::cout)
Calls the appropriate sequence of methods to build a solution or a time stepping sequence.
void BuildConnectivity()
Build the connectivity of the grid.
virtual TPZBndCond * CreateBC(TPZMaterial *reference, int id, int typ, TPZFMatrix< STATE > &val1, TPZFMatrix< STATE > &val2)
Creates an object TPZBndCond derived of TPZMaterial.
Contains declaration of TPZSubCompMesh class which implements a group of computational elements as a ...
Implements a skyline storage format to parallelized process. Matrix.
int InsertMaterialObject(TPZMaterial *mat)
Insert a material object in the datastructure.
virtual TPZMatrix< STATE > * CreateAssemble(TPZFMatrix< STATE > &rhs, TPZAutoPointer< TPZGuiInterface > guiInterface)
This class implements a geometric mesh for the pz environment. Geometry.
Implements a bi-dimensional linear problem.
Implements computational mesh. Computational Mesh.
int Size(const int block_diagonal) const
Returns block dimension.
Contains TPZSolver class which defines a abstract class of solvers which will be used by matrix class...
Contains TPZStepSolver class which defines step solvers class.
void SetDirect(const DecomposeType decomp)
Contains the TPZDXGraphMesh class which implements the interface of the graphmesh to the OpenDX graph...
void InitializeBlock()
Resequence the block object, remove unconnected connect objects and reset the dimension of the soluti...
bool IsCondensed() const
Access method to return the indication whether the connect is condensed or not.
virtual void Print(std::ostream &out=std::cout) const
Prints mesh data.