OOFEM  2.4
OOFEM.org - Object Oriented Finite Element Solver
oofem::FEInterpolation Class Referenceabstract

Class representing a general abstraction for finite element interpolation class. More...

#include <feinterpol.h>

+ Inheritance diagram for oofem::FEInterpolation:

Public Member Functions

 FEInterpolation (int o)
 
virtual ~FEInterpolation ()
 
virtual IRResultType initializeFrom (InputRecord *ir)
 Initializes receiver according to object description stored in input record. More...
 
virtual int giveNumberOfNodes () const
 Returns the number of geometric nodes of the receiver. More...
 
std::string errorInfo (const char *func) const
 
virtual integrationDomain giveIntegrationDomain () const =0
 Returns the integration domain of the interpolator. More...
 
virtual Element_Geometry_Type giveGeometryType () const =0
 Returns the geometry type fo the interpolator. More...
 
int giveInterpolationOrder ()
 Returns the interpolation order. More...
 
virtual void evalN (FloatArray &answer, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the array of interpolation functions (shape functions) at given point. More...
 
virtual double evaldNdx (FloatMatrix &answer, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the matrix of derivatives of interpolation functions (shape functions) at given point. More...
 
virtual void evald2Ndx2 (FloatMatrix &answer, const FloatArray &lcoords, const FEICellGeometry &cellgeo)
 Evaluates the matrix of second derivatives of interpolation functions (shape functions) at given point. More...
 
virtual void evaldNdxi (FloatMatrix &answer, const FloatArray &lcoords, const FEICellGeometry &cellgeo)
 Evaluates the matrix of derivatives of interpolation functions (shape functions) at given point. More...
 
virtual void giveLocalNodeCoords (FloatMatrix &answer)
 Returns a matrix containing the local coordinates for each node corresponding to the interpolation. More...
 
virtual void local2global (FloatArray &answer, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates global coordinates from given local ones. More...
 
virtual int global2local (FloatArray &answer, const FloatArray &gcoords, const FEICellGeometry &cellgeo)=0
 Evaluates local coordinates from given global ones. More...
 
virtual double giveTransformationJacobian (const FloatArray &lcoords, const FEICellGeometry &cellgeo)
 Evaluates the determinant of the transformation. More...
 
virtual void giveJacobianMatrixAt (FloatMatrix &jacobianMatrix, const FloatArray &lcoords, const FEICellGeometry &cellgeo)
 Gives the jacobian matrix at the local coordinates. More...
 
virtual IntegrationRulegiveIntegrationRule (int order)
 Sets up a suitable integration rule for numerical integrating over volume. More...
 
Edge boundary functions.

Provide interpolation services for boundary edges (entity of dimension 1)

virtual void boundaryEdgeEvalN (FloatArray &answer, int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the basis functions on the requested boundary. More...
 
virtual double boundaryEdgeGiveTransformationJacobian (int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the determinant of the transformation Jacobian on the requested boundary. More...
 
virtual void boundaryEdgeLocal2Global (FloatArray &answer, int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Maps the local boundary coordinates to global. More...
 
virtual integrationDomain giveBoundaryEdgeIntegrationDomain (int boundary) const =0
 Returns boundary integration domain. More...
 
virtual IntegrationRulegiveBoundaryEdgeIntegrationRule (int order, int boundary)
 Sets up a suitable integration rule for integrating over the requested boundary. More...
 
virtual void boundaryEdgeGiveNodes (IntArray &answer, int boundary)=0
 Gives the boundary nodes for requested boundary number. More...
 
Surface interpolation services

Provide interpolation services for boundary edges (entities of dimension 2)

virtual void boundarySurfaceEvalN (FloatArray &answer, int isurf, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the array of edge interpolation functions (shape functions) at given point. More...
 
virtual void boundarySurfaceEvaldNdx (FloatMatrix &answer, int isurf, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the matrix of derivatives of edge interpolation functions (shape functions) at given point. More...
 
virtual double boundarySurfaceEvalNormal (FloatArray &answer, int isurf, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the normal out of the surface at given point. More...
 
virtual void boundarySurfaceLocal2global (FloatArray &answer, int isurf, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates edge global coordinates from given local ones. More...
 
virtual double boundarySurfaceGiveTransformationJacobian (int isurf, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the edge jacobian of transformation between local and global coordinates. More...
 
virtual integrationDomain giveBoundarySurfaceIntegrationDomain (int boundary) const =0
 Returns boundary integration domain. More...
 
virtual IntegrationRulegiveBoundarySurfaceIntegrationRule (int order, int boundary)
 Sets up a suitable integration rule for integrating over the requested boundary. More...
 
virtual void boundarySurfaceGiveNodes (IntArray &answer, int boundary)=0
 Gives the boundary nodes for requested boundary number. More...
 
General boundary interpolation functions.

Provide interpolation servises for boundary entities with one dimension lower than the receiver interpolation.

Typically these are mapped to boundaryEdge and boundarySurface methods depending on dimension.

virtual void boundaryGiveNodes (IntArray &answer, int boundary)=0
 Gives the boundary nodes for requested boundary number. More...
 
virtual void boundaryEvalN (FloatArray &answer, int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the basis functions on the requested boundary. More...
 
virtual double boundaryEvalNormal (FloatArray &answer, int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the normal on the requested boundary. More...
 
virtual double boundaryGiveTransformationJacobian (int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Evaluates the determinant of the transformation Jacobian on the requested boundary. More...
 
virtual void boundaryLocal2Global (FloatArray &answer, int boundary, const FloatArray &lcoords, const FEICellGeometry &cellgeo)=0
 Maps the local boundary coordinates to global. More...
 
virtual double evalNXIntegral (int boundary, const FEICellGeometry &cellgeo)
 Computes the integral $ \int_S n \cdot x \mathrm{d}s $. More...
 
virtual integrationDomain giveBoundaryIntegrationDomain (int boundary) const =0
 Returns boundary integration domain. More...
 
virtual IntegrationRulegiveBoundaryIntegrationRule (int order, int boundary)
 Sets up a suitable integration rule for integrating over the requested boundary. More...
 
Methods to support interpolation defined on patch by patch basis.
virtual int giveKnotSpanBasisFuncMask (const IntArray &knotSpan, IntArray &mask)
 Returns indices (zero based) of nonzero basis functions for given knot span. More...
 
virtual int giveNumberOfKnotSpanBasisFunctions (const IntArray &knotSpan)
 Returns the number of nonzero basis functions at individual knot span,. More...
 
virtual bool hasSubPatchFormulation ()
 Returns true, if receiver is formulated on sub-patch basis. More...
 
virtual const double *const * giveKnotVector ()
 Returns the subdivision of patch parametric space. More...
 
virtual int giveNumberOfKnotSpans (int dim)
 Returns the number of knot spans of the receiver. More...
 
virtual const FloatArraygiveKnotValues (int dim)
 Returns the knot values of the receiver. More...
 
virtual const IntArraygiveKnotMultiplicity (int dim)
 Returns the knot multiplicity of the receiver. More...
 
virtual int giveNsd ()=0
 Returns number of spatial dimensions. More...
 
virtual int giveNumberOfEdges () const
 Returns number of edges. More...
 

Protected Attributes

int order
 

Detailed Description

Class representing a general abstraction for finite element interpolation class.

The boundary functions denote the (numbered) region that have 1 spatial dimension (i.e. edges) or 2 spatial dimensions.

Definition at line 132 of file feinterpol.h.

Constructor & Destructor Documentation

oofem::FEInterpolation::FEInterpolation ( int  o)
inline

Definition at line 138 of file feinterpol.h.

virtual oofem::FEInterpolation::~FEInterpolation ( )
inlinevirtual

Definition at line 141 of file feinterpol.h.

Member Function Documentation

virtual void oofem::FEInterpolation::boundaryEdgeEvalN ( FloatArray answer,
int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the basis functions on the requested boundary.

Only basis functions that are nonzero anywhere on the boundary are given. Ordering can be obtained from giveBoundaryNodes. Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
answerBasis functions Array to be filled with the boundary nodes.
boundaryBoundary number.
lcoordsThe local coordinates (on the boundary local coordinate system).
cellgeoUnderlying cell geometry.
Todo:

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEI1dLin, oofem::FEI1dQuad, and oofem::FEInterpolation3d.

Referenced by oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::MITC4Shell::computeEdgeNMatrix(), and oofem::StructuralElement::computeEdgeNMatrix().

virtual void oofem::FEInterpolation::boundaryEdgeGiveNodes ( IntArray answer,
int  boundary 
)
pure virtual

Gives the boundary nodes for requested boundary number.

Parameters
answerArray to be filled with the boundary nodes.
boundaryBoundary number.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEI2dLineLin, oofem::FEI1dLin, oofem::FEI1dQuad, and oofem::FEInterpolation3d.

Referenced by oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::Element::giveBoundaryEdgeNodes(), and oofem::Set::giveNodeList().

virtual double oofem::FEInterpolation::boundaryEdgeGiveTransformationJacobian ( int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the determinant of the transformation Jacobian on the requested boundary.

Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
boundaryBoundary number.
lcoordsThe local coordinates (on the boundary local coordinate system).
cellgeoUnderlying cell geometry.
Returns
The determinant of the boundary transformation Jacobian.

Implemented in oofem::BSplineInterpolation, oofem::FEI2dQuadQuadAxi, oofem::FEI2dQuadLinAxi, oofem::FEI2dTrLinAxi, oofem::FEInterpolation2d, oofem::FEI1dLin, oofem::FEI1dQuad, and oofem::FEInterpolation3d.

Referenced by oofem::StructuralElement::computeEdgeVolumeAround().

virtual void oofem::FEInterpolation::boundaryEdgeLocal2Global ( FloatArray answer,
int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Maps the local boundary coordinates to global.

Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
answerGlobal coordinates.
boundaryBoundary number.
lcoordsThe local coordinates (on the boundary local coordinate system).
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEI1dLin, oofem::FEI1dQuad, and oofem::FEInterpolation3d.

Referenced by oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), and oofem::TransportElement::computeEdgeBCSubVectorAt().

virtual void oofem::FEInterpolation::boundaryEvalN ( FloatArray answer,
int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the basis functions on the requested boundary.

Only basis functions that are nonzero anywhere on the boundary are given. Ordering can be obtained from giveBoundaryNodes. Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
answerBasis functions Array to be filled with the boundary nodes.
boundaryBoundary number.
lcoordsThe local coordinates (on the boundary local coordinate system).
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::PrescribedMean::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::PFEMElement2d::computeEdgeNMatrixAt(), oofem::PFEMElement2d::computeEgdeNVectorAt(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransportGradientNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), and oofem::MixedGradientPressureNeumann::integrateVolTangent().

virtual double oofem::FEInterpolation::boundaryEvalNormal ( FloatArray answer,
int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual
virtual void oofem::FEInterpolation::boundaryGiveNodes ( IntArray answer,
int  boundary 
)
pure virtual

Gives the boundary nodes for requested boundary number.

Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
answerArray to be filled with the boundary nodes.
boundaryBoundary number.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::PrescribedMean::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::Line::computeNumberOfIntersectionPoints(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransportGradientNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::Set::giveNodeList(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GeometryBasedEI::updateNodeEnrMarker(), and oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay().

virtual double oofem::FEInterpolation::boundaryGiveTransformationJacobian ( int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the determinant of the transformation Jacobian on the requested boundary.

Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
boundaryBoundary number.
lcoordsThe local coordinates (on the boundary local coordinate system).
cellgeoUnderlying cell geometry.
Returns
The determinant of the boundary transformation Jacobian.

Implemented in oofem::BSplineInterpolation, oofem::FEI2dQuadQuadAxi, oofem::FEI2dQuadLinAxi, oofem::FEI2dTrLinAxi, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::PrescribedMean::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::PrescribedMean::computeDomainSize(), oofem::PFEMElement2d::computeEdgeVolumeAround(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), and oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector().

virtual void oofem::FEInterpolation::boundaryLocal2Global ( FloatArray answer,
int  boundary,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Maps the local boundary coordinates to global.

Boundaries are defined as the corner nodes for 1D geometries, edges for 2D geometries and surfaces for 3D geometries.

Parameters
answerGlobal coordinates.
boundaryBoundary number.
lcoordsThe local coordinates (on the boundary local coordinate system).
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::TransportGradientNeumann::computeEta(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), and oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent().

virtual void oofem::FEInterpolation::boundarySurfaceEvaldNdx ( FloatMatrix answer,
int  isurf,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the matrix of derivatives of edge interpolation functions (shape functions) at given point.

These derivatives are in global coordinate system (where the nodal coordinates are defined).

Parameters
answerContains resulting matrix of derivatives, the member at i,j position contains value of dNj/dxi.
isurfDetermines the surface number.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

virtual void oofem::FEInterpolation::boundarySurfaceEvalN ( FloatArray answer,
int  isurf,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the array of edge interpolation functions (shape functions) at given point.

Parameters
answerContains resulting array of evaluated interpolation functions.
isurfSurface number.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::QDKTPlate::computeSurfaceNMatrix(), oofem::MITC4Shell::computeSurfaceNMatrix(), and oofem::StructuralElement::computeSurfaceNMatrix().

virtual double oofem::FEInterpolation::boundarySurfaceEvalNormal ( FloatArray answer,
int  isurf,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the normal out of the surface at given point.

Parameters
answerContains resulting normal vector.
isurfDetermines the surface number.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.
Returns
Surface mapping jacobian.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

virtual void oofem::FEInterpolation::boundarySurfaceGiveNodes ( IntArray answer,
int  boundary 
)
pure virtual

Gives the boundary nodes for requested boundary number.

Parameters
answerArray to be filled with the boundary nodes.
boundaryBoundary number.

Implemented in oofem::FEInterpolation3d, oofem::BSplineInterpolation, oofem::FEInterpolation2d, and oofem::FEInterpolation1d.

Referenced by oofem::Element::giveBoundarySurfaceNodes(), and oofem::Set::giveNodeList().

virtual double oofem::FEInterpolation::boundarySurfaceGiveTransformationJacobian ( int  isurf,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the edge jacobian of transformation between local and global coordinates.

Parameters
isurfDetermines the surface number.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.
Returns
Determinant of the transformation.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::StructuralElement::computeSurfaceVolumeAround().

virtual void oofem::FEInterpolation::boundarySurfaceLocal2global ( FloatArray answer,
int  isurf,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates edge global coordinates from given local ones.

These derivatives are in global coordinate system (where the nodal coordinates are defined).

Parameters
answerContains resulting global coordinates.
isurfDetermines the surface number.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEInterpolation2d, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Referenced by oofem::TransportElement::computeSurfaceBCSubVectorAt().

std :: string oofem::FEInterpolation::errorInfo ( const char *  func) const
inline

Definition at line 490 of file feinterpol.h.

virtual void oofem::FEInterpolation::evald2Ndx2 ( FloatMatrix answer,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
inlinevirtual

Evaluates the matrix of second derivatives of interpolation functions (shape functions) at given point.

These derivatives are in global coordinate system (where the nodal coordinates are defined)

Parameters
answerContains resulting matrix of derivatives, the member at i,j position contains value of dNi/dxj.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.

Reimplemented in oofem::FEI1dHermite, oofem::FEI3dLineLin, and oofem::FEI2dTrQuad.

Definition at line 183 of file feinterpol.h.

References OOFEM_ERROR.

virtual double oofem::FEInterpolation::evaldNdx ( FloatMatrix answer,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the matrix of derivatives of interpolation functions (shape functions) at given point.

These derivatives are in global coordinate system (where the nodal coordinates are defined)

Parameters
answerContains resulting matrix of derivatives, the member at i,j position contains value of dNi/dxj.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.
Returns
Determinant of the Jacobian.

Implemented in oofem::BSplineInterpolation, oofem::FEI3dHexaQuad, oofem::TSplineInterpolation, oofem::FEI2dLineQuad, oofem::FEI2dLineHermite, oofem::FEI2dLineLin, oofem::FEI2dQuadQuad, oofem::FEI3dWedgeLin, oofem::FEI1dLin, oofem::FEI1dQuad, oofem::FEI3dWedgeQuad, oofem::FEI3dTrQuad, oofem::FEI1dHermite, oofem::FEI3dTetQuad, oofem::FEI3dTrLin, oofem::FEI2dQuadLin, oofem::FEI3dLineLin, oofem::FEI2dTrLin, oofem::FEI2dTrQuad, oofem::FEI2dQuadConst, oofem::FEI2dTrConst, oofem::FEI3dHexaLin, oofem::FEI3dTetLin, and oofem::NURBSInterpolation.

Referenced by oofem::FEInterpolation2d::boundarySurfaceEvaldNdx(), oofem::PhaseFieldElement::computeBd_matrixAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::PFEMElement2d::computeBMatrix(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::TransportElement::computeBmatrixAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::WeakPeriodicBoundaryCondition::computeDeformationGradient(), oofem::tet21ghostsolid::computeDeformationGradientVectorAt(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::TransportElement::computeGradientMatrixAt(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::PFEMElement2d::computePressureLaplacianMatrix(), oofem::GeometryBasedEI::evaluateEnrFuncDerivAt(), and oofem::Shell7Base::giveZ2integratedPolynomial2GradientForStressRecAt().

virtual void oofem::FEInterpolation::evaldNdxi ( FloatMatrix answer,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
inlinevirtual
virtual void oofem::FEInterpolation::evalN ( FloatArray answer,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates the array of interpolation functions (shape functions) at given point.

Parameters
answerContains resulting array of evaluated interpolation functions.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEI3dHexaQuad, oofem::TSplineInterpolation, oofem::FEI2dLineQuad, oofem::FEI2dLineHermite, oofem::FEI2dLineLin, oofem::FEI2dQuadQuad, oofem::FEI3dWedgeLin, oofem::FEI1dLin, oofem::FEI1dQuad, oofem::FEI3dWedgeQuad, oofem::FEI2dQuadBiQuad, oofem::FEI3dTrQuad, oofem::FEI1dHermite, oofem::FEI3dTetQuad, oofem::FEI3dTrLin, oofem::FEI2dQuadLin, oofem::FEI3dLineLin, oofem::FEI2dTrLin, oofem::FEI2dTrQuad, oofem::FEI3dHexaTriQuad, oofem::FEI2dQuadConst, oofem::FEI2dTrConst, oofem::FEI3dHexaLin, oofem::FEI3dTetLin, and oofem::NURBSInterpolation.

Referenced by oofem::PrescribedMean::assemble(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::FEInterpolation2d::boundarySurfaceEvalN(), oofem::AxisymElement::computeBHmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::PhaseFieldElement::computeDamageAt(), oofem::IntElLine1PF::computeDamageAt(), oofem::StructuralInterfaceElementPhF::computeDamageAt(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::GeometryBasedEI::computeIntersectionPoints(), oofem::TransportElement::computeLoadVector(), oofem::TransportElement::computeNAt(), oofem::XfemElementInterface::computeNCohesive(), oofem::PhaseFieldElement::computeNd_matrixAt(), oofem::StructuralInterfaceElementPhF::computeNd_matrixAt(), oofem::IntElLine1PF::computeNd_vectorAt(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeNMatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::QDKTPlate::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::Shell7Base::evalInitialDirectorAt(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::DofManValueField::evaluateAt(), oofem::GeometryBasedEI::evaluateEnrFuncAt(), oofem::GeometryBasedEI::evaluateEnrFuncDerivAt(), oofem::GeometryBasedEI::evaluateEnrFuncJumps(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_d(), oofem::Shell7Base::giveL2contribution(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::MMAShapeFunctProjection::interpolateIntVarAt(), oofem::Inclusion::isMaterialModified(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::EnrichmentItem::tipIsTouchingEI(), oofem::Shell7Base::vtkEvalInitialGlobalCoordinateAt(), oofem::Shell7Base::vtkEvalInitialGlobalCZCoordinateAt(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::Shell7Base::ZZNodalRecoveryMI_ComputeEstimatedInterpolationMtrx(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNValProduct().

IntegrationRule * oofem::FEInterpolation::giveBoundaryEdgeIntegrationRule ( int  order,
int  boundary 
)
virtual

Sets up a suitable integration rule for integrating over the requested boundary.

The required polynomial order for the determinant of the jacobian is added automatically.

Parameters
orderPolynomial order of the integrand (should NOT including determinant of jacobian).
boundaryBoundary number.

Reimplemented in oofem::BSplineInterpolation, oofem::FEInterpolation3d, and oofem::FEInterpolation1d.

Definition at line 74 of file feinterpol.C.

References oofem::IntegrationRule::getRequiredNumberOfIntegrationPoints(), and oofem::IntegrationRule::setUpIntegrationPoints().

Referenced by oofem::QuadAxisym1_ht::giveBoundaryEdgeIntegrationRule(), and oofem::Element::giveBoundaryEdgeIntegrationRule().

IntegrationRule * oofem::FEInterpolation::giveBoundaryIntegrationRule ( int  order,
int  boundary 
)
virtual

Sets up a suitable integration rule for integrating over the requested boundary.

The required polynomial order for the determinant of the jacobian is added automatically.

Parameters
orderPolynomial order of the integrand (should NOT including determinant of jacobian).
boundaryBoundary number.

Reimplemented in oofem::BSplineInterpolation, oofem::FEInterpolation3d, oofem::FEI3dHexaQuad, oofem::FEI3dTrQuad, oofem::FEI3dTetQuad, oofem::FEI3dTrLin, oofem::FEI3dWedgeLin, oofem::FEI3dWedgeQuad, oofem::FEInterpolation1d, oofem::FEI3dTetLin, oofem::FEI3dHexaLin, oofem::FEI3dLineLin, and oofem::FEI3dHexaTriQuad.

Definition at line 63 of file feinterpol.C.

References oofem::IntegrationRule::getRequiredNumberOfIntegrationPoints(), and oofem::IntegrationRule::setUpIntegrationPoints().

Referenced by oofem::PrescribedMean::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::PrescribedMean::computeDomainSize(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::TransportGradientNeumann::computeEta(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::TransportGradientNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionDev(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionXTangent(), and oofem::MixedGradientPressureNeumann::integrateVolTangent().

IntegrationRule * oofem::FEInterpolation::giveBoundarySurfaceIntegrationRule ( int  order,
int  boundary 
)
virtual

Sets up a suitable integration rule for integrating over the requested boundary.

The required polynomial order for the determinant of the jacobian is added automatically.

Parameters
orderPolynomial order of the integrand (should NOT including determinant of jacobian).
boundaryBoundary number.

Definition at line 85 of file feinterpol.C.

References oofem::IntegrationRule::getRequiredNumberOfIntegrationPoints(), and oofem::IntegrationRule::setUpIntegrationPoints().

Referenced by oofem::QuadAxisym1_ht::giveBoundarySurfaceIntegrationRule(), and oofem::Element::giveBoundarySurfaceIntegrationRule().

virtual void oofem::FEInterpolation::giveJacobianMatrixAt ( FloatMatrix jacobianMatrix,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
inlinevirtual
virtual const IntArray* oofem::FEInterpolation::giveKnotMultiplicity ( int  dim)
inlinevirtual

Returns the knot multiplicity of the receiver.

Reimplemented in oofem::BSplineInterpolation.

Definition at line 471 of file feinterpol.h.

Referenced by oofem::IGAElement::initializeFrom(), and oofem::IGATSplineElement::initializeFrom().

virtual int oofem::FEInterpolation::giveKnotSpanBasisFuncMask ( const IntArray knotSpan,
IntArray mask 
)
inlinevirtual

Returns indices (zero based) of nonzero basis functions for given knot span.

The knot span identifies the sub-region of the finite element.

Returns
Nonzero if mask is provided, zero otherwise meaning that all basis functions are generally nonzero.

Reimplemented in oofem::BSplineInterpolation, and oofem::TSplineInterpolation.

Definition at line 444 of file feinterpol.h.

Referenced by oofem::StructuralElementEvaluator::giveIntegrationElementLocalCodeNumbers().

virtual const FloatArray* oofem::FEInterpolation::giveKnotValues ( int  dim)
inlinevirtual

Returns the knot values of the receiver.

Reimplemented in oofem::BSplineInterpolation.

Definition at line 467 of file feinterpol.h.

Referenced by oofem::IGAElement::initializeFrom(), and oofem::IGATSplineElement::initializeFrom().

virtual const double* const* oofem::FEInterpolation::giveKnotVector ( )
inlinevirtual
virtual void oofem::FEInterpolation::giveLocalNodeCoords ( FloatMatrix answer)
inlinevirtual

Returns a matrix containing the local coordinates for each node corresponding to the interpolation.

Reimplemented in oofem::FEI3dWedgeQuad, and oofem::FEI3dTrQuad.

Definition at line 199 of file feinterpol.h.

References OOFEM_ERROR.

Referenced by oofem::Shell7Base::setupInitialNodeDirectors().

virtual int oofem::FEInterpolation::giveNumberOfKnotSpanBasisFunctions ( const IntArray knotSpan)
inlinevirtual

Returns the number of nonzero basis functions at individual knot span,.

Returns
Zero in case of all basis functions generally nonzero, answer otherwise.

Reimplemented in oofem::BSplineInterpolation, and oofem::TSplineInterpolation.

Definition at line 449 of file feinterpol.h.

virtual int oofem::FEInterpolation::giveNumberOfKnotSpans ( int  dim)
inlinevirtual

Returns the number of knot spans of the receiver.

Reimplemented in oofem::BSplineInterpolation.

Definition at line 463 of file feinterpol.h.

Referenced by oofem::IGAElement::initializeFrom(), and oofem::IGATSplineElement::initializeFrom().

double oofem::FEInterpolation::giveTransformationJacobian ( const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
virtual

Evaluates the determinant of the transformation.

Parameters
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.
Returns
Determinant of the transformation.

Reimplemented in oofem::FEI2dQuadQuadAxi, oofem::FEI2dQuadLinAxi, oofem::FEI2dTrLinAxi, oofem::FEI2dLineQuad, oofem::FEI2dLineLin, oofem::FEI3dWedgeLin, oofem::FEI2dLineHermite, oofem::FEI1dLin, oofem::FEI1dQuad, oofem::FEI3dWedgeQuad, oofem::FEI1dHermite, oofem::FEI3dLineLin, oofem::FEI2dTrLin, oofem::FEI2dTrConst, and oofem::FEI3dTetLin.

Definition at line 43 of file feinterpol.C.

References oofem::FloatMatrix::giveDeterminant().

Referenced by oofem::PrescribedMean::assemble(), oofem::FEInterpolation2d::boundarySurfaceEvalNormal(), oofem::FEInterpolation2d::boundarySurfaceGiveTransformationJacobian(), oofem::NLStructuralElement::computeCurrentVolume(), oofem::PrescribedMean::computeDomainSize(), oofem::SolidShell::computeEASBmatrixAt(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::QuadAxisym1_ht::computeVolumeAround(), oofem::Quad1_ht::computeVolumeAround(), oofem::Brick1_ht::computeVolumeAround(), oofem::QBrick1_ht::computeVolumeAround(), oofem::Tr21Stokes::computeVolumeAround(), oofem::Quad1PlateSubSoil::computeVolumeAround(), oofem::tet21ghostsolid::computeVolumeAround(), oofem::Quad1Mindlin::computeVolumeAround(), oofem::Quad1MindlinShell3D::computeVolumeAround(), oofem::QDKTPlate::computeVolumeAround(), oofem::TR21_2D_SUPG::computeVolumeAround(), oofem::Quad10_2D_SUPG::computeVolumeAround(), oofem::TR1_2D_SUPG2_AXI::computeVolumeAroundID(), oofem::TR1_2D_SUPG2::computeVolumeAroundID(), oofem::NeumannMomentLoad::computeXbar(), oofem::MatlabExportModule::doOutputHomogenizeDofIDs(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::FEI2dQuadLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::giveTransformationJacobian(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), and oofem::TR21_2D_SUPG::LS_PCS_computeVolume().

virtual int oofem::FEInterpolation::global2local ( FloatArray answer,
const FloatArray gcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates local coordinates from given global ones.

If local coordinates cannot be found (generate elements, or point far outside geometry, then the center coordinate will be used as a last resort, and the return value will be zero.

Parameters
answerContains evaluated local coordinates.
gcoordsArray containing global coordinates.
cellgeoUnderlying cell geometry.
Returns
Nonzero is returned if point is within the element geometry, zero otherwise.

Implemented in oofem::BSplineInterpolation, oofem::FEI3dHexaQuad, oofem::TSplineInterpolation, oofem::FEInterpolation2d, oofem::FEI3dWedgeLin, oofem::FEI1dLin, oofem::FEI1dQuad, oofem::FEI3dWedgeQuad, oofem::FEI1dHermite, oofem::FEI2dLineHermite, oofem::FEI3dTrQuad, oofem::FEI2dLineQuad, oofem::FEI3dLineLin, oofem::FEI3dTetQuad, oofem::FEI3dTrLin, oofem::FEI2dLineLin, oofem::FEI2dQuadLin, oofem::FEI2dTrLin, oofem::FEI2dTrConst, oofem::FEI3dHexaLin, oofem::FEI3dTetLin, and oofem::NURBSInterpolation.

Referenced by oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::Element::computeLocalCoordinates(), oofem::NeumannMomentLoad::computeValueAtBoundary(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::DofManValueField::evaluateAt(), oofem::UnstructuredGridField::Cell::giveClosestPoint(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), and oofem::SpatialLocalizerInterface::SpatialLocalizerI_giveClosestPoint().

virtual bool oofem::FEInterpolation::hasSubPatchFormulation ( )
inlinevirtual
virtual IRResultType oofem::FEInterpolation::initializeFrom ( InputRecord ir)
inlinevirtual

Initializes receiver according to object description stored in input record.

Reimplemented in oofem::BSplineInterpolation, and oofem::TSplineInterpolation.

Definition at line 143 of file feinterpol.h.

References oofem::IRRT_OK.

Referenced by oofem::IGAElement::initializeFrom(), and oofem::IGATSplineElement::initializeFrom().

virtual void oofem::FEInterpolation::local2global ( FloatArray answer,
const FloatArray lcoords,
const FEICellGeometry cellgeo 
)
pure virtual

Evaluates global coordinates from given local ones.

Parameters
answerContains resulting global coordinates.
lcoordsArray containing (local) coordinates.
cellgeoUnderlying cell geometry.

Implemented in oofem::BSplineInterpolation, oofem::FEI3dHexaQuad, oofem::TSplineInterpolation, oofem::FEI2dQuadQuad, oofem::FEI3dWedgeLin, oofem::FEI1dLin, oofem::FEI1dQuad, oofem::FEI3dWedgeQuad, oofem::FEI1dHermite, oofem::FEI2dLineHermite, oofem::FEI3dTrQuad, oofem::FEI2dLineQuad, oofem::FEI3dLineLin, oofem::FEI3dTetQuad, oofem::FEI3dTrLin, oofem::FEI2dLineLin, oofem::FEI2dQuadLin, oofem::FEI2dTrQuad, oofem::FEI2dTrLin, oofem::FEI2dQuadConst, oofem::FEI2dTrConst, oofem::FEI3dHexaLin, oofem::FEI3dTetLin, and oofem::NURBSInterpolation.

Referenced by oofem::FEInterpolation2d::boundarySurfaceLocal2global(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Element::computeGlobalCoordinates(), oofem::TransportElement::computeLoadVector(), oofem::NeumannMomentLoad::computeXbar(), oofem::drawIGAPatchDeformedGeometry(), oofem::IGAElement::drawRawGeometry(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::UnstructuredGridField::Cell::giveClosestPoint(), oofem::FEInterpolation2d::global2local(), oofem::SpatialLocalizerInterface::SpatialLocalizerI_giveClosestPoint(), oofem::TR1_2D_SUPG2_AXI::updateIntegrationRules(), and oofem::TR1_2D_SUPG2::updateIntegrationRules().

Member Data Documentation

int oofem::FEInterpolation::order
protected

Definition at line 135 of file feinterpol.h.


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

This page is part of the OOFEM documentation. Copyright (c) 2011 Borek Patzak
Project e-mail: info@oofem.org
Generated at Tue Jan 2 2018 20:07:35 for OOFEM by doxygen 1.8.11 written by Dimitri van Heesch, © 1997-2011