NeoPZ
Classes | Macros | Enumerations | Functions | Variables
The Common classes

Defines type of the floating point calculations used in.
Defines timer object to calculate CPU time used in the execution of code snippets. More...

Classes

struct  TPZCounter
 Implements a counter by operations. Common. More...
 
class  TPZFlopCounter
 This class implements floating point number associated with a counter of the operations performed with it by type.
(arithmetic, trigonometric, exponencial and logarithmic operations performed with it). Common. More...
 
class  TPZGuiInterface
 This class implements a very simple interface from PZ kernel to GUI. Module: Common. More...
 

Macros

#define PZError
 Defines the output device to error messages and the DebugStop() function. More...
 
#define DebugStop()
 Returns a message to user put a breakpoint in. More...
 
#define MadpackVersion
 Mad pack version. More...
 
#define MadpackReleaseDate
 Mad pack release version. More...
 

Enumerations

enum  MElementType {
  EPoint, EOned, ETriangle, EQuadrilateral,
  ETetraedro, EPiramide, EPrisma, ECube,
  EPolygonal, EInterface, EInterfacePoint, EInterfaceLinear,
  EInterfaceSurface, ESubstructure, EGlobLoc, EDiscontinuous,
  EAgglomerate, ENoType, EInterfaceDisc
}
 Define the element types. More...
 
enum  MOptype {
  ESum, EProd, EDiv, ESqrt,
  EPow, ECos, ESin, EAcos,
  EAsin, EAtan, EExp, ELog
}
 Types of operations to be counted. More...
 

Functions

int MElementType_NNodes (MElementType elType)
 constant which defines the type of HDiv approximation space More...
 
std::string MElementType_Name (MElementType elType)
 Returns the name of the element type. More...
 
std::ostream & operator<< (std::ostream &out, const TPZCounter &count)
 Re-implements << operator to show the counter (count) data. More...
 
float fabs (std::complex< float > __x)
 This is the type of floating point number PZ will use. More...
 
double fabs (std::complex< double > __x)
 
long double fabs (std::complex< long double > __x)
 
TPZFlopCounter sqrt (const TPZFlopCounter &orig)
 Returns the square root of the value and increments the counter of the square root. More...
 
TPZFlopCounter fabsFlop (const TPZFlopCounter &orig)
 Returns the absolute value and doesn't increments the counters. More...
 
REAL fabs (const TPZFlopCounter &orig)
 Returns the absolute value as REAL and doesn't increments the counters. More...
 
TPZFlopCounter pow (const TPZFlopCounter &orig, const TPZFlopCounter &xp)
 Returns the power and increments the counter of the power. More...
 
TPZFlopCounter acos (const TPZFlopCounter &orig)
 Returns the arc cosine in radians and increments the counter of the Arc Cosine. More...
 
TPZFlopCounter asin (const TPZFlopCounter &orig)
 Returns the arc sine in radians and increments the counter of the Arc Sine. More...
 
TPZFlopCounter cos (const TPZFlopCounter &orig)
 Returns the cosine in radians and increments the counter of the Cosine. More...
 
TPZFlopCounter sin (const TPZFlopCounter &orig)
 Returns the sine in radians and increments the counter of the sine. More...
 
TPZFlopCounter atan (const TPZFlopCounter &orig)
 Returns the arc tangent in radians and increments the counter of the Arc Tangent. More...
 
TPZFlopCounter atan2 (const TPZFlopCounter &val1, const TPZFlopCounter &val2)
 Returns the arc tangent in radians and increments the counter of the Arc Tangent.
ATAN2 returns the arc tangent of x(val1) and y(val2) coordinates as an angle expressed in radians. More...
 
TPZFlopCounter exp (const TPZFlopCounter &orig)
 Returns the exponencial and increments the counter of the Exponencial. More...
 
TPZFlopCounter log (const TPZFlopCounter &orig)
 Returns the natural logarithm and increment the counter of the logarithm. More...
 
TPZFlopCounter log10 (const TPZFlopCounter &orig)
 Returns the decimal logarithm and increment the counter of the logarithm. More...
 
TPZFlopCounter operator* (double val1, const TPZFlopCounter &val2)
 Performs $ val1 * val2$. Doesn't increments counters. More...
 
TPZFlopCounter operator/ (double val1, const TPZFlopCounter &val2)
 Performs $ val1 / val2$. Doesn't increments counters. More...
 
TPZFlopCounter operator+ (double val1, const TPZFlopCounter &val2)
 Performs $ val1 + val2$. Doesn't increments counters. More...
 
TPZFlopCounter operator+ (const TPZFlopCounter &val2, double val1)
 Performs $ val1 + val2$. Doesn't increments counters. More...
 
TPZFlopCounter operator- (double val1, const TPZFlopCounter &val2)
 Performs $ val1 - val2$. Doesn't increments counters. More...
 
std::ostream & operator<< (std::ostream &out, const TPZFlopCounter &val)
 Implements to write (output) only the floating point value. More...
 
std::istream & operator>> (std::istream &out, TPZFlopCounter &val)
 Implements to read (input) only the floating point value. More...
 
REAL ZeroTolerance ()
 Returns the tolerance to Zero value. Actually: $ 1e-10 $. More...
 
template<typename T , typename std::enable_if< is_arithmetic_pz< T >::value, int >::type * = nullptr>
void ZeroTolerance (T &tol)
 
bool IsZero (long double a)
 Returns if the value a is close Zero as the allowable tolerance. More...
 
bool IsZero (double a)
 
bool IsZero (float a)
 
bool IsZero (std::complex< long double > a)
 
bool IsZero (std::complex< double > a)
 
bool IsZero (std::complex< float > a)
 
bool IsZero (int a)
 
bool IsZero (int64_t a)
 
template<class T >
const T & Max (const T &a, const T &b)
 Returns the maximum value between a and b. More...
 
template<class T >
const T & Min (const T &a, const T &b)
 Returns the minimum value between a and b. More...
 

Variables

int gPrintLevel
 Extern variable to control level of printting (priority print?) More...
 
const int gNumOp
 Number of type of the operations actually counted. More...
 

Detailed Description

Defines type of the floating point calculations used in.
Defines timer object to calculate CPU time used in the execution of code snippets.

Macro Definition Documentation

◆ DebugStop

#define DebugStop ( )

Returns a message to user put a breakpoint in.

Definition at line 20 of file pzerror.h.

Referenced by TPZHWTools::A2x2Inverse(), TPZHWTools::A3x3Inverse(), TPZElastoPlasticAnalysis::AcceptSolution(), TPZAgglomerateElement::AccumulateIntegrationRule(), TPZTransfer< TVar >::AddBlockNumbers(), TPZAcademicGeoMesh::AddBoundaryElements(), TPZAcademicGeoMesh::AddBoundaryElementsByCoord(), TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZConnect::AddDependency(), TPZBuildMultiphysicsMesh::AddElements(), TPZMultiphysicsCompMesh::AddElements(), TPZFMatrix< STATE >::AddFel(), TPZCompMeshTools::AddHDivPyramidRestraints(), TPZSkylMatrix< TVar >::AddKel(), TPZBuildSBFem::AddPartition(), TPZSkylMatrix< TVar >::AddSameStruct(), TPZInterpolatedElement::AddShapeRestraint(), TPZCompEl::AddShapeRestraint(), TPZBuildMultiphysicsMesh::AddWrap(), TPZCutHillMcKee::SGraph::AdjacentNodesOrdered(), TPZSBFemVolume::AdjustAxes3D(), TPZCompMeshTools::AdjustFluxPolynomialOrders(), TPZProjectEllipse::AdjustingWithEllipse(), TPZInterpolatedElement::AdjustPreferredSideOrder(), TPZFrontStructMatrix< front >::AdjustSequenceNumbering(), pztopology::TPZPyramid::AdjustTopDirections(), TPZNodesetCompute::AnalyseNode(), TPZBuildMultiphysicsMesh::AppendConnects(), TPZCompElDisc::AppendExternalShapeFunctions(), TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZTransform< T >::Apply(), TPZElementMatrix::ApplyConstraints(), TPZMatElastoPlastic2D< T, TMEM >::ApplyDeltaStrain(), TPZMatElastoPlastic2D< T, TMEM >::ApplyDeltaStrainComputeDep(), TPZGradientFlux::ApplyLimiter(), TPZMHMixedHybridMeshControl::ApplyNeighbourBoundaryCondition(), TPZElementMatrix::ApplyOneShapeConstraints(), TPZPorousElasticCriterion::ApplyStrain(), TPZElasticCriterion::ApplyStrain(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStrain(), TPZPorousElasticCriterion::ApplyStrainComputeDep(), TPZElasticCriterion::ApplyStrainComputeDep(), TPZPorousElasticCriterion::ApplyStrainComputeSigma(), TPZElasticCriterion::ApplyStrainComputeSigma(), TPZPlasticStep< YC_t, TF_t, ER_t >::ApplyStrainComputeSigma(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStrainComputeSigma(), TPZSandlerDimaggio< SANDLERDIMAGGIOPARENT >::ApplyStrainComputeSigma(), TPZLadeKim::ApplyStrainComputeSigma(), TPZSandlerExtended::ApplyStrainComputeSigma(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStressComputeStrain(), pzgeom::TPZArc3D::ArcAngle(), TPZSubMeshAnalysis::Assemble(), TPZStructMatrixGCTP::Assemble(), TPZStructMatrixGC::Assemble(), TPZStructMatrixST::Assemble(), TPZDohrStructMatrix::Assemble(), TPZStructMatrixCS::Assemble(), TPZStructMatrixTBBFlow::Assemble(), TPZStructMatrixOT::Assemble(), TPZParFrontStructMatrix< front >::Assemble(), TPZStructMatrixOR::Assemble(), TPZEulerAnalysis::Assemble(), TPZSubCompMesh::Assemble(), TPZBlockDiagonalStructMatrix::AssembleBlockDiagonal(), ThreadDohrmanAssembly< TVar >::AssembleMatrices(), TPZAnalysis::AssembleResidual(), TPZHybridizeHDiv::AssociateElements(), TPZMultiphysicsCompMesh::AutoBuild(), TPZPostProcAnalysis::AutoBuildDisc(), TPZSYsmpMatrix< TVar >::AutoFill(), TPZFBMatrix< TVar >::AutoFill(), TPZSBMatrix< TVar >::AutoFill(), TPZBlockDiagonal< STATE >::AutoFill(), TPZFYsmpMatrix< TVar >::AutoFill(), TPZSkylNSymMatrix< TVar >::AutoFill(), TPZSkylMatrix< TVar >::AutoFill(), TPZFileEqnStorage< TVar >::Backward(), TPZDiscontinuousGalerkin::BCInterfaceJump(), pztopology::TPZPoint::BlendFactorForSide(), pztopology::TPZLine::BlendFactorForSide(), pztopology::TPZTetrahedron::BlendFactorForSide(), pztopology::TPZPyramid::BlendFactorForSide(), pztopology::TPZTriangle::BlendFactorForSide(), pztopology::TPZCube::BlendFactorForSide(), pztopology::TPZPrism::BlendFactorForSide(), pztopology::TPZQuadrilateral::BlendFactorForSide(), TPZBlockDiagonalStructMatrix::BlockSizes(), TPZMHMixedMeshChannelControl::BuildComputationalMesh(), TPZMHMixedHybridMeshControl::BuildComputationalMesh(), TPZMHMixedMeshControl::BuildComputationalMesh(), TPZGeoElSide::BuildConnectivities(), TPZMultiphysicsElement::BuildCornerConnectList(), TPZSBFemVolume::BuildCornerConnectList(), TPZInterfaceElement::BuildCornerConnectList(), BuildElementGroups(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZMHMixedMeshControl::BuildMultiPhysicsMesh(), TPZMultiphysicsCompMesh::BuildMultiphysicsSpace(), TPZMultiphysicsCompMesh::BuildMultiphysicsSpaceWithMemory(), TPZRefPatternTools::BuildRefPatternModelName(), TPZInterpolationSpace::BuildTransferMatrix(), TPZInterpolatedElement::BuildTransferMatrix(), TPZCompMesh::BuildTransferMatrixDesc(), TPZMHMeshControl::BuildWrapMesh(), TPZInterpolatedElement::CalcIntegral(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZCondensedCompEl::CalcResidual(), TPZInterfaceElement::CalcResidual(), TPZElementGroup::CalcResidual(), TPZSubCompMesh::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZSBFemElementGroup::CalcStiff(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZCompElLagrange::CalcStiff(), TPZCondensedCompEl::CalcStiff(), TPZInterfaceElement::CalcStiff(), TPZElementGroup::CalcStiff(), TPZSubCompMesh::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), pztopology::Pr< TFather >::CenterPoint(), pztopology::TPZTetrahedron::CenterPoint(), pztopology::TPZPyramid::CenterPoint(), pztopology::TPZTriangle::CenterPoint(), pztopology::TPZCube::CenterPoint(), pztopology::TPZPrism::CenterPoint(), pztopology::TPZLine::CenterPoint(), pztopology::TPZQuadrilateral::CenterPoint(), pzgeom::TPZChangeEl::ChangeToQuadratic(), pzgeom::TPZChangeEl::ChangeToQuarterPoint(), pzshape::TPZShapeDisc::ChebyshevWithoutScale(), TPZAcademicGeoMesh::CheckConsistency(), TCedricTest::CheckConsistency(), TPZMHMeshControl::CheckDivisionConsistency(), CheckElement(), TPZMHMixedHybridMeshControl::CheckMeshConsistency(), pztopology::TPZPyramid::CheckProjectionForSingularity(), pztopology::TPZPrism::CheckProjectionForSingularity(), pztopology::TPZTetrahedron::CheckProjectionForSingularity(), pztopology::TPZTriangle::CheckProjectionForSingularity(), TPZCheckGeom::CheckUniqueId(), TPZTracerFlow::ClassId(), TPZCompMesh::CleanUpUnconnectedNodes(), TPZFMatrix< STATE >::Clear(), TPZSBFemVolume::Clone(), TPZMultiphysicsCompEl< TGeometry >::Clone(), TPZStructMatrixOR::Clone(), TPZMultiphysicsCompEl< TGeometry >::ClonePatchEl(), TPZSBFemVolume::ClonePatchEl(), TPZCompElLagrange::ClonePatchEl(), hdivCurvedJCompAppMath::CMeshFlux(), Hdiv2dPaper201504::CMeshMixed(), hdivCurvedJCompAppMath::CMeshMixed(), Hdiv3dPaper201504::CMeshMixed(), Hdiv2dPaper201504::CMeshPressure(), hdivCurvedJCompAppMath::CMeshPressure(), Hdiv3dPaper201504::CMeshPressure(), TPZRenumbering::ColorElements(), TPZRenumbering::ColorNodes(), TPZMatrix< STATE >::Cols(), TPZSkylParMatrix< TVar >::ColumnToWork(), TPZMohrCoulombNeto::CommitDeformation(), TPZMohrCoulombPV::CommitDeformation(), TPZMaterialData::Compare(), TPZFMatrix< STATE >::Compare(), TPZMatrix< STATE >::Compare(), TPZRefPatternTools::CompareTopologies(), TPZMatrix< STATE >::CompareValues(), TPZYCModifiedMohrCoulomb::Compute(), pzgeom::TPZEllipse3D::ComputeAngle(), pzgeom::TPZArc3D::ComputeAtributes(), pzgeom::TPZCylinderMap< TGeo >::ComputeCornerCoordinates(), TPZMatElastoPlastic2D< T, TMEM >::ComputeDeltaStrainVector(), TPZAxesTools< TVar >::ComputeDetjac(), TPZCompMeshTools::ComputeDifferenceNorm(), pztopology::TPZCube::ComputeDirections(), pztopology::TPZPrism::ComputeDirections(), pztopology::TPZPyramid::ComputeDirections(), pztopology::TPZLine::ComputeDirections(), pztopology::TPZTetrahedron::ComputeDirections(), pztopology::TPZQuadrilateral::ComputeDirections(), pztopology::computedirectionsC(), pztopology::computedirectionsPr(), TPZTensor< STATE >::ComputeEigenvectors(), TPZCompMesh::ComputeElGraph(), ComputeError(), TPZInterfaceElement::ComputeErrorFace(), TPZGenGrid::ComputeGeometricProgression(), TPZGradientReconstruction::TPZGradientData::ComputeGradient(), TPZInterpolationSpace::ComputeIntegrationOrder(), TPZMultiphysicsElement::ComputeIntegrationOrder(), TPZCondensedCompEl::ComputeIntegrationOrder(), TPZElementGroup::ComputeIntegrationOrder(), TPZCompEl::ComputeIntegrationOrder(), TPZSBFemVolume::ComputeKMatrices(), TPZYCSandlerDimaggioL::ComputeLatIntersectionRight(), TPZSBFemElementGroup::ComputeMatrices(), TPZInterfaceElement::ComputeNormal(), TPZGeoEl::ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZInterfaceElement::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeRequiredData(), TPZInterpolationSpace::ComputeRequiredData(), TPZCompElHDiv< TSHAPE >::ComputeRequiredData(), TPZCompElHDivBound2< TSHAPE >::ComputeShape(), TPZCompElHDiv< TSHAPE >::ComputeShapeIndex(), TPZMultiphysicsInterfaceElement::ComputeSideTransform(), TPZMatElasticity2D::ComputeSigma(), TPZMohrCoulombNeto::ComputeSigmaTangent(), TPZMohrCoulombPV::ComputeSigmaTangent(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter2(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter3(), TPZMulticamadaOrthotropic::ComputeSolution(), TPZReducedSpace::ComputeSolution(), TPZMultiphysicsCompEl< TGeometry >::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolution(), TPZInterfaceElement::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompEl::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZPorousElasticResponse::ComputeStrain(), TPZViscoelastic::ComputeStressTensor(), TPZRefPattern::ComputeTransforms(), TPZGradientReconstruction::TPZGradientData::ComputeWeights(), TPZYCSandlerDimaggio::ComputeX(), TPZSubMeshAnalysis::CondensedSolution(), TPZBuildSBFem::Configure(), TPZCompEl::Connect(), TPZMHMeshControl::ConnectedElements(), TPZMHMeshControl::ConnectedInterfaceElements(), TPZCompElHDivPressure< TSHAPE >::ConnectIndex(), TPZIntelGen< TSHAPE >::ConnectIndex(), TPZCompElHDiv< TSHAPE >::ConnectIndex(), TPZSBFemVolume::ConnectIndex(), TPZMultiphysicsInterfaceElement::ConnectIndex(), TPZCompElLagrange::ConnectIndex(), TPZReducedSpace::ConnectIndex(), TPZInterfaceElement::ConnectIndex(), TPZCompElHDivBound2< TSHAPE >::ConnectOrder(), TPZCircBufferedStream::ConstReadFromBuffer(), TPZContBufferedStream::ConstReadFromBuffer(), TPZElast3Dnlinear::Contribute(), TPZTransientMaterial< TBASEMAT >::Contribute(), TPZBurger::Contribute(), TPZElasticity2DHybrid::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZMatHyperElastic::Contribute(), TPZEuler::Contribute(), TPZConsLawTest::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMatPoisson3dReferred::Contribute(), TPZPorousElasticity::Contribute(), TPZMat2dLin::Contribute(), TPZViscoelastic::Contribute(), TPZMatDualHybridPoisson::Contribute(), TPZL2Projection::Contribute(), TPZThermicElast3D::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZMultiphase::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZCoupledTransportDarcyBC::Contribute(), TPZMixedDarcyFlow::Contribute(), TPZDualPoisson::Contribute(), TPZMixedPoissonParabolic::Contribute(), TPZPrimalPoisson::Contribute(), TPZTracerFlow::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticity3D::Contribute(), TPZCoupledTransportDarcy::Contribute(), TPZVecL2::Contribute(), TPZLagrangeMultiplier::Contribute(), TPZMixedPoisson::Contribute(), TPZMatMixedPoisson3D::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatLaplacian::Contribute(), TPZMaterial::Contribute(), TPZEulerConsLaw::Contribute(), TPZElast3Dnlinear::ContributeBC(), TPZElasticity2DHybrid::ContributeBC(), TPZMatHyperElastic::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZPorousElasticity::ContributeBC(), TPZSpaceTimeRichardsEq::ContributeBC(), TPZBurger::ContributeBC(), TPZReynoldsFlow::ContributeBC(), TPZMultiphase::ContributeBC(), TPZTracerFlow::ContributeBC(), TPZPrimalPoisson::ContributeBC(), TPZDualPoisson::ContributeBC(), TPZMatElastoPlastic2D< T, TMEM >::ContributeBC(), TPZMixedDarcyFlow::ContributeBC(), TPZMixedPoissonParabolic::ContributeBC(), TPZBndCondWithMem< TMEM >::ContributeBC(), TPZLagrangeMultiplier::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZElasticityMaterial::ContributeBC(), TPZMatConvectionProblem::ContributeBC(), TPZEulerEquation::ContributeBC(), TPZMixedPoisson::ContributeBC(), TPZSwelling::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZMixedElasticityMaterial::ContributeBC(), TPZMatMixedPoisson3D::ContributeBC(), TPZBndCond::ContributeBC(), TPZMaterial::ContributeBC(), TPZMatPoisson3dReferred::ContributeBCInterface(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZMultiphase::ContributeBCInterface(), TPZTracerFlow::ContributeBCInterface(), TPZElasticityAxiMaterial::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZBndCondWithMem< TMEM >::ContributeBCInterface(), TPZEulerEquation::ContributeBCInterface(), TPZCoupledTransportDarcy::ContributeBCInterface(), TPZLagrangeMultiplier::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZBndCond::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsDual(), TPZConsLawTest::ContributeInterface(), TPZHybridPoisson::ContributeInterface(), TPZMatPoisson3dReferred::ContributeInterface(), TPZMatDualHybridPoisson::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZBurger::ContributeInterface(), TPZTracerFlow::ContributeInterface(), TPZDiscontinuousGalerkin::ContributeInterface(), TPZMultiphase::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZBndCondWithMem< TMEM >::ContributeInterface(), TPZCoupledTransportDarcyBC::ContributeInterface(), TPZEulerEquation::ContributeInterface(), TPZLagrangeMultiplier::ContributeInterface(), TPZCoupledTransportDarcy::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZBndCond::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), TPZDohrSubstructCondense< TTVar >::ContributeRhs(), TPZMatElasticity2D::ContributeVec(), TPZL2Projection::ContributeVecShape(), TPZElast3Dnlinear::ContributeVecShapeAux(), TPZElasticity3D::ContributeVecShapeBC(), TPZElast3Dnlinear::ContributeVecShapeBCAux(), TPZMatMixedPoisson3D::ContributeWithoutSecondIntegration(), TPZCompMesh::ConvertDiscontinuous2Continuous(), TPZRenumbering::CornerEqs(), TPZSBandStructMatrix::Create(), TPBSpStructMatrix::Create(), TPZSpStructMatrix::Create(), TPZBandStructMatrix::Create(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZMHMixedHybridMeshControl::CreateAxialFluxElement(), TPZCreateApproximationSpace::CreateCompEl(), CreateCompMesh(), TCedricTest::CreateCondensedElements(), TPZBuildSBFem::CreateElementCenterNodes(), TPZBuildSBFem::CreateElementGroups(), TPZGeoMesh::CreateGeoElement(), TPZAcademicGeoMesh::CreateGeoMesh(), TPZHierarquicalGrid::CreateGeometricElement(), TPZGradientReconstruction::TPZGradientData::CreateGhostsNeighbors(), TPZSBFemVolume::CreateGraphicalElement(), TPZMHMixedMeshControl::CreateHDivPressureMHMMesh(), TPZSavable::CreateInstance(), TPZMultiphysicsInterfaceElement::CreateIntegrationRule(), TPZMultiphysicsElement::CreateInterface(), TPZInterpolationSpace::CreateInterface(), TPZHybridizeHDiv::CreateInterfaceElements(), TPZMHMeshControl::CreateInterfaceElements(), TPZMHMixedHybridMeshControl::CreateInternalAxialFluxes(), TPZMHMeshControl::CreateLagrangeMultiplierMesh(), TPZMHMixedHybridMeshControl::CreateLowerDimensionPressureElements(), TPZCheckGeom::CreateMesh(), TPZAgglomerateElement::CreateMidSideConnect(), TPZInterpolatedElement::CreateMidSideConnect(), TPZRefPattern::CreateMidSideNodes(), TPZMHMixedHybridMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedHybridMeshControl::CreatePressureInterfaces(), TPZMHMixedMeshControl::CreatePressureMHMMesh(), TPZMHMixedMeshControl::CreateRotationMesh(), TPZMHMixedMeshControl::CreateSkeleton(), TPZMHMixedHybridMeshControl::CreateSkeletonAxialFluxes(), TPZMHMeshControl::CreateSkeletonElements(), tht::CreateThread(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZMHMeshControl::CreateWrap(), TPZMHMeshControl::CriaMalhaTemporaria(), Cross(), TPZEulerEquation::cSpeed(), TPZCompElPostProc< TCOMPEL >::dataequal(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky_blk(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZFYsmpMatrix< TVar >::Decompose_LU(), TPZFMatrix< STATE >::Decompose_LU(), TPZSkylMatrix< TVar >::DecomposeColumn(), TPZSkylMatrix< TVar >::DecomposeColumn2(), TPZSkylParMatrix< TVar >::DecomposeColumnCholesky(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::DecomposeK00(), TPZFrontSym< TVar >::DecomposeOneEquation(), TPZFrontNonSym< TVar >::DecomposeOneEquation(), TPZMHMeshControl::DefinePartition(), TPZMHMeshControl::DefineSkeleton(), TPZGeoMesh::DeleteElement(), TPZTensor< STATE >::DirectEigenValues(), dist(), TPZGeoElRefLess< TGeo >::Divide(), TPZMHMeshControl::DivideWrap(), TPZStochasticSearch< TVar >::DoSearch(), TPZVTKGraphMesh::DrawSolution(), TPZHyperPlaneIntersect::EdgeIntersect(), TPZIntelGen< TSHAPE >::EffectiveSideOrder(), TPZCompElHDivPressureBound< TSHAPE >::EffectiveSideOrder(), TPZCompElHDiv< TSHAPE >::EffectiveSideOrder(), TPZTensor< STATE >::EigenProjection(), TPZTensor< STATE >::EigenSystem(), TPZTensor< STATE >::Eigenvalue(), TPZRefPattern::Element(), TPZFrontSym< TVar >::Element4JGreatEqualI(), TPZStructMatrixGC::ElementColoring(), TPZStructMatrixOT::ElementColoring(), TPZEqnArray< TVar >::EqnForward(), TPZFMatrix< STATE >::Error(), TPZMatrix< STATE >::Error(), TPZDualPoisson::Errors(), TPZMixedElasticityMaterial::Errors(), TPZMatMixedPoisson3D::Errors(), TPZMaterial::Errors(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZMultiphysicsElement::EvaluateError(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZCompEl::EvaluateError(), TPZSubCompMesh::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZFunction< STATE >::Execute(), TPZGradient::Execute(), TPZDummyFunction< TVar >::Execute(), TPZFront< TVar >::STensorProductMTData::Execute(), TPZInterfaceElement::ExistInterfaces(), TPZCompMeshTools::ExpandHDivPyramidRestraints(), TPZFront< STATE >::ExtractFrontMatrix(), TPZPlasticStep< YC_t, TF_t, ER_t >::ExtractTangent(), TPZRefPattern::FatherSide(), FillAtomic(), TPZPorousElasticity::FillBoundaryConditionDataRequirement(), TPZPorousElasticity::FillDataRequirements(), TPZCompElHDiv< TSHAPE >::FillOrder(), TPZEquationFilter::FilterSkyline(), TPZGeoMesh::FindApproxElement(), FindCapElement(), TPZGeoMesh::FindCloseElement(), TPZMHMixedHybridMeshControl::FindConnectedElements(), TPZGraphMesh::FindFirstInterpolatedElement(), TPZSloanRenumbering::FindHighestPriority(), TPZPlasticStep< YC_t, TF_t, ER_t >::FindPointAtYield(), FindPressureSkeleton(), TPZRefPattern::FindSubEl(), TPZCompElHDivPressureBound< TSHAPE >::FirstShapeIndex(), TPZMatDualHybridPoisson::Flux(), TPZInterpolatedElement::ForceSideOrder(), hdivCurvedJCompAppMath::Forcing(), hdivCurvedJCompAppMath::ForcingBC1D(), hdivCurvedJCompAppMath::ForcingBC2D(), hdivCurvedJCompAppMath::ForcingBC3D(), hdivCurvedJCompAppMath::ForcingBC4D(), hdivCurvedJCompAppMath::ForcingH1(), TPZInterfaceElement::FreeInterface(), TPZEulerEquation::FromConservativeToPrimitive(), TPZFMatrix< STATE >::g(), TPZEquationFilter::Gather(), TPZGeoElSide::GelLocIndex(), TPZGenGrid::GenerateElements(), TPZGenGrid::GenerateElementsZigZag(), TPZRefPatternTools::GenerateGMeshFromElementVec(), TPZGmshReader::GeometricGmshMesh(), TPZGmshReader::GeometricGmshMesh3(), TPZGmshReader::GeometricGmshMesh4(), TPZGenGrid::GeometricProgression(), TPZMatrix< STATE >::Get(), TPZGeoElSide::GetAllSiblings(), TPZGeoEl::GetAllSiblings(), TPZPersistenceManager::GetAutoPointer(), TPZRestoredInstance::GetAutoPointerToMyObj(), TPZFBMatrix< TVar >::GetBand(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZRefPatternTools::GetCompatibleRefPatterns(), TPZPlasticStep< YC_t, TF_t, ER_t >::GetElasticResponse(), TPZRefPatternTools::GetElTypePermutations(), pztopology::TPZQuadrilateral::GetGatherPermute(), GetGeoNodeIds(), pztopology::TPZTriangle::GetHDivGatherPermute(), TPZPersistenceManager::GetInstance(), TPZMultiphysicsInterfaceElement::GetIntegrationRule(), TPZCompElDisc::GetIntegrationRule(), TPZSBFemVolume::GetIntegrationRule(), TPZCompEl::GetIntegrationRule(), TPZGeoMeshBuilder::GetNumberofNodes(), TPZGmshReader::GetNumberofNodes(), TPZFrontStructMatrix< front >::GetNumElConnected(), pztopology::GetPermutation(), TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec(), TPZIdentifyRefPattern::GetRefPattern(), TPZPersistenceManager::GetSharedPointer(), TPZRestoredInstance::GetSharedPtrToMyObj(), pztopology::TPZCube::GetSideHDivPermutation(), pztopology::TPZPrism::GetSideHDivPermutation(), pztopology::TPZPyramid::GetSideHDivPermutation(), pztopology::TPZTetrahedron::GetSideHDivPermutation(), pztopology::TPZQuadrilateral::GetSideHDivPermutation(), TPZCompElHDivBound2< TSHAPE >::GetSideOrient(), TPZCompElHDiv< TSHAPE >::GetSideOrient(), TPZInterpolationSpace::GetSideOrient(), GetSideShapeFunction(), TPZMatrix< STATE >::GetSub(), TPZGeoElRefPattern< TGeo >::GetSubElements2(), pztopology::TPZPyramid::GetTransformId(), pztopology::TPZTetrahedron::GetTransformId(), TPZSkylNSymMatrix< TVar >::GetVal(), TPZFBMatrix< TVar >::GetVal(), TPZBlock< STATE >::GetVal(), TPZFMatrix< STATE >::GetVal(), TPZSkylMatrix< TVar >::GetVal(), TPZSkylNSymMatrix< TVar >::GetValB(), TPZSkylNSymMatrix< TVar >::GetValSup(), TPZVTKGeoMesh::GetVTK_ElType(), Hdiv2dPaper201504::GMesh(), pzgeom::TPZGeoQuad::GradX(), pzgeom::TPZGeoCube::GradX(), pzgeom::TPZQuadraticPrism::GradX(), pzgeom::TPZGeoPrism::GradX(), pzgeom::TPZGeoTetrahedra::GradX(), pzgeom::TPZQuadraticPyramid::GradX(), pzgeom::TPZGeoPyramid::GradX(), pzgeom::TPZQuadraticCube::GradX(), pzgeom::TPZQuadraticTetra::GradX(), pzgeom::TPZGeoTriangle::GradX(), pzgeom::TPZQuadraticTrig::GradX(), pzgeom::TPZQuadraticLine::GradX(), pzgeom::TPZQuadraticQuad::GradX(), pzgeom::TPZGeoBlend< TGeo >::GradX(), pzgeom::TPZArc3D::GradX(), TPZFMatrix< STATE >::GramSchmidt(), TPZMHMixedMeshControl::GroupandCondenseElements(), TPZMHMixedHybridMeshControl::GroupandCondenseElements(), TPZMHMixedHybridMeshControl::GroupElements(), TPZElementGroup::HasMaterial(), TPZMHMeshControl::HasWrapNeighbour(), TPZGeoElRefLess< TGeo >::HDivPermutation(), TPZGeoEl::HDivPermutation(), TPZMHMixedMeshControl::Hybridize(), TPZHybridizeHDiv::Hybridize(), TPZHybridizeHDiv::HybridizeInternalSides(), TPZMHMixedMeshControl::HybridizeSkeleton(), TPZMHMeshControl::HybridizeSkeleton(), TPZAnalysis::IdentifyPostProcessingMatIds(), TPZInterpolatedElement::IdentifySideOrder(), TPZMatrix< STATE >::Identity(), TPZDiffMatrix< T >::index(), TPZSBMatrix< TVar >::Index(), TPZCompElHDiv< TSHAPE >::IndexShapeToVec(), TPZCompElHDiv< TSHAPE >::IndexShapeToVec2(), TPZYCDruckerPragerPV::InitialDamage(), TPZYCCamClayPV::InitialDamage(), TPZYCMohrCoulombPV::InitialDamage(), TPZYCSandlerDimaggioL2::InitialGuess(), TPZYCSandlerDimaggioL::InitialGuess(), TPZYCSandlerDimaggio::InitialGuess(), TPZAgglomerateElement::InitializeElement(), TPZInterfaceElement::InitializeElementMatrix(), TPZReducedSpace::InitializeElementMatrix(), TPZMultiphysicsInterfaceElement::InitializeElementMatrix(), TPZInterpolationSpace::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZGradientReconstruction::TPZGradientData::InitializeGradData(), TPZSBFemVolume::InitializeIntegrationRule(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZCompEl::InitializeIntegrationRule(), tht::InitializeMutex(), tht::InitializeSemaphore(), TPZRefPatternDataBase::InitializeUniformRefPattern(), TPZInterfaceElement::InitMaterialData(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMixedElasticityMaterial::Inner(), TPZMixedElasticityMaterial::InnerVec(), TPZGeoMeshBuilder::InsertElement(), TPZGmshReader::InsertElement(), TPZMHMixedHybridMeshControl::InsertFractureFlowMaterial(), TPZCompMesh::InsertMaterialObject(), TPZMHMixedHybridMeshControl::InsertPeriferalHdivMaterialObjects(), TPZMHMixedMeshControl::InsertPeriferalHdivMaterialObjects(), TPZMHMixedHybridMeshControl::InsertPeriferalMaterialObjects(), TPZMHMixedMeshControl::InsertPeriferalMaterialObjects(), TPZHybridizeHDiv::InsertPeriferalMaterialObjects(), TPZMHMeshControl::InsertPeriferalMaterialObjects(), TPZMHMixedMeshControl::InsertPeriferalPressureMaterialObjects(), TPZMHMixedMeshControl::InsertPeriferalRotationMaterialObjects(), TPZGradientReconstruction::TPZGradientData::InsertWeights(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZCompMesh::Integrate(), pzshape::TPZShapeDisc::IntegratedLegendre(), TPZInterfaceElement::IntegrateInterface(), TPZElementGroup::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZInterpolationSpace::IntegrateSolution(), TPZCompEl::IntegrateSolution(), TPZLagrangeMultiplier::InterfaceJump(), TPZBndCond::InterfaceJump(), TPZSubCompMesh::InternalIndex(), TPZRefPattern::InternalNodesIndexes(), TPZRefPattern::InternalSidesIndexes(), IsInSideParametricDomain(), pzgeom::TPZGeoBlend< TGeo >::IsLinearMapping(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZGeoEl::Jacobian(), TPZGeoEl::JacobianXYZ(), TPZMHMeshControl::JoinSubdomains(), pzshape::TPZShapeDisc::Legendre(), pzshape::TPZShapeDisc::LegendreWithoutScale(), TPZPorousElasticResponse::LinearizedElasticResponse(), TPZSBFemElementGroup::LoadEigenVector(), TPZSubMeshFrontalAnalysis::LoadSolution(), TPZCondensedCompEl::LoadSolution(), TPZSBFemElementGroup::LoadSolution(), TPBSpStructMatrix::main(), TPZSymetricSpStructMatrix::main(), TPZSpStructMatrix::main(), TPZFrontStructMatrix< front >::main(), TPZParFrontStructMatrix< front >::main(), main(), TPZInterfaceElement::main(), TPZSubCompMesh::main(), TPZSubCompMesh::MakeAllInternal(), hdivCurvedJCompAppMath::MakeCircle(), MalhaCubo(), MalhaGeom(), pztopology::TPZPyramid::MapToSide(), pztopology::TPZPrism::MapToSide(), pztopology::TPZTetrahedron::MapToSide(), pztopology::TPZTriangle::MapToSide(), MElementType_Name(), MElementType_NNodes(), TPZGenGrid::MergeGeoMesh(), TPZInterpolatedElement::MidSideConnect(), TPZInterpolationSpace::MinMaxSolutionValues(), TPZRefPatternTools::ModifyElementsBasedOnRefpFound(), TPZCompMesh::ModifyPermute(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::MultAdd(), TPZStructMatrixGCTP::MultiThread_Assemble(), TPZYCSandlerDimaggioL2::N(), TPZYCSandlerDimaggioL::N(), TPZYCSandlerDimaggio::N(), pztopology::TPZPyramid::NBilinearSides(), pztopology::TPZPrism::NBilinearSides(), pztopology::TPZTetrahedron::NBilinearSides(), pztopology::TPZTriangle::NBilinearSides(), TPZIntelGen< TSHAPE >::NConnectShapeF(), TPZReducedSpace::NConnectShapeF(), TPZCompElHDivPressureBound< TSHAPE >::NConnectShapeF(), TPZCompElHDiv< TSHAPE >::NConnectShapeF(), TPZCompElDisc::NConnectShapeF(), pztopology::TPZLine::NContainedSides(), pzgeom::TPZChangeEl::NearestNode(), TPZCompEl::NeedsComputing(), TPZMHMixedHybridMeshControl::NeedsHDivWrapper(), pzgeom::TPZGeoBlend< TGeo >::Neighbour(), TPZGeoElRefLess< TGeo >::Neighbour(), TPZGeoElRefLess< TGeo >::NeighbourIndex(), TPZCompMesh::NEquations(), TPZYCSandlerDimaggioL::NewtonF2(), TPZCompElDisc::NInterfaces(), TPZGradientReconstruction::TPZGradientData::NodeCloserCenterX(), TPZRefPatternTools::NodesHunter(), TPZGeoElSide::Normal(), Normalize(), TPZGeoEl::NormalOrientation(), TPZIntTriang::NPoints(), TPZSBFemVolume::NSideConnects(), TPZRefPattern::NSideNodes(), TPZRefPattern::NSideSubGeoElSides(), TPZPorousElasticity::NSolutionVariables(), TPZMaterial::NSolutionVariables(), TPZPorousElasticity::NStateVariables(), TPZRefPattern::NSubElements(), TPZEquationFilter::NumActive(), TPZSubCompMesh::NumInternalEquations(), TPZFileEqnStorage< TVar >::OpenGeneric(), TPZBFileStream::OpenRead(), TPZPersistenceManager::OpenRead(), TPZBFileStream::OpenWrite(), TPZPersistenceManager::OpenWrite(), TPZGenMatrix< TObj >::operator()(), TPZFBMatrix< TVar >::operator()(), TPZSkylNSymMatrix< TVar >::operator()(), TPZBlock< STATE >::operator()(), TPZMatrix< STATE >::operator()(), TPZFMatrix< STATE >::operator()(), TPZSkylMatrix< TVar >::operator()(), operator-(), TPZFMatrix< STATE >::operator-(), operator-=(), TPZPorousElasticity::operator=(), TPZGuiInterface::operator=(), TPZHierarquicalGrid::operator==(), TPZVec< std::pair< int, int > >::operator[](), TPZChunkVector< TPZGraphNode, 10 >::operator[](), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), pzgeom::TPZEllipse3D::ParametricDomainNodeCoord(), pztopology::TPZPyramid::ParametricDomainNodeCoord(), pztopology::TPZCube::ParametricDomainNodeCoord(), pztopology::TPZPrism::ParametricDomainNodeCoord(), pztopology::TPZLine::ParametricDomainNodeCoord(), pztopology::TPZTetrahedron::ParametricDomainNodeCoord(), pztopology::TPZPoint::ParametricDomainNodeCoord(), pztopology::TPZTriangle::ParametricDomainNodeCoord(), pztopology::TPZQuadrilateral::ParametricDomainNodeCoord(), TPZRefPatternTools::PerfectMatchRefPattern(), TPZElementMatrix::PermuteGather(), TPZIntQuadQuarterPoint::Point(), TPZIntQuad::Point(), pzshape::TPZShapeDisc::Polynomial(), TPZDummyFunction< TVar >::PolynomialOrder(), pzshape::TPZShapeDisc::PolynomialWithoutScale(), TPZSloanRenumbering::PopHighestPriorityNode(), TPZAnalysis::PostProcessErrorParallel(), TPZReducedSpace::PRefine(), TPZEulerAnalysis::PrepareDXMesh(), TPZAUSMFlux::Pressure(), TPZEulerEquation::Pressure(), TPZCompEl::PressureConnectIndex(), TPZPorousElasticity::Print(), TPZCondensedCompEl::Print(), TPZInterpolatedElement::Print(), TPZElementMatrix::Print(), TPZSBFemElementGroup::Print(), TPZCompMesh::Print(), TPZMatrix< STATE >::Print(), Hdiv2dPaper201504::PrintErrors(), hdivCurvedJCompAppMath::PrintErrors(), Hdiv3dPaper201504::PrintErrors(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZMHMeshControl::PrintSubdomain(), TPZSSpMatrix< TVar >::ProdEsc(), ProjectBissectionInParametricDomain(), TPZGradientReconstruction::ProjectionL2GradientReconstructed(), TPZYCCamClayPV::ProjectSigma(), TPZYCDruckerPragerPV::ProjectSigma(), TPZYCMohrCoulombPV::ProjectSigma(), TPZSandlerExtended::ProjectSigma(), TPZYCMohrCoulombPV::ProjectSigmaDep(), TPZSandlerExtended::ProjectSigmaDep(), TPZCompMesh::ProjectSolution(), TPZYCDruckerPragerPV::ProjectToSurfaceF1(), TPZCutHillMcKee::SGraph::PseudoPeripheralNodes(), TPZFBMatrix< TVar >::Put(), TPZCompMeshTools::PutinSubmeshes(), TPZMatrix< STATE >::PutSub(), TPZSYsmpMatrix< TVar >::PutVal(), TPZFBMatrix< TVar >::PutVal(), TPZFYsmpMatrix< TVar >::PutVal(), TPZSBMatrix< TVar >::PutVal(), TPZMatrix< STATE >::PutVal(), PYBIND11_MODULE(), TPZGradientReconstruction::TPZGradientData::QRFactorization(), TPZMatrixMarket::Read(), TPZGenGrid::Read(), TPZMixedDarcyFlow::Read(), TPZLinearConvecDiff::Read(), TPZPrimalPoisson::Read(), TPZDualPoisson::Read(), TPZPorousElasticity::Read(), TPZMatDualHybridPoisson::Read(), TPZEqnArray< TVar >::Read(), TPZReynoldsFlow::Read(), TPZCompElWithMem< TBASE >::Read(), TPZGeoElRefPattern< TGeo >::Read(), TPZTracerFlow::Read(), TPZDohrMatrix< TVar, TSubStruct >::Read(), TPZNullMaterial::Read(), TPZMatElastoPlastic2D< T, TMEM >::Read(), TPZStream::Read(), TPZVecL2::Read(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Read(), TPZDummyFunction< TVar >::Read(), TPZElasticity3D::Read(), TPZPlasticStep< YC_t, TF_t, ER_t >::Read(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZFileEqnStorage< TVar >::ReadBlockPositions(), TPZFileStream::ReadData(), TPZBFileStream::ReadData(), TPZContBufferedStream::ReadFromBuffer(), TPZCircBufferedStream::ReadFromBuffer(), TPZReadMeshHR::ReadMaterials(), TPZVec< std::pair< int, int > >::ReallocForNuma(), TPZSBMatrix< TVar >::Redim(), TPZSubMeshAnalysis::ReducedRightHandSide(), TPZMultiphysicsCompEl< TGeometry >::ReferredElement(), TPZReducedSpace::ReferredIntel(), RefinamentoUniforme(), TPZRefPatternTools::RefineDirectional(), TPZSavable::Register(), TPZSavable::RegisterClassId(), RemoveEl(), TPZMultiphysicsElement::RemoveInterfaces(), TPZInterpolationSpace::RemoveInterfaces(), TPZFileEqnStorage< TVar >::ReOpen(), TPZHyperPlaneIntersect::Reorder(), TPZCondensedCompEl::Resequence(), TPZRenumbering::Resequence(), TPZCutHillMcKee::Resequence(), TPZSloanRenumbering::Resequence(), TPZSloanRenumbering::Resequence2(), TPZConnect::Reset(), TPZGeoElRefLess< TGeo >::ResetSubElements(), TPZCompElHDiv< TSHAPE >::RestrainedFace(), TPZInterpolatedElement::RestrainSide(), TPZYCMohrCoulombPV::ReturnMapApex(), TPZYCMohrCoulombPV::ReturnMapLeftEdge(), TPZYCMohrCoulombPV::ReturnMapPlane(), TPZMohrCoulombPV::ReturnMapPlane(), TPZMohrCoulombNeto::ReturnMapPlane(), TPZYCMohrCoulombPV::ReturnMapRightEdge(), TPZMohrCoulombPV::ReturnMapRightEdge(), TPZMohrCoulombNeto::ReturnMapRightEdge(), TPZMatrix< STATE >::ReturnNearestValue(), TPZHybridizeHDiv::RightElement(), TPZSubMeshFrontalAnalysis::Run(), TPZSubMeshAnalysis::Run(), Hdiv2dPaper201504::Run(), hdivCurvedJCompAppMath::Run(), Hdiv3dPaper201504::Run(), TPZVerySparseMatrix< TVar >::s(), TPZMatrix< STATE >::s(), TPZCompMesh::SaddlePermute(), TPZEquationFilter::Scatter(), TPZPersistenceManager::ScheduleToWrite(), TPZDohrStructMatrix::SeparateUnconnected(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZMultiphysicsElement::SetActiveApproxSpaces(), TPZEquationFilter::SetActiveEquations(), TPZCreateApproximationSpace::SetAllCreateFunctionsHDiv(), TPZCreateApproximationSpace::SetAllCreateFunctionsHDivPressure(), TPZCreateApproximationSpace::SetAllCreateFunctionsHDivReferred(), pzgeom::TPZEllipse3D::SetAxes(), TPZSBMatrix< TVar >::SetBand(), TPZGenGrid::SetBC(), TPZAcademicGeoMesh::SetBCIDVector(), TPZTransfer< TVar >::SetBlockMatrix(), TPZGradientReconstruction::TPZGradientData::SetCel(), TPZSubMeshAnalysis::SetCompMesh(), TPZSBFemElementGroup::SetComputeOnlyMassMatrix(), TPZCondensedCompEl::SetConnectIndex(), TPZCompElHDivPressure< TSHAPE >::SetConnectIndex(), TPZCompElHDivBound2< TSHAPE >::SetConnectIndex(), TPZCompElHDiv< TSHAPE >::SetConnectIndex(), TPZElementGroup::SetConnectIndex(), TPZReducedSpace::SetConnectIndex(), TPZSBFemVolume::SetConnectIndex(), TPZCompElLagrange::SetConnectIndex(), TPZInterfaceElement::SetConnectIndex(), TPZGeoNode::SetCoord(), TPZIntQuadQuarterPoint::SetCorner(), pzgeom::TPZWavyLine::SetData(), pzgeom::TPZTriangleSphere< GeomTriang >::SetData(), pzgeom::TPZQuadSphere< GeomQuad >::SetData(), TPZFYsmpMatrix< TVar >::SetData(), TPZGradientReconstruction::SetDataGhostsNeighbors(), pzgeom::TPZTriangleTorus::SetDataPhiTheta(), pzgeom::TPZQuadTorus::SetDataPhiTheta(), pzgeom::TPZTriangleTorus::SetDataRadius(), pzgeom::TPZQuadTorus::SetDataRadius(), TPZFrontSym< TVar >::SetDecomposeType(), TPZFrontNonSym< TVar >::SetDecomposeType(), TPZSBFemVolume::SetDensity(), TPZConnect::SetDependenceOrder(), TPZMatPoisson3d::SetDimension(), TPZMatLaplacian::SetDimension(), TPZStochasticSearch< TVar >::SetDistribution(), TPZPlasticStep< YC_t, TF_t, ER_t >::SetElasticResponse(), TPZSBFemVolume::SetElementGroupIndex(), TPZGenGrid::SetElementType(), TPZCompElDisc::SetFalseUseQsiEta(), TPZGeoElMapped< TBase >::SetFatherIndex(), pztopology::TPZQuadrilateral::SetHdivType(), TPZMultiphysicsCompEl< TGeometry >::SetIntegrationRule(), TPZMHMixedMeshControl::SetLagrangeAveragePressure(), TPZMultiphysicsInterfaceElement::SetLeftRightElementIndices(), TPZInterfaceElement::SetLeftRightElements(), TPZViscoelastic::SetMaterialDataHooke(), TPZAcademicGeoMesh::SetMaterialId(), TPZStructMatrixBase::SetMaterialIds(), TPZTransform< T >::SetMatrix(), TPZCompEl::SetMemoryIndices(), TPZStructMatrixBase::SetMesh(), TPZMatRedStructMatrix< TStructMatrix, TSparseMatrix >::SetMesh(), TPZAcademicGeoMesh::SetMeshType(), TPZEquationFilter::SetMinMaxEq(), TPZCompEl::SetMultiphysicsElementSolution(), pzgeom::TPZNodeRep< 15, pztopology::TPZPrism >::SetNeighbourInfo(), TPZConnect::SetNShape(), TPZConnect::SetNState(), TPZAcademicGeoMesh::SetNumberElements(), TPZSubCompMesh::SetNumberRigidBodyModes(), TPZMaterial::SetNumLoadCases(), TPZIntTriang::SetOrder(), TPZConnect::SetOrder(), TPZElasticityAxiMaterial::SetOrigin(), TPZPorousElasticity::SetParameters(), TPZBuildSBFem::SetPartitions(), TPZMixedDarcyFlow::SetPermeability(), TPZMixedPoisson::SetPermeabilityTensor(), TPZMatMixedPoisson3D::SetPermeabilityTensor(), TPZMaterial::SetPostProcessIndex(), TPZPostProcAnalysis::SetPostProcessVariables(), TPZStepSolver< TVar >::SetPreconditioner(), TPZReducedSpace::SetPreferredOrder(), TPZCompMeshTools::SetPressureOrders(), TPZMHMeshControl::SetProblemType(), TPZGeoEl::SetRefPattern(), TPZIntelGen< TSHAPE >::SetSideOrder(), TPZCompElHDivBound2< TSHAPE >::SetSideOrient(), TPZCompElHDiv< TSHAPE >::SetSideOrient(), TPZInterpolationSpace::SetSideOrient(), TPZFMatrix< STATE >::SetSize(), TPZSBFemVolume::SetSkeleton(), TPZSkylMatrix< TVar >::SetSkyline(), TPZCompElDisc::SetTrueUseQsiEta(), TPZGaussRule::SetType(), hdivCurvedJCompAppMath::SetupDisconnectedHdivboud(), TPZSymetricSpStructMatrix::SetupMatrixData(), SetupPyramidRestraint(), pzshape::TPZShapeDisc::Shape(), TPZReducedSpace::Shape(), TPZCompElHDivPressure< TSHAPE >::Shape(), TPZCompElHDivPressureBound< TSHAPE >::Shape(), TPZSBFemVolume::Shape(), pzshape::TPZShapeDisc::Shape0D(), pzshape::TPZShapeTetra::ShapeGenerating(), pzshape::TPZShapePiram::ShapeInternal(), pzshape::TPZShapeTriang::ShapeInternal(), pzshape::TPZShapePrism::ShapeInternal(), pzshape::TPZShapeTetra::ShapeInternal(), pzshape::TPZShapeQuad::ShapeInternal(), pzshape::TPZShapeCube::ShapeInternal(), pzshape::TPZShapeTriang::ShapeOrder(), pzshape::TPZShapeQuad::ShapeOrder(), pzshape::TPZShapeLinear::ShapeOrder(), TPZReducedSpace::ShapeX(), TPZAnalysis::ShowShape(), TPZReducedSpace::SideConnectLocId(), TPZSBFemVolume::SideConnectLocId(), TPZCompElDisc::SideConnectLocId(), TPZGeoElRefLess< TGeo >::SideIsUndefined(), pztopology::TPZTetrahedron::SideNodeLocId(), TPZRefPattern::SideNodes(), TPZCompElHDiv< TSHAPE >::SideOrient(), TPZRefPattern::SidePartition(), TPZCompElHDivPressureBound< TSHAPE >::SideShapeFunction(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), TPZCompElHDiv< TSHAPE >::SideShapeFunction(), pzshape::TPZShapeTriang::SideShapeOrder(), pzshape::TPZShapePiram::SideShapeOrder(), pzshape::TPZShapeTetra::SideShapeOrder(), pzshape::TPZShapePrism::SideShapeOrder(), pzshape::TPZShapeCube::SideShapeOrder(), pzshape::TPZShapeQuad::SideShapeOrder(), pzshape::TPZShapeLinear::SideShapeOrder(), TPZRefPatternTools::SidesToRefine(), TPZRefPattern::SideSubGeoElSide(), TPZSkylMatrix< TVar >::Size(), TPZCompMesh::Skyline(), TPZNonLinMultGridAnalysis::SmoothingSolution2(), hdivCurvedJCompAppMath::SolExata(), hdivCurvedJCompAppMath::SolExataH1(), TPZMultPlaca::Solution(), TPZMultCamada::Solution(), TPZMatHybrid::Solution(), TPZLinearConvection::Solution(), TPZMatOrthotropic::Solution(), TPZPlaca::Solution(), TPZEuler::Solution(), TPZViscoelastic::Solution(), TPZVecL2::Solution(), TPZPorousElasticity::Solution(), TPZConsLawTest::Solution(), TPZThermicElast3D::Solution(), TPZNullMaterial::Solution(), TPZMixedDarcyFlow::Solution(), TPZPrimalPoisson::Solution(), TPZElasticityAxiMaterial::Solution(), TPZEulerEquation::Solution(), TPZDualPoisson::Solution(), TPZElasticity3D::Solution(), TPZElasticityMaterial::Solution(), TPZMatElasticity2D::Solution(), TPZMatLaplacian::Solution(), TPZMaterial::Solution(), TPZMatPoisson3d::Solution(), TPZMixedElasticityMaterial::Solution(), TPZSwelling::Solution(), TPZCompEl::Solution(), TPZLagrangeMultiplier::SolutionDisc(), TPZMGSolver< TVar >::Solve(), TPZStepSolver< TVar >::Solve(), TPZAnalysis::Solve(), TPZMatrix< STATE >::SolveBICG(), TPZMatrix< STATE >::SolveBICGStab(), TPZMatrix< STATE >::SolveCG(), TPZFrontMatrix< TVar, store, front >::SolveDirect(), TPZMatrix< STATE >::SolveEigenvaluesJacobi(), TPZMatrix< STATE >::SolveGMRES(), TPZMatrix< STATE >::SolveIR(), TPZMatrix< STATE >::SolveJacobi(), TPZSkylMatrix< TVar >::SolveSOR(), TPZAUSMFlux::SoundSpeed(), TPZHybridizeHDiv::SplitConnects(), TPZMHMixedHybridMeshControl::SplitFluxElementsAroundFractures(), TPZFront< TVar >::STensorProductMTData::STensorProductMTData(), StopError(), TPZFileEqnStorage< TVar >::Store(), TPZAnalysis::StructMatrix(), TPZMetis::Subdivide(), TPZGeoElRefPattern< TGeo >::SubElement(), TPZFBMatrix< TVar >::Substitution(), TPZFMatrix< STATE >::Substitution(), TPZMHMeshControl::SubStructure(), TPZYCDruckerPragerPV::SurfaceParamF1(), TPZSandlerExtended::SurfaceParamF1(), TPZSandlerExtended::SurfaceParamF2(), TPZFrontSym< TVar >::TensorProductIJ(), TPZFrontNonSym< TVar >::TensorProductIJ(), TPZFront< STATE >::TensorProductIJ(), TPZStructMatrixOR::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWork(), TPZStructMatrixOT::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWorkResidual(), TPZStructMatrixOT::ThreadData::ThreadWorkResidual(), pzgeom::TPZArc3D::TPZArc3D(), TPZBndCond::TPZBndCond(), TPZCompEl::TPZCompEl(), TPZCompElHDivBound2< TSHAPE >::TPZCompElHDivBound2(), TPZCompElHDivPressureBound< TSHAPE >::TPZCompElHDivPressureBound(), TPZCompElLagrange::TPZCompElLagrange(), TPZCondensedCompEl::TPZCondensedCompEl(), TPZConservationLaw::TPZConservationLaw(), TPZFileEqnStorage< TVar >::TPZFileEqnStorage(), TPZGeoEl::TPZGeoEl(), TPZGeoElBC::TPZGeoElBC(), TPZGeoElRefPattern< TGeo >::TPZGeoElRefPattern(), TPZGeoElSide::TPZGeoElSide(), TPZGradientReconstruction::TPZGradientReconstruction(), TPZGuiInterface::TPZGuiInterface(), TPZHierarquicalGrid::TPZHierarquicalGrid(), TPZIntelGen< TSHAPE >::TPZIntelGen(), TPZInterfaceElement::TPZInterfaceElement(), TPZMatConvectionProblem::TPZMatConvectionProblem(), TPZMatPoisson3d::TPZMatPoisson3d(), TPZMeshSolution::TPZMeshSolution(), TPZMHMeshControl::TPZMHMeshControl(), TPZMixedPoisson::TPZMixedPoisson(), TPZMultiphase::TPZMultiphase(), TPZMultiphysicsCompEl< TGeometry >::TPZMultiphysicsCompEl(), TPZMultiphysicsInterfaceElement::TPZMultiphysicsInterfaceElement(), pzgeom::TPZNodeRep< 15, pztopology::TPZPrism >::TPZNodeRep(), TPZPorousElasticity::TPZPorousElasticity(), TPZProjectEllipse::TPZProjectEllipse(), TPZSkylNSymMatrix< TVar >::TPZSkylNSymMatrix(), TPZTensor< STATE >::TPZTensor(), TPZViscoelastic::TPZViscoelastic(), TPZMixedElasticityMaterial::Tr(), TPZSubCompMesh::TransferElementFrom(), TPZBuildMultiphysicsMesh::TransferFromMeshes(), TPZBuildMultiphysicsMesh::TransferFromMultiPhysics(), TPZMultiphysicsElement::TransferMultiphysicsElementSolution(), TPZSloanRenumbering::TransferPriority(), TPZPostProcAnalysis::TransferSolution(), TPZMHMeshControl::TransferToMultiphysics(), TPZRefPattern::Transform(), TPZRefPatternTools::TransformationTest(), TPZGeoEl::TransformSonToFather(), TPZFBMatrix< TVar >::Transpose(), TPZFMatrix< STATE >::Transpose(), pztopology::TPZPyramid::TShape(), TPZNonLinMultGridAnalysis::TwoGridAlgorithm(), TPZDohrSubstructCondense< TTVar >::UGlobal(), UniformRefinement(), TPZBndCondWithMem< TMEM >::UpdateBCValues(), TPZBndCond::UpdateBCValues(), TPZSkylNSymMatrix< TVar >::UpdateFrom(), TPZFMatrix< STATE >::UpdateFrom(), TPZMatrix< STATE >::UpdateFrom(), TPZSkylMatrix< TVar >::UpdateFrom(), TPZViscoelastic::UpdateQsi(), TPZMatWithMemTranslator< TMEMTranslator >::UpdateStream(), TPZSandlerExtendedTranslator::UpdateStream(), TPZEulerEquation::uRes(), TPZPorousElasticity::VariableIndex(), TPZInterpolatedElement::VerifyConstraintConsistency(), TPZSubCompMesh::VerifyDatastructureConsistency(), TPZGeoEl::VerifyNodeCoordinates(), TPZHybridizeHDiv::VerifySolutionConsistency(), TPZMatrix< STATE >::VerifySymmetry(), TPZGeoEl::WhichSide(), TPZMHMeshControl::WhichSubdomain(), TPZGeoEl::WhichSubel(), TPZMHMeshControl::WrapMaterialId(), TPZMixedDarcyFlow::Write(), TPZLinearConvecDiff::Write(), TPZStructMatrixTBBFlow::Write(), TPZPrimalPoisson::Write(), TPZDualPoisson::Write(), TPZPorousElasticity::Write(), TPZSavable::Write(), TPZMatDualHybridPoisson::Write(), TPZReynoldsFlow::Write(), TPZTracerFlow::Write(), TPZNullMaterial::Write(), TPZVecL2::Write(), TPZDummyFunction< TVar >::Write(), TPZElasticity3D::Write(), TPZInterfaceElement::Write(), TPZDohrMatrix< TVar, TSubStruct >::Write(), TPZPlasticStep< YC_t, TF_t, ER_t >::Write(), TPZFileStream::WriteData(), TPZBFileStream::WriteData(), TPZPersistenceManager::WriteToFile(), pzgeom::TPZGeoBlend< TGeo >::X(), pzgeom::TPZEllipse3D::X(), TPZGeoElRefLess< TGeo >::X(), TPZMatrix< STATE >::Zero(), TPZCompEl::~TPZCompEl(), TPZCompElHDiv< TSHAPE >::~TPZCompElHDiv(), TPZCompElHDivBound2< TSHAPE >::~TPZCompElHDivBound2(), TPZElementGroup::~TPZElementGroup(), TPZGeoEl::~TPZGeoEl(), and TPZPorousElasticity::~TPZPorousElasticity().

◆ MadpackReleaseDate

#define MadpackReleaseDate

Mad pack release version.

Definition at line 17 of file pzversion.h.

◆ MadpackVersion

#define MadpackVersion

Mad pack version.

Definition at line 12 of file pzversion.h.

◆ PZError

#define PZError

Defines the output device to error messages and the DebugStop() function.

Definition at line 15 of file pzerror.h.

Referenced by TPZAgglomerateElement::AccumulateIntegrationRule(), TPZCompElDisc::AccumulateIntegrationRule(), TPZCompElDisc::AccumulateVertices(), TPZDiffMatrix< T >::Add(), TPZDiffMatrix< T >::AddAlignDiv(), TPZDiffMatrix< T >::AddDiv(), TPZFMatrix< STATE >::AddFel(), TPZSkylMatrix< TVar >::AddSameStruct(), TPZAgglomerateElement::AddSubElementIndex(), TPZCompElHDivPressure< TSHAPE >::Append(), TPZCompElHDiv< TSHAPE >::Append(), TPZCompElDisc::AppendExternalShapeFunctions(), TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZEulerConsLaw::ApproxRoe_Flux(), TPZPostProcAnalysis::Assemble(), TPZEulerAnalysis::Assemble(), TPZDiscontinuousGalerkin::BCInterfaceJump(), TPZMatPoisson3d::BCInterfaceJump(), pztopology::TPZPoint::BlendFactorForSide(), pztopology::TPZLine::BlendFactorForSide(), pztopology::TPZTetrahedron::BlendFactorForSide(), pztopology::TPZPyramid::BlendFactorForSide(), pztopology::TPZTriangle::BlendFactorForSide(), pztopology::TPZCube::BlendFactorForSide(), pztopology::TPZPrism::BlendFactorForSide(), pztopology::TPZQuadrilateral::BlendFactorForSide(), TPZGeoElSide::BuildConnectivities(), TPZCompElDisc::BuildTransferMatrix(), TPZCompMesh::BuildTransferMatrix(), TPZCompMesh::BuildTransferMatrixDesc(), TPZGeoElRefLess< TGeo >::BuildTransform2(), TPZGeoEl::BuildTransform2(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZAgglomerateElement::CalcResidual(), TPZInterpolationSpace::CalcResidual(), TPZInterfaceElement::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZCompElPostProc< TCOMPEL >::CalcStiff(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZInterpolationSpace::CalcStiff(), TPZInterfaceElement::CalcStiff(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), TPZCompElDisc::CenterPoint(), pzgeom::TPZChangeEl::ChangeToGeoBlend(), TPZInterfaceElement::CheckConsistencyOfMappedQsi(), pztopology::TPZPyramid::CheckProjectionForSingularity(), TPZCheckGeom::CheckRefinement(), TPZCheckRestraint::CheckRestraint(), TPZRefPattern::CheckSideAndSubElConsistency(), TPZRefPattern::CheckSideConsistency(), TPZCheckGeom::CheckSideTransform(), TPZCheckGeom::CheckSubFatherTransform(), TPZCompMesh::CleanUpUnconnectedNodes(), TPZMultiphysicsCompEl< TGeometry >::Clone(), TPZMultiphysicsCompEl< TGeometry >::ClonePatchEl(), TPZAdmChunkVector< TPZGeoEl *>::CompactDataStructure(), TPZInterpolatedElement::CompareElement(), TPZCompEl::ComputeError(), TPZInterfaceElement::ComputeErrorFace(), TPZInterfaceElement::ComputeNormal(), TPZInterpolationSpace::ComputeNormal(), TPZGeoEl::ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZInterpolationSpace::ComputeRequiredData(), TPZInterpolationSpace::ComputeShape(), TPZCompElPostProc< TCOMPEL >::ComputeShape(), TPZCompElDisc::ComputeShape(), TPZSBFemVolume::ComputeShape(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter2(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter3(), TPZConsLawTest::ComputeSolLeft(), TPZConsLawTest::ComputeSolRight(), TPZMultiphysicsCompEl< TGeometry >::ComputeSolution(), TPZSubCompMesh::ComputeSolution(), TPZMaterial::ComputeSquareResidual(), TPZArtDiff::ComputeTau(), TPZRefPattern::ComputeTransforms(), TPZGeoEl::ComputeXInverse(), TPZIntRuleT::ComputingSymmetricCubatureRule(), TPZIntRuleT3D::ComputingSymmetricCubatureRule(), TPZMatrix< STATE >::ConditionNumber(), TPZInterfaceElement::ConnectIndex(), TPZCircBufferedStream::ConstReadFromBuffer(), TPZContBufferedStream::ConstReadFromBuffer(), pztopology::Pr< TFather >::ContainedSideLocId(), pztopology::TPZTetrahedron::ContainedSideLocId(), pztopology::TPZPyramid::ContainedSideLocId(), pztopology::TPZPrism::ContainedSideLocId(), pztopology::TPZTriangle::ContainedSideLocId(), pztopology::TPZCube::ContainedSideLocId(), pztopology::TPZQuadrilateral::ContainedSideLocId(), pztopology::TPZLine::ContainedSideLocId(), TPZTransientMaterial< TBASEMAT >::Contribute(), TPZPlaca::Contribute(), TPZMatPlaca2::Contribute(), TPZElasticity2DHybrid::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZConsLawTest::Contribute(), TPZNLMat1d::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZMat2dLin::Contribute(), TPZMat1dLin::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZPostProcMat::Contribute(), TPZElasticity3D::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatPoisson3d::Contribute(), TPZEulerConsLaw::Contribute(), TPZEulerConsLaw::ContributeApproxImplConvFace(), TPZMatHybrid::ContributeBC(), TPZLinearConvection::ContributeBC(), TPZTransientMaterial< TBASEMAT >::ContributeBC(), TPZPlaca::ContributeBC(), TPZMaterialTest::ContributeBC(), TPZMatPlaca2::ContributeBC(), TPZMatHyperElastic::ContributeBC(), TPZBiharmonic::ContributeBC(), TPZNLMat1d::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZNonLinBiharmonic::ContributeBC(), TPZBurger::ContributeBC(), TPZMat2dLin::ContributeBC(), TPZMat1dLin::ContributeBC(), TPZPrimalPoisson::ContributeBC(), TPZMatElastoPlastic2D< T, TMEM >::ContributeBC(), TPZMatElastoPlastic< T, TMEM >::ContributeBC(), TPZPostProcMat::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZSwelling::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZMatPoisson3d::ContributeBC(), TPZTransientMaterial< TBASEMAT >::ContributeBCInterface(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZElasticityAxiMaterial::ContributeBCInterface(), TPZMatConvectionProblem::ContributeBCInterface(), TPZElasticityMaterial::ContributeBCInterface(), TPZMatLaplacian::ContributeBCInterface(), TPZMatPoisson3d::ContributeBCInterface(), TPZMixedElasticityMaterial::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZArtDiff::ContributeBornhaus(), TPZMaterial::ContributeErrors(), TPZArtDiff::ContributeExplDiff(), TPZBurger::ContributeGradStab(), TPZTransientMaterial< TBASEMAT >::ContributeInterface(), TPZElasticityMaterial::ContributeInterface(), TPZMixedElasticityMaterial::ContributeInterface(), TPZDiscontinuousGalerkin::ContributeInterfaceBCErrors(), TPZLagrangeMultiplier::ContributeInterfaceBCErrors(), TPZDiscontinuousGalerkin::ContributeInterfaceErrors(), TPZLagrangeMultiplier::ContributeInterfaceErrors(), TPZBurger::ContributeSUPG(), TPZElasticity3D::ContributeVecShapeBC(), TPZElast3Dnlinear::ContributeVecShapeBCAux(), TPZInterpolationSpace::Convert2Axes(), TPZGeoNode::Coord(), TPZCompElWithMem< TBASE >::CopyIntPtIndicesFrom(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZCoupledTransportDarcy::CreateBC(), TPZGeoMesh::CreateGeoBlendElement(), TPZGeoMesh::CreateGeoElement(), TPZGeoMesh::CreateGeoElementMapped(), CreateGeoElementPattern(), TPZGradientReconstruction::TPZGradientData::CreateGhostsNeighbors(), TPZMultiphysicsInterfaceElement::CreateIntegrationRule(), TPZMultiphysicsElement::CreateInterfaces(), TPZInterpolationSpace::CreateInterfaces(), TPZCompElDisc::CreateMidSideConnect(), TPZAgglomerateElement::CreateMidSideConnect(), pztopology::TPZCube::CreateSideIntegrationRule(), pztopology::TPZPyramid::CreateSideIntegrationRule(), pztopology::TPZPrism::CreateSideIntegrationRule(), pztopology::TPZLine::CreateSideIntegrationRule(), pztopology::TPZTetrahedron::CreateSideIntegrationRule(), pztopology::TPZTriangle::CreateSideIntegrationRule(), pztopology::TPZQuadrilateral::CreateSideIntegrationRule(), TPZEulerConsLaw::cSpeed(), TPZEulerEquation::cSpeed(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZSpBlockDiagPivot< TVar >::Decompose_LU(), TPZSkylNSymMatrix< TVar >::Decompose_LU(), TPZDiffMatrix< T >::Decompose_LU(), TPZGeoMesh::DeleteElement(), TPZArtDiff::Delta(), TPZEulerConsLaw::Det(), TPZArtDiff::DiffusionName(), TPZGeoElSide::Dimension(), TPZGeoEl::Distance(), TPZGeoElRefPattern< TGeo >::Divide(), TPZCompElDisc::Divide(), TPZGeoEl::Divide(), TPZCompMesh::Divide(), Dot(), TPZArtDiff::EigenSystemBornhaus(), TPZArtDiff::EigenSystemSUPG(), TPZMatElastoPlastic< T, TMEM >::EigenValues(), TPZMatElastoPlastic< T, TMEM >::EigenVectors(), TPZRefPattern::Element(), TPZMGAnalysis::ElementError(), TPZGeoEl::ElementExists(), TPZGeoEl::ElementRadius(), TPZMatPlaca2::Errors(), TPZIncNavierStokesKEps::Errors(), TPZMaterial::Errors(), TPZMaterial::ErrorsHdiv(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZInterpolationSpace::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZInterfaceElement::ExistInterfaces(), TPZFlowCompMesh::ExpandSolution2(), TPZGeoEl::Father2(), pzrefine::TPZRefTriangle::FatherSide(), pzrefine::TPZRefPrism::FatherSide(), pzrefine::TPZRefPyramid::FatherSide(), pzrefine::TPZRefQuad::FatherSide(), pzrefine::TPZRefCube::FatherSide(), pzrefine::TPZRefLinear::FatherSide(), pzrefine::TPZRefPoint::FatherSide(), TPZRefPattern::FatherSide(), TPZGeoEl::FatherSide(), TPZVec< std::pair< int, int > >::Fill(), TPZMatElastoPlastic2D< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZBndCond::FillDataRequirements(), TPZRefPattern::FindSubEl(), TPZPlaca::Flux(), TPZMatPlaca2::Flux(), TPZMat2dLin::Flux(), TPZMatElastoPlastic< T, TMEM >::Flux(), TPZMatPorous< T, TMEM >::Flux(), TPZEulerConsLaw::Flux(), TPZElasticity3D::Flux(), TPZCompElWithMem< TBASE >::ForcePrepareIntPtIndices(), TPZInterfaceElement::FreeInterface(), TPZEulerEquation::FromConservativeToPrimitive(), TPZRefPattern::GeneratePermutations(), TPZGeoElSide::GetAllSiblings(), TPZGeoEl::GetAllSiblings(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZCoupledTransportDarcyBC::GetCurrentMaterial(), TPZCoupledTransportDarcy::GetCurrentMaterial(), TPZCoupledTransportDarcy::GetMaterial(), TPZCoupledTransportDarcyBC::GetNonNullMaterial(), pztopology::GetPermutation(), TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec(), TPZIdentifyRefPattern::GetRefPattern(), TPZIdentifyRefPattern::GetSideRefPattern(), GetSideShapeFunction(), pzrefine::TPZRefPrism::GetSubElements(), pzrefine::TPZRefTriangle::GetSubElements(), pzrefine::TPZRefCube::GetSubElements(), pzrefine::TPZRefPyramid::GetSubElements(), pzrefine::TPZRefQuad::GetSubElements(), pzrefine::TPZRefLinear::GetSubElements(), pzrefine::TPZRefTetrahedra::GetSubElements(), pzrefine::TPZRefPoint::GetSubElements(), TPZGeoEl::GetSubElements2(), pzrefine::TPZRefTriangle::GetTransform(), pzrefine::TPZRefPrism::GetTransform(), pzrefine::TPZRefPyramid::GetTransform(), pzrefine::TPZRefQuad::GetTransform(), pzrefine::TPZRefCube::GetTransform(), pzrefine::TPZRefLinear::GetTransform(), pzrefine::TPZRefTetrahedra::GetTransform(), TPZGeoElRefLess< TGeo >::GetTransform(), TPZIdentifyRefPattern::GetUniform(), pztopology::Pr< TFather >::HigherDimensionSides(), pztopology::TPZTetrahedron::HigherDimensionSides(), pztopology::TPZPyramid::HigherDimensionSides(), pztopology::TPZTriangle::HigherDimensionSides(), pztopology::TPZPrism::HigherDimensionSides(), pztopology::TPZQuadrilateral::HigherDimensionSides(), pztopology::TPZCube::HigherDimensionSides(), pztopology::TPZLine::HigherDimensionSides(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZAnalysisError::HPAdapt(), TPZNonLinMultGridAnalysis::IMesh(), TPZDiffMatrix< T >::index(), TPZAgglomerateElement::IndexesDiscSubEls(), TPZAgglomerateElement::InitializeElement(), TPZInterfaceElement::InitializeElementMatrix(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZInterfaceElement::InitMaterialData(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZAgglomerateElement::InnerRadius(), TPZInterpolationSpace::InnerRadius(), TPZRefPatternDataBase::InsertRefPattern(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZCompEl::Integrate(), TPZInterfaceElement::IntegrateInterface(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZInterpolationSpace::IntegrateSolution(), TPZMatPoisson3d::InterfaceErrors(), TPZBndCond::InterfaceJump(), TPZGeoMesh::InterfaceMaterial(), TPZInterpolationSpace::InterpolateSolution(), TPZMatrix< STATE >::Inverse(), IsInSideParametricDomain(), TPZMatLaplacian::IsSymetric(), TPZMatPoisson3d::IsSymetric(), TPZEulerConsLaw::JacobFlux(), TPZAgglomerateElement::LesserEdgeOfEl(), TPZAgglomerateElement::ListOfDiscEl(), TPZIntRuleP3D::Loc(), TPZGaussRule::Loc(), TPZIntRuleT::Loc(), TPZIntRuleT3D::Loc(), TPZInterfaceElement::main(), pztopology::TPZPyramid::MapToSide(), TPZMatrix< STATE >::MatrixNorm(), TPZFlowCompMesh::MaxVelocityOfMesh(), pzrefine::TPZRefTriangle::MidSideNodeIndex(), pzrefine::TPZRefPrism::MidSideNodeIndex(), pzrefine::TPZRefCube::MidSideNodeIndex(), pzrefine::TPZRefQuad::MidSideNodeIndex(), pzrefine::TPZRefPyramid::MidSideNodeIndex(), pzrefine::TPZRefLinear::MidSideNodeIndex(), pzrefine::TPZRefTetrahedra::MidSideNodeIndex(), pzrefine::TPZRefPoint::MidSideNodeIndex(), TPZGeoElRefPattern< TGeo >::MidSideNodeIndex(), TPZGeoElRefLess< TGeo >::MidSideNodeIndex(), TPZArtDiff::MMatrix(), TPZDiffMatrix< T >::Multiply(), TPZDiffMatrix< T >::MultiplyAdd(), TPZSubCompMesh::NConnectShapeF(), pzshape::TPZShapePiram::NConnectShapeF(), pzshape::TPZShapeTriang::NConnectShapeF(), pzshape::TPZShapePrism::NConnectShapeF(), pzshape::TPZShapeTetra::NConnectShapeF(), pzshape::TPZShapeQuad::NConnectShapeF(), pzshape::TPZShapeCube::NConnectShapeF(), pzshape::TPZShapeLinear::NConnectShapeF(), TPZCompElDisc::NConnectShapeF(), pztopology::TPZTriangle::NContainedSides(), pztopology::TPZQuadrilateral::NContainedSides(), pztopology::TPZLine::NContainedSides(), TPZConnect::NDof(), TPZGeoElSide::NeighbourSideTransform(), TPZMaterial::NewMaterial(), TPZMatElastoPlastic< T, TMEM >::NFluxes(), TPZMatPorous< T, TMEM >::NFluxes(), TPZElasticity3D::NFluxes(), TPZCompElDisc::NInterfaces(), TPZRenumbering::NodeToElGraph(), TPZGeoElSide::Normal(), TPZMatOrthotropic::Normalize(), TPZInt1d::NPoints(), TPZIntTriang::NPoints(), TPZIntQuad::NPoints(), TPZIntCube3D::NPoints(), TPZIntTetra3D::NPoints(), TPZIntPyram3D::NPoints(), pzshape::TPZShapeDisc::NShapeF(), pzrefine::TPZRefPrism::NSideSubElements(), pzrefine::TPZRefTriangle::NSideSubElements(), pzrefine::TPZRefCube::NSideSubElements(), pzrefine::TPZRefPyramid::NSideSubElements(), pzrefine::TPZRefQuad::NSideSubElements(), pzrefine::TPZRefLinear::NSideSubElements(), pzrefine::TPZRefTetrahedra::NSideSubElements(), pzrefine::TPZRefPoint::NSideSubElements(), TPZIncNavierStokesKEps::NSolutionVariables(), TPZViscoelastic::NSolutionVariables(), TPZMaterial::NSolutionVariables(), TPZRefPattern::NSubElements(), pztopology::TPZTetrahedron::NumSides(), pztopology::TPZPyramid::NumSides(), pztopology::TPZTriangle::NumSides(), pztopology::TPZPrism::NumSides(), pztopology::TPZCube::NumSides(), pztopology::TPZQuadrilateral::NumSides(), pztopology::TPZLine::NumSides(), TPZArtDiff::ODotOperator(), TPZBFileStream::OpenRead(), TPZFileStream::OpenRead(), TPZPersistenceManager::OpenRead(), TPZBFileStream::OpenWrite(), TPZFileStream::OpenWrite(), TPZVec< std::pair< int, int > >::operator[](), TPZChunkVector< TPZGraphNode, 10 >::operator[](), TPZStack< int, 100 >::Peek(), TPZInt1d::Point(), TPZIntTriang::Point(), TPZIntQuad::Point(), TPZIntCube3D::Point(), TPZIntTetra3D::Point(), TPZIntPyram3D::Point(), TPZIntPrism3D::Point(), pzshape::TPZShapeDisc::Polynomial(), pzshape::TPZShapeDisc::PolynomialWithoutScale(), TPZStack< int, 100 >::Pop(), TPZAnalysis::PostProcessErrorParallel(), TPZAnalysis::PostProcessErrorSerial(), TPZIntelGen< TSHAPE >::PreferredSideOrder(), TPZCompElHDivBound2< TSHAPE >::PreferredSideOrder(), TPZCompElHDiv< TSHAPE >::PreferredSideOrder(), TPZInterpolatedElement::PRefine(), TPZCompElWithMem< TBASE >::PrepareIntPtIndices(), TPZAUSMFlux::Pressure(), TPZEulerConsLaw::Pressure(), TPZEulerEquation::Pressure(), TPZElasticity3D::PrincipalDirection(), ProjectBissectionInParametricDomain(), TPZCompMesh::ProjectSolution(), TPZGeoEl::QuadArea(), TPZFileStream::ReadData(), TPZBFileStream::ReadData(), TPZCircBufferedStream::ReadFromBuffer(), TPZContBufferedStream::ReadFromBuffer(), TPZVec< std::pair< int, int > >::ReallocForNuma(), TPZMultiphysicsCompEl< TGeometry >::ReferredElement(), TPZCompMesh::RemakeAllInterfaceElements(), TPZGeoElSide::RemoveConnectivity(), TPZMultiphysicsElement::RemoveInterfaces(), TPZInterpolationSpace::RemoveInterfaces(), TPZNonLinMultGridAnalysis::ResetReference(), TPZAdmChunkVector< TPZGeoEl *>::Resize(), TPZManVector< TPZPostProcVar, 20 >::Resize(), TPZVec< std::pair< int, int > >::Resize(), TPZChunkVector< TPZGraphNode, 10 >::Resize(), TPZGeoMesh::RestoreReference(), TPZArtDiff::RMMatrix(), TPZEulerConsLaw::Roe_Flux(), TPZArtDiff::RotMatrix(), saxpy(), sdot(), TPZGeoElSide::SetConnectivity(), TPZMatPoisson3dReferred::SetConvectionTerm(), TPZGeoNode::SetCoord(), TPZCoupledTransportDarcy::SetCurrentMaterial(), pzgeom::TPZQuadSphere< GeomQuad >::SetData(), TPZLinearConvection::SetData(), TPZMaterial::SetData(), TPZGradientReconstruction::SetDataGhostsNeighbors(), TPZEulerConsLaw::SetDelta(), TPZAdmChunkVector< TPZGeoEl *>::SetFree(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolution(), TPZCompElDisc::SetInnerRadius(), TPZInterfaceElement::SetLeftRightElements(), TPZCoupledTransportDarcyBC::SetMaterial(), TPZViscoelastic::SetMaterialDataHooke(), TPZGeoElSide::SetNeighbour(), TPZCompElDisc::SetNInterfaces(), TPZElasticity3D::SetPostProcessingDirection(), TPZPostProcAnalysis::SetPostProcessVariables(), TPZPostProcMat::SetPostProcessVarIndexList(), TPZReducedSpace::SetPreferredOrder(), TPZNonLinMultGridAnalysis::SetReference(), TPZGeoElRefPattern< TGeo >::SetRefPattern(), TPZGeoEl::SetRefPattern(), TPZCompElHDivBound2< TSHAPE >::SetSideOrder(), TPZIntelGen< TSHAPE >::SetSideOrder(), TPZCompElHDivPressureBound< TSHAPE >::SetSideOrder(), TPZCompElHDiv< TSHAPE >::SetSideOrder(), TPZGeoElRefPattern< TGeo >::SetSubElement(), TPZGeoElement< TGeo, TRef >::SetSubElement(), TPZGeoElRefLess< TGeo >::SetSubElement(), pzshape::TPZShapeDisc::Shape(), pzshape::TPZShapeLinear::Shape(), pzshape::TPZShapeDisc::Shape0D(), TPZGeoEl::Shape1d(), pzshape::TPZShapeDisc::Shape2D(), pzshape::TPZShapeDisc::Shape2DFull(), pzshape::TPZShapeTriang::ShapeInternal(), TPZGeoEl::ShapePhi1d(), TPZGuiInterface::ShowErrorMessage(), TPZGeoEl::SideArea(), TPZCompElHDiv< TSHAPE >::SideConnectLocId(), pztopology::Pr< TFather >::SideDimension(), pztopology::TPZTetrahedron::SideDimension(), pztopology::TPZTriangle::SideDimension(), pztopology::TPZPyramid::SideDimension(), pztopology::TPZPrism::SideDimension(), pztopology::TPZQuadrilateral::SideDimension(), pztopology::TPZCube::SideDimension(), pztopology::TPZLine::SideDimension(), TPZGeoElRefLess< TGeo >::SideIsUndefined(), TPZGeoElRefLess< TGeo >::SideNodeIndex(), pztopology::Pr< TFather >::SideNodeLocId(), pztopology::TPZTetrahedron::SideNodeLocId(), pztopology::TPZPyramid::SideNodeLocId(), pztopology::TPZTriangle::SideNodeLocId(), pztopology::TPZPrism::SideNodeLocId(), pztopology::TPZQuadrilateral::SideNodeLocId(), pztopology::TPZCube::SideNodeLocId(), pztopology::TPZLine::SideNodeLocId(), TPZGeoElRefLess< TGeo >::SideNodeLocIndex(), pzshape::TPZShapeTriang::SideShape(), pzshape::TPZShapeTetra::SideShape(), pzshape::TPZShapePiram::SideShape(), pzshape::TPZShapePrism::SideShape(), pzshape::TPZShapeCube::SideShape(), TPZGeoElRefPattern< TGeo >::SideSubElement(), pztopology::Pr< TFather >::SideToSideTransform(), pztopology::TPZPyramid::SideToSideTransform(), pztopology::TPZCube::SideToSideTransform(), pztopology::TPZLine::SideToSideTransform(), pztopology::TPZPrism::SideToSideTransform(), pztopology::TPZTetrahedron::SideToSideTransform(), pztopology::TPZTriangle::SideToSideTransform(), pztopology::TPZQuadrilateral::SideToSideTransform(), TPZGeoElSide::SideToSideTransform(), TPZGeoElSide::SideTransform3(), TPZCompElDisc::SizeOfElement(), TPZIncNavierStokesKEps::Solution(), TPZViscoelastic::Solution(), TPZEulerConsLaw::Solution(), TPZEulerEquation::Solution(), TPZElasticity3D::Solution(), TPZMaterial::Solution(), TPZPostProcAnalysis::Solve(), TPZMatrix< STATE >::SolveEigensystemJacobi(), TPZMatrix< STATE >::SolveEigenvaluesJacobi(), TPZAUSMFlux::SoundSpeed(), TPZAgglomerateElement::SubElement(), TPZFMatrix< STATE >::Substitution(), TPZSpBlockDiagPivot< TVar >::Substitution2(), TPZFront< STATE >::TensorProductIJ(), TPZConservationLaw::TPZConservationLaw(), TPZConsLawTest::TPZConsLawTest(), TPZElasticity3D::TPZElasticity3D(), TPZGaussRule::TPZGaussRule(), TPZGeoElBC::TPZGeoElBC(), TPZInterfaceElement::TPZInterfaceElement(), TPZIntRuleList::TPZIntRuleList(), TPZIntRuleT::TPZIntRuleT(), TPZIntRuleT3D::TPZIntRuleT3D(), TPZMultiphysicsCompEl< TGeometry >::TPZMultiphysicsCompEl(), TPZVec< std::pair< int, int > >::TPZVec(), TPZViscoelastic::TPZViscoelastic(), TPZRefPatternTools::TransformationTest(), pztopology::Pr< TFather >::TransformElementToSide(), pztopology::TPZPyramid::TransformElementToSide(), pztopology::TPZCube::TransformElementToSide(), pztopology::TPZPrism::TransformElementToSide(), pztopology::TPZLine::TransformElementToSide(), pztopology::TPZTetrahedron::TransformElementToSide(), pztopology::TPZTriangle::TransformElementToSide(), pztopology::TPZQuadrilateral::TransformElementToSide(), pztopology::Pr< TFather >::TransformSideToElement(), pztopology::TPZPyramid::TransformSideToElement(), pztopology::TPZCube::TransformSideToElement(), pztopology::TPZLine::TransformSideToElement(), pztopology::TPZPrism::TransformSideToElement(), pztopology::TPZTetrahedron::TransformSideToElement(), pztopology::TPZTriangle::TransformSideToElement(), pztopology::TPZQuadrilateral::TransformSideToElement(), TPZGeoEl::TransformSonToFather(), TPZGeoEl::TriangleArea(), TPZNonLinMultGridAnalysis::UniformlyRefineMesh(), TPZIdentifyRefPattern::UniformSubElem(), TPZBndCond::UpdateBCValues(), TPZCoupledTransportDarcyBC::UpdateConvectionDir(), TPZCoupledTransportDarcyBC::UpdateConvectionDirInterface(), TPZEulerConsLaw::uRes(), TPZEulerEquation::uRes(), TPZMatElastoPlastic< T, TMEM >::VariableIndex(), TPZPostProcMat::VariableIndex(), TPZAxesTools< TVar >::VerifyAxes(), TPZGeoEl::VerifyNodeCoordinates(), TPZIntRuleP3D::W(), TPZGaussRule::W(), TPZIntRuleT::W(), TPZIntRuleT3D::W(), TPZGeoEl::WhichSide(), TPZGeoEl::WhichSubel(), TPZInterfaceElement::Write(), TPZFileStream::WriteData(), and TPZBFileStream::WriteData().

Enumeration Type Documentation

◆ MElementType

Define the element types.

Zero-dimensional: EPoint.
One-dimensional: EOned (element) EInterfacePoint (interface).
Two-dimensional: ETriangle EQuadrilateral (element) EInterfaceLinear (interface).
Three-dimensional: ETetrahedro EPiramide EPrisma ECube (element) EInterfaceSurface (interface).
n-dimensional: ESubstructure EGlobLoc EDiscontinuous EInterfaceDisc EAgglomerate

Defines the element types

Parameters
EPointelement 0D - type point - associated index 0
EOnedelement 1D - type oned - associated index 1
ETriangleelement 2D - type triangle - associated index 2
EQuadrilateralelement 2D - type quad - associated index 3
ETetraedroelement 3D - type tetraedro - associated index 4
EPiramideelement 3D - type piramide - associated index 5
EPrismaelement 3D - type prisma - associated index 6
ECubeelement 3D - type cube - associated index 7
EPolygonalelement ?? - type ?? - associated index 8
EInterfaceelement nD - type interface - associated index 9
EInterfacePointelement 1D - type interface - associated index 10
EInterfaceLinearelement 2D - type interface - associated index 11
EInterfaceSurfaceelement 3D - type interface - associated index 12
ESubstructureelement nD - type submesh - associated index 13
EGlobLocelement nD - type global-local - associated index 14
EDiscontinuouselement nD - type discontinuous- associated index 15
EInterfaceDiscelement nD - type interface - associated index 16
EAgglomerateelement nD - type agglomerate - associated index 17
ENoTypeelement 0D - type none - associated index 18
Enumerator
EPoint 
EOned 
ETriangle 
EQuadrilateral 
ETetraedro 
EPiramide 
EPrisma 
ECube 
EPolygonal 
EInterface 
EInterfacePoint 
EInterfaceLinear 
EInterfaceSurface 
ESubstructure 
EGlobLoc 
EDiscontinuous 
EAgglomerate 
ENoType 
EInterfaceDisc 

Definition at line 52 of file pzeltype.h.

◆ MOptype

enum MOptype

Types of operations to be counted.

Operations to be counted: Sum, Product, Division, Square root, Power,
Sine, Cosine, Arc Sine, Arc Cosine, Arc Tangent, Exponencial and Logarithm.

Enumerator
ESum 
EProd 
EDiv 
ESqrt 
EPow 
ECos 
ESin 
EAcos 
EAsin 
EAtan 
EExp 
ELog 

Definition at line 105 of file pzreal.h.

Function Documentation

◆ acos()

TPZFlopCounter acos ( const TPZFlopCounter orig)
inline

Returns the arc cosine in radians and increments the counter of the Arc Cosine.

Definition at line 496 of file pzreal.h.

References EAcos, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZFlopCounter::operator!=().

◆ asin()

TPZFlopCounter asin ( const TPZFlopCounter orig)
inline

Returns the arc sine in radians and increments the counter of the Arc Sine.

Definition at line 505 of file pzreal.h.

References EAsin, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZFlopCounter::operator!=().

◆ atan()

TPZFlopCounter atan ( const TPZFlopCounter orig)
inline

Returns the arc tangent in radians and increments the counter of the Arc Tangent.

Definition at line 532 of file pzreal.h.

References EAtan, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZCounter::clear(), and TPZFlopCounter::operator!=().

◆ atan2()

TPZFlopCounter atan2 ( const TPZFlopCounter val1,
const TPZFlopCounter val2 
)
inline

◆ cos()

TPZFlopCounter cos ( const TPZFlopCounter orig)
inline

Returns the cosine in radians and increments the counter of the Cosine.

Definition at line 514 of file pzreal.h.

References ECos, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by pzgeom::TPZEllipse3D::AdjustNodesCoordinates(), pzgeom::TPZArc3D::ArcAngle(), TPZCounter::clear(), TPZMohrCoulombNeto::CommitDeformation(), TPZMohrCoulombPV::CommitDeformation(), TPZYCTrescaRegularized::Compute(), TPZYCRankine< T_YCBASE >::Compute(), TPZYCTresca::Compute(), TPZYCMohrCoulomb::Compute(), TPZYCWillamWarnke::Compute(), TPZYCVonMisesCombTresca::Compute(), TPZYCModifiedMohrCoulomb::Compute(), TPZYCMohrCoulombPV::ComputeApexGradient(), TPZSandlerExtended::ComputeCapCoVertexTangent(), TPZSandlerExtended::ComputeCapTangent(), TPZSandlerExtended::ComputeCapVertexTangent(), TPZSandlerExtended::ComputeFailureTangent(), TPZMat2dLin::ConvectionDiffusion(), TPZGenGrid::Coord(), TPZYCCamClayPV::D2DistanceToSurface(), TPZYCDruckerPragerPV::D2DistanceToSurfaceF1(), TPZSandlerExtended::D2DistFunc1(), TPZYCCamClayPV::DDistanceToSurface(), TPZYCDruckerPragerPV::DDistanceToSurfaceF1(), TPZSandlerExtended::DDistF2IJ(), TPZSandlerExtended::DDistFunc1(), TPZYCDruckerPragerPV::DF1Cart(), TPZSandlerExtended::DF1Cart(), TPZSandlerExtended::DF2Cart(), TPZYCCamClayPV::DFuncCart(), TPZYCSandlerDimaggio::DFuncEpsp(), TPZYCSandlerDimaggio::DFuncEpspL(), TPZYCSandlerDimaggio::DFuncEpspUsingL(), TPZYCSandlerDimaggio::DFuncTheta(), TPZYCSandlerDimaggio::DFuncTheta2(), TPZYCSandlerDimaggio::DFuncTheta2L(), TPZTensor< STATE >::DirectEigenValues(), TPZSandlerExtended::DistF2IJ(), TPZYCSandlerDimaggio::DistThetaL(), TPZSandlerExtended::DResLF2(), TPZTensor< STATE >::Eigenvalue(), TPZSandlerExtended::F2Cyl(), Forcing(), hdivCurvedJCompAppMath::Forcing(), hdivCurvedJCompAppMath::ForcingBC1D(), hdivCurvedJCompAppMath::ForcingBC2D(), hdivCurvedJCompAppMath::ForcingBC3D(), hdivCurvedJCompAppMath::ForcingBC4D(), hdivCurvedJCompAppMath::ForcingBC5D(), TPZHWTools::FromHWCylToHWCart(), TPZHWTools::FromHWCylToPrincipal(), TPZSandlerExtended::FromThetaKToSigIJ(), TPZYCSandlerDimaggio::FuncEpsp(), TPZYCSandlerDimaggio::FuncEpspL(), TPZYCSandlerDimaggio::FuncEpspUsingL(), TPZYCSandlerDimaggio::FuncTheta2L(), TPZYCSandlerDimaggio::FuncThetaL(), TPZMathTools::Function(), hdivCurvedJCompAppMath::GMeshCilindricalMesh(), TPZYCDruckerPragerPV::GradF1SigmaTrial(), TPZSandlerExtended::GradF1SigmaTrial(), TPZSandlerExtended::GradF2SigmaTrial(), TPZYCCamClayPV::GradSigmaTrial(), pzgeom::TPZCylinderMap< TGeo >::GradX(), pzgeom::TPZWavyLine::GradX(), pzgeom::TPZQuadTorus::GradX(), pzgeom::TPZEllipse3D::GradX(), pzgeom::TPZTriangleTorus::GradX(), TPZYCMohrCoulomb::H(), TPZYCModifiedMohrCoulomb::H(), pzgeom::TPZEllipse3D::InsertExampleElement(), TPZSandlerExtended::JacobianCoVertex(), TPZSandlerExtended::Jacobianf1(), TPZSandlerExtended::Jacobianf2(), TPZSandlerExtended::Jacobianf2CoVertex(), TPZSandlerExtended::Jacobianf2Vertex(), TPZSandlerExtended::JacobianVertex(), TPZElasticity3D::MohrCoulombPlasticFunction(), TPZYCTrescaRegularized::N(), TPZYCTresca::N(), TPZYCWillamWarnke::N(), TPZYCSandlerDimaggio::NewtonF2(), TPZYCSandlerDimaggio::NewtonF2L(), TPZYCSandlerDimaggio::NewtonF3(), TPZFlopCounter::operator!=(), hdivCurvedJCompAppMath::ParametricCircle(), hdivCurvedJCompAppMath::ParametricSphere(), TPZYCMohrCoulombPV::PhiPlane(), TPZMohrCoulombPV::PhiPlane(), TPZMohrCoulombNeto::PhiPlane(), TPZIntQuadQuarterPoint::Point(), TPZSandlerExtended::Res1(), TPZSandlerExtended::Res2(), TPZSandlerExtended::Res2CoVertex(), TPZSandlerExtended::Res2Vertex(), TPZSandlerExtended::ResLF2(), TPZSandlerExtended::ResLF2IJ(), TPZYCCamClayPV::ResLFunc(), TPZYCMohrCoulombPV::ReturnMapApex(), TPZYCMohrCoulombPV::ReturnMapLeftEdge(), TPZMohrCoulombNeto::ReturnMapLeftEdge(), TPZMohrCoulombPV::ReturnMapLeftEdge(), TPZYCMohrCoulombPV::ReturnMapPlane(), TPZMohrCoulombPV::ReturnMapPlane(), TPZMohrCoulombNeto::ReturnMapPlane(), TPZYCMohrCoulombPV::ReturnMapRightEdge(), TPZMohrCoulombNeto::ReturnMapRightEdge(), TPZMohrCoulombPV::ReturnMapRightEdge(), hdivCurvedJCompAppMath::RotateGeomesh(), hdivCurvedJCompAppMath::RotateNode(), RotationMatrix(), TPZYCDruckerPrager::SetUp(), SolExata(), Hdiv2dPaper201504::SolExata(), hdivCurvedJCompAppMath::SolExata(), Hdiv3dPaper201504::SolExata(), Hdiv2dPaper201504::SolExataH1(), Hdiv3dPaper201504::SolExataH1(), TPZElasticityAxiMaterial::Solution(), TPZElasticityMaterial::Solution(), TPZMixedElasticityMaterial::Solution(), TPZMatrix< STATE >::SolveEigenvaluesJacobi(), TPZYCCamClayPV::SurfaceInCyl(), TPZPolynomial::Tartaglia(), TPZYCSandlerDimaggio::UpdateSigtrialIJL(), pzgeom::TPZTriangleTorus::X(), pzgeom::TPZCylinderMap< TGeo >::X(), pzgeom::TPZEllipse3D::X(), pzgeom::TPZQuadTorus::X(), pzgeom::TPZArc3D::X(), TPZBlendNACA::xla(), TPZBlendNACA::xua(), TPZBlendNACA::yl(), TPZBlendNACA::yla(), TPZBlendNACA::yu(), and TPZBlendNACA::yua().

◆ exp()

TPZFlopCounter exp ( const TPZFlopCounter orig)
inline

Returns the exponencial and increments the counter of the Exponencial.

Definition at line 553 of file pzreal.h.

References EExp, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZFlopCounter::operator!=().

◆ fabs() [1/4]

float fabs ( std::complex< float >  __x)
inline

This is the type of floating point number PZ will use.

This is the type of State PZ will use.

Definition at line 233 of file pzreal.h.

References abs().

Referenced by TPZCounter::clear(), IsZero(), and TPZFlopCounter::operator!=().

◆ fabs() [2/4]

double fabs ( std::complex< double >  __x)
inline

Definition at line 239 of file pzreal.h.

References abs().

◆ fabs() [3/4]

long double fabs ( std::complex< long double >  __x)
inline

Definition at line 245 of file pzreal.h.

References abs().

◆ fabs() [4/4]

REAL fabs ( const TPZFlopCounter orig)
inline

Returns the absolute value as REAL and doesn't increments the counters.

Definition at line 481 of file pzreal.h.

References abs(), and TPZFlopCounter::fVal.

◆ fabsFlop()

TPZFlopCounter fabsFlop ( const TPZFlopCounter orig)
inline

Returns the absolute value and doesn't increments the counters.

Definition at line 474 of file pzreal.h.

References abs(), and TPZFlopCounter::fVal.

Referenced by TPZFlopCounter::operator!=().

◆ IsZero() [1/8]

bool IsZero ( long double  a)
inline

Returns if the value a is close Zero as the allowable tolerance.

Definition at line 668 of file pzreal.h.

References fabs().

Referenced by TPZProjectEllipse::AdjustingWithEllipse(), TPZSBMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::AutoFill(), TPZSkylNSymMatrix< TVar >::AutoFill(), pzshape::TPZShapeDisc::ChebyshevWithoutScale(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter2(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter3(), TPZSBFemVolume::ComputeSolution(), TPZPorousElasticResponse::ComputeStrain(), TPZTracerFlow::ContributeBCInterface(), TPZMatPoisson3d::ContributeInterface(), TPZFMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky_blk(), TPZSSpMatrix< TVar >::Decompose_LDLt(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZSFMatrix< TVar >::Decompose_LDLt(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSkylMatrix< TVar >::Decompose_LDLt(), TPZMatrix< STATE >::Decompose_LDLt(), TPZDiffMatrix< T >::Decompose_LU(), TPZFMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::Decompose_LU(), TPZSkylParMatrix< TVar >::DecomposeColumnCholesky(), TPZEulerEquation::FromConservativeToPrimitive(), TPZSandlerExtended::InitialDamage(), pzshape::TPZShapeDisc::IntegratedLegendre(), TPZExtractVal::IsZero(), pzgeom::TPZGeoTriangle::Jacobian(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZGeoEl::Jacobian(), TPZGeoEl::JacobianXYZ(), pzshape::TPZShapeDisc::Legendre(), pzshape::TPZShapeDisc::LegendreWithoutScale(), TPZGenGrid::MergeGeoMesh(), Hdiv3dPaper201504::MyDoubleComparer(), TPZGeoElSide::Normal(), TPZSpMatrix< TVar >::operator*=(), TPZSkylMatrix< TVar >::operator*=(), pzshape::TPZShapeDisc::Polynomial(), pzshape::TPZShapeDisc::PolynomialWithoutScale(), TPZMatrix< STATE >::Print(), TPZYCMohrCoulombPV::ProjectSigma(), TPZSandlerExtended::ProjectSigma(), TPZYCDruckerPragerPV::ProjectToSurfaceF1(), TPZSkylNSymMatrix< TVar >::PutVal(), TPZFBMatrix< TVar >::PutVal(), TPZSpMatrix< TVar >::PutVal(), TPZSkylMatrix< TVar >::PutVal(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZYCMohrCoulombPV::ReturnMapApex(), TPZYCMohrCoulombPV::ReturnMapLeftEdge(), TPZYCMohrCoulombPV::ReturnMapPlane(), TPZYCMohrCoulombPV::ReturnMapRightEdge(), TPZFMatrix< STATE >::SetSize(), pzshape::TPZShapePiramHdiv::Shape(), TPZSBFemVolume::Shape(), TPZEulerEquation::Solution(), TPZProjectEllipse::StandardFormatForSimpleEllipse(), TPZDiffMatrix< T >::Substitution(), TPZFMatrix< STATE >::Substitution(), TPZMatrix< STATE >::Substitution(), TPZPlasticStepPV< YC_t, ER_t >::TangentOperator(), TPZGaussRule::TPZGaussRule(), TPZVerySparseMatrix< TVar >::TPZVerySparseMatrix(), TPZPlasticStepPV< YC_t, ER_t >::TrialStressCorrection(), pztopology::TPZPyramid::TShape(), UniformRefinement(), TPZAxesTools< TVar >::VerifyAxes(), TPZSandlerExtended::YieldFunction(), and ZeroTolerance().

◆ IsZero() [2/8]

bool IsZero ( double  a)
inline

Definition at line 676 of file pzreal.h.

References fabs().

◆ IsZero() [3/8]

bool IsZero ( float  a)
inline

Definition at line 684 of file pzreal.h.

References fabs().

◆ IsZero() [4/8]

bool IsZero ( std::complex< long double >  a)
inline

Definition at line 692 of file pzreal.h.

References fabs().

◆ IsZero() [5/8]

bool IsZero ( std::complex< double >  a)
inline

Definition at line 700 of file pzreal.h.

References fabs().

◆ IsZero() [6/8]

bool IsZero ( std::complex< float >  a)
inline

Definition at line 708 of file pzreal.h.

References fabs().

◆ IsZero() [7/8]

bool IsZero ( int  a)
inline

Definition at line 716 of file pzreal.h.

◆ IsZero() [8/8]

bool IsZero ( int64_t  a)
inline

Definition at line 719 of file pzreal.h.

◆ log()

TPZFlopCounter log ( const TPZFlopCounter orig)
inline

Returns the natural logarithm and increment the counter of the logarithm.

Definition at line 562 of file pzreal.h.

References ELog, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZFlopCounter::operator!=().

◆ log10()

TPZFlopCounter log10 ( const TPZFlopCounter orig)
inline

Returns the decimal logarithm and increment the counter of the logarithm.

Definition at line 571 of file pzreal.h.

References ELog, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZFlopCounter::operator!=().

◆ Max()

template<class T >
const T& Max ( const T &  a,
const T &  b 
)
inline

Returns the maximum value between a and b.

Definition at line 724 of file pzreal.h.

Referenced by TPZGeoEl::CharacteristicSize(), TPZCompElDisc::CreateIntegrationRule(), pzgeom::TPZGeoTriangle::Jacobian(), and TPZCompMesh::SaddlePermute().

◆ MElementType_Name()

std::string MElementType_Name ( MElementType  elType)
inline

◆ MElementType_NNodes()

int MElementType_NNodes ( MElementType  elType)
inline

constant which defines the type of HDiv approximation space

Returns the number of nodes according to the type of the element

Definition at line 80 of file pzeltype.h.

References DebugStop.

Referenced by pzgeom::TPZGeoBlend< TGeo >::GradX(), TPZVTKGeoMesh::PrintCMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZVTKGeoMesh::PrintGMeshVTKmy_material(), TPZVTKGeoMesh::PrintGMeshVTKneighbour_material(), TPZRefPattern::ReadAndCreateRefinementPattern(), and pzgeom::TPZGeoBlend< TGeo >::X().

◆ Min()

template<class T >
const T& Min ( const T &  a,
const T &  b 
)
inline

Returns the minimum value between a and b.

Definition at line 729 of file pzreal.h.

References erf().

Referenced by TPZGeoEl::CharacteristicSize(), TPZSFMatrix< TVar >::operator=(), TPZSFMatrix< TVar >::Resize(), TPZCompMesh::SaddlePermute(), and TPZGeoEl::SmallerEdge().

◆ operator*()

TPZFlopCounter operator* ( double  val1,
const TPZFlopCounter val2 
)
inline

Performs $ val1 * val2$. Doesn't increments counters.

Definition at line 579 of file pzreal.h.

Referenced by TPZGenAMatrix< TObj >::TPZGenAMatrix().

◆ operator+() [1/2]

TPZFlopCounter operator+ ( double  val1,
const TPZFlopCounter val2 
)
inline

Performs $ val1 + val2$. Doesn't increments counters.

Definition at line 595 of file pzreal.h.

Referenced by TPZGenAMatrix< TObj >::TPZGenAMatrix().

◆ operator+() [2/2]

TPZFlopCounter operator+ ( const TPZFlopCounter val2,
double  val1 
)
inline

Performs $ val1 + val2$. Doesn't increments counters.

Definition at line 603 of file pzreal.h.

◆ operator-()

TPZFlopCounter operator- ( double  val1,
const TPZFlopCounter val2 
)
inline

Performs $ val1 - val2$. Doesn't increments counters.

Definition at line 611 of file pzreal.h.

Referenced by TPZGenAMatrix< TObj >::TPZGenAMatrix().

◆ operator/()

TPZFlopCounter operator/ ( double  val1,
const TPZFlopCounter val2 
)
inline

Performs $ val1 / val2$. Doesn't increments counters.

Definition at line 587 of file pzreal.h.

◆ operator<<() [1/2]

std::ostream& operator<< ( std::ostream &  out,
const TPZCounter count 
)

Re-implements << operator to show the counter (count) data.

Definition at line 40 of file pzreal.cpp.

References TPZCounter::fCount, gNumOp, and names.

Referenced by TPZCounter::clear().

◆ operator<<() [2/2]

std::ostream& operator<< ( std::ostream &  out,
const TPZFlopCounter val 
)
inline

Implements to write (output) only the floating point value.

Definition at line 620 of file pzreal.h.

References TPZFlopCounter::fVal.

◆ operator>>()

std::istream& operator>> ( std::istream &  out,
TPZFlopCounter val 
)
inline

Implements to read (input) only the floating point value.

Definition at line 625 of file pzreal.h.

References TPZFlopCounter::fVal.

◆ pow()

TPZFlopCounter pow ( const TPZFlopCounter orig,
const TPZFlopCounter xp 
)
inline

Returns the power and increments the counter of the power.

Definition at line 487 of file pzreal.h.

References EPow, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by stats.StatsError::__str__(), TPZSpaceTimeRichardsEq::C_Coef(), TPZLadeKimThermoForceA::CheckConv(), TPZYCLadeKim::CheckConv(), TPZLadeKimThermoForceA::Compute(), TPZSandlerExtended::ComputeCapCoVertexTangent(), TPZSandlerExtended::ComputeCapTangent(), TPZTensor< STATE >::ComputeEigenvectors(), TPZSandlerExtended::ComputeFailureTangent(), TPZEulerConsLaw::ComputeGhostState(), TPZTensor< T >::TPZDecomposed::ComputeJ2(), TPZSandlerExtended::ComputeJ2(), TPZSBFemVolume::ComputeSolution(), TPZLadeKimThermoForceA::ComputeTangent(), TPZGradientReconstruction::TPZGradientData::ComputeWeights(), TPZGaussRule::ComputingGaussJacobiQuadrature(), TPZBiharmonic::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZBiharmonic::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), CreateCompMesh(), TPZYCCamClayPV::D2DistanceToSurface(), TPZYCDruckerPragerPV::D2DistanceToSurfaceF1(), TPZSandlerExtended::D2DistFunc1(), TCedricTest::d2fx(), TPZCompElPostProc< TCOMPEL >::dataequal(), TPZYCDruckerPragerPV::DDistanceToSurfaceF1(), TPZEulerConsLaw::DeltaX(), TPZYCDruckerPragerPV::DF1Cart(), TPZTensor< STATE >::DirectEigenValues(), TPZSpaceTimeRichardsEq::DKDsol(), TPZYCDruckerPragerPV::DResLF1(), TFadBinaryPow< L, R >::dx(), FadBinaryPow< L, R >::dx(), TFadBinaryPow< L, TFadCst< typename L::value_type > >::dx(), FadBinaryPow< L, FadCst< R > >::dx(), TFadBinaryPow< TFadCst< typename R::value_type >, R >::dx(), FadBinaryPow< FadCst< L >, R >::dx(), TFadBinaryPow< L, int >::dx(), FadBinaryPow< L, int >::dx(), TPZMat2dLin::Errors(), TPZMaterialTest3D::Errors(), TPZMatOrthotropic::Errors(), TPZMatHyperElastic::Errors(), TPZConsLawTest::Errors(), TPZElasticityAxiMaterial::Errors(), TPZMixedElasticityMaterial::Errors(), TPZSwelling::ExactSolution(), TPZLadeNelsonElasticResponse::ExtractTangent(), TPZPlasticStep< YC_t, TF_t, ER_t >::ExtractTangent(), TFadBinaryPow< L, R >::fastAccessDx(), FadBinaryPow< L, R >::fastAccessDx(), TFadBinaryPow< L, TFadCst< typename L::value_type > >::fastAccessDx(), FadBinaryPow< L, FadCst< R > >::fastAccessDx(), TFadBinaryPow< TFadCst< typename R::value_type >, R >::fastAccessDx(), FadBinaryPow< FadCst< L >, R >::fastAccessDx(), TFadBinaryPow< L, int >::fastAccessDx(), FadBinaryPow< L, int >::fastAccessDx(), TPZMathTools::Function(), TPZPorousElasticResponse::G(), TPZYCCamClayPV::GradSigmaTrial(), TPZAnalysisError::h_Parameter(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZAnalysisError::HPAdapt(), TPZSandlerExtended::InitialDamage(), pzgeom::TPZEllipse3D::InsertExampleElement(), pzshape::TPZShapeDisc::IntegratedLegendre(), TPZMatPoisson3d::InterfaceErrors(), TPZSandlerExtended::JacobianCoVertex(), TPZSandlerExtended::Jacobianf1(), TPZSandlerExtended::Jacobianf2(), TPZSandlerExtended::Jacobianf2CoVertex(), TPZPorousElasticResponse::K(), TPZSpaceTimeRichardsEq::K_Coef(), pzshape::TPZShapeDisc::Legendre(), MalhaGeom(), TPZElastoPlasticAnalysis::ManageIterativeProcess(), TPZElasticity3D::MohrCoulombPlasticFunction(), TPZSandlerExtended::NormalFunctionToF1(), TPZCompElDisc::NormalizeConst(), TPZSandlerExtended::NormalToF1(), TPZFlopCounter::operator!=(), TPZNormalRandom< TVar >::pdf(), TPZYCCamClayPV::Phi(), TPZPlasticStep< YC_t, TF_t, ER_t >::PlasticIntegrate(), TPZPorousElasticResponse::Poisson(), TPZPorousElasticResponse::Poisson_linearized(), Hdiv3dPaper201504::PrintErrors(), TPZPlasticStep< YC_t, TF_t, ER_t >::ProcessLoad(), TPZPlasticStep< YC_t, TF_t, ER_t >::ProcessStrainNoSubIncrement(), TPZBiharmonicEstimator::Psi(), TPZSandlerExtended::Res1(), TPZSandlerExtended::Res2(), TPZSandlerExtended::Res2CoVertex(), Hdiv3dPaper201504::Run(), TPZSpaceTimeRichardsEq::Se(), TPZLadeKimThermoForceA::SetUp(), TPZLadeKim::SetUp(), TPZYCLadeKim::SetYieldStatusMode(), TPZSBFemVolume::Shape(), TPZElasticityAxiMaterial::Solution(), TPZElasticityMaterial::Solution(), TPZMixedElasticityMaterial::Solution(), TPZLadeNelsonElasticResponse::SolveSigma(), TPZPolynomial::Tartaglia(), TPZPlasticStep< YC_t, TF_t, ER_t >::UpdatePlasticVars(), TFadBinaryPow< L, R >::val(), FadBinaryPow< L, R >::val(), TFadBinaryPow< L, TFadCst< typename L::value_type > >::val(), FadBinaryPow< L, FadCst< R > >::val(), TFadBinaryPow< TFadCst< typename R::value_type >, R >::val(), FadBinaryPow< FadCst< L >, R >::val(), TFadBinaryPow< L, int >::val(), FadBinaryPow< L, int >::val(), stats::variance(), test::variance(), ZeroTolerance(), and TPZAnalysisError::ZoomInSingularity().

◆ sin()

TPZFlopCounter sin ( const TPZFlopCounter orig)
inline

Returns the sine in radians and increments the counter of the sine.

Definition at line 523 of file pzreal.h.

References ESin, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZCounter::clear(), and TPZFlopCounter::operator!=().

◆ sqrt()

TPZFlopCounter sqrt ( const TPZFlopCounter orig)
inline

Returns the square root of the value and increments the counter of the square root.

Definition at line 465 of file pzreal.h.

References ESqrt, TPZCounter::fCount, TPZFlopCounter::fVal, and TPZFlopCounter::gCount.

Referenced by TPZCounter::clear(), and TPZFlopCounter::operator!=().

◆ ZeroTolerance() [1/2]

REAL ZeroTolerance ( )
inline

◆ ZeroTolerance() [2/2]

template<typename T , typename std::enable_if< is_arithmetic_pz< T >::value, int >::type * = nullptr>
void ZeroTolerance ( T &  tol)
inline

Definition at line 640 of file pzreal.h.

References abs(), IsZero(), pow(), pzgeom::tol, TFad< Num, T >::val(), and ZeroTolerance().

Variable Documentation

◆ gNumOp

const int gNumOp

Number of type of the operations actually counted.

Definition at line 108 of file pzreal.h.

Referenced by TPZCounter::clear(), TPZCounter::copy(), TPZCounter::operator+=(), TPZCounter::operator-(), TPZCounter::operator-=(), operator<<(), TPZCounter::Print(), and RunStat::~RunStat().

◆ gPrintLevel

int gPrintLevel

Extern variable to control level of printting (priority print?)