18 static LoggerPtr logger(Logger::getLogger(
"pz.mesh.TPZInterpolationSpace"));
128 int nsol = sol.
size();
129 int nstate = sol[0].
size();
130 int dim = axes.
Rows();
132 dphix.
Resize(nsol,nstate*dim);
133 for (
int isol =0; isol<nsol; isol++) {
134 for (
int istate=0; istate<nstate; istate++) {
135 phi(isol,istate) = sol[isol][istate];
136 for (
int id=0;
id<dim;
id++) {
137 dphix(isol,
id+istate*dim) = dsol[isol](id,istate);
153 int64_t nsol = data.
sol.
size();
154 int nstate = data.
sol[0].
size();
158 for (int64_t isol =0; isol<nsol; isol++) {
159 for (
int istate=0; istate<nstate; istate++) {
160 data.
phi(isol,istate) = data.
sol[isol][istate];
161 for (
int id=0;
id<dim;
id++) {
162 data.
dphix(isol,
id+istate*dim) = data.
dsol[isol](id,istate);
220 const int numdof = 1;
227 const int nshape = this->
NShapeF();
228 const int numeq = nshape*numdof;
236 for(i=0; i<ncon; i++){
243 for(i=0; i<ncon; i++){
254 const int numdof = 1;
261 const int nshape = this->
NShapeF();
262 const int numeq = nshape*numdof;
268 for(i=0; i<ncon; i++){
273 for(i=0; i<ncon; i++){
315 if (!intel && !mf_cel) {
344 const int dim = axes.
Rows();
360 int nsol = phi.
Rows();
365 int64_t numbersol = MeshSol.
Cols();
366 int64_t numberdof = MeshSol.
Rows();
370 for (int64_t is=0 ; is<numbersol; is++) {
373 dsol[is].Redim(nstate, nstate*dim);
380 int dfvar = block.
Size(dfseq);
381 int64_t pos = block.
Position(dfseq);
385 if(nsol * nstate != dfvar)
395 for(
int ib=0; ib < nsol; ib++) {
397 for (int64_t is=0; is<numbersol; is++) {
399 for(int64_t iv = 0; iv < nstate; iv++){
400 sol[is][iv%nstate] += (STATE)phi(ib,iv)*MeshSol(pos+ib*nstate+iv,is);
402 for(int64_t
id = 0;
id < dim;
id++){
403 dsol[is](iv%nstate,id) += (STATE)dphix(ib,
id+iv*dim)*MeshSol(pos+ib*nstate+iv,is);
456 int nsides = ref->
NSides();
458 if(dimension == 2 && to_postpro){
469 if(dimension == 3 && to_postpro){
488 if(dimension == 1 && to_postpro){
bool Material_Is_PostProcessed(int matid)
Return a directive if the material id is being postprocessed.
Represents a graphical mesh used for post processing purposes. Post processing.
virtual int ClassId() const override
Define the class id associated with the class.
Contains the TPZGraphElTd class which implements the graphical discontinuous triangular element...
int Position(const int block_diagonal) const
Returns the position of first element block dependent on matrix diagonal.
virtual int NConnectShapeF(int inod, int order) const override
Returns the number of shapefunctions associated with a connect.
int Set(const int index, const int dim, const int pos=-1)
Modifies existing block dimensions or creates a new block with given index.
Represents a set of shape functions associated with a computational element/side. Computational Eleme...
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.
TPZManVector< REAL, 3 > x
value of the coordinate at the integration point
To export a graphical one dimensional discontinuous element. Post processing.
virtual void ShapeX(TPZVec< REAL > &qsi, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphix, TPZFMatrix< REAL > &axes)
Computes the shape function set at the point x.
TPZCompEl * ReferredEl(int64_t index)
TPZInterpolationSpace * ReferredIntel() const
virtual TPZCompEl * Element(int64_t elindex)=0
clarg::argInt dimension("-d", "Matrices dimension M x M", 1000)
TPZStack< int64_t > fConnect
Vector of pointers to TPZConnect objects.
TPZFNMatrix< 1000, STATE > fMat
Pointer to a blocked matrix object.
void CreateGraphicalElement(TPZGraphMesh &grafgrid, int dimension) override
Creates corresponding graphical element(s) if the dimension matches graphical elements are used to ge...
To export a graphical two-dimensional discontinuous element. Post processing.
To export a graphical three dimensional discontinuous element. Post processing.
void SetCreateFunctions(TPZVec< TCreateFunction > &createfuncs)
Set custom function pointers.
Contains the TPZGraphEl class which implements the graphical one-, two- and three-dimensional element...
virtual int NStateVariables() const =0
Returns the number of state variables associated with the material.
TPZGradSolVec dsol
vector of the derivatives of the solution at the integration point
MShapeFunctionType fShapeType
Contains the declaration of the TPZMultiphysicsElement class. This class is abstract.
TPZFNMatrix< 9, REAL > jacinv
value of the inverse of the jacobian at the integration point
Implements the graphical element for a pyramid using a map to the cube element. Post processing...
virtual int NSides() const =0
Returns the number of connectivities of the element.
virtual int MaxOrder() override
Returns the max order of interpolation.
TPZBlock< STATE > fBlock
Block structure associated with fMat.
Contains the TPZGraphEl1d class which implements the graphical one dimensional element.
virtual TPZCompEl * ClonePatchEl(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.
TPZReducedSpace()
Default constructor.
virtual void Resize(const int64_t newsize, const T &object)
Resizes the vector object.
TPZFNMatrix< 9, REAL > jacobian
value of the jacobian at the integration point
virtual void Read(TPZStream &buf, void *context) override
Reads the element data from a stream.
TPZFNMatrix< 220, REAL > phi
vector of shapefunctions (format is dependent on the value of shapetype)
virtual int NShapeF() const override
It returns the shapes number of the element.
void InitializeElementMatrix(TPZElementMatrix &ek, TPZElementMatrix &ef) override
Initialize element matrix in which is computed CalcStiff.
void Write(TPZStream &buf, int withclassid) const override
Save the element data to a stream.
virtual void ComputeRequiredData(TPZMaterialData &data, TPZVec< REAL > &qsi) override
Compute and fill data with requested attributes.
TPZFNMatrix< 660, REAL > dphix
values of the derivative of the shape functions
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...
int ClassId() const override
Define the class id associated with the class.
virtual TPZMaterial * Material() const
Identify the material object associated with the element.
Implements a graphical element for a triangle mapped into de quadrilateral element. Post processing.
int64_t size() const
Returns the number of elements of the vector.
TPZCreateApproximationSpace & ApproxSpace()
int64_t SequenceNumber() const
Returns the Sequence number of the connect object.
static TPZCompEl * CreateReducedElement(TPZGeoEl *gel, TPZCompMesh &mesh, int64_t &index)
void Read(TPZStream &buf, void *context) override
Read the element data from a stream.
Contains the TPZGraphElT3d class which implements the graphical representation of a tetrahedra elemen...
Implements the graphical element for a prism using a degenerated cube element. Post processing...
Defines the behaviour of all geometric elements. GeometryTPZGeoEl is the common denominator for all g...
Contains the TPZGraphElQ2dd class which implements the graphical two-dimensional discontinuous elemen...
Implements the graphical representation of a tetrahedra element. Post processing. ...
Contains declaration of TPZCompMeshReferred class which implements the structure to allow one mesh to...
virtual void FillDataRequirements(TPZMaterialData &data)
Fill material data parameter with necessary requirements for the.
virtual void ComputeSolution(TPZVec< REAL > &qsi, TPZMaterialData &data) override
#define DebugStop()
Returns a message to user put a breakpoint in.
Contains the TPZGraphElPrismMapped class which implements the graphical element for a prism using a d...
TPZCompMesh * Mesh() const
Return a pointer to the grid of the element.
virtual ~TPZReducedSpace()
Default destructor.
void Jacobian(TPZVec< REAL > &qsi, TPZFMatrix< REAL > &jac, TPZFMatrix< REAL > &axes, REAL &detjac, TPZFMatrix< REAL > &jacinv) const
Compute a decomposition of the gradient of the mapping function, as a rotation matrix (Jacobian) and ...
Implements the structure to allow one mesh to refer to the solution of another. Geometry.
unsigned int NShape() const
int64_t Rows() const
Returns number of rows.
Contains the TPZGraphElT class which implements the graphical triangular element. ...
TPZFNMatrix< 9, REAL > axes
axes indicating the directions of the derivatives of the shapefunctions
const TPZBlock< STATE > & Block() const
Access the block structure of the solution vector.
Contains the TPZGraphMesh class which represents a graphical mesh used for post processing purposes...
Contains the TPZGraphElPyramidMapped class which implements the graphical element for a pyramid using...
int64_t Index() const
Returns element index of the mesh fELementVec list.
REAL HSize
measure of the size of the element
virtual int64_t ConnectIndex(int i) const override
Returns the index of the ith connectivity of the element.
int intGlobPtIndex
global point index
int SetNBlocks(const int num_of_blocks)
Sets number of blocks on diagonal matrix.
virtual void ComputeSolution(TPZVec< REAL > &qsi, TPZMaterialData &data)
int Redim(const int64_t newRows, const int64_t newCols) override
Redimension a matrix and ZERO your elements.
virtual TPZConnect & Connect(int i) const
Returns a pointer to the ith node.
int32_t Hash(std::string str)
This class associates an element matrix with the coeficients of its contribution in the global stiffn...
Implements the interfaces for TPZCompElDisc, TPZInterfaceElement and TPZInterpolatedElement. Computational element.
virtual void Write(TPZStream &buf, int withclassid) const override
Saves the element data to a stream.
virtual int Dimension() const =0
Returns the dimension of the element.
TPZGeoEl * Reference() const
Return a pointer to the corresponding geometric element if such exists, return 0 otherwise.
virtual void X(TPZVec< REAL > &qsi, TPZVec< REAL > &result) const =0
Return the coordinate in real space of the point coordinate in the master element space...
virtual void ComputeShape(TPZVec< REAL > &qsi, TPZMaterialData &data) override
Compute shape functions based on master element in the classical FEM manne.
Implements computational mesh. Computational Mesh.
int Size(const int block_diagonal) const
Returns block dimension.
Contains the TPZGraphElT2dMapped class which implements a graphical element for a triangle mapped int...
int NumLoadCases()
returns the number of load cases for this material object
void Fill(const T ©, const int64_t from=0, const int64_t numelem=-1)
Will fill the elements of the vector with a copy object.
int64_t Cols() const
Returns number of cols.
virtual int MaxOrder()
Returns the max order of interpolation.
int Resize(const int64_t newRows, const int64_t wCols) override
Redimension a matrix, but maintain your elements.
virtual void ComputeNormal(TPZMaterialData &data)
Computes the proper normal vector towards the neighbour element.
Defines the interface for saving and reading data. Persistency.
virtual TPZCompEl * Clone(TPZCompMesh &mesh) const override
Method for creating a copy of the element.
Contains the TPZGraphEl1dd class which implements the graphical one dimensional discontinuous element...
Contains the declaration of the Reduced Space class.
virtual REAL InnerRadius()
Returns the inner radius value.
virtual int NConnects() const override
Returns the number of nodes of the element.
static void SetAllCreateFunctionsReducedSpace(TPZCompMesh *cmesh)
Defines the interface of a computational element. Computational Element.
TPZSolVec sol
vector of the solutions at the integration point
virtual void Shape(TPZVec< REAL > &qsi, TPZFMatrix< REAL > &phi, TPZFMatrix< REAL > &dphi) override
Computes the shape function set at the point x.
Contains the TPZGraphElQ3dd class which implements the graphical three dimensional discontinuous elem...
TPZFMatrix< STATE > & Solution()
Access the solution vector.
REAL detjac
determinant of the jacobian
virtual void InitMaterialData(TPZMaterialData &data) override
Initialize a material data and its attributes based on element dimension, number of state variables a...