NeoPZ
|
This class implements a simple vector storage scheme for a templated class T. Utility. More...
#include <pzgeopoint.h>
Public Member Functions | |
TPZVec () | |
Creates a vector with size 0. More... | |
TPZVec (const int64_t size) | |
Creates a vector of a given size. More... | |
TPZVec (const int64_t size, const T ©) | |
Creates a vector of a given size. More... | |
TPZVec (const TPZVec< T > ©) | |
Creates a vector with copy constructor. will call the empty constructor on all objects of type T created. More... | |
TPZVec (const std::initializer_list< T > &list) | |
Creates a vector from a initializer list. More... | |
virtual | ~TPZVec () |
destructor, will delete the storage allocated More... | |
void | MigratePages () |
void | ReallocForNuma () |
TPZVec< T > & | operator= (const TPZVec< T > ©) |
will copy the vector into the current vector. More... | |
TPZVec< T > & | operator= (const std::initializer_list< T > &list) |
create a new vector and stores in the current vector More... | |
TPZVec< T > & | operator= (const T &a) |
Operator attribution. Fills the vector with a value of type T. More... | |
T & | operator[] (const int64_t index) const |
Access operator, will perform bounds checking unless the variable NODEBUG is defined. More... | |
T * | begin () const |
Casting operator. Returns The fStore pointer. More... | |
T * | end () const |
Returns a pointer to the last+1 element. More... | |
void | Fill (const T ©, const int64_t from=0, const int64_t numelem=-1) |
Will fill the elements of the vector with a copy object. More... | |
int64_t | NElements () const |
Returns the number of elements of the vector. More... | |
int64_t | size () const |
Returns the number of elements of the vector. More... | |
virtual void | Resize (const int64_t newsize, const T &object) |
Resizes the vector object reallocating the necessary storage, copying the existing objects to the new storage. More... | |
virtual void | Resize (const int64_t newsize) |
Resizes the vector object reallocating the necessary storage, copying the existing objects to the new storage. The new members are not initialized. More... | |
virtual void | resize (const int64_t newsize) |
void | Print (std::ostream &out=std::cout) |
Prints the structural information of the vector object to the output stream. This method will not print the objects themselves! More... | |
virtual void | clear () |
Empty the vector, make its size zero. More... | |
Protected Attributes | |
T * | fStore |
Allocated storage for the vector object. More... | |
int64_t | fNElements |
Number of elements of the vector object. More... | |
Friends | |
template<class T2 > | |
std::ostream & | operator<< (std::ostream &Out, const TPZVec< T2 > &v) |
Extraction operator. More... | |
This class implements a simple vector storage scheme for a templated class T. Utility.
The copy constructor and operator= requires the operator= to be implemented on the class T.
Definition at line 19 of file pzgeopoint.h.
destructor, will delete the storage allocated
Definition at line 325 of file pzvec.h.
Referenced by operator<<().
T * TPZVec< T >::begin | ( | ) | const |
Casting operator. Returns The fStore pointer.
Returns a pointer to the first element
Definition at line 450 of file pzvec.h.
Referenced by TPZFYsmpMatrix< TVar >::AddKelOld(), TPZDohrStructMatrix::ClusterIslands(), TPZRenumbering::ColorElements(), TPZHybridizeHDiv::ComputeNState(), TPZSBMatrix< TVar >::Copy(), TPZVec< std::pair< int, int > >::operator[](), TPZIntelGen< TSHAPE >::Read(), TPZCompElHDivPressure< TSHAPE >::Read(), TPZCompElHDiv< TSHAPE >::Read(), ResequenceByGeometry(), TPZSBMatrix< TVar >::SetBand(), Sort(), TPZBlockDiagonal< STATE >::Substitution(), TPZMaterialData::Write(), TPZIntelGen< TSHAPE >::Write(), TPZCompElHDivPressure< TSHAPE >::Write(), TPZCompElHDiv< TSHAPE >::Write(), and TPZFileEqnStorage< TVar >::WriteHeaders().
|
virtual |
Empty the vector, make its size zero.
Definition at line 444 of file pzvec.h.
Referenced by TPZNodesetCompute::AnalyseNode(), Hdiv3dPaper201504::CreateOneCuboWithTetraedrons(), TPZSloanRenumbering::SList::Reset(), and TPZVec< std::pair< int, int > >::resize().
T * TPZVec< T >::end | ( | ) | const |
Returns a pointer to the last+1 element.
Definition at line 455 of file pzvec.h.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZFYsmpMatrix< TVar >::AutoFill(), TPZMHMixedMeshControl::BuildMultiPhysicsMesh(), TPZDohrStructMatrix::ClusterIslands(), TPZRenumbering::ColorElements(), TPZGmshReader::GeometricGmshMesh3(), TPZGmshReader::GeometricGmshMesh4(), TPZVec< std::pair< int, int > >::operator=(), TPZVec< std::pair< int, int > >::operator[](), and ResequenceByGeometry().
void TPZVec< T >::Fill | ( | const T & | copy, |
const int64_t | from = 0 , |
||
const int64_t | numelem = -1 |
||
) |
Will fill the elements of the vector with a copy object.
copy | object which will be copied |
from | first index which will be overwritten |
numelem | number of elements which will be overwritten |
Definition at line 460 of file pzvec.h.
Referenced by TPZInterpolatedElement::AdjustPreferredSideOrder(), TPZNodesetCompute::AnalyseGraph(), TPZElementMatrix::ApplyConstraints(), TPZCompMesh::AssembleError(), TPZHybridizeHDiv::AssociateElements(), TPZSkylMatrix< TVar >::AutoFill(), TPZMatLaplacian::BCInterfaceJump(), TPZMatPoisson3d::BCInterfaceJump(), TPZElementMatrix::BuildDependencyOrder(), TPZConnect::BuildDependencyOrder(), TPZCompElDisc::BuildTransferMatrix(), TPZAgglomerateElement::CalcStiff(), TPZRenumbering::ColorElements(), TPZNodesetCompute::ColorGraph(), TPZRenumbering::ColorNodes(), TPZMulticamadaOrthotropic::ComputeCenterForces(), TPZInterpolationSpace::ComputeError(), TPZGradientFlux::ComputeFlux(), TPZGenSubStruct::ComputeInternalEquationPermutation(), TPZDohrStructMatrix::ComputeInternalEquationPermutation(), TPZCompMesh::ComputeNodElCon(), TPZInterfaceElement::ComputeNormal(), pzgeom::TPZArc3D::ComputeR2Points(), TPZReducedSpace::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZL2Projection::Contribute(), TPZVecL2::Contribute(), TPZCompMesh::ConvertDiscontinuous2Continuous(), TPZRenumbering::ConvertGraph(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZSpBlockDiagPivot< TVar >::Decompose_LU(), TPZArtDiff::Divergent(), TPZVTKGraphMesh::DrawSolution(), TPZMVGraphMesh::DrawSolution(), TPZV3DGraphMesh::DrawSolution(), TPZDXGraphMesh::DrawSolution(), TPZStructMatrixGC::ElementColoring(), TPZStructMatrixOT::ElementColoring(), TPZMGAnalysis::ElementError(), Hdiv2dPaper201504::ErrorH1(), hdivCurvedJCompAppMath::ErrorH1(), Hdiv3dPaper201504::ErrorH1(), Hdiv2dPaper201504::ErrorPrimalDual(), hdivCurvedJCompAppMath::ErrorPrimalDual(), Hdiv3dPaper201504::ErrorPrimalDual(), TPZMatDualHybridPoisson::Errors(), TPZMat1dLin::Errors(), TPZCoupledTransportDarcyBC::Errors(), TPZPrimalPoisson::Errors(), TPZL2Projection::Errors(), TPZDualPoisson::Errors(), TPZMixedPoisson::Errors(), TPZMatLaplacian::Errors(), TPZMatPoisson3d::Errors(), TPZMatMixedPoisson3D::Errors(), TPZBndCond::Errors(), TPZVecL2::ErrorsHdiv(), TPZMatPoisson3d::ErrorsHdiv(), TPZMatMixedPoisson3D::ErrorsHdiv(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZAnalysisError::EvaluateError(), TPZInterpolationSpace::EvaluateError(), TPZElementGroup::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZInterfaceElement::EvaluateError(), TPZCompMesh::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZTransfer< TVar >::ExpandColumnVectorEntries(), TPZGeoMesh::FindApproxElement(), TPZCoupledTransportDarcyBC::Flux(), TPZBndCond::Flux(), TPZRefPattern::GenerateSideRefPatterns(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZInterfaceElement::GetConnects(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZYCSandlerDimaggioL::InitialGuess(), TPZYCSandlerDimaggio::InitialGuess(), TPZPlasticStep< YC_t, TF_t, ER_t >::InitialGuess(), TPZSkylNSymMatrix< TVar >::InitializeElem(), TPZSkylMatrix< TVar >::InitializeElem(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZInterfaceElement::Integrate(), TPZCompEl::Integrate(), TPZInterfaceElement::IntegrateInterface(), TPZInterpolationSpace::IntegrateSolution(), TPZPlasticStep< YC_t, TF_t, ER_t >::IntegrationOverview(), TPZGeoElMapped< TBase >::KsiBar(), TPZProjectEllipse::LeastSquaresToGetEllipse(), TPZProjectEllipse::LeastSquaresToGetSimpleEllipse(), TPZMGAnalysis::MeshError(), TPZStructMatrixOT::MultiThread_Assemble(), TPZRenumbering::NodeToElGraph(), TPZGeoElSide::Normal(), TPZArtDiff::ODotOperator(), TPZPermutation::operator++(), TPZVec< std::pair< int, int > >::operator[](), TPZFrontStructMatrix< front >::OrderElement(), TPZStructMatrixGCTP::OrderElement(), TPZStructMatrixGC::OrderElement(), TPZStructMatrixOT::OrderElement(), TPZAnalysis::PostProcess(), TPZAnalysis::PostProcessErrorParallel(), TPZAnalysis::PostProcessErrorSerial(), TPZCompEl::PrintCoordinate(), TPZCompEl::PrintSolution(), TPZMatrixMarket::Read(), TPZSkylMatrix< TVar >::Redim(), TPZGenSubStruct::ReorderInternalNodes(), TPZGenSubStruct::ReorderInternalNodes2(), TPZSloanRenumbering::SList::Reset(), TPZFront< STATE >::Reset(), TPZEquationFilter::SetActiveEquations(), TPZTransfer< TVar >::SetBlocks(), TPZEulerConsLaw::SetDelta(), TPZSkylNSymMatrix< TVar >::SetSkyline(), TPZSkylMatrix< TVar >::SetSkyline(), TPZCompElDisc::SetTrueUseQsiEta(), TPZSloanRenumbering::SList::SList(), TPZInterpolationSpace::Solution(), TPZMaterial::Solution(), TPZCompElDisc::SolutionX(), TPZGeoElMapped< TBase >::TKsiBar(), TPZBuildSBFem::TPZBuildSBFem(), TPZElasticity3D::TPZElasticity3D(), TPZSkylMatrix< TVar >::TPZSkylMatrix(), TPZSkylNSymMatrix< TVar >::TPZSkylNSymMatrix(), pzgeom::TPZGeoBlend< TGeo >::X(), TPZSYsmpMatrix< TVar >::Zero(), TPZBlockDiagonal< STATE >::Zero(), TPZFYsmpMatrix< TVar >::Zero(), TPZSkylNSymMatrix< TVar >::Zero(), and TPZSkylMatrix< TVar >::Zero().
|
inline |
Definition at line 74 of file pzvec.h.
Referenced by TPZSkylMatrix< TVar >::MigratePages().
|
inline |
Returns the number of elements of the vector.
Definition at line 190 of file pzvec.h.
Referenced by TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZAgglomerateElement::AccumulateVertices(), TPZDiffMatrix< T >::AddAlignDiv(), TPZTransfer< TVar >::AddBlockNumbers(), TPZBuildMultiphysicsMesh::AddConnects(), TPZMultiphysicsCompMesh::AddConnects(), TPZDiffMatrix< T >::AddDiv(), TPZFMatrix< STATE >::AddFel(), TPZFrontSym< TVar >::AddKel(), TPZFrontNonSym< TVar >::AddKel(), TPZFYsmpMatrix< TVar >::AddKel(), TPZMatrix< STATE >::AddKel(), TPZSkylMatrix< TVar >::AddKel(), TPZFYsmpMatrix< TVar >::AddKelOld(), TPZMulticamadaOrthotropic::AddPlacaOrtho(), TPZSkylMatrix< TVar >::AddSameStruct(), TPZConnect::AddToList(), TPZCompMesh::AdjustBoundaryElements(), TPZInterpolatedElement::AdjustPreferredSideOrder(), TPZFrontStructMatrix< front >::AdjustSequenceNumbering(), TPZGeoElRefLess< TGeo >::AllHigherDimensionSides(), TPZSubCompMesh::AllocateNewConnect(), TPZAdmChunkVector< TPZGeoEl *>::AllocateNewElement(), TPZProjectEllipse::AlmostZeroToZero(), TPZNodesetCompute::AnalyseGraph(), TPZNodesetCompute::AnalyseNode(), Append(), TPZMGAnalysis::AppendMesh(), TPZNonLinMultGridAnalysis::AppendMesh(), TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZElementMatrix::ApplyConstraints(), TPZMultiphase::ApplyPN(), TPZMultiphase::ApplyQnD(), TPZMultiphase::ApplySin(), TPZMultiphase::ApplySout(), TPZPlasticStep< YC_t, TF_t, ER_t >::ApplyStrainComputeSigma_Internal(), TPZEulerConsLaw::ApproxRoe_Flux(), AreEqual(), TPZDohrAssembly< STATE >::Assemble(), TPZBlockDiagonalStructMatrix::AssembleBlockDiagonal(), TPZDohrAssembly< STATE >::AssembleCoarse(), AssembleColor(), TPZCompMesh::AssembleError(), AssembleMatrices(), TPZCompMesh::AutoBuildContDisc(), TPZBlockDiagonal< STATE >::AutoFill(), TPZCompMesh::BandWidth(), TPZMatPoisson3d::BCInterfaceJump(), TPZLine::Belongs(), TPZGeoElSide::BuildConnectivities(), TPZGeoMesh::BuildConnectivity(), TPZConnect::BuildConnectList(), TPZCompEl::BuildConnectList(), TPZElementMatrix::BuildDependencyOrder(), TPZConnect::BuildDependencyOrder(), TPZNodesetCompute::BuildElementGraph(), TPZSparseBlockDiagonal< TVar >::BuildFromMatrix(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZCreateApproximationSpace::BuildMesh(), TPZNodesetCompute::BuildNodeGraph(), TPZAnalysis::BuildPreconditioner(), TPZRefPattern::BuildSideMesh(), TPZInterpolationSpace::BuildTransferMatrix(), TPZInterpolatedElement::BuildTransferMatrix(), TPZNodesetCompute::BuildVertexGraph(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZAgglomerateElement::CalcStiff(), TPZSubCompMesh::CalcStiff(), CanAssemble(), TPZInterfaceElement::CenterNormal(), pzgeom::TPZChangeEl::ChangeToQuadratic(), pzgeom::TPZChangeEl::ChangeToQuarterPoint(), TPZInterfaceElement::CheckConsistencyOfMappedQsi(), TPZCheckMesh::CheckConstraintDimension(), CheckConvergence(), TPZInterpolatedElement::CheckElementConsistency(), TPZCheckGeom::CheckInternalTransforms(), TPZCheckGeom::CheckRefinement(), TPZGeoEl::CheckSubelDataStructure(), TPZDXGraphMesh::Close(), TPZDohrStructMatrix::ClusterIslands(), Hdiv2dPaper201504::CMeshMixed(), hdivCurvedJCompAppMath::CMeshMixed(), Hdiv3dPaper201504::CMeshMixed(), TPZCompMesh::Coarsen(), TPZNodesetCompute::ColorGraph(), TPZRenumbering::ColorNodes(), TPZRefPatternTools::CompareTopologies(), TPZFrontSym< TVar >::Compress(), TPZFrontNonSym< TVar >::Compress(), TPZYCVonMisesCombTresca::Compute(), TPZMulticamadaOrthotropic::ComputeCenterForces(), TPZElementMatrix::ComputeDestinationIndices(), TPZMixedElasticityMaterial::ComputeDivergenceOnDeformed(), TPZCompMesh::ComputeElGraph(), TPZMGAnalysis::ComputeError(), TPZCompMesh::ComputeFillIn(), TPZMaterialData::ComputeFunctionDivergence(), TPZGenSubStruct::ComputeInternalEquationPermutation(), TPZDohrStructMatrix::ComputeInternalEquationPermutation(), TPZGeoElSide::ComputeNeighbours(), TPZCompMesh::ComputeNodElCon(), TPZCompElHDivPressureBound< TSHAPE >::ComputeShapeIndex(), TPZCompElHDivBound2< TSHAPE >::ComputeShapeIndex(), TPZCompElHDiv< TSHAPE >::ComputeShapeIndex(), TPZInterpolatedElement::ComputeSideOrder(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZGeoEl::ComputeXInverse(), ConjugateSide(), TPZMultCamada::Contribute(), TPZL2Projection::Contribute(), TPZMultiphase::Contribute(), TPZMixedPoissonParabolic::Contribute(), TPZMixedDarcyFlow::Contribute(), TPZDualPoisson::Contribute(), TPZVecL2::Contribute(), TPZMixedPoisson::Contribute(), TPZMatMixedPoisson3D::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZBndCond::Contribute(), TPZDohrSubstructCondense< TTVar >::Contribute_Kc(), TPZDohrSubstructCondense< TTVar >::Contribute_v2_local(), TPZMultCamada::ContributeBC(), TPZSwelling::ContributeBC(), TPZMultiphase::ContributeBCInterface(), TPZArtDiff::ContributeBornhaus(), TPZArtDiff::ContributeExplDiff(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZMaterialCoupling::ContributeInterface(), TPZMultiphase::ContributeInterface(), TPZMaterialCoupling::ContributeInterface2(), TPZBndCond::ContributeInterfaceErrors(), TPZMatMixedPoisson3D::ContributeWithoutSecondIntegration(), TPZCompMesh::ConvertDiscontinuous2Continuous(), TPZRenumbering::ConvertGraph(), TPZRenumbering::ConvertToElementoToElementGraph(), TPZSkylNSymMatrix< TVar >::Copy(), TPZSkylMatrix< TVar >::Copy(), TPZCompElWithMem< TBASE >::CopyIntPtIndicesFrom(), TPZRenumbering::CornerEqs(), TPBSpStructMatrix::Create(), TPZSpStructMatrix::Create(), TPZDohrStructMatrix::Create(), TPZAgglomerateElement::CreateAgglomerateMesh(), TPZGeoElRefLess< TGeo >::CreateBCGeoEl(), TPZBuildSBFem::CreateElementGroups(), TPZGradientReconstruction::TPZGradientData::CreateGhostsNeighbors(), TPZMultiphysicsElement::CreateInterface(), TPZInterpolationSpace::CreateInterface(), TPZMultiphysicsElement::CreateInterfaces(), TPZInterpolationSpace::CreateInterfaces(), TPZCompElDisc::CreateMidSideConnect(), TPZInterpolatedElement::CreateMidSideConnect(), TPZRefPattern::CreateMidSideNodes(), Hdiv3dPaper201504::CreateOneCuboWithTetraedrons(), TPZBuildSBFem::CreateVolumetricElements(), TPZEulerConsLaw::cSpeed(), TPZCompElPostProc< TCOMPEL >::dataequal(), TPZSpBlockDiagPivot< TVar >::Decompose_LU(), TPZBlockDiagonal< STATE >::Decompose_LU(), TPZAnalysis::DefineElementTable(), TPZCheckMesh::DependencyReport(), TPZCheckRestraint::Diagnose(), pztopology::Pr< TFather >::Diagnostic(), TPZMultiphysicsCompEl< TGeometry >::Dimension(), TPZGeoEl::Distance(), TPZCompElDisc::Divide(), TPZInterpolatedElement::Divide(), TPZCompMeshReferred::DivideReferredEl(), TPZGradientFlux::Dot(), TPZIncNavierStokesKEps::Dot(), Dot(), TPZVTKGraphMesh::DrawSolution(), TPZMVGraphMesh::DrawSolution(), TPZV3DGraphMesh::DrawSolution(), TPZDXGraphMesh::DrawSolution(), TPZGraphEl::DrawSolution(), TPZCompElHDiv< TSHAPE >::EffectiveSideOrder(), TPZTensor< STATE >::EigenProjection(), TPZArtDiff::EigenSystemBornhaus(), TPZArtDiff::EigenSystemSUPG(), TPZSBFemElementGroup::EigenvaluesReal(), TPZSBFemVolume::EigenvaluesReal(), TPZParFrontStructMatrix< front >::ElementAssemble(), TPZStructMatrixGC::ElementColoring(), TPZStructMatrixOT::ElementColoring(), TPZMGAnalysis::ElementError(), TPZEqnArray< TVar >::EqnForward(), TPZGeoElSide::EqualorHigherCompElementList2(), TPZGeoElSide::EqualorHigherCompElementList3(), TPZFrontMatrix< TVar, store, front >::EquationsToDecompose(), TPZMat1dLin::Errors(), TPZAnalysisError::EvaluateError(), TPZInterpolationSpace::EvaluateError(), TPZCompMesh::EvaluateError(), TPZInterfaceElement::ExistInterfaces(), TPZAnalysisError::ExpandConnected(), TPZCompElSide::ExpandConnected(), TPZTransfer< TVar >::ExpandDoubleValueEntries(), TPZNodesetCompute::ExpandGraph(), TPZConnect::ExpandShape(), TPZInterpolationSpace::ExpandShapeFunctions(), TPZDohrAssembly< STATE >::Extract(), TPZDohrAssembly< STATE >::ExtractCoarse(), TPZFrontSym< TVar >::ExtractFrontMatrix(), TPZFrontNonSym< TVar >::ExtractFrontMatrix(), Find(), TPZSparseBlockDiagonal< TVar >::FindBlockIndex(), TPZGeoMesh::FindElementCaju(), TPZChunkVector< TPZGraphNode, 10 >::FindObject(), TPZPoroElastoPlasticAnalysis::FindPorousMaterials(), TPZGeoMesh::FindSubElement(), TPZInterpolatedElement::ForceSideOrder(), TPZSparseBlockDiagonal< TVar >::Gather(), TPZRefPatternTools::GenerateGMeshFromElementVec(), TPZGenSubStruct::GenerateMesh(), TPZMulticamadaOrthotropic::GenerateMesh(), TPZCutHillMcKee::SGraph::GetAdjacentNodes(), TPZGeoMesh::GetBoundaryElements(), TPZSubCompMesh::GetFromSuperMesh(), TPZGeoEl::GetHigherSubElements(), TPZGeoMesh::GetNodePtr(), TPZCompMesh::GetNodeToElGraph(), TPZPrInteg< TFather >::GetOrder(), TPZPostProcMat::GetPostProcessVarIndexList(), TPZCompEl::GetRefElPatch(), TPZMultiphysicsCompEl< TGeometry >::GetReferenceIndexVec(), TPZIdentifyRefPattern::GetRefPattern(), TPZIntRuleList::GetRule(), TPZIntRuleList::GetRuleP3D(), TPZIntRuleList::GetRuleT(), TPZIntRuleList::GetRuleT3D(), pztopology::TPZPrism::GetSideHDivPermutation(), TPZFYsmpMatrix< TVar >::GetSub(), TPZMatrix< STATE >::GetSub(), TPZGeoElRefPattern< TGeo >::GetSubElements2(), TPZGeoEl::GetSubElements2(), TPZBlockDiagonal< STATE >::GetVal(), TPZParFrontStructMatrix< front >::GlobalAssemble(), pzgeom::TPZGeoBlend< TGeo >::GradX(), TPZYCVonMisesCombTresca::H(), TPZGeoElRefPattern< TGeo >::HasSubElement(), TPZGeoElSide::HigherDimensionElementList(), pztopology::Pr< TFather >::HigherDimensionSides(), TPZGeoElSide::HigherLevelCompElementList2(), TPZGeoElSide::HigherLevelCompElementList3(), TPZAnalysisError::hp_Adaptive_Mesh_Design(), TPZAnalysisError::HPAdapt(), TPZGenSubStruct::IdentifyCornerNodes(), TPZDohrStructMatrix::IdentifyCornerNodes(), TPZDohrStructMatrix::IdentifyExternalConnectIndexes(), TPZIdentifyRefPattern::IdentifySide(), TPZInterpolatedElement::IdentifySideOrder(), TPZCompElHDivBound2< TSHAPE >::IndexShapeToVec(), TPZCompElHDiv< TSHAPE >::IndexShapeToVec2(), TPZGeoNode::Initialize(), TPZBlockDiagonal< STATE >::Initialize(), pzgeom::TPZNodeRep< 15, pztopology::TPZPrism >::Initialize(), TPZGenSubStruct::InitializeDohrCondense(), TPZSkylNSymMatrix< TVar >::InitializeElem(), TPZSkylMatrix< TVar >::InitializeElem(), TPZInterfaceElement::InitializeElementMatrix(), TPZGradientReconstruction::TPZGradientData::InitializeGradData(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), InitializeMatrices(), TPZGeoEl::InitializeNeighbours(), TPZPlasticStep< YC_t, TF_t, ER_t >::InitializeValidEqs(), TPZGeoElSide::InsertConnectivity(), TPZDiscontinuousGalerkin::InterfaceJump(), TPZBndCond::InterfaceJump(), Intersect(), TPZPermutation::IsFirst(), pzgeom::TPZGeoBlend< TGeo >::IsLinearMapping(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZAgglomerateElement::LesserEdgeOfEl(), TPZCompEl::LoadSolution(), TPZCompElSide::LowerIdElementList(), TPZGeoElSide::LowerLevelCompElementList2(), TPZSubCompMesh::MakeExternal(), TPZSubCompMesh::MakeInternal(), malha_predio(), MalhaCubo(), Input::MalhaCubo(), MalhaPredio(), pzgeom::TPZGeoBlend< TGeo >::MapToNeighSide(), Max(), TPZGeoElRefPattern< TGeo >::MidSideNodeIndex(), TPZGeoElRefPattern< TGeo >::MidSideNodeIndices(), Min(), TPZInterpolationSpace::MinMaxSolutionValues(), MinPassIndex(), TPZArtDiff::MMatrix(), TPZRefPatternTools::ModifyElementsBasedOnRefpFound(), TPZSparseBlockDiagonal< TVar >::MultAdd(), TPZBlockDiagonal< STATE >::MultAdd(), TPZDiffMatrix< T >::Multiply(), TPZElementMatrix::NConnects(), TPZMultiphysicsCompEl< TGeometry >::NConnects(), TPZSubCompMesh::NConnects(), TPZFront< STATE >::NElements(), TPZFront< STATE >::NFree(), TPZAdmChunkVector< TPZGeoEl *>::NFreeElements(), TPZAgglomerateElement::NIndexes(), TPZNonLinMultGridAnalysis::NMeshes(), TPZCutHillMcKee::SGraph::NNodes(), TPZFront< STATE >::NonNullFrontSize(), TPZNumeric::Norm(), Norm(), Normalize(), TPZNumeric::NormalizeVetor(), TPZMulticamadaOrthotropic::NPlacas(), pzshape::TPZShapeQuad::NShapeF(), TPZGeoElSide::NSides(), TPZPostProcMat::NSolutionVariables(), TPZMultCamada::NStateVariables(), TPZPostProcMat::NStateVariables(), TPZFront< TVar >::STensorProductMTData::NThreads(), NullForce(), TPZBlockDiagonal< STATE >::NumberofBlocks(), TPZMultiphysicsCompEl< TGeometry >::NumberOfCompElementsInsideThisCompEl(), TPZSkylNSymMatrix< TVar >::NumElements(), TPZSkylMatrix< TVar >::NumElements(), TPZArtDiff::ODotOperator(), TPZBlockDiagonal< STATE >::operator()(), TPZPermutation::operator++(), operator<<(), TPZManVector< TPZPostProcVar, 20 >::operator=(), TPZVec< std::pair< int, int > >::operator=(), TPZChunkVector< TPZGraphNode, 10 >::operator=(), TPZVec< std::pair< int, int > >::operator[](), TPZAnalysis::OptimizeBandwidth(), TPZFrontStructMatrix< front >::OrderElement(), TPZStructMatrixGCTP::OrderElement(), TPZStructMatrixGC::OrderElement(), TPZStructMatrixOT::OrderElement(), TPZStack< int, 100 >::Peek(), TPZPermutation::Permute(), TPZCompMesh::Permute(), TPZPairStructMatrix::PermuteScatter(), TPZPairStructMatrix::ThreadData::PermuteScatter(), parallel_assemble_task_t< TVar >::PermuteScatter(), TPZDiffusionConsLaw::PointOperator(), TPZMGAnalysis::PopMesh(), TPZNonLinMultGridAnalysis::PopMesh(), TPZAnalysis::PostProcess(), TPZAnalysis::PostProcessErrorParallel(), TPZAnalysis::PostProcessErrorSerial(), TPZAnalysis::PostProcessTable(), TPZArtDiff::PrepareFastDiff(), TPZAnalysis::PrePostProcessTable(), TPZEulerConsLaw::Pressure(), TPZSparseBlockDiagonal< TVar >::Print(), TPZMetis::Print(), TPZMulticamadaOrthotropic::Print(), TPZNodesetCompute::Print(), TPZPostProcMat::Print(), TPZFrontMatrix< TVar, store, front >::Print(), TPZPlasticStep< YC_t, TF_t, ER_t >::Print(), TPZInterpolatedElement::Print(), TPZElementMatrix::Print(), TPZEqnArray< TVar >::Print(), TPZRenumbering::Print(), TPZBlockDiagonal< STATE >::Print(), TPZAgglomerateElement::Print(), TPZCompElDisc::Print(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZTimeTemp::PrintLine(), TPZCompEl::PrintSolution(), TPZMulticamadaOrthotropic::PrintTensors(), TPZCutHillMcKee::ProcessParentNode(), ProjectInParametricDomain(), TPZAgglomerateElement::ProjectSolution(), TPZCutHillMcKee::SGraph::PseudoPeripheralNodes(), TPZStack< int, 100 >::Push(), TPZBlockDiagonal< STATE >::PutVal(), TPZGraphElTd::QsiEta(), TPZGraphElT::QsiEta(), TPZGraphEl::QsiEta(), TPZGeoEl::QuadArea(), TPZStream::Read(), TPZVec< std::pair< int, int > >::ReallocForNuma(), TPZInterpolatedElement::RecomputeRestraints(), TPZCompElSide::RemoveConnectDuplicates(), TPZCompElSide::RemoveDuplicates(), RemoveEl(), TPZMultiphysicsElement::RemoveInterface(), TPZInterpolationSpace::RemoveInterface(), TPZMultiphysicsElement::RemoveInterfaces(), TPZInterpolationSpace::RemoveInterfaces(), TPZInterpolatedElement::RemoveSideRestraintsII(), TPZGenSubStruct::ReorderInternalNodes2(), TPZMetis::Resequence(), TPZSloan::Resequence(), TPZCutHillMcKee::Resequence(), TPZSloanRenumbering::Resequence(), TPZSloanRenumbering::Resequence2(), TPZSequenceSolver< TVar >::ResetMatrix(), TPZNonLinMultGridAnalysis::ResetReference(), TPZSequenceSolver< TVar >::ResetSolver(), TPZAdmChunkVector< TPZGeoEl *>::Resize(), TPZChunkVector< TPZGraphNode, 10 >::Resize(), TPZMatrix< STATE >::ReturnNearestValue(), TPZArtDiff::RMMatrix(), TPZEulerConsLaw::Roe_Flux(), TPZCutHillMcKee::SGraph::RootedLevelStructure(), TPZArtDiff::RotMatrix(), saxpy(), TPZSparseBlockDiagonal< TVar >::Scatter(), sdot(), TPZDohrStructMatrix::SeparateUnconnected(), TPZEquationFilter::SetActiveEquations(), TPZBlock< STATE >::SetAll(), TPZGenPartialGrid::SetBC(), TPZGenGrid::SetBC(), TPZPoroElastoPlasticAnalysis::SetContributionTime(), TPZGeoNode::SetCoord(), TPZGenGrid::SetData(), pzgeom::TPZQuadSphere< GeomQuad >::SetData(), TPZEulerConsLaw::SetDelta(), TPZPoroElastoPlasticAnalysis::SetDeltaT(), TPZConnect::SetDependenceOrder(), TPZCompMesh::SetElementSolution(), TPZGeoElMapped< TBase >::SetFatherIndex(), TPZCompElWithMem< TBASE >::SetFreeIntPtIndices(), TPZLine::SetLine(), TPZSubCompMesh::SetNumberRigidBodyModes(), TPZFrontMatrix< TVar, store, front >::SetNumElConnected(), TPZFront< STATE >::SetNumRigidBodyModes(), TPZInt1d::SetOrder(), TPZPrInteg< TFather >::SetOrder(), TPZElasticity3D::SetPostProcessingDirection(), TPZPostProcAnalysis::SetPostProcessVariables(), TPZPostProcMat::SetPostProcessVarIndexList(), TPZNonLinMultGridAnalysis::SetReference(), TPZGeoEl::SetSubElementConnectivities(), TPZSymetricSpStructMatrix::SetupMatrixData(), pzshape::SPr< TFather >::Shape(), pzshape::TPZShapePrism::ShapeGenerating(), pzshape::TPZShapeCube::ShapeGenerating(), TPZCutHillMcKee::SGraph::ShrinkLastLevel(), TPZRefPatternTools::SidesToRefine(), pztopology::Pr< TFather >::SideToSideTransform(), TPZCompMesh::Skyline(), TPZMultCamada::Solution(), TPZPostProcMat::Solution(), TPZMatLaplacian::Solution(), TPZMatPoisson3d::Solution(), TPZSequenceSolver< TVar >::Solve(), TPZMGAnalysis::Solve(), TPZDohrSubstructCondense< TTVar >::SolveSystemPhi(), Sort(), TPZNumeric::SortArray3(), TPZCutHillMcKee::SGraph::SortNodes(), sscal(), TPZPlasticTest::StrainTest(), TPZPlasticTest::StressTest(), TPZMetis::Subdivide(), TPZSpBlockDiagPivot< TVar >::Substitution(), TPZSparseBlockDiagonal< TVar >::Substitution(), TPZBlockDiagonal< STATE >::Substitution(), TPZFMatrix< STATE >::Substitution(), TPZSpBlockDiagPivot< TVar >::Substitution2(), TPZString::SubStr(), TPZDohrStructMatrix::SubStructure(), SubStructure(), TPZGenSubStruct::SubStructure(), TPZFront< STATE >::SymbolicAddKel(), TPZFrontSym< TVar >::SymbolicAddKel(), TPZFrontNonSym< TVar >::SymbolicAddKel(), TPZFrontSym< TVar >::TensorProductIJ(), TPZFrontNonSym< TVar >::TensorProductIJ(), TPZEulerConsLaw::Test_Flux(), TPZAnalysis::ThreadData::ThreadWork(), pzgeom::TPZArc3D::TPZArc3D(), TPZBlockDiagonal< STATE >::TPZBlockDiagonal(), TPZChunkVector< TPZGraphNode, 10 >::TPZChunkVector(), TPZConsLawTest::TPZConsLawTest(), TPZElasticity3D::TPZElasticity3D(), TPZGeoElRefPattern< TGeo >::TPZGeoElRefPattern(), TPZGeoNode::TPZGeoNode(), TPZManVector< TPZPostProcVar, 20 >::TPZManVector(), TPZMultPlaca::TPZMultPlaca(), pzgeom::TPZNodeRep< 15, pztopology::TPZPrism >::TPZNodeRep(), TPZPairStructMatrix::TPZPairStructMatrix(), TPZSequenceSolver< TVar >::TPZSequenceSolver(), TPZSparseBlockDiagonal< TVar >::TPZSparseBlockDiagonal(), TPZGeoEl::TransformSonToFather(), TPZBlockDiagonal< STATE >::Transpose(), TPZGeoEl::TriangleArea(), TPZMGAnalysis::UniformlyRefineMesh(), TPZNonLinMultGridAnalysis::UniformlyRefineMesh(), TPZGenSubStruct::UniformRefine(), TPZSparseBlockDiagonal< TVar >::UpdateFrom(), TPZSequenceSolver< TVar >::UpdateFrom(), TPZBlockDiagonal< STATE >::UpdateFrom(), TPZSkylNSymMatrix< TVar >::UpdateFrom(), TPZSkylMatrix< TVar >::UpdateFrom(), TPZInterpolatedElement::UpdateNeighbourSideOrder(), TPZEulerConsLaw::uRes(), TPZPostProcMat::VariableIndex(), pzgeom::TPZGeoQuad::VectorialProduct(), pzgeom::TPZGeoTriangle::VectorialProduct(), TPZCheckMesh::VerifyConnect(), TPZSubCompMesh::VerifyDatastructureConsistency(), TPZGeoEl::WhichSide(), WhoBlockedMe(), TPZSequenceSolver< TVar >::Write(), TPZStructMatrixTBBFlow::Write(), TPZEqnArray< TVar >::Write(), TPZStream::Write(), TPZParFrontMatrix< TVar, store, front >::WriteFile(), TPZStream::WritePointers(), pzgeom::TPZGeoBlend< TGeo >::X(), TPZAnalysisError::ZoomInSingularity(), TPZFront< TVar >::STensorProductMTData::~STensorProductMTData(), TPZChunkVector< TPZGraphNode, 10 >::~TPZChunkVector(), TPZIntRuleList::~TPZIntRuleList(), TPZMGAnalysis::~TPZMGAnalysis(), and TPZNonLinMultGridAnalysis::~TPZNonLinMultGridAnalysis().
will copy the vector into the current vector.
copy | vector which will be copied |
Definition at line 333 of file pzvec.h.
Referenced by TPZVec< std::pair< int, int > >::ReallocForNuma().
|
inline |
Access operator, will perform bounds checking unless the variable NODEBUG is defined.
index | element in the vector which will be acessed |
Definition at line 148 of file pzvec.h.
Referenced by TPZStack< int, 100 >::Peek(), TPZStack< int, 100 >::Push(), and TPZVec< std::pair< int, int > >::ReallocForNuma().
|
inline |
Prints the structural information of the vector object to the output stream.
This method will not print the objects themselves!
Definition at line 482 of file pzvec.h.
Referenced by TPZMatElastoPlastic< T, TMEM >::ComputeDeltaStrainVector(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZElasticityAxiMaterial::ContributeInterface(), TPZMHMixedMeshControl::CreateHDivPressureMHMMesh(), TPZTensor< STATE >::EigenSystemJacobi(), TPZMixedElasticityMaterial::Errors(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), NormalVector(), TPZMulticamadaOrthotropic::Print(), TPZTensor< T >::TPZDecomposed::Print(), TPZCompElHDiv< TSHAPE >::Print(), TPZMaterialData::Print(), TPZRefPattern::Print(), TPZMaterialData::PrintMathematica(), TPZSandlerExtended::ProjectSigmaDep(), TPZVec< std::pair< int, int > >::resize(), TPZMohrCoulombNeto::ReturnMapRightEdge(), TPZMohrCoulombPV::ReturnMapRightEdge(), and TPZGeoElMapped< TBase >::TGradX().
|
inline |
Definition at line 77 of file pzvec.h.
Referenced by TPZSkylMatrix< TVar >::ReallocForNuma().
|
virtual |
Resizes the vector object reallocating the necessary storage, copying the existing objects to the new storage.
newsize | size of the vector |
object | object used to initialize the new members |
Reimplemented in TPZManVector< T, NumExtAlloc >, TPZManVector< TPZGeoNode *>, TPZManVector< T, 3 >, TPZManVector< REAL, N >, TPZManVector< REAL >, TPZManVector< TPZVec< REAL > >, TPZManVector< STATE, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompEl *, NumExtAlloc >, TPZManVector< int64_t >, TPZManVector< REAL, 6+6+1+TPZYCLadeKim::NYield >, TPZManVector< std::pair< int64_t, int >, 4 >, TPZManVector< TPZMatrixSolver< TVar > *, DEFAULTVEC_ALLOC >, TPZManVector< REAL, 10 >, TPZManVector< int, N >, TPZManVector< TTVar >, TPZManVector< std::map< int, std::vector< int > >, 4 >, TPZManVector< TPZConnect *>, TPZManVector< TPZMatrixSolver< STATE > *, DEFAULTVEC_ALLOC >, TPZManVector< int64_t, 3 >, TPZManVector< TPZFMatrix< REAL >, DEFAULTVEC_ALLOC >, TPZManVector< int, NumExtAlloc >, TPZManVector< REAL, 6 >, TPZManVector< T, 6 >, TPZManVector< unsigned int, 3 >, TPZManVector< TPZCompMesh *, DEFAULTVEC_ALLOC >, TPZManVector< int >, TPZManVector< TPZBlock::TNode >, TPZManVector< STATE, 2 >, TPZManVector< TPZCompMesh *, 2 >, TPZManVector< int64_t, 20 >, TPZManVector< std::map< std::string, int >, 4 >, TPZManVector< char, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompMesh *, 3 >, TPZManVector< TPZPlacaOrthotropic, DEFAULTVEC_ALLOC >, TPZManVector< TPZElementMatrix *, DEFAULTVEC_ALLOC >, TPZManVector< TPZManVector< T, 3 >, 3 >, TPZManVector< int64_t, NumExtAlloc >, TPZManVector< STATE, 3 >, TPZManVector< int, 6 >, TPZManVector< TPZGeoEl **>, TPZManVector< TPZGraphNode *>, TPZManVector< T *>, TPZManVector< TVar >, TPZManVector< TPZManVector< REAL, 10 >, 100 >, TPZManVector< TPZCompEl **>, TPZManVector< REAL, DEFAULTVEC_ALLOC >, TPZManVector< std::pair< int, std::string >, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompElSide, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompElSide, 5 >, TPZManVector< TPZCompEl *, DEFAULTVEC_ALLOC >, TPZManVector< std::complex< double > >, TPZManVector< TPZEqnArray< TVar > *, DEFAULTVEC_ALLOC >, TPZManVector< int, 5 >, TPZManVector< TPZFMatrix< STATE > *, DEFAULTVEC_ALLOC >, TPZManVector< std::map< int, int >, 4 >, TPZManVector< REAL, 3 >, TPZManVector< int, 4 >, TPZManVector< TPZFemGradSol, 20 >, TPZManVector< int, DEFAULTVEC_ALLOC >, TPZManVector< STATE, 6 >, TPZManVector< MaterialDataV, DEFAULTVEC_ALLOC >, TPZManVector< TPZEqnArray< TVar >, DEFAULTVEC_ALLOC >, TPZManVector< int, 3 >, TPZManVector< T, N >, TPZManVector< long double >, TPZManVector< TPZPlasticIntegrMem< REAL, YC_t::NYield >, DEFAULTVEC_ALLOC >, TPZManVector< int64_t, DEFAULTVEC_ALLOC >, TPZManVector< int, TSHAPE::NFaces >, TPZManVector< TVar, NumExtAlloc >, TPZManVector< int, TFather::Top::NSides >, TPZManVector< TPZMatPlaca2 *, DEFAULTVEC_ALLOC >, TPZManVector< int64_t, 27 >, TPZManVector< TPZCompElLagrange::TLagrange, 3 >, TPZManVector< std::map< int, std::string >, 4 >, TPZManVector< TPZTensor< T >, 3 >, TPZManVector< int64_t, TSHAPE::NSides >, TPZManVector< TPZGraphEl **>, TPZManVector< TPZManVector< REAL, 3 >, DEFAULTVEC_ALLOC >, TPZManVector< std::pair< int, int64_t > >, TPZManVector< TPZFemSol, 20 >, and TPZManVector< TPZPostProcVar, 20 >.
Definition at line 373 of file pzvec.h.
Referenced by TPZCutHillMcKee::SGraph::AdjacentNodes(), TPZCutHillMcKee::SGraph::AdjacentNodesOrdered(), TPZNodesetCompute::AnalyseGraph(), Append(), TPZMatElastoPlastic< T, TMEM >::ApplyDirection(), TPZElasticity3D::ApplyDirection(), TPZHybridizeHDiv::AssociateElements(), pztopology::TPZLine::BlendFactorForSide(), pztopology::TPZTetrahedron::BlendFactorForSide(), pztopology::TPZPyramid::BlendFactorForSide(), pztopology::TPZTriangle::BlendFactorForSide(), pztopology::TPZCube::BlendFactorForSide(), pztopology::TPZPrism::BlendFactorForSide(), pztopology::TPZQuadrilateral::BlendFactorForSide(), TPZBlockDiagonalStructMatrix::BlockSizes(), TPZElementMatrix::BuildDependencyOrder(), TPZConnect::BuildDependencyOrder(), TPZNodesetCompute::BuildNodeGraph(), TPZNodesetCompute::BuildVertexGraph(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZInterfaceElement::CenterNormal(), TPZBlockDiagonal< STATE >::Clear(), TPZSkylNSymMatrix< TVar >::Clear(), TPZVec< std::pair< int, int > >::clear(), TPZSkylMatrix< TVar >::Clear(), TPZRenumbering::ColorElements(), TPZNodesetCompute::ColorGraph(), TPZRenumbering::ColorNodes(), TPZRefPatternTools::CompareTopologies(), TPZBuildMultiphysicsMesh::ComputeAtomicIndexes(), pztopology::TPZCube::ComputeDirections(), pztopology::TPZPrism::ComputeDirections(), pztopology::TPZPyramid::ComputeDirections(), pztopology::TPZLine::ComputeDirections(), pztopology::TPZTetrahedron::ComputeDirections(), pztopology::TPZPoint::ComputeDirections(), pztopology::TPZQuadrilateral::ComputeDirections(), TPZCompMesh::ComputeElGraph(), TPZHierarquicalGrid::ComputeExtrusion(), TPZGradientFlux::ComputeFlux(), TPZGenGrid::ComputeGeometricProgression(), TPZGenSubStruct::ComputeInternalEquationPermutation(), TPZDohrStructMatrix::ComputeInternalEquationPermutation(), TPZSkylNSymMatrix< TVar >::ComputeMaxSkyline(), TPZSkylMatrix< TVar >::ComputeMaxSkyline(), TPZCompMesh::ComputeNodElCon(), TPZInterfaceElement::ComputeNormal(), TPZSubCompMesh::ComputePermutationInternalFirst(), TPZCompElHDivPressureBound< TSHAPE >::ComputeShapeIndex(), TPZCompElHDivBound2< TSHAPE >::ComputeShapeIndex(), TPZCompElHDiv< TSHAPE >::ComputeShapeIndex(), TPZInterpolatedElement::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZRefPattern::ComputeTransforms(), TPZGeoEl::ComputeXInverse(), TPZIntRuleP3D::ComputingCubatureRuleForPyramid(), TPZGaussRule::ComputingGaussChebyshevQuadrature(), TPZGaussRule::ComputingGaussJacobiQuadrature(), TPZGaussRule::ComputingGaussLegendreQuadrature(), TPZGaussRule::ComputingGaussLobattoQuadrature(), TPZMatConvectionProblem::Contribute(), TPZBiharmonicEstimator::ContributeErrorsSimple(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsSimple(), TPZBiharmonicEstimator::ContributeInterfaceErrorsSimple(), TPZCompMesh::ConvertDiscontinuous2Continuous(), TPZRenumbering::ConvertToElementoToElementGraph(), TPZSBMatrix< TVar >::Copy(), TPZSkylNSymMatrix< TVar >::Copy(), TPZSkylMatrix< TVar >::Copy(), TPZDohrStructMatrix::Create(), TPZCheckGeom::CreateMesh(), TPZRefPattern::CreateNewNodes(), Hdiv3dPaper201504::CreateOneCuboWithTetraedrons(), TPZYCCamClayPV::DDistanceToSurface(), TPZYCDruckerPragerPV::DDistanceToSurfaceF1(), TPZSpBlockDiagPivot< TVar >::Decompose_LU(), TPZFMatrix< STATE >::Decompose_LU(), TPZAnalysis::DefineElementTable(), TPZArtDiff::Divergent(), pzrefine::TPZRefPrism::Divide(), pzrefine::TPZRefTriangle::Divide(), pzrefine::TPZRefCube::Divide(), pzrefine::TPZRefPyramid::Divide(), pzrefine::TPZRefQuad::Divide(), pzrefine::TPZRefLinear::Divide(), pzrefine::TPZRefTetrahedra::Divide(), pzrefine::TPZRefPoint::Divide(), TPZGeoElRefPattern< TGeo >::Divide(), TPZCompElDisc::Divide(), TPZInterpolatedElement::Divide(), TPZCompEl::Divide(), TPZCompMesh::Divide(), TPZVTKGraphMesh::DrawSolution(), TPZMVGraphMesh::DrawSolution(), TPZDXGraphMesh::DrawSolution(), TPZMatElastoPlastic< T, TMEM >::EigenValues(), TPZMatElastoPlastic< T, TMEM >::EigenVectors(), TPZStructMatrixGC::ElementColoring(), TPZStructMatrixOT::ElementColoring(), TPZLinearConvecDiff::Errors(), TPZMatDualHybridPoisson::Errors(), TPZL2Projection::Errors(), TPZMixedPoisson::Errors(), TPZMatLaplacian::Errors(), TPZMatPoisson3d::Errors(), TPZMatMixedPoisson3D::Errors(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZInterpolationSpace::EvaluateError(), TPZElementGroup::EvaluateError(), TPZSBFemVolume::EvaluateError(), TPZCompMesh::EvaluateError(), TPZCompElDisc::EvaluateSquareResidual2D(), TPZNodesetCompute::ExpandGraph(), TPZExtendGridDimension::ExtendedMesh(), TPZEquationFilter::Filter(), TPZEquationFilter::FilterSkyline(), TPZGeoMesh::FindApproxElement(), TPZGeoMesh::FindElementCaju(), TPZGeoMesh::FindSubElement(), TPZCompElHDivBound2< TSHAPE >::FirstShapeIndex(), TPZEulerConsLaw::Flux(), TPZDohrSubstructCondense< TTVar >::GatherVec(), TPZGenGrid::GenerateElements(), TPZRefPattern::GenerateSideRefPatterns(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), TPZInterfaceElement::GetConnects(), TPZGeoEl::GetHigherSubElements(), TPZIntelGen< TSHAPE >::GetInterpolationOrder(), TPZCompElHDivBound2< TSHAPE >::GetInterpolationOrder(), TPZCompElHDivPressure< TSHAPE >::GetInterpolationOrder(), TPZCompElHDivPressureBound< TSHAPE >::GetInterpolationOrder(), TPZCompElHDiv< TSHAPE >::GetInterpolationOrder(), TPZMHMixedMeshControl::GetMeshVec(), TPZMHMeshControl::GetMeshVec(), TPZGeoEl::GetNodeIndices(), pztopology::GetPermutation(), TPZPostProcMat::GetPostProcessVarIndexList(), TPZIntRuleList::GetRule(), TPZIntRuleList::GetRuleP3D(), TPZIntRuleList::GetRuleT(), TPZIntRuleList::GetRuleT3D(), pztopology::TPZPrism::GetSideHDivDirections(), pztopology::TPZPyramid::GetSideHDivDirections(), pztopology::TPZCube::GetSideHDivDirections(), pztopology::TPZLine::GetSideHDivDirections(), pztopology::TPZTetrahedron::GetSideHDivDirections(), pztopology::TPZTriangle::GetSideHDivDirections(), pztopology::TPZQuadrilateral::GetSideHDivDirections(), pztopology::TPZLine::GetSideHDivPermutation(), pztopology::TPZTriangle::GetSideHDivPermutation(), TPZGenSubStruct::IdentifyEqNumbers(), TPZGenSubStruct::IdentifySubCornerEqs(), TPZDohrStructMatrix::IdentifySubCornerEqs(), TPZBlockDiagonal< STATE >::Initialize(), TPZGenSubStruct::InitializeDohrCondense(), TPZSkylNSymMatrix< TVar >::InitializeElem(), TPZSkylMatrix< TVar >::InitializeElem(), TPZPlasticStep< YC_t, TF_t, ER_t >::InitializeValidEqs(), TPZGmshReader::InsertElement(), TPZInterfaceElement::Integrate(), TPZInterfaceElement::IntegrateInterface(), TPZMatPoisson3d::InterfaceErrors(), TPZRefPattern::InternalNodesIndexes(), TPZCompElDisc::InternalPoint(), TPZRefPattern::InternalSidesIndexes(), TPZAgglomerateElement::ListOfGroupings(), TPZCompMeshReferred::LoadReferred(), malha_predio(), MalhaCubo(), Input::MalhaCubo(), MalhaPredio(), pzgeom::TPZGeoBlend< TGeo >::MapToNeighSide(), pztopology::Pr< TFather >::MapToSide(), pztopology::TPZPyramid::MapToSide(), pztopology::TPZCube::MapToSide(), pztopology::TPZPrism::MapToSide(), pztopology::TPZLine::MapToSide(), pztopology::TPZTetrahedron::MapToSide(), pztopology::TPZPoint::MapToSide(), pztopology::TPZTriangle::MapToSide(), pztopology::TPZQuadrilateral::MapToSide(), TPZGenGrid::MergeGeoMesh(), TPZMGAnalysis::MeshError(), TPZGeoElRefPattern< TGeo >::MidSideNodeIndices(), TPZGeoEl::MidSideNodeIndices(), TPZDiffMatrix< T >::Multiply(), TPZStructMatrixOT::MultiThread_Assemble(), TPZGeoElSide::NeighbourSideTransform(), TPZRefPatternTools::NodesHunter(), TPZRenumbering::NodeToElGraph(), TPZGeoElSide::Normal(), NormalVector(), pzshape::TPZShapeQuad::NShapeF(), pzshape::TPZShapeCube::NShapeF(), TPZArtDiff::ODotOperator(), TPZVec< std::pair< int, int > >::operator=(), TPZFrontStructMatrix< front >::OrderElement(), TPZStructMatrixGCTP::OrderElement(), TPZStructMatrixGC::OrderElement(), TPZStructMatrixOT::OrderElement(), pzgeom::TPZEllipse3D::ParametricDomainNodeCoord(), pztopology::TPZPyramid::ParametricDomainNodeCoord(), pztopology::TPZCube::ParametricDomainNodeCoord(), pztopology::TPZPrism::ParametricDomainNodeCoord(), pztopology::TPZLine::ParametricDomainNodeCoord(), pztopology::TPZTetrahedron::ParametricDomainNodeCoord(), pztopology::TPZTriangle::ParametricDomainNodeCoord(), pztopology::TPZPoint::ParametricDomainNodeCoord(), pztopology::TPZQuadrilateral::ParametricDomainNodeCoord(), pzshape::TPZShapePoint::PermuteSides(), TPZAnalysis::PostProcess(), TPZAnalysis::PostProcessErrorParallel(), TPZAnalysis::PostProcessErrorSerial(), TPZArtDiff::PrepareFastDiff(), TPZEulerConsLaw::Pressure(), TPZElasticity3D::PrincipalDirection(), ProjectBissectionInParametricDomain(), PYBIND11_MODULE(), TPZGeoElSide::QsiElement(), TPZGeoEl::QuadArea(), TPZPoroElastoPlasticMem::Read(), TPZSkylNSymMatrix< TVar >::Read(), TPZStream::Read(), TPZRefPattern::Read(), TPZSkylMatrix< TVar >::Read(), TPZGenGrid::ReadAndMergeGeoMesh(), TPZGMSHReadMesh::ReadMesh2D(), TPZGMSHReadMesh::ReadMesh2D2(), TPZGMSHReadMesh::ReadMesh3D(), TPZStream::ReadPointers(), TPZFBMatrix< TVar >::Redim(), TPZSkylMatrix< TVar >::Redim(), TPZPlasticStep< YC_t, TF_t, ER_t >::RemoveInvalidEqs(), TPZGenSubStruct::ReorderInternalNodes(), TPZGenSubStruct::ReorderInternalNodes2(), TPZSandlerExtended::Res1(), TPZSandlerExtended::Res2(), TPZSandlerExtended::Res2CoVertex(), TPZMetis::Resequence(), TPZSloan::Resequence(), TPZSloanRenumbering::Resequence(), TPZEquationFilter::Reset(), TPZFront< STATE >::Reset(), TPZCompMeshReferred::ResetReferred(), TPZVec< std::pair< int, int > >::resize(), TPZSkylMatrix< TVar >::Resize(), TPZCompMesh::SaddlePermute(), TPZCompMesh::SaddlePermute2(), TPZDohrSubstructCondense< TTVar >::ScatterVec(), TPZCutHillMcKee::SGraph::Set2Vec(), TPZEquationFilter::SetActiveEquations(), TPZTransfer< TVar >::SetBlocks(), TPZEulerConsLaw::SetDelta(), TPZBndCond::SetLoadCases(), TPZGeoElRefPattern< TGeo >::SetRefPattern(), TPZGaussRule::SetType(), TPZCutHillMcKee::SGraph::ShrinkLastLevel(), TPZRefPatternTools::SidesToRefine(), TPZVec< std::pair< int, int > >::size(), TPZCompMesh::Skyline(), TPZSubCompMesh::SkylineInternal(), TPZSloanRenumbering::SList::SList(), SolExata(), TPZMultCamada::Solution(), TPZLinearConvecDiff::Solution(), TPZLinearConvection::Solution(), TPZMatElastoPlastic< T, TMEM >::Solution(), TPZMatOrthotropic::Solution(), TPZPlaca::Solution(), TPZEuler::Solution(), TPZBiharmonic::Solution(), TPZMatPlaca2::Solution(), TPZMatHyperElastic::Solution(), TPZMatDualHybridPoisson::Solution(), TPZNonLinBiharmonic::Solution(), TPZMat2dLin::Solution(), TPZPostProcMat::Solution(), TPZTracerFlow::Solution(), TPZMixedDarcyFlow::Solution(), TPZPrimalPoisson::Solution(), TPZElasticityAxiMaterial::Solution(), TPZMultiphase::Solution(), TPZEulerConsLaw::Solution(), TPZEulerEquation::Solution(), TPZL2Projection::Solution(), TPZDualPoisson::Solution(), TPZElasticity3D::Solution(), TPZMultiphysicsCompEl< TGeometry >::Solution(), TPZMixedPoisson::Solution(), TPZMatConvectionProblem::Solution(), TPZMatElasticity2D::Solution(), TPZMatLaplacian::Solution(), TPZInterpolationSpace::Solution(), TPZMaterial::Solution(), TPZMultiphysicsInterfaceElement::Solution(), TPZMatPoisson3d::Solution(), TPZMatMixedPoisson3D::Solution(), TPZCompEl::Solution(), TPZMatrix< STATE >::SolveEigenvaluesJacobi(), TPZFront< TVar >::STensorProductMTData::STensorProductMTData(), TPZMetis::Subdivide(), TPZBlockDiagonal< STATE >::TPZBlockDiagonal(), TPZConsLawTest::TPZConsLawTest(), TPZFrontMatrix< TVar, store, front >::TPZFrontMatrix(), TPZGeoElRefPattern< TGeo >::TPZGeoElRefPattern(), TPZGmshReader::TPZGmshReader(), TPZHierarquicalGrid::TPZHierarquicalGrid(), TPZIntRuleList::TPZIntRuleList(), TPZMatConvectionProblem::TPZMatConvectionProblem(), TPZSparseBlockDiagonal< TVar >::TPZSparseBlockDiagonal(), TPZGeoEl::TransformSonToFather(), TPZGeoEl::TriangleArea(), TPZInterpolationSpace::VectorialProd(), pzgeom::TPZGeoQuad::VectorialProduct(), pzgeom::TPZGeoTriangle::VectorialProduct(), TPZInterfaceElement::VetorialProd(), TPZStructMatrixTBBFlow::Write(), TPZGeoElSide::X(), pzgeom::TPZGeoBlend< TGeo >::X(), TPZGaussRule::~TPZGaussRule(), and TPZIntRuleList::~TPZIntRuleList().
|
virtual |
Resizes the vector object reallocating the necessary storage, copying the existing objects to the new storage.
The new members are not initialized.
newsize | size of the vector |
Reimplemented in TPZManVector< T, NumExtAlloc >, TPZManVector< TPZGeoNode *>, TPZManVector< T, 3 >, TPZManVector< REAL, N >, TPZManVector< REAL >, TPZManVector< TPZVec< REAL > >, TPZManVector< STATE, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompEl *, NumExtAlloc >, TPZManVector< int64_t >, TPZManVector< REAL, 6+6+1+TPZYCLadeKim::NYield >, TPZManVector< std::pair< int64_t, int >, 4 >, TPZManVector< TPZMatrixSolver< TVar > *, DEFAULTVEC_ALLOC >, TPZManVector< REAL, 10 >, TPZManVector< int, N >, TPZManVector< TTVar >, TPZManVector< std::map< int, std::vector< int > >, 4 >, TPZManVector< TPZConnect *>, TPZManVector< TPZMatrixSolver< STATE > *, DEFAULTVEC_ALLOC >, TPZManVector< int64_t, 3 >, TPZManVector< TPZFMatrix< REAL >, DEFAULTVEC_ALLOC >, TPZManVector< int, NumExtAlloc >, TPZManVector< REAL, 6 >, TPZManVector< T, 6 >, TPZManVector< unsigned int, 3 >, TPZManVector< TPZCompMesh *, DEFAULTVEC_ALLOC >, TPZManVector< int >, TPZManVector< TPZBlock::TNode >, TPZManVector< STATE, 2 >, TPZManVector< TPZCompMesh *, 2 >, TPZManVector< int64_t, 20 >, TPZManVector< std::map< std::string, int >, 4 >, TPZManVector< char, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompMesh *, 3 >, TPZManVector< TPZPlacaOrthotropic, DEFAULTVEC_ALLOC >, TPZManVector< TPZElementMatrix *, DEFAULTVEC_ALLOC >, TPZManVector< TPZManVector< T, 3 >, 3 >, TPZManVector< int64_t, NumExtAlloc >, TPZManVector< STATE, 3 >, TPZManVector< int, 6 >, TPZManVector< TPZGeoEl **>, TPZManVector< TPZGraphNode *>, TPZManVector< T *>, TPZManVector< TVar >, TPZManVector< TPZManVector< REAL, 10 >, 100 >, TPZManVector< TPZCompEl **>, TPZManVector< REAL, DEFAULTVEC_ALLOC >, TPZManVector< std::pair< int, std::string >, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompElSide, DEFAULTVEC_ALLOC >, TPZManVector< TPZCompElSide, 5 >, TPZManVector< TPZCompEl *, DEFAULTVEC_ALLOC >, TPZManVector< std::complex< double > >, TPZManVector< TPZEqnArray< TVar > *, DEFAULTVEC_ALLOC >, TPZManVector< int, 5 >, TPZManVector< TPZFMatrix< STATE > *, DEFAULTVEC_ALLOC >, TPZManVector< std::map< int, int >, 4 >, TPZManVector< REAL, 3 >, TPZManVector< int, 4 >, TPZManVector< TPZFemGradSol, 20 >, TPZManVector< int, DEFAULTVEC_ALLOC >, TPZManVector< STATE, 6 >, TPZManVector< MaterialDataV, DEFAULTVEC_ALLOC >, TPZManVector< TPZEqnArray< TVar >, DEFAULTVEC_ALLOC >, TPZManVector< int, 3 >, TPZManVector< T, N >, TPZManVector< long double >, TPZManVector< TPZPlasticIntegrMem< REAL, YC_t::NYield >, DEFAULTVEC_ALLOC >, TPZManVector< int64_t, DEFAULTVEC_ALLOC >, TPZManVector< int, TSHAPE::NFaces >, TPZManVector< TVar, NumExtAlloc >, TPZManVector< int, TFather::Top::NSides >, TPZManVector< TPZMatPlaca2 *, DEFAULTVEC_ALLOC >, TPZManVector< int64_t, 27 >, TPZManVector< TPZCompElLagrange::TLagrange, 3 >, TPZManVector< std::map< int, std::string >, 4 >, TPZManVector< TPZTensor< T >, 3 >, TPZManVector< int64_t, TSHAPE::NSides >, TPZManVector< TPZGraphEl **>, TPZManVector< TPZManVector< REAL, 3 >, DEFAULTVEC_ALLOC >, TPZManVector< std::pair< int, int64_t > >, TPZManVector< TPZFemSol, 20 >, and TPZManVector< TPZPostProcVar, 20 >.
|
inlinevirtual |
Definition at line 213 of file pzvec.h.
Referenced by TPZMultiphysicsCompEl< TGeometry >::AddElement(), TPZBuildSBFem::AddPartition(), TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZElementMatrix::ApplyConstraints(), TPZSkylMatrix< TVar >::AutoFill(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcStiff(), pzgeom::TPZChangeEl::ChangeToQuadratic(), TPZAnalysis::CleanUp(), TPZFBMatrix< TVar >::Clear(), TPZSBMatrix< TVar >::Clear(), TPZSYsmpMatrix< TVar >::ComputeDiagonal(), TPZFYsmpMatrix< TVar >::ComputeDiagonal(), TPZTensor< STATE >::ComputeEigenvalues(), TPZTensor< STATE >::ComputeEigenvectorsInternal(), TPZCompElDisc::ComputeSolution(), TPZBuildSBFem::Configure(), ConnectSolution(), TPZSandlerExtended::ConvergenceRate(), TPZFBMatrix< TVar >::CopyFrom(), TPZSBMatrix< TVar >::CopyFrom(), TPZSkylMatrix< TVar >::CopyFrom(), TPZBuildSBFem::CreateElementCenterNodes(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), TPZGenGrid::ElementConnectivityZigZag(), Hdiv2dPaper201504::ErrorH1(), hdivCurvedJCompAppMath::ErrorH1(), Hdiv3dPaper201504::ErrorH1(), Hdiv2dPaper201504::ErrorPrimalDual(), hdivCurvedJCompAppMath::ErrorPrimalDual(), Hdiv3dPaper201504::ErrorPrimalDual(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZCompElHDiv< TSHAPE >::FillOrder(), hdivCurvedJCompAppMath::Forcing(), hdivCurvedJCompAppMath::ForcingBC1D(), hdivCurvedJCompAppMath::ForcingBC2D(), hdivCurvedJCompAppMath::ForcingBC3D(), hdivCurvedJCompAppMath::ForcingBC4D(), TPZElastoPlasticAnalysis::GetActiveEquations(), TPZCompEl::GetMemoryIndices(), TPZMHMeshControl::GetMeshes(), TPZMHMeshControl::GetMeshVec(), hdivCurvedJCompAppMath::GMeshCilindricalMesh(), TPZCompElHDiv< TSHAPE >::IndexShapeToVec2(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZCompElHDiv< TSHAPE >::InitMaterialData(), TPZRefPattern::InsertPermuted(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZInterpolationSpace::InterpolateSolution(), TPZFYsmpMatrix< TVar >::operator=(), TPZMatElasticity2D::operator=(), TPZYCDruckerPragerPV::Phi(), TPZYCCamClayPV::Phi(), TPZPorousElasticCriterion::Phi(), TPZElasticCriterion::Phi(), TPZYCMohrCoulombPV::Phi(), TPZMultiphysicsCompEl< TGeometry >::PolynomialOrder(), TCedricTest::PyramidalAndTetrahedralMesh(), TPZAcademicGeoMesh::PyramidalAndTetrahedralMesh(), TPZMatrixMarket::Read(), TPZStream::ReadPointers(), TPZSBMatrix< TVar >::Redim(), TPZSBMatrix< TVar >::SetBand(), TPZFBMatrix< TVar >::SetBand(), TPZFYsmpMatrix< TVar >::SetData(), TPZGraphMesh::SetNames(), TPZCompElDisc::SetTrueUseQsiEta(), Hdiv2dPaper201504::SolExata(), hdivCurvedJCompAppMath::SolExata(), Hdiv3dPaper201504::SolExata(), Hdiv2dPaper201504::SolExataH1(), hdivCurvedJCompAppMath::SolExataH1(), Hdiv3dPaper201504::SolExataH1(), TPZMultiphysicsCompEl< TGeometry >::Solution(), TPZMaterial::Solution(), TPZMultiphysicsInterfaceElement::Solution(), TPZSandlerExtended::TaylorCheckDDistF1(), TPZSandlerExtended::TaylorCheckDDistF1DSigtrial(), TPZSandlerExtended::TaylorCheckDDistF2(), TPZSandlerExtended::TaylorCheckDDistF2DSigtrial(), TPZSandlerExtended::TaylorCheckDF1Cart(), TPZSandlerExtended::TaylorCheckDF2Cart(), TPZSandlerExtended::TaylorCheckDistF1(), TPZSandlerExtended::TaylorCheckDistF2(), TPZSandlerExtended::TaylorCheckDtbkDsigtrial(), TPZSandlerExtended::TaylorCheckParamF1Sigtrial(), TPZSandlerExtended::TaylorCheckProjectF1(), TPZSandlerExtended::TaylorCheckProjectF2(), TPZSandlerExtended::TaylorCheckProjectSigma(), TPZBuildSBFem::TPZBuildSBFem(), TPZCondensedCompEl::TPZCondensedCompEl(), TPZMatConvectionProblem::TPZMatConvectionProblem(), TPZMatElasticity2D::TPZMatElasticity2D(), TPZProjectEllipse::TPZProjectEllipse(), TPZSBMatrix< TVar >::TPZSBMatrix(), TPZStochasticSearch< TVar >::TPZStochasticSearch(), and TPZSandlerExtended::YieldFunction().
|
inline |
Returns the number of elements of the vector.
Definition at line 196 of file pzvec.h.
Referenced by TPZMHMeshControl::AddBoundaryInterfaceElements(), TPZBuildMultiphysicsMesh::AddConnects(), TPZMultiphysicsCompMesh::AddConnects(), TPZElementGroup::AddElement(), TPZSBFemElementGroup::AddElement(), TPZMultiphysicsCompEl< TGeometry >::AddElement(), TPZBuildMultiphysicsMesh::AddElements(), TPZMultiphysicsCompMesh::AddElements(), TPZCompMeshTools::AddHDivPyramidRestraints(), TPZBuildSBFem::AddPartition(), TPZInterpolatedElement::AdjustPreferredSideOrder(), TPZMultiphysicsCompEl< TGeometry >::AffineTransform(), TPZReferredCompEl< TCOMPEL >::AppendOtherSolution(), TPZTransform< T >::Apply(), TPZMatElastoPlastic< T, TMEM >::ApplyDeltaStrain(), TPZMatElastoPlastic< T, TMEM >::ApplyDeltaStrainComputeDep(), TPZGradientFlux::ApplyLimiter(), TPZElementMatrix::ApplyOneShapeConstraints(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStrainComputeDep(), TPZSYsmpMatrix< TVar >::AutoFill(), TPZFYsmpMatrix< TVar >::AutoFill(), TPZMatLaplacian::BCInterfaceJump(), TPZMatPoisson3d::BCInterfaceJump(), pztopology::TPZTetrahedron::BlendFactorForSide(), pztopology::TPZPyramid::BlendFactorForSide(), pztopology::TPZTriangle::BlendFactorForSide(), pztopology::TPZPrism::BlendFactorForSide(), TPZCompEl::BuildConnectList(), TPZElementGroup::BuildCornerConnectList(), TPZCompElLagrange::BuildCornerConnectList(), BuildElementGroups(), TPZBuildMultiphysicsMesh::BuildHybridMesh(), TPZCreateApproximationSpace::BuildMesh(), TPZMultiphysicsCompMesh::BuildMultiphysicsSpace(), TPZMultiphysicsCompMesh::BuildMultiphysicsSpaceWithMemory(), TPZElementGroup::CalcResidual(), TPZMultiphysicsCompEl< TGeometry >::CalcResidual(), TPZSBFemElementGroup::CalcStiff(), TPZMultiphysicsInterfaceElement::CalcStiff(), TPZInterfaceElement::CalcStiff(), TPZElementGroup::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(), TPZCheckMesh::CheckConstraintDimension(), TPZElementGroup::ClonePatchEl(), TPZDohrStructMatrix::ClusterIslands(), Hdiv2dPaper201504::CMeshMixed(), hdivCurvedJCompAppMath::CMeshMixed(), Hdiv3dPaper201504::CMeshMixed(), TPZRenumbering::ColorElements(), TPZRefPatternTools::CompareTopologies(), TPZSYsmpMatrix< TVar >::ComputeDiagonal(), TPZFYsmpMatrix< TVar >::ComputeDiagonal(), TPZCompMeshTools::ComputeDifferenceNorm(), pztopology::TPZCube::ComputeDirections(), ComputeError(), TPZMaterialData::ComputeFluxValues(), TPZSBFemElementGroup::ComputeMassMatrix(), TPZSBFemElementGroup::ComputeMatrices(), TPZHybridizeHDiv::ComputeNState(), TPZRefPattern::ComputePartition(), TPZMultiphysicsElement::ComputeRequiredData(), TPZMultiphysicsCompEl< TGeometry >::ComputeRequiredData(), TPZMultiphysicsInterfaceElement::ComputeSideTransform(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter2(), TPZGradientReconstruction::TPZGradientData::ComputeSlopeLimiter3(), TPZSBFemVolume::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZViscoelastic::ComputeStressTensor(), TPZGradientReconstruction::TPZGradientData::ComputeWeights(), TPZBuildSBFem::Configure(), TPZMHMeshControl::ConnectedElements(), TPZMultiphysicsInterfaceElement::ConnectIndex(), TPZCompElLagrange::ConnectIndex(), ConnectNorm(), TPZTransientMaterial< TBASEMAT >::Contribute(), TPZBurger::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZMatHyperElastic::Contribute(), TPZConsLawTest::Contribute(), TPZEuler::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMatPoisson3dReferred::Contribute(), TPZL2Projection::Contribute(), TPZThermicElast3D::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZMultiphase::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZCoupledTransportDarcyBC::Contribute(), TPZMixedPoissonParabolic::Contribute(), TPZTracerFlow::Contribute(), TPZDualPoisson::Contribute(), TPZCoupledTransportDarcy::Contribute(), TPZLagrangeMultiplier::Contribute(), TPZVecL2::Contribute(), TPZMixedPoisson::Contribute(), TPZMatMixedPoisson3D::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMaterial::Contribute(), TPZEulerConsLaw::Contribute(), TPZMatHyperElastic::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZSpaceTimeRichardsEq::ContributeBC(), TPZBurger::ContributeBC(), TPZMultiphase::ContributeBC(), TPZMixedPoissonParabolic::ContributeBC(), TPZMixedDarcyFlow::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZMixedPoisson::ContributeBC(), TPZSwelling::ContributeBC(), TPZMatMixedPoisson3D::ContributeBC(), TPZMaterial::ContributeBC(), TPZMatPoisson3dReferred::ContributeBCInterface(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZMultiphase::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZEulerEquation::ContributeBCInterface(), TPZCoupledTransportDarcy::ContributeBCInterface(), TPZEulerConsLaw::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsDual(), TPZArtDiff::ContributeExplDiff(), TPZConsLawTest::ContributeInterface(), TPZHybridPoisson::ContributeInterface(), TPZMatPoisson3dReferred::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZBurger::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZCoupledTransportDarcyBC::ContributeInterface(), TPZEulerEquation::ContributeInterface(), TPZLagrangeMultiplier::ContributeInterface(), TPZCoupledTransportDarcy::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZBndCond::ContributeInterface(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsDual(), TPZBiharmonicEstimator::ContributeInterfaceErrorsDual(), TPZL2Projection::ContributeVecShape(), TPZMatMixedPoisson3D::ContributeWithoutSecondIntegration(), TPZSandlerExtended::ConvergenceRate(), TPZRenumbering::ConvertGraph(), TPZRenumbering::ConvertToElementoToElementGraph(), TPZFBMatrix< TVar >::CopyFrom(), TPZSBMatrix< TVar >::CopyFrom(), TPZSkylMatrix< TVar >::CopyFrom(), TPZRenumbering::CornerEqs(), TPZSpStructMatrix::Create(), TPZParSkylineStructMatrix::Create(), TCedricTest::CreateCondensedElements(), TPZBuildSBFem::CreateElementCenterNodes(), TPZBuildSBFem::CreateElementGroups(), TPZGeoMesh::CreateGeoElement(), TPZHierarquicalGrid::CreateGeometricElement(), TPZElementGroup::CreateGraphicalElement(), TPZMultiphysicsInterfaceElement::CreateGraphicalElement(), TPZMHMeshControl::CreateInterfaceElements(), TPZMHMixedHybridMeshControl::CreateMultiPhysicsInterfaceElements(), TPZMHMixedMeshControl::CreateMultiPhysicsInterfaceElements(), TPZHybridizeHDiv::CreateMultiphysicsMesh(), TPZBuildSBFem::CreateVolumetricElements(), TPZBuildSBFem::CreateVolumetricElementsFromSkeleton(), Cross(), TPZAnalysis::DefineGraphMesh(), TPZMHMeshControl::DefinePartition(), TPZMHMeshControl::DefinePartitionbyCoarseIndices(), TPZElementGroup::Dimension(), dist(), TPZMHMeshControl::DivideBoundarySkeletonElements(), TPZBuildSBFem::DivideSkeleton(), TPZMHMeshControl::DivideSkeletonElements(), TPZMHMeshControl::DivideWrap(), TPZStochasticSearch< TVar >::DoSearch(), TPZIntelGen< TSHAPE >::EffectiveSideOrder(), TPZTensor< STATE >::EigenSystem(), TPZStructMatrixOT::ElementColoring(), Hdiv2dPaper201504::ErrorH1(), hdivCurvedJCompAppMath::ErrorH1(), Hdiv3dPaper201504::ErrorH1(), Hdiv2dPaper201504::ErrorPrimalDual(), hdivCurvedJCompAppMath::ErrorPrimalDual(), Hdiv3dPaper201504::ErrorPrimalDual(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZElementGroup::EvaluateError(), TPZSubCompMesh::EvaluateError(), TPZInterfaceElement::EvaluateInterfaceJump(), TPZGradient::Execute(), TPZPlasticStep< YC_t, TF_t, ER_t >::ExtractTangent(), FillAtomic(), TPZTracerFlow::FillBoundaryConditionDataRequirement(), TPZMixedDarcyFlow::FillBoundaryConditionDataRequirement(), TPZMixedPoissonParabolic::FillBoundaryConditionDataRequirement(), TPZPrimalPoisson::FillBoundaryConditionDataRequirement(), TPZDualPoisson::FillBoundaryConditionDataRequirement(), TPZMultiphase::FillBoundaryConditionDataRequirement(), TPZMaterial::FillBoundaryConditionDataRequirement(), TPZMixedPoisson::FillBoundaryConditionDataRequirement(), TPZMatMixedPoisson3D::FillBoundaryConditionDataRequirement(), TPZTracerFlow::FillDataRequirements(), TPZMixedPoissonParabolic::FillDataRequirements(), TPZMixedDarcyFlow::FillDataRequirements(), TPZPrimalPoisson::FillDataRequirements(), TPZDualPoisson::FillDataRequirements(), TPZMaterial::FillDataRequirements(), TPZMultiphase::FillDataRequirements(), TPZMixedPoisson::FillDataRequirements(), TPZMixedElasticityMaterial::FillDataRequirements(), TPZMatMixedPoisson3D::FillDataRequirements(), TPZBndCond::FillDataRequirements(), TPZTracerFlow::FillDataRequirementsInterface(), TPZLagrangeMultiplier::FillDataRequirementsInterface(), TPZMaterial::FillDataRequirementsInterface(), TPZBndCond::FillDataRequirementsInterface(), TPZEquationFilter::Filter(), TPZEquationFilter::FilterSkyline(), TPZGeoMesh::FindApproxElement(), TPZMHMixedHybridMeshControl::FindConnectedElements(), TPZGenGrid::GenerateElementsZigZag(), TPZReadGIDGrid::GeometricGIDMesh(), TPZGmshReader::GeometricGmshMesh4(), TPZGeoElSide::GetAllSiblings(), TPZGradientReconstruction::TPZGradientData::GetCenterPointAndCellAveraged(), pztopology::TPZQuadrilateral::GetGatherPermute(), pztopology::TPZTriangle::GetHDivGatherPermute(), TPZCompElHDivBound2< TSHAPE >::GetInterpolationOrder(), TPZSkylMatrix< TVar >::GetNelemts(), TPZFrontStructMatrix< front >::GetNumElConnected(), pztopology::GetPermutation(), pztopology::TPZQuadrilateral::GetSideHDivPermutation(), pzgeom::TPZGeoBlend< TGeo >::GradX(), pzgeom::TPZTriangleSphere< GeomTriang >::GradX(), TPZCompMeshTools::GroupElements(), TPZMHMixedHybridMeshControl::GroupElements(), TPZElementGroup::HasMaterial(), TPZHybridizeHDiv::Hybridize(), TPZMHMixedMeshControl::HybridizeSkeleton(), TPZInterpolatedElement::IdentifySideOrder(), TPZCompElHDiv< TSHAPE >::IndexShapeToVec2(), TPZMultiphysicsCompEl< TGeometry >::InitializeElementMatrix(), TPZGradientReconstruction::TPZGradientData::InitializeGradData(), TPZMultiphysicsCompEl< TGeometry >::InitializeIntegrationRule(), TPZSBFemVolume::InitMaterialData(), TPZInterpolationSpace::InitMaterialData(), TPZMultiphysicsInterfaceElement::InitMaterialData(), TPZCompElHDiv< TSHAPE >::InitMaterialData(), TPZMultiphysicsCompEl< TGeometry >::InitMaterialData(), TPZMixedElasticityMaterial::InnerVec(), TPZGeoMeshBuilder::InsertElement(), TPZGmshReader::InsertElement(), TPZMultiphysicsCompEl< TGeometry >::Integrate(), TPZElementGroup::Integrate(), TPZCompMesh::Integrate(), TPZElementGroup::IntegrateSolution(), TPZMultiphysicsCompEl< TGeometry >::IntegrateSolution(), TPZMaterial::IntegrationRuleOrder(), TPZDiscontinuousGalerkin::InterfaceJump(), TPZHyperPlaneIntersect::Intersect(), TPZMHMeshControl::JoinSubdomains(), TPZSBFemElementGroup::LoadEigenVector(), TPZElementGroup::LoadElementReference(), TPZSBFemElementGroup::LoadElementReference(), TPZMultiphase::LoadKMap(), TPZElementGroup::LoadSolution(), TPZSBFemElementGroup::LoadSolution(), TPZMultiphysicsCompMesh::LoadSolutionFromMeshes(), TPZMultiphysicsCompMesh::LoadSolutionFromMultiPhysics(), pztopology::TPZPyramid::MapToSide(), TPZSkylMatrix< TVar >::MemoryFootprint(), TPZGenGrid::MergeGeoMesh(), TPZBndCond::MinimumNumberofLoadCases(), TPZRefPatternTools::ModifyElementsBasedOnRefpFound(), TPZCompMesh::ModifyPermute(), TPZStructMatrixGCTP::MultiThread_Assemble(), TPZStructMatrixOT::MultiThread_Assemble(), TPZEquationFilter::NActiveEquations(), TPZIntelGen< TSHAPE >::NConnects(), TPZElementGroup::NConnects(), TPZMultiphysicsInterfaceElement::NConnects(), TPZCompElLagrange::NConnects(), TPZCompElHDiv< TSHAPE >::NConnectShapeF(), TPZElementGroup::NeedsComputing(), TPZMHMixedHybridMeshControl::NeedsHDivWrapper(), TPZMultiphysicsCompEl< TGeometry >::NMeshes(), TPZGradientReconstruction::TPZGradientData::NodeCloserCenterX(), pzshape::TPZShapeQuad::NShapeF(), TPZRefPattern::NSubElements(), TPZSBFemElementGroup::NumEigenValues(), TPZStochasticSearch< TVar >::NVars(), TPZSBMatrix< TVar >::operator*(), TPZFBMatrix< TVar >::operator*(), TPZSBMatrix< TVar >::operator*=(), TPZFBMatrix< TVar >::operator*=(), TPZFBMatrix< TVar >::operator+(), TPZSBMatrix< TVar >::operator+=(), TPZFBMatrix< TVar >::operator+=(), operator-(), TPZFBMatrix< TVar >::operator-(), operator-=(), TPZSBMatrix< TVar >::operator-=(), TPZFBMatrix< TVar >::operator-=(), operator<<(), TPZMatElasticity2D::operator=(), TPZManVector< TPZPostProcVar, 20 >::operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), TPZCompMesh::Permute(), TPZSubCompMesh::PermuteExternalConnects(), TPZElementMatrix::PermuteGather(), TPZPlasticStep< YC_t, TF_t, ER_t >::PlasticLoop(), TPZIntQuad::Point(), TPZMultiphysicsCompEl< TGeometry >::PolynomialOrder(), TPZElementGroup::Print(), TPZCondensedCompEl::Print(), TPZTensor< T >::TPZDecomposed::Print(), TPZSYsmpMatrix< TVar >::Print(), TPZMHMixedMeshControl::Print(), TPZSBFemElementGroup::Print(), TPZMaterialData::Print(), TPZMultiphysicsCompEl< TGeometry >::Print(), TPZRefPattern::Print(), Hdiv2dPaper201504::PrintErrors(), hdivCurvedJCompAppMath::PrintErrors(), Hdiv3dPaper201504::PrintErrors(), TPZVTKGeoMesh::PrintGMeshVTK(), TPZProjectEllipse::PrintingAsSimpleEquation(), TPZMaterialData::PrintMathematica(), TPZMHMeshControl::PrintSubdomain(), TPZAnalysis::PrintVectorByElement(), PYBIND11_MODULE(), TPZSubCompMesh::Read(), TPZSkylMatrix< TVar >::ReallocForNuma(), TPZMultiphysicsCompEl< TGeometry >::ReferredElement(), RefinamentoUniforme(), TPZMetis::Resequence(), TPZCondensedCompEl::Resequence(), TPZHybridizeHDiv::RightElement(), Hdiv2dPaper201504::Run(), hdivCurvedJCompAppMath::Run(), Hdiv3dPaper201504::Run(), TPZCompMesh::SaddlePermute(), TPZCompMesh::SaddlePermute2(), TPZStructMatrixOT::Serial_Assemble(), TPZMultiphysicsElement::SetActiveApproxSpaces(), TPZEquationFilter::SetActiveEquations(), pzgeom::TPZEllipse3D::SetAxes(), TPZAcademicGeoMesh::SetBCIDVector(), TPZCompElLagrange::SetConnectIndex(), pzgeom::TPZWavyLine::SetData(), pzgeom::TPZTriangleSphere< GeomTriang >::SetData(), TPZFYsmpMatrix< TVar >::SetData(), TPZGradientReconstruction::SetDataGhostsNeighbors(), TPZStochasticSearch< TVar >::SetDistribution(), TPZCompMesh::SetElementSolution(), TPZCompElWithMem< TBASE >::SetIntegrationRule(), TPZMultiphysicsInterfaceElement::SetLeftRightElementIndices(), TPZCompElWithMem< TBASE >::SetMemoryIndices(), TPZCompEl::SetMemoryIndices(), TPZElasticityAxiMaterial::SetOrigin(), TPZBuildSBFem::SetPartitions(), TPZSBFemVolume::SetPhiEigVal(), TPZIntelGen< TSHAPE >::SetSideOrder(), TPZSBFemVolume::SetSkeleton(), TPZMHMeshControl::SetSubdomain(), hdivCurvedJCompAppMath::SetupDisconnectedHdivboud(), TPZSymetricSpStructMatrix::SetupMatrixData(), pztopology::TPZLine::Shape(), pztopology::TPZTetrahedron::Shape(), pztopology::TPZTriangle::Shape(), pztopology::TPZPyramid::Shape(), pztopology::TPZPrism::Shape(), pztopology::TPZCube::Shape(), pztopology::TPZQuadrilateral::Shape(), TPZReducedSpace::ShapeX(), TPZBuildMultiphysicsMesh::ShowShape(), TPZAnalysis::ShowShape(), TPZRefPattern::SidePartition(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), TPZCompElHDiv< TSHAPE >::SideShapeFunction(), pzshape::TPZShapeTetra::SideShapeOrder(), pzshape::TPZShapePiram::SideShapeOrder(), pzshape::TPZShapePrism::SideShapeOrder(), pzshape::TPZShapeCube::SideShapeOrder(), TPZCompMesh::Skyline(), TPZMultPlaca::Solution(), TPZMatHybrid::Solution(), TPZMultCamada::Solution(), TPZLinearConvection::Solution(), TPZMatOrthotropic::Solution(), TPZPlaca::Solution(), TPZEuler::Solution(), TPZViscoelastic::Solution(), TPZVecL2::Solution(), TPZConsLawTest::Solution(), TPZThermicElast3D::Solution(), TPZNullMaterial::Solution(), TPZMat2dLin::Solution(), TPZElasticityAxiMaterial::Solution(), TPZL2Projection::Solution(), TPZElasticity3D::Solution(), TPZMultiphysicsCompEl< TGeometry >::Solution(), TPZMixedPoisson::Solution(), TPZElasticityMaterial::Solution(), TPZMatElasticity2D::Solution(), TPZMatLaplacian::Solution(), TPZMaterial::Solution(), TPZMultiphysicsInterfaceElement::Solution(), TPZMatPoisson3d::Solution(), TPZMixedElasticityMaterial::Solution(), TPZSwelling::Solution(), TPZFYsmpMatrix< TVar >::SolveJacobi(), TPZHybridizeHDiv::SplitConnects(), TPZBuildSBFem::StandardConfiguration(), TPZProjectEllipse::StandardFormatForSimpleEllipse(), TPZStructMatrixOT::ThreadData::ThreadWork(), TPZStructMatrixOT::ThreadData::ThreadWorkResidual(), TPZCompElHDiv< TSHAPE >::TPZCompElHDiv(), TPZElementGroup::TPZElementGroup(), TPZGeoElRefPattern< TGeo >::TPZGeoElRefPattern(), TPZManVector< TPZPostProcVar, 20 >::TPZManVector(), TPZMatElasticity2D::TPZMatElasticity2D(), TPZMHMeshControl::TPZMHMeshControl(), TPZVec< std::pair< int, int > >::TPZVec(), TPZBuildMultiphysicsMesh::TransferFromMeshes(), TPZBuildMultiphysicsMesh::TransferFromMultiPhysics(), TPZElementGroup::TransferMultiphysicsElementSolution(), TPZMHMeshControl::TransferToMultiphysics(), TPZBuildMultiphysicsMesh::UniformRefineCompEl(), TPZElementGroup::Unwrap(), TPZBndCond::UpdateBCValues(), TPZViscoelastic::UpdateQsi(), TPZBndCond::Val2(), TPZHybridizeHDiv::VerifySolutionConsistency(), TPZStructMatrixTBBFlow::Write(), TPZMaterialData::Write(), TPZRefPattern::Write(), TPZRefPattern::WritePattern(), pzgeom::TPZGeoBlend< TGeo >::X(), TPZGeoElRefLess< TGeo >::X(), TPZGeoElSide::YoungestChildren(), TPZSBMatrix< TVar >::Zero(), TPZFBMatrix< TVar >::Zero(), TPZAnalyticSolution::~TPZAnalyticSolution(), TPZCompElHDiv< TSHAPE >::~TPZCompElHDiv(), TPZCompElHDivBound2< TSHAPE >::~TPZCompElHDivBound2(), TPZElementGroup::~TPZElementGroup(), and TPZIntelGen< TSHAPE >::~TPZIntelGen().
|
friend |
Extraction operator.
|
protected |
Number of elements of the vector object.
Definition at line 233 of file pzvec.h.
Referenced by TPZVec< std::pair< int, int > >::end(), TPZManVector< TPZPostProcVar, 20 >::Expand(), TPZVec< std::pair< int, int > >::Fill(), TPZVec< std::pair< int, int > >::MigratePages(), TPZVec< std::pair< int, int > >::NElements(), TPZManVector< TPZPostProcVar, 20 >::operator=(), TPZVec< std::pair< int, int > >::operator=(), TPZVec< std::pair< int, int > >::operator[](), TPZStack< int, 100 >::Pop(), TPZVec< std::pair< int, int > >::Print(), TPZVec< std::pair< int, int > >::ReallocForNuma(), TPZManVector< TPZPostProcVar, 20 >::Resize(), TPZVec< std::pair< int, int > >::Resize(), TPZManVector< TPZPostProcVar, 20 >::Shrink(), TPZVec< std::pair< int, int > >::size(), TPZManVector< TPZPostProcVar, 20 >::TPZManVector(), and TPZVec< std::pair< int, int > >::TPZVec().
|
protected |
Allocated storage for the vector object.
Definition at line 230 of file pzvec.h.
Referenced by TPZVec< std::pair< int, int > >::begin(), TPZVec< std::pair< int, int > >::end(), TPZManVector< TPZPostProcVar, 20 >::Expand(), TPZVec< std::pair< int, int > >::Fill(), TPZVec< std::pair< int, int > >::MigratePages(), TPZStack< TVar, 1000 >::operator TVar *(), TPZManVector< TPZPostProcVar, 20 >::operator=(), TPZVec< std::pair< int, int > >::operator=(), TPZString::operator==(), TPZVec< std::pair< int, int > >::operator[](), TPZStack< int, 100 >::Pop(), TPZVec< std::pair< int, int > >::ReallocForNuma(), TPZManVector< TPZPostProcVar, 20 >::Resize(), TPZVec< std::pair< int, int > >::Resize(), TPZManVector< TPZPostProcVar, 20 >::Shrink(), TPZManVector< TPZPostProcVar, 20 >::TPZManVector(), TPZVec< std::pair< int, int > >::TPZVec(), TPZManVector< TPZPostProcVar, 20 >::~TPZManVector(), and TPZVec< std::pair< int, int > >::~TPZVec().