NeoPZ
Public Types | Public Member Functions | Public Attributes | List of all members
TPZMaterialData Class Reference

#include <pzmaterialdata.h>

Inheritance diagram for TPZMaterialData:
[legend]
Collaboration diagram for TPZMaterialData:
[legend]

Public Types

enum  MShapeFunctionType { EEmpty, EScalarShape, EVecandShape, EVecShape }
 

Public Member Functions

 TPZMaterialData ()
 Default constructor. More...
 
 TPZMaterialData (const TPZMaterialData &cp)
 Copy constructor. More...
 
 ~TPZMaterialData ()
 Default destructor. More...
 
void SetAllRequirements (bool set)
 Set all flags at once. More...
 
TPZMaterialDataoperator= (const TPZMaterialData &cp)
 
void Print (std::ostream &out) const
 Prints the data. More...
 
void PrintMathematica (std::ostream &out) const
 Prints the data in a format suitable for Mathematica. More...
 
void Write (TPZStream &buf, int withclassid) const override
 Saves the element data to a stream. More...
 
void Read (TPZStream &buf, void *context) override
 Reads the element data from a stream. More...
 
virtual bool Compare (TPZSavable *copy, bool override=false) override
 Compares the object for identity with the object pointed to, eventually copy the object. More...
 
virtual bool Compare (TPZSavable *copy, bool override=false) const override
 Compares the object for identity with the object pointed to, eventually copy the object. More...
 
void ComputeFluxValues (TPZFMatrix< REAL > &fluxes)
 Computes the flux values based on a Material of Hdiv approx space. More...
 
void ComputeFunctionDivergence ()
 Computes the flux divergence values based on a Material of Hdiv approx space. More...
 
int ClassId () const override
 Define the class id associated with the class. 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
 
- Public Member Functions inherited from TPZRegisterClassId
template<typename T >
 TPZRegisterClassId (int(T::*)() const)
 
 TPZRegisterClassId ()=default
 

Public Attributes

MShapeFunctionType fShapeType
 
int intLocPtIndex
 Index of the current integration point being evaluated. More...
 
int intGlobPtIndex
 global point index More...
 
int NintPts
 amount of points in the integrstion rule More...
 
Flags indicating whether some attributes shall be computed or not
bool fNeedsSol
 
bool fNeedsNeighborSol
 
bool fNeedsHSize
 
bool fNeedsNeighborCenter
 
bool fNeedsNormalVecFad
 
bool fNeedsNormal
 
bool fActiveApproxSpace
 
Attributes to be computed in CalcStiff
TPZFNMatrix< 220, REAL > phi
 vector of shapefunctions (format is dependent on the value of shapetype) More...
 
TPZFNMatrix< 660, REAL > dphi
 values of the derivative of the shape functions over the master element More...
 
TPZFNMatrix< 660, REAL > dphix
 values of the derivative of the shape functions More...
 
TPZFNMatrix< 220, REAL > divphi
 values of the divergence of the shapefunctions in the mapped element (only applicable to H(div)) spaces More...
 
TPZFNMatrix< 9, REAL > axes
 axes indicating the directions of the derivatives of the shapefunctions More...
 
TPZFNMatrix< 9, REAL > jacobian
 value of the jacobian at the integration point More...
 
TPZFNMatrix< 9, REAL > jacinv
 value of the inverse of the jacobian at the integration point More...
 
TPZManVector< REAL, 3 > normal
 normal to the element at the integration point More...
 
TPZManVector< REAL, 3 > x
 value of the coordinate at the integration point More...
 
TPZManVector< REAL, 3 > xParametric
 value of the coordinate at the integration point corresponding to the x-parametric coordinate (master element) More...
 
int p
 maximum polinomial order of the shape functions More...
 
TPZSolVec sol
 vector of the solutions at the integration point More...
 
TPZGradSolVec dsol
 vector of the derivatives of the solution at the integration point More...
 
TPZSolVec divsol
 vector of the divergence of the solution at the integration point (only of hdiv spaces) More...
 
REAL HSize
 measure of the size of the element More...
 
REAL detjac
 determinant of the jacobian More...
 
TPZManVector< REAL, 3 > XCenter
 value of the coordinate at the center of the element More...
 
TPZFNMatrix< 180 > fDirectionsOnMaster
 Directions on the master element. More...
 
int numberdualfunctions
 number of dual function (e.g. pressure in HDiv approximations) More...
 
int gelElId
 
TPZManVector< std::pair< int, int64_t > > fVecShapeIndex
 correspondence between normal vector index and index of the shape functions More...
 
TPZFNMatrix< 180 > fNormalVec
 list of normal vectors More...
 

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 TPZSavableCreateInstance (const int &classId)
 

Detailed Description

Definition at line 33 of file pzmaterialdata.h.

Member Enumeration Documentation

◆ MShapeFunctionType

Enumerator
EEmpty 
EScalarShape 
EVecandShape 
EVecShape 

Definition at line 38 of file pzmaterialdata.h.

Constructor & Destructor Documentation

◆ TPZMaterialData() [1/2]

TPZMaterialData::TPZMaterialData ( )

◆ TPZMaterialData() [2/2]

TPZMaterialData::TPZMaterialData ( const TPZMaterialData cp)

Copy constructor.

Definition at line 41 of file pzmaterialdata.cpp.

References operator=().

◆ ~TPZMaterialData()

TPZMaterialData::~TPZMaterialData ( )

Default destructor.

Definition at line 86 of file pzmaterialdata.cpp.

Member Function Documentation

◆ ClassId()

int TPZMaterialData::ClassId ( ) const
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 TPZMatPorous< T, TMEM >, and TPZMatTemporal.

Definition at line 303 of file pzmaterialdata.cpp.

References Hash().

Referenced by TPZMatTemporal::ClassId().

◆ Compare() [1/2]

bool TPZMaterialData::Compare ( TPZSavable copy,
bool  override = false 
)
overridevirtual

Compares the object for identity with the object pointed to, eventually copy the object.

Compare the object for identity with the object pointed to, eventually copy the object.

Compares both objects bitwise for identity. Put an entry in the log file if different overwrite the calling object if the override flag is true

compare both objects bitwise for identity. Put an entry in the log file if different overwrite the calling object if the override flag is true

Reimplemented from TPZSavable.

Definition at line 100 of file pzmaterialdata.cpp.

References axes, TPZFMatrix< TVar >::Compare(), divphi, dphi, dphix, jacinv, jacobian, LOGPZ_DEBUG, and phi.

◆ Compare() [2/2]

bool TPZMaterialData::Compare ( TPZSavable copy,
bool  override = false 
) const
overridevirtual

Compares the object for identity with the object pointed to, eventually copy the object.

Compares both objects bitwise for identity. Put an entry in the log file if different overwrite the calling object if the override flag is true

Reimplemented from TPZSavable.

Definition at line 156 of file pzmaterialdata.cpp.

References DebugStop.

◆ ComputeFluxValues()

void TPZMaterialData::ComputeFluxValues ( TPZFMatrix< REAL > &  fluxes)

Computes the flux values based on a Material of Hdiv approx space.

Definition at line 308 of file pzmaterialdata.cpp.

References EVecandShape, fNormalVec, fShapeType, fVecShapeIndex, phi, TPZFMatrix< TVar >::Redim(), and TPZVec< T >::size().

◆ ComputeFunctionDivergence()

void TPZMaterialData::ComputeFunctionDivergence ( )

Computes the flux divergence values based on a Material of Hdiv approx space.

Compute the divergence of the shape functions.

Definition at line 330 of file pzmaterialdata.cpp.

References detjac, divphi, dphi, fDirectionsOnMaster, fVecShapeIndex, TPZVec< T >::NElements(), TPZFMatrix< TVar >::Redim(), and TPZMatrix< TVar >::Rows().

Referenced by TPZCompElHDiv< TSHAPE >::ComputeRequiredData().

◆ operator=()

TPZMaterialData & TPZMaterialData::operator= ( const TPZMaterialData cp)

◆ Print()

void TPZMaterialData::Print ( std::ostream &  out) const

◆ PrintMathematica()

void TPZMaterialData::PrintMathematica ( std::ostream &  out) const

Prints the data in a format suitable for Mathematica.

Print the data in a format suitable for Mathematica

Definition at line 193 of file pzmaterialdata.cpp.

References axes, detjac, divsol, dphi, dphix, dsol, EMathematicaInput, fDirectionsOnMaster, gelElId, HSize, intGlobPtIndex, intLocPtIndex, jacinv, jacobian, NintPts, normal, p, phi, TPZVec< T >::Print(), TPZMatrix< TVar >::Print(), TPZVec< T >::size(), sol, x, and XCenter.

Referenced by TPZElasticityAxiMaterial::ContributeInterface().

◆ Read()

void TPZMaterialData::Read ( TPZStream buf,
void *  context 
)
overridevirtual

Reads the element data from a stream.

Read the element data from a stream

Reimplemented from TPZSavable.

Reimplemented in TPZMatPorous< T, TMEM >.

Definition at line 265 of file pzmaterialdata.cpp.

References axes, detjac, divphi, divsol, dphi, dphix, dsol, fShapeType, gelElId, HSize, intGlobPtIndex, intLocPtIndex, jacinv, jacobian, NintPts, normal, p, phi, TPZStream::Read(), TPZFNMatrix< N, TVar >::Read(), sol, x, and XCenter.

◆ SetAllRequirements()

void TPZMaterialData::SetAllRequirements ( bool  set)

◆ Write()

void TPZMaterialData::Write ( TPZStream buf,
int  withclassid 
) const
overridevirtual

Saves the element data to a stream.

Save the element data to a stream

Reimplemented from TPZSavable.

Reimplemented in TPZMatPorous< T, TMEM >.

Definition at line 224 of file pzmaterialdata.cpp.

References axes, TPZVec< T >::begin(), detjac, divphi, divsol, dphi, dphix, dsol, fShapeType, gelElId, HSize, intGlobPtIndex, intLocPtIndex, jacinv, jacobian, NintPts, normal, p, phi, TPZVec< T >::size(), sol, TPZStream::Write(), TPZFNMatrix< N, TVar >::Write(), x, and XCenter.

Member Data Documentation

◆ axes

TPZFNMatrix<9,REAL> TPZMaterialData::axes

axes indicating the directions of the derivatives of the shapefunctions

Definition at line 63 of file pzmaterialdata.h.

Referenced by TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZInterfaceElement::CalcResidual(), TPZInterfaceElement::CalcStiff(), Compare(), TPZMatElastoPlastic2D< T, TMEM >::ComputeDeltaStrainVector(), TPZMatElastoPlastic< T, TMEM >::ComputeDeltaStrainVector(), TPZInterpolationSpace::ComputeError(), TPZInterfaceElement::ComputeErrorFace(), TPZSBFemVolume::ComputeKMatrices(), TPZInterpolationSpace::ComputeNormal(), TPZInterfaceElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZCompElHDivBound2< TSHAPE >::ComputeShape(), TPZInterpolationSpace::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZReferredCompEl< TCOMPEL >::ComputeSolution(), TPZReducedSpace::ComputeSolution(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZMatHybrid::Contribute(), TPZLinearConvection::Contribute(), TPZBCTension::Contribute(), TPZPlaca::Contribute(), TPZBurger::Contribute(), TPZMatOrthotropic::Contribute(), TPZMatPlaca2::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZEuler::Contribute(), TPZLinearConvecDiff::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMatPoisson3dReferred::Contribute(), TPZMat2dLin::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZMatElastoPlastic< T, TMEM >::Contribute(), TPZElasticity3D::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZMatConvectionProblem::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatPoisson3d::Contribute(), TPZMatElasticity2D::Contribute(), TPZLinearConvecDiff::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZSpaceTimeRichardsEq::ContributeBC(), TPZBurger::ContributeBC(), TPZMat2dLin::ContributeBC(), TPZElasticityAxiMaterial::ContributeBC(), TPZNullMaterial::ContributeBC(), TPZMatPoisson3d::ContributeBC(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZMatDualHybridPoisson::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZMatConvectionProblem::ContributeInterface(), TPZMatLaplacian::ContributeInterface(), TPZMatPoisson3d::ContributeInterface(), TPZMatElasticity2D::ContributeVec(), TPZElasticityMaterial::ContributeVecShape(), TPZElasticityAxiMaterial::Errors(), TPZMatConvectionProblem::Errors(), TPZMaterial::Errors(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZMatPorous< T, TMEM >::Flux(), TPZTracerFlow::FractureFactor(), TPZInterfaceElement::InitMaterialData(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZInterfaceElement::IntegrateInterface(), TPZInterpolationSpace::IntegrateSolution(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZSBFemVolume::Shape(), TPZReducedSpace::ShapeX(), TPZMultPlaca::Solution(), TPZMultCamada::Solution(), TPZLinearConvecDiff::Solution(), TPZMatHybrid::Solution(), TPZLinearConvection::Solution(), TPZMatOrthotropic::Solution(), TPZPlaca::Solution(), TPZEuler::Solution(), TPZConsLawTest::Solution(), TPZVecL2::Solution(), TPZMatDualHybridPoisson::Solution(), TPZThermicElast3D::Solution(), TPZNullMaterial::Solution(), TPZElasticityAxiMaterial::Solution(), TPZCoupledTransportDarcy::Solution(), TPZMatConvectionProblem::Solution(), TPZElasticityMaterial::Solution(), TPZMatElasticity2D::Solution(), TPZMatLaplacian::Solution(), TPZMaterial::Solution(), TPZMatPoisson3d::Solution(), TPZMixedElasticityMaterial::Solution(), TPZSwelling::Solution(), TPZSBFemVolume::Solution(), and Write().

◆ detjac

REAL TPZMaterialData::detjac

◆ divphi

TPZFNMatrix<220, REAL> TPZMaterialData::divphi

values of the divergence of the shapefunctions in the mapped element (only applicable to H(div)) spaces

Definition at line 61 of file pzmaterialdata.h.

Referenced by Compare(), ComputeFunctionDivergence(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), operator=(), Print(), Read(), and Write().

◆ divsol

TPZSolVec TPZMaterialData::divsol

vector of the divergence of the solution at the integration point (only of hdiv spaces)

Definition at line 81 of file pzmaterialdata.h.

Referenced by TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), operator=(), Print(), PrintMathematica(), Read(), and Write().

◆ dphi

TPZFNMatrix<660, REAL> TPZMaterialData::dphi

◆ dphix

TPZFNMatrix<660, REAL> TPZMaterialData::dphix

values of the derivative of the shape functions

Definition at line 59 of file pzmaterialdata.h.

Referenced by TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZAgglomerateElement::CalcStiff(), Compare(), TPZInterpolationSpace::ComputeError(), TPZSBFemVolume::ComputeKMatrices(), TPZInterfaceElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZReducedSpace::ComputeSolution(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZMatHybrid::Contribute(), TPZLinearConvection::Contribute(), TPZBCTension::Contribute(), TPZViscoelastic::Contribute(), TPZPlaca::Contribute(), TPZBurger::Contribute(), TPZMaterialTest::Contribute(), TPZMatOrthotropic::Contribute(), TPZMatPlaca2::Contribute(), TPZMaterialTest3D::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZBiharmonic::Contribute(), TPZMatHyperElastic::Contribute(), TPZConsLawTest::Contribute(), TPZEuler::Contribute(), TPZLinearConvecDiff::Contribute(), TPZNLMat1d::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZReynoldsFlow::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMat2dLin::Contribute(), TPZMatDualHybridPoisson::Contribute(), TPZThermicElast3D::Contribute(), TPZMat1dLin::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZPrimalPoisson::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZMatElastoPlastic< T, TMEM >::Contribute(), TPZElasticity3D::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZMatLaplacian::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatPoisson3d::Contribute(), TPZMatElasticity2D::Contribute(), TPZEulerConsLaw::Contribute(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZBiharmonic::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZMatLaplacian::ContributeBCInterface(), TPZMatPoisson3d::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsSimple(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZMatDualHybridPoisson::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZBurger::ContributeInterface(), TPZBiharmonic::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZMatConvectionProblem::ContributeInterface(), TPZMatLaplacian::ContributeInterface(), TPZMatPoisson3d::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZMatElasticity2D::ContributeVec(), TPZElasticityMaterial::ContributeVecShape(), TPZElasticity3D::ContributeVecShape(), TPZElast3Dnlinear::ContributeVecShapeAux(), TPZInterpolationSpace::EvaluateError(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZSBFemVolume::ExtendShapeFunctions(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZReducedSpace::ShapeX(), and Write().

◆ dsol

TPZGradSolVec TPZMaterialData::dsol

vector of the derivatives of the solution at the integration point

Definition at line 79 of file pzmaterialdata.h.

Referenced by TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZAgglomerateElement::CalcStiff(), TPZMatElastoPlastic2D< T, TMEM >::ComputeDeltaStrainVector(), TPZMatElastoPlastic< T, TMEM >::ComputeDeltaStrainVector(), TPZInterpolationSpace::ComputeError(), TPZSBFemVolume::ComputeKMatrices(), TPZMatPorous< T, TMEM >::ComputePorePressure(), TPZInterfaceElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZReferredCompEl< TCOMPEL >::ComputeSolution(), TPZReducedSpace::ComputeSolution(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZViscoelastic::ComputeStressTensor(), TPZElasticity3D::ComputeStressTensor(), TPZBCTension::Contribute(), TPZViscoelastic::Contribute(), TPZBurger::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZMatHyperElastic::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMatPoisson3dReferred::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZPrimalPoisson::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZCoupledTransportDarcyBC::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZCoupledTransportDarcy::Contribute(), TPZMatLaplacian::Contribute(), TPZMatElasticity2D::Contribute(), TPZEulerConsLaw::Contribute(), TPZMatElasticity2D::ContributeBC(), TPZMatPoisson3dReferred::ContributeBCInterface(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZCoupledTransportDarcy::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsDual(), TPZMatPoisson3dReferred::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZBurger::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZCoupledTransportDarcyBC::ContributeInterface(), TPZCoupledTransportDarcy::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), TPZMatElasticity2D::ContributeVec(), TPZElast3Dnlinear::ContributeVecShapeAux(), TPZElasticityAxiMaterial::Errors(), TPZMatConvectionProblem::Errors(), TPZMaterial::Errors(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZInterfaceElement::IntegrateInterface(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZReducedSpace::ShapeX(), TPZMultPlaca::Solution(), TPZMatElastoPlastic2D< T, TMEM >::Solution(), TPZLinearConvecDiff::Solution(), TPZMultCamada::Solution(), TPZMatHybrid::Solution(), TPZLinearConvection::Solution(), TPZMatOrthotropic::Solution(), TPZPlaca::Solution(), TPZEuler::Solution(), TPZViscoelastic::Solution(), TPZConsLawTest::Solution(), TPZVecL2::Solution(), TPZMatDualHybridPoisson::Solution(), TPZThermicElast3D::Solution(), TPZNullMaterial::Solution(), TPZPrimalPoisson::Solution(), TPZElasticityAxiMaterial::Solution(), TPZCoupledTransportDarcy::Solution(), TPZMatConvectionProblem::Solution(), TPZElasticityMaterial::Solution(), TPZMatElasticity2D::Solution(), TPZMatLaplacian::Solution(), TPZMaterial::Solution(), TPZMatPoisson3d::Solution(), TPZMixedElasticityMaterial::Solution(), TPZSwelling::Solution(), TPZSBFemVolume::Solution(), TPZMaterialData(), TPZMatPorous< T, TMEM >::UpdatePorePressure(), TPZViscoelastic::UpdateQsi(), and Write().

◆ fActiveApproxSpace

bool TPZMaterialData::fActiveApproxSpace

Definition at line 48 of file pzmaterialdata.h.

◆ fDirectionsOnMaster

TPZFNMatrix<180> TPZMaterialData::fDirectionsOnMaster

◆ fNeedsHSize

bool TPZMaterialData::fNeedsHSize

◆ fNeedsNeighborCenter

bool TPZMaterialData::fNeedsNeighborCenter

◆ fNeedsNeighborSol

bool TPZMaterialData::fNeedsNeighborSol

◆ fNeedsNormal

bool TPZMaterialData::fNeedsNormal

◆ fNeedsNormalVecFad

bool TPZMaterialData::fNeedsNormalVecFad

◆ fNeedsSol

bool TPZMaterialData::fNeedsSol

Definition at line 46 of file pzmaterialdata.h.

Referenced by TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZInterfaceElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZCompElHDiv< TSHAPE >::ComputeRequiredData(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZPrimalPoisson::FillBoundaryConditionDataRequirement(), TPZDualPoisson::FillBoundaryConditionDataRequirement(), TPZMatElastoPlastic2D< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZMaterial::FillBoundaryConditionDataRequirement(), TPZMatLaplacian::FillBoundaryConditionDataRequirement(), TPZMatPoisson3d::FillBoundaryConditionDataRequirement(), TPZElasticityMaterial::FillBoundaryConditionDataRequirement(), TPZElasticity3D::FillBoundaryConditionDataRequirement(), TPZMatElasticity2D::FillBoundaryConditionDataRequirement(), TPZMixedElasticityMaterial::FillBoundaryConditionDataRequirement(), TPZMatElastoPlastic< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZElast3Dnlinear::FillDataRequirements(), TPZPrimalPoisson::FillDataRequirements(), TPZDualPoisson::FillDataRequirements(), TPZViscoelastic::FillDataRequirements(), TPZMatLaplacian::FillDataRequirements(), TPZElasticityMaterial::FillDataRequirements(), TPZPostProcMat::FillDataRequirements(), TPZElasticity3D::FillDataRequirements(), TPZMatElasticity2D::FillDataRequirements(), TPZMixedElasticityMaterial::FillDataRequirements(), TPZMatElastoPlastic< T, TMEM >::FillDataRequirements(), TPZBndCond::FillDataRequirements(), TPZDiscontinuousGalerkin::FillDataRequirementsInterface(), TPZTracerFlow::FillDataRequirementsInterface(), TPZInterfaceElement::InitMaterialData(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZInterpolationSpace::IntegrateSolution(), operator=(), and SetAllRequirements().

◆ fNormalVec

TPZFNMatrix<180> TPZMaterialData::fNormalVec

◆ fShapeType

MShapeFunctionType TPZMaterialData::fShapeType

◆ fVecShapeIndex

TPZManVector<std::pair<int,int64_t> > TPZMaterialData::fVecShapeIndex

◆ gelElId

int TPZMaterialData::gelElId

◆ HSize

REAL TPZMaterialData::HSize

◆ intGlobPtIndex

int TPZMaterialData::intGlobPtIndex

◆ intLocPtIndex

int TPZMaterialData::intLocPtIndex

◆ jacinv

TPZFNMatrix<9,REAL> TPZMaterialData::jacinv

value of the inverse of the jacobian at the integration point

Definition at line 67 of file pzmaterialdata.h.

Referenced by TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZInterfaceElement::CalcResidual(), TPZInterfaceElement::CalcStiff(), Compare(), TPZInterpolationSpace::ComputeError(), TPZInterfaceElement::ComputeErrorFace(), TPZSBFemVolume::ComputeKMatrices(), TPZReducedSpace::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZCompElHDivBound2< TSHAPE >::ComputeShape(), TPZInterpolationSpace::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZLinearConvection::Contribute(), TPZBCTension::Contribute(), TPZBurger::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZEuler::Contribute(), TPZMatPoisson3d::Contribute(), TPZEulerConsLaw::Contribute(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZSBFemVolume::ExtendShapeFunctions(), TPZInterfaceElement::InitMaterialData(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZInterfaceElement::IntegrateInterface(), TPZInterpolationSpace::IntegrateSolution(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZSBFemVolume::Shape(), and Write().

◆ jacobian

TPZFNMatrix<9,REAL> TPZMaterialData::jacobian

◆ NintPts

int TPZMaterialData::NintPts

amount of points in the integrstion rule

Definition at line 118 of file pzmaterialdata.h.

Referenced by operator=(), Print(), PrintMathematica(), Read(), TPZMaterialData(), and Write().

◆ normal

TPZManVector<REAL,3> TPZMaterialData::normal

normal to the element at the integration point

Definition at line 69 of file pzmaterialdata.h.

Referenced by TPZGradientFlux::ApplyLimiter(), TPZMultiphase::ApplyPN(), TPZMultiphase::ApplyQnD(), TPZMultiphase::ApplySin(), TPZMultiphase::ApplySout(), TPZInterfaceElement::CalcResidual(), TPZInterfaceElement::ComputeErrorFace(), TPZInterpolationSpace::ComputeNormal(), TPZInterfaceElement::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZMatHyperElastic::ContributeBC(), TPZMatElastoPlastic2D< T, TMEM >::ContributeBC(), TPZMatElastoPlastic< T, TMEM >::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZElasticityMaterial::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZMixedElasticityMaterial::ContributeBC(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZMultiphase::ContributeBCInterface(), TPZTracerFlow::ContributeBCInterface(), TPZBiharmonic::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZMatConvectionProblem::ContributeBCInterface(), TPZEulerEquation::ContributeBCInterface(), TPZMatLaplacian::ContributeBCInterface(), TPZMatPoisson3d::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZMaterialCoupling::ContributeInterface(), TPZConsLawTest::ContributeInterface(), TPZHybridPoisson::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZMatDualHybridPoisson::ContributeInterface(), TPZBurger::ContributeInterface(), TPZMultiphase::ContributeInterface(), TPZTracerFlow::ContributeInterface(), TPZBiharmonic::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZEulerEquation::ContributeInterface(), TPZMatConvectionProblem::ContributeInterface(), TPZMatLaplacian::ContributeInterface(), TPZMatPoisson3d::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZBndCond::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBndCond::ContributeInterfaceErrors(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), TPZMatElastoPlastic2D< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZInterfaceElement::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZInterfaceElement::IntegrateInterface(), operator=(), Print(), PrintMathematica(), Read(), and Write().

◆ numberdualfunctions

int TPZMaterialData::numberdualfunctions

◆ p

int TPZMaterialData::p

◆ phi

TPZFNMatrix<220, REAL> TPZMaterialData::phi

vector of shapefunctions (format is dependent on the value of shapetype)

Definition at line 55 of file pzmaterialdata.h.

Referenced by TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZAgglomerateElement::CalcStiff(), Compare(), TPZInterpolationSpace::ComputeError(), ComputeFluxValues(), TPZSBFemVolume::ComputeKMatrices(), TPZInterfaceElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZCompElHDivBound2< TSHAPE >::ComputeShape(), TPZInterpolationSpace::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZReducedSpace::ComputeSolution(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZMatHybrid::Contribute(), TPZTransientMaterial< TBASEMAT >::Contribute(), TPZLinearConvection::Contribute(), TPZBCTension::Contribute(), TPZPlaca::Contribute(), TPZViscoelastic::Contribute(), TPZBurger::Contribute(), TPZMaterialTest::Contribute(), TPZMatOrthotropic::Contribute(), TPZMatPlaca2::Contribute(), TPZMaterialTest3D::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZBiharmonic::Contribute(), TPZMatHyperElastic::Contribute(), TPZConsLawTest::Contribute(), TPZEuler::Contribute(), TPZLinearConvecDiff::Contribute(), TPZNLMat1d::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZReynoldsFlow::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMat2dLin::Contribute(), TPZMatDualHybridPoisson::Contribute(), TPZL2Projection::Contribute(), TPZThermicElast3D::Contribute(), TPZMat1dLin::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZPrimalPoisson::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZPostProcMat::Contribute(), TPZMatElastoPlastic< T, TMEM >::Contribute(), TPZElasticity3D::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZVecL2::Contribute(), TPZMatConvectionProblem::Contribute(), TPZMatLaplacian::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatPoisson3d::Contribute(), TPZMatElasticity2D::Contribute(), TPZEulerConsLaw::Contribute(), TPZMatHybrid::ContributeBC(), TPZLinearConvection::ContributeBC(), TPZPlaca::ContributeBC(), TPZMaterialTest3D::ContributeBC(), TPZMatOrthotropic::ContributeBC(), TPZMaterialTest::ContributeBC(), TPZMatPlaca2::ContributeBC(), TPZElasticity2DHybrid::ContributeBC(), TPZLinearConvecDiff::ContributeBC(), TPZMatHyperElastic::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZConsLawTest::ContributeBC(), TPZSpaceTimeRichardsEq::ContributeBC(), TPZBurger::ContributeBC(), TPZMat2dLin::ContributeBC(), TPZMatDualHybridPoisson::ContributeBC(), TPZReynoldsFlow::ContributeBC(), TPZMat1dLin::ContributeBC(), TPZPrimalPoisson::ContributeBC(), TPZMatElastoPlastic2D< T, TMEM >::ContributeBC(), TPZElasticityAxiMaterial::ContributeBC(), TPZMatElastoPlastic< T, TMEM >::ContributeBC(), TPZL2Projection::ContributeBC(), TPZNullMaterial::ContributeBC(), TPZMatPorous< T, TMEM >::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZElasticityMaterial::ContributeBC(), TPZVecL2::ContributeBC(), TPZSwelling::ContributeBC(), TPZMatLaplacian::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZMixedElasticityMaterial::ContributeBC(), TPZMatPoisson3d::ContributeBC(), TPZEulerConsLaw::ContributeBC(), TPZMatLaplacian::ContributeBCHDiv(), TPZMatPoisson3d::ContributeBCHDiv(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZBiharmonic::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZMatConvectionProblem::ContributeBCInterface(), TPZMatLaplacian::ContributeBCInterface(), TPZMatPoisson3d::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsSimple(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZMaterialCoupling::ContributeInterface(), TPZConsLawTest::ContributeInterface(), TPZHybridPoisson::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZMatDualHybridPoisson::ContributeInterface(), TPZBurger::ContributeInterface(), TPZBiharmonic::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZCoupledTransportDarcyBC::ContributeInterface(), TPZLagrangeMultiplier::ContributeInterface(), TPZMatConvectionProblem::ContributeInterface(), TPZMatLaplacian::ContributeInterface(), TPZMatPoisson3d::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZBndCond::ContributeInterface(), TPZMaterialCoupling::ContributeInterface2(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsSimple(), TPZBiharmonicEstimator::ContributeInterfaceErrorsSimple(), TPZMatElasticity2D::ContributeVec(), TPZL2Projection::ContributeVecShape(), TPZElasticityMaterial::ContributeVecShape(), TPZElasticity3D::ContributeVecShape(), TPZElast3Dnlinear::ContributeVecShapeAux(), TPZElasticity3D::ContributeVecShapeBC(), TPZElasticityMaterial::ContributeVecShapeBC(), TPZElast3Dnlinear::ContributeVecShapeBCAux(), TPZCompElPostProc< TCOMPEL >::dataequal(), TPZInterpolationSpace::EvaluateError(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZSBFemVolume::ExtendShapeFunctions(), TPZMatElastoPlastic2D< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZMixedElasticityMaterial::FillVecShapeIndex(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZSBFemVolume::Shape(), TPZReducedSpace::ShapeX(), and Write().

◆ sol

TPZSolVec TPZMaterialData::sol

vector of the solutions at the integration point

Definition at line 77 of file pzmaterialdata.h.

Referenced by TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZMatElastoPlastic< T, TMEM >::ApplyDeltaStrain(), TPZMatElastoPlastic< T, TMEM >::ApplyDeltaStrainComputeDep(), TPZGradientFlux::ApplyLimiter(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZAgglomerateElement::CalcStiff(), TPZInterpolationSpace::ComputeError(), TPZMatPorous< T, TMEM >::ComputePorePressure(), TPZInterfaceElement::ComputeRequiredData(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZReferredCompEl< TCOMPEL >::ComputeSolution(), TPZReducedSpace::ComputeSolution(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZTransientMaterial< TBASEMAT >::Contribute(), TPZBCTension::Contribute(), TPZBurger::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZConsLawTest::Contribute(), TPZEuler::Contribute(), TPZReynoldsFlow::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZL2Projection::Contribute(), TPZThermicElast3D::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZPostProcMat::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZEulerConsLaw::Contribute(), TPZMatHyperElastic::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZSpaceTimeRichardsEq::ContributeBC(), TPZBurger::ContributeBC(), TPZPrimalPoisson::ContributeBC(), TPZMatElastoPlastic2D< T, TMEM >::ContributeBC(), TPZMatElastoPlastic< T, TMEM >::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZSwelling::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZEulerEquation::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsDual(), TPZConsLawTest::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZBurger::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZEulerEquation::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBndCond::ContributeInterfaceErrors(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), TPZMatElasticity2D::ContributeVec(), TPZL2Projection::ContributeVecShape(), TPZElast3Dnlinear::ContributeVecShapeBCAux(), TPZElasticityAxiMaterial::Errors(), TPZMatConvectionProblem::Errors(), TPZMaterial::Errors(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZMatElastoPlastic2D< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZInterfaceElement::IntegrateInterface(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZReducedSpace::ShapeX(), TPZMultPlaca::Solution(), TPZMatElastoPlastic2D< T, TMEM >::Solution(), TPZLinearConvecDiff::Solution(), TPZMultCamada::Solution(), TPZMatHybrid::Solution(), TPZLinearConvection::Solution(), TPZMatElastoPlastic< T, TMEM >::Solution(), TPZMatOrthotropic::Solution(), TPZPlaca::Solution(), TPZEuler::Solution(), TPZViscoelastic::Solution(), TPZConsLawTest::Solution(), TPZVecL2::Solution(), TPZMatDualHybridPoisson::Solution(), TPZThermicElast3D::Solution(), TPZNullMaterial::Solution(), TPZPostProcMat::Solution(), TPZPrimalPoisson::Solution(), TPZElasticityAxiMaterial::Solution(), TPZCoupledTransportDarcy::Solution(), TPZMatConvectionProblem::Solution(), TPZElasticityMaterial::Solution(), TPZMatElasticity2D::Solution(), TPZMatLaplacian::Solution(), TPZMaterial::Solution(), TPZMatPoisson3d::Solution(), TPZMixedElasticityMaterial::Solution(), TPZSwelling::Solution(), TPZMatMixedPoisson3D::Solution(), TPZSBFemVolume::Solution(), TPZMaterialData(), TPZMatPorous< T, TMEM >::UpdatePorePressure(), and Write().

◆ x

TPZManVector<REAL,3> TPZMaterialData::x

value of the coordinate at the integration point

Definition at line 71 of file pzmaterialdata.h.

Referenced by TPZMatElastoPlastic< T, TMEM >::ApplyDeltaStrain(), TPZMatElastoPlastic< T, TMEM >::ApplyDeltaStrainComputeDep(), TPZGradientFlux::ApplyLimiter(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZAgglomerateElement::CalcStiff(), TPZInterfaceElement::CalcStiff(), TPZInterpolationSpace::ComputeError(), TPZSBFemVolume::ComputeKMatrices(), TPZReducedSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZCompElHDivPressure< TSHAPE >::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZMatHybrid::Contribute(), TPZBCTension::Contribute(), TPZPlaca::Contribute(), TPZBurger::Contribute(), TPZMaterialTest::Contribute(), TPZMatOrthotropic::Contribute(), TPZMatPlaca2::Contribute(), TPZMaterialTest3D::Contribute(), TPZBiharmonic::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZMatHyperElastic::Contribute(), TPZEuler::Contribute(), TPZConsLawTest::Contribute(), TPZLinearConvecDiff::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZMat2dLin::Contribute(), TPZMatDualHybridPoisson::Contribute(), TPZL2Projection::Contribute(), TPZMat1dLin::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZPrimalPoisson::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZMatElastoPlastic< T, TMEM >::Contribute(), TPZElasticity3D::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZVecL2::Contribute(), TPZMatConvectionProblem::Contribute(), TPZMatLaplacian::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatPoisson3d::Contribute(), TPZMatElasticity2D::Contribute(), TPZEulerConsLaw::Contribute(), TPZBndCond::Contribute(), TPZElasticity2DHybrid::ContributeBC(), TPZLinearConvecDiff::ContributeBC(), TPZMatDualHybridPoisson::ContributeBC(), TPZPrimalPoisson::ContributeBC(), TPZElasticityAxiMaterial::ContributeBC(), TPZNullMaterial::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZVecL2::ContributeBC(), TPZMatLaplacian::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZMatPoisson3d::ContributeBC(), TPZMatLaplacian::ContributeBCHDiv(), TPZMatPoisson3d::ContributeBCHDiv(), TPZMatLaplacian::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsDual(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZConsLawTest::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZBndCond::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBndCond::ContributeInterfaceErrors(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), TPZMatElasticity2D::ContributeVec(), TPZL2Projection::ContributeVecShape(), TPZElasticityMaterial::ContributeVecShape(), TPZElasticity3D::ContributeVecShape(), TPZElast3Dnlinear::ContributeVecShapeAux(), TPZCompElPostProc< TCOMPEL >::dataequal(), TPZElasticityAxiMaterial::Errors(), TPZMatConvectionProblem::Errors(), TPZMaterial::Errors(), TPZVecL2::ErrorsHdiv(), TPZMatLaplacian::ErrorsHdiv(), TPZMatPoisson3d::ErrorsHdiv(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZMatPorous< T, TMEM >::Flux(), TPZInterfaceElement::InitMaterialData(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZMatPoisson3d::LocalNeumanContribute(), operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), Print(), PrintMathematica(), TPZInterpolationSpace::ProjectFlux(), Read(), TPZMatDualHybridPoisson::Solution(), TPZPrimalPoisson::Solution(), TPZCompElHDivPressure< TSHAPE >::Solution(), TPZElasticityAxiMaterial::Solution(), TPZMatConvectionProblem::Solution(), TPZElasticityMaterial::Solution(), TPZInterpolationSpace::Solution(), TPZMatLaplacian::Solution(), TPZMatPoisson3d::Solution(), TPZMixedElasticityMaterial::Solution(), TPZSBFemVolume::Solution(), and Write().

◆ XCenter

TPZManVector<REAL,3> TPZMaterialData::XCenter

◆ xParametric

TPZManVector<REAL,3> TPZMaterialData::xParametric

value of the coordinate at the integration point corresponding to the x-parametric coordinate (master element)

Definition at line 73 of file pzmaterialdata.h.

Referenced by TPZInterpolationSpace::ComputeRequiredData().


The documentation for this class was generated from the following files: