KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
Public Types | Public Member Functions | List of all members
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > Class Template Reference

A sinlge quadrature point, that can be used for geometries without a predefined integration scheme, i.e. they can handle material point elements, isogeometric analysis elements or standard finite elements which are defined at a single quadrature point. This point defines a line segment described on a underlying surface. Shape functions and integration types have to be precomputed and are set from from outside. The parent pointer can provide the adress to the owner of this quadrature point. More...

#include <quadrature_point_geometry.h>

Inheritance diagram for Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >:
Collaboration diagram for Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >:

Public Types

typedef Geometry< TPointType > BaseType
 
typedef Geometry< TPointType > GeometryType
 
typedef GeometryType::IndexType IndexType
 
typedef GeometryType::SizeType SizeType
 
typedef GeometryType::PointsArrayType PointsArrayType
 
typedef GeometryType::CoordinatesArrayType CoordinatesArrayType
 
typedef GeometryType::IntegrationPointType IntegrationPointType
 
typedef GeometryType::IntegrationPointsArrayType IntegrationPointsArrayType
 
typedef GeometryData::ShapeFunctionsGradientsType ShapeFunctionsGradientsType
 
typedef GeometryShapeFunctionContainer< GeometryData::IntegrationMethodGeometryShapeFunctionContainerType
 
typedef GeometryType::IntegrationPointsContainerType IntegrationPointsContainerType
 
typedef GeometryType::ShapeFunctionsValuesContainerType ShapeFunctionsValuesContainerType
 
typedef GeometryType::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
 
- Public Types inherited from Kratos::Geometry< TPointType >
enum class  QualityCriteria {
  INRADIUS_TO_CIRCUMRADIUS , AREA_TO_LENGTH , SHORTEST_ALTITUDE_TO_LENGTH , INRADIUS_TO_LONGEST_EDGE ,
  SHORTEST_TO_LONGEST_EDGE , REGULARITY , VOLUME_TO_SURFACE_AREA , VOLUME_TO_EDGE_LENGTH ,
  VOLUME_TO_AVERAGE_EDGE_LENGTH , VOLUME_TO_RMS_EDGE_LENGTH , MIN_DIHEDRAL_ANGLE , MAX_DIHEDRAL_ANGLE ,
  MIN_SOLID_ANGLE
}
 
enum class  LumpingMethods { ROW_SUM , DIAGONAL_SCALING , QUADRATURE_ON_NODES }
 This defines the different methods to compute the lumping methods. More...
 
typedef Geometry< TPointType > GeometryType
 This Geometry type. More...
 
typedef PointerVector< TPointType > PointsArrayType
 
typedef GeometryData::IntegrationMethod IntegrationMethod
 
typedef PointerVector< GeometryTypeGeometriesArrayType
 
typedef TPointType PointType
 
typedef std::size_t IndexType
 
typedef std::size_t SizeType
 
typedef PointType::CoordinatesArrayType CoordinatesArrayType
 
typedef IntegrationPoint< 3 > IntegrationPointType
 
typedef std::vector< IntegrationPointTypeIntegrationPointsArrayType
 
typedef std::array< IntegrationPointsArrayType, static_cast< int >GeometryData::IntegrationMethod::NumberOfIntegrationMethods)> IntegrationPointsContainerType
 
typedef std::array< Matrix, static_cast< int >GeometryData::IntegrationMethod::NumberOfIntegrationMethods)> ShapeFunctionsValuesContainerType
 
typedef GeometryData::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
 
typedef DenseVector< MatrixJacobiansType
 
typedef GeometryData::ShapeFunctionsGradientsType ShapeFunctionsGradientsType
 
typedef GeometryData::ShapeFunctionsSecondDerivativesType ShapeFunctionsSecondDerivativesType
 
typedef GeometryData::ShapeFunctionsThirdDerivativesType ShapeFunctionsThirdDerivativesType
 
typedef DenseVector< doubleNormalType
 
typedef PointType::Pointer PointPointerType
 data type stores in this container. More...
 
typedef const PointPointerType ConstPointPointerType
 
typedef TPointType & PointReferenceType
 
typedef const TPointType & ConstPointReferenceType
 
typedef std::vector< PointPointerTypePointPointerContainerType
 
typedef PointsArrayType::iterator iterator
 PointsArrayType typedefs. More...
 
typedef PointsArrayType::const_iterator const_iterator
 
typedef PointsArrayType::ptr_iterator ptr_iterator
 
typedef PointsArrayType::ptr_const_iterator ptr_const_iterator
 
typedef PointsArrayType::difference_type difference_type
 

Public Member Functions

 KRATOS_CLASS_POINTER_DEFINITION (QuadraturePointGeometry)
 Pointer definition of QuadraturePointGeometry. More...
 
JacobiansTypeJacobian (JacobiansType &rResult) const
 using base class functions More...
 
virtual JacobiansTypeJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod) const
 using base class functions More...
 
virtual JacobiansTypeJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod, Matrix &DeltaPosition) const
 using base class functions More...
 
MatrixJacobian (Matrix &rResult, IndexType IntegrationPointIndex) const
 using base class functions More...
 
virtual MatrixJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 using base class functions More...
 
virtual MatrixJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod, const Matrix &rDeltaPosition) const
 using base class functions More...
 
virtual MatrixJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const
 using base class functions More...
 
virtual MatrixJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates, Matrix &rDeltaPosition) const
 using base class functions More...
 
VectorDeterminantOfJacobian (Vector &rResult) const
 
virtual VectorDeterminantOfJacobian (Vector &rResult, IntegrationMethod ThisMethod) const
 
double DeterminantOfJacobian (IndexType IntegrationPointIndex) const
 
virtual double DeterminantOfJacobian (IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
virtual double DeterminantOfJacobian (const CoordinatesArrayType &rPoint) const
 
const MatrixShapeFunctionsValues () const
 
virtual VectorShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType &rCoordinates) const
 
const MatrixShapeFunctionsValues (IntegrationMethod ThisMethod) const
 
const ShapeFunctionsGradientsTypeShapeFunctionsLocalGradients () const
 
const ShapeFunctionsGradientsTypeShapeFunctionsLocalGradients (IntegrationMethod ThisMethod) const
 
virtual MatrixShapeFunctionsLocalGradients (Matrix &rResult, const CoordinatesArrayType &rPoint) const
 
JacobiansTypeInverseOfJacobian (JacobiansType &rResult) const
 
virtual JacobiansTypeInverseOfJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod) const
 
MatrixInverseOfJacobian (Matrix &rResult, IndexType IntegrationPointIndex) const
 
virtual MatrixInverseOfJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
virtual MatrixInverseOfJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const
 
Life Cycle
 QuadraturePointGeometry (const PointsArrayType &ThisPoints, const IntegrationPointsContainerType &rIntegrationPoints, const ShapeFunctionsValuesContainerType &rShapeFunctionValues, const ShapeFunctionsLocalGradientsContainerType &rShapeFunctionsDerivativesVector)
 Constructor with points and all shape function containers separately. More...
 
 QuadraturePointGeometry (const PointsArrayType &ThisPoints, const IntegrationPointsContainerType &rIntegrationPoints, const ShapeFunctionsValuesContainerType &rShapeFunctionValues, const ShapeFunctionsLocalGradientsContainerType &rShapeFunctionsDerivativesVector, GeometryType *pGeometryParent)
 Constructor with points and all shape function containers separately including the parent. More...
 
 QuadraturePointGeometry (const PointsArrayType &ThisPoints, const GeometryShapeFunctionContainerType &ThisGeometryShapeFunctionContainer)
 Constructor with points and geometry shape function container. More...
 
 QuadraturePointGeometry (const PointsArrayType &ThisPoints, const GeometryShapeFunctionContainerType &ThisGeometryShapeFunctionContainer, GeometryType *pGeometryParent)
 Constructor with points, geometry shape function container, parent. More...
 
 QuadraturePointGeometry (const PointsArrayType &ThisPoints, const IntegrationPointType &ThisIntegrationPoint, const Matrix &ThisShapeFunctionsValues, const DenseVector< Matrix > &ThisShapeFunctionsDerivatives)
 Constructor with points, N, Vector<DN_De, ...> More...
 
 QuadraturePointGeometry (const PointsArrayType &ThisPoints, const IntegrationPointType &ThisIntegrationPoint, const Matrix &ThisShapeFunctionsValues, const DenseVector< Matrix > &ThisShapeFunctionsDerivatives, GeometryType *pGeometryParent)
 Constructor with points, N, Vector<DN_De, ...>, parent. More...
 
 QuadraturePointGeometry (const PointsArrayType &ThisPoints)=delete
 Constructor. More...
 
 QuadraturePointGeometry (const IndexType GeometryId, const PointsArrayType &ThisPoints)
 Constructor with Geometry Id. More...
 
 QuadraturePointGeometry (const std::string &GeometryName, const PointsArrayType &ThisPoints)
 Constructor with Geometry Name. More...
 
 ~QuadraturePointGeometry () override=default
 Destructor. More...
 
 QuadraturePointGeometry (QuadraturePointGeometry const &rOther)
 Copy constructor. More...
 
Operators
QuadraturePointGeometryoperator= (const QuadraturePointGeometry &rOther)
 Assignment operator. More...
 
Operations
BaseType::Pointer Create (PointsArrayType const &ThisPoints) const override
 Creates a new geometry pointer. More...
 
BaseType::Pointer Create (const IndexType NewGeometryId, PointsArrayType const &rThisPoints) const override
 Creates a new geometry pointer. More...
 
BaseType::Pointer Create (const IndexType NewGeometryId, const BaseType &rGeometry) const override
 Creates a new geometry pointer. More...
 
Dynamic access to internals
void Calculate (const Variable< array_1d< double, 3 >> &rVariable, array_1d< double, 3 > &rOutput) const override
 Calculate with array_1d<double, 3> More...
 
void Calculate (const Variable< Vector > &rVariable, Vector &rOutput) const override
 Calculate with Vector. More...
 
Geometry Shape Function Container
void SetGeometryShapeFunctionContainer (const GeometryShapeFunctionContainer< GeometryData::IntegrationMethod > &rGeometryShapeFunctionContainer) override
 
Parent
GeometryTypeGetGeometryParent (IndexType Index) const override
 Some geometries require relations to other geometries. This is the case for e.g. quadrature points. To reach the parent geometry this function can be used. More...
 
void SetGeometryParent (GeometryType *pGeometryParent) override
 Some geometries require relations to other geometries. This is the case for e.g. quadrature points. To set or change the parent geometry this function can be used. More...
 
Geometrical Operations
double DomainSize () const override
 Returns the domain size of this quadrature point. More...
 
Point Center () const override
 Calculates global location of this integration point. More...
 
Mathematical Informations
SizeType PolynomialDegree (IndexType LocalDirectionIndex) const override
 Returns the polynomial degree of the parent geometry. More...
 
Coordinates
CoordinatesArrayTypeGlobalCoordinates (CoordinatesArrayType &rResult, CoordinatesArrayType const &LocalCoordinates) const override
 
CoordinatesArrayTypeGlobalCoordinates (CoordinatesArrayType &rResult, CoordinatesArrayType const &LocalCoordinates, Matrix &DeltaPosition) const override
 
Jacobian
MatrixJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const override
 Jacobian in given point. Computed on parent geometry. Error if Parent is not assigned is only thrown in debug mode. More...
 
double DeterminantOfJacobian (const CoordinatesArrayType &rPoint) const override
 
VectorDeterminantOfJacobianParent (Vector &rResult) const
 
MatrixInverseOfJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const override
 
Shape Function
VectorShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType &rCoordinates) const override
 
virtual MatrixShapeFunctionsLocalGradients (Matrix &rResult, const CoordinatesArrayType &rPoint) const override
 
Kratos Geometry Families
GeometryData::KratosGeometryFamily GetGeometryFamily () const override
 
GeometryData::KratosGeometryType GetGeometryType () const override
 
Input and output
std::string Info () const override
 Turn back information as a string. More...
 
void PrintInfo (std::ostream &rOStream) const override
 Print information about this object. More...
 
void PrintData (std::ostream &rOStream) const override
 Print object's data. More...
 
- Public Member Functions inherited from Kratos::Geometry< TPointType >
 Geometry ()
 Standard Constructor. Generates self assigned id. More...
 
 Geometry (IndexType GeomertyId)
 Standard Constructor with a geometry Id. More...
 
 Geometry (const std::string &GeometryName)
 Standard Constructor with a Name. More...
 
 Geometry (const PointsArrayType &ThisPoints, GeometryData const *pThisGeometryData=&GeometryDataInstance())
 
 Geometry (IndexType GeometryId, const PointsArrayType &ThisPoints, GeometryData const *pThisGeometryData=&GeometryDataInstance())
 
 Geometry (const std::string &GeometryName, const PointsArrayType &ThisPoints, GeometryData const *pThisGeometryData=&GeometryDataInstance())
 
 Geometry (const Geometry &rOther)
 Copy constructor. More...
 
template<class TOtherPointType >
 Geometry (Geometry< TOtherPointType > const &rOther)
 Copy constructor with TOtherPointType. More...
 
virtual ~Geometry ()
 Destructor. Do nothing!!! More...
 
Geometryoperator= (const Geometry &rOther)
 
template<class TOtherPointType >
Geometryoperator= (Geometry< TOtherPointType > const &rOther)
 
 operator PointsArrayType & ()
 
TPointType & operator[] (const SizeType &i)
 
TPointType const & operator[] (const SizeType &i) const
 
PointPointerTypeoperator() (const SizeType &i)
 
ConstPointPointerTypeoperator() (const SizeType &i) const
 
iterator begin ()
 
const_iterator begin () const
 
iterator end ()
 
const_iterator end () const
 
ptr_iterator ptr_begin ()
 
ptr_const_iterator ptr_begin () const
 
ptr_iterator ptr_end ()
 
ptr_const_iterator ptr_end () const
 
PointReferenceType front ()
 
ConstPointReferenceType front () const
 
PointReferenceType back ()
 
ConstPointReferenceType back () const
 
SizeType size () const
 
SizeType PointsNumber () const
 
virtual SizeType PointsNumberInDirection (IndexType LocalDirectionIndex) const
 Returns number of points per direction. More...
 
SizeType max_size () const
 
void swap (GeometryType &rOther)
 
void push_back (PointPointerType x)
 
void clear ()
 
void reserve (int dim)
 
int capacity ()
 
PointPointerContainerTypeGetContainer ()
 ‍** Gives a reference to underly normal container. *‍/ More...
 
const PointPointerContainerTypeGetContainer () const
 
DataValueContainerGetData ()
 
DataValueContainer const & GetData () const
 
void SetData (DataValueContainer const &rThisData)
 
template<class TDataType >
bool Has (const Variable< TDataType > &rThisVariable) const
 
template<class TVariableType >
void SetValue (const TVariableType &rThisVariable, typename TVariableType::Type const &rValue)
 
template<class TVariableType >
TVariableType::Type & GetValue (const TVariableType &rThisVariable)
 
template<class TVariableType >
TVariableType::Type const & GetValue (const TVariableType &rThisVariable) const
 
virtual void Assign (const Variable< bool > &rVariable, const bool Input)
 Assign with bool. More...
 
virtual void Assign (const Variable< int > &rVariable, const int Input)
 Assign with int. More...
 
virtual void Assign (const Variable< double > &rVariable, const double Input)
 Assign with double. More...
 
virtual void Assign (const Variable< array_1d< double, 2 >> &rVariable, const array_1d< double, 2 > &rInput)
 Assign with array_1d<double, 2> More...
 
virtual void Assign (const Variable< array_1d< double, 3 >> &rVariable, const array_1d< double, 3 > &rInput)
 Assign with array_1d<double, 3> More...
 
virtual void Assign (const Variable< array_1d< double, 6 >> &rVariable, const array_1d< double, 6 > &rInput)
 Assign with array_1d<double, 6> More...
 
virtual void Assign (const Variable< Vector > &rVariable, const Vector &rInput)
 Assign with Vector. More...
 
virtual void Assign (const Variable< Matrix > &rVariable, const Matrix &rInput)
 Assign with Matrix. More...
 
virtual void Calculate (const Variable< bool > &rVariable, bool &rOutput) const
 Calculate with bool. More...
 
virtual void Calculate (const Variable< int > &rVariable, int &rOutput) const
 Calculate with int. More...
 
virtual void Calculate (const Variable< double > &rVariable, double &rOutput) const
 Calculate with double. More...
 
virtual void Calculate (const Variable< array_1d< double, 2 >> &rVariable, array_1d< double, 2 > &rOutput) const
 Calculate with array_1d<double, 2> More...
 
virtual void Calculate (const Variable< array_1d< double, 6 >> &rVariable, array_1d< double, 6 > &rOutput) const
 Calculate with array_1d<double, 6> More...
 
virtual void Calculate (const Variable< Matrix > &rVariable, Matrix &rOutput) const
 Calculate with Matrix. More...
 
Pointer Create (const std::string &rNewGeometryName, PointsArrayType const &rThisPoints) const
 Creates a new geometry pointer. More...
 
virtual Pointer Create (const GeometryType &rGeometry) const
 Creates a new geometry pointer. More...
 
virtual Pointer Create (const IndexType NewGeometryId, const GeometryType &rGeometry) const
 Creates a new geometry pointer. More...
 
Pointer Create (const std::string &rNewGeometryName, const GeometryType &rGeometry) const
 Creates a new geometry pointer. More...
 
void ClonePoints ()
 
virtual VectorLumpingFactors (Vector &rResult, const LumpingMethods LumpingMethod=LumpingMethods::ROW_SUM) const
 Lumping factors for the calculation of the lumped mass matrix. More...
 
GeometryData const & GetGeometryData () const
 GeometryData contains all information about dimensions and has a set of precomputed values for integration points and shape functions, including derivatives. More...
 
virtual GeometryTypeGetGeometryPart (const IndexType Index)
 Used for composite geometries. It returns the the geometry part, corresponding to the Index. More...
 
virtual const GeometryTypeGetGeometryPart (const IndexType Index) const
 Used for composite geometries. It returns the the geometry part, corresponding to the Index. More...
 
virtual GeometryType::Pointer pGetGeometryPart (const IndexType Index)
 Used for composite geometries. It returns the pointer of a geometry part, corresponding to the Index. More...
 
virtual const GeometryType::Pointer pGetGeometryPart (const IndexType Index) const
 Used for composite geometries. It returns the const pointer of a geometry part, corresponding to the Index. More...
 
virtual void SetGeometryPart (const IndexType Index, GeometryType::Pointer pGeometry)
 Allows to exchange certain geometries. More...
 
virtual IndexType AddGeometryPart (GeometryType::Pointer pGeometry)
 Allows to enhance the coupling geometry, with another geometry. More...
 
virtual void RemoveGeometryPart (GeometryType::Pointer pGeometry)
 Removes a geometry part. More...
 
virtual void RemoveGeometryPart (const IndexType Index)
 Removes a geometry part. More...
 
virtual bool HasGeometryPart (const IndexType Index) const
 Use to check if certain Indexed object is within the geometry parts of this geometry. More...
 
virtual SizeType NumberOfGeometryParts () const
 
SizeType WorkingSpaceDimension () const
 
SizeType LocalSpaceDimension () const
 
virtual double Length () const
 
virtual double Area () const
 This method calculate and return area or surface area of this geometry depending to it's dimension. More...
 
virtual double Volume () const
 This method calculate and return volume of this geometry. More...
 
virtual double MinEdgeLength () const
 
virtual double MaxEdgeLength () const
 
virtual double AverageEdgeLength () const
 
virtual double Circumradius () const
 
virtual double Inradius () const
 
virtual bool HasIntersection (const GeometryType &ThisGeometry) const
 
virtual bool HasIntersection (const Point &rLowPoint, const Point &rHighPoint) const
 
virtual void BoundingBox (TPointType &rLowPoint, TPointType &rHighPoint) const
 Calculates the boundingbox of the geometry. More...
 
virtual array_1d< double, 3 > Normal (const CoordinatesArrayType &rPointLocalCoordinates) const
 It returns a vector that is normal to its corresponding geometry in the given local point. More...
 
virtual array_1d< double, 3 > Normal (IndexType IntegrationPointIndex) const
 It returns the vector, which is normal to its corresponding geometry in the given integration point for the default integration method. More...
 
virtual array_1d< double, 3 > Normal (IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 It returns the vector, which is normal to its corresponding geometry in the given integration point. More...
 
virtual array_1d< double, 3 > UnitNormal (const CoordinatesArrayType &rPointLocalCoordinates) const
 It computes the unit normal of the geometry in the given local point. More...
 
virtual array_1d< double, 3 > UnitNormal (IndexType IntegrationPointIndex) const
 It returns the normalized normal vector in the given integration point. More...
 
virtual array_1d< double, 3 > UnitNormal (IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 It returns the normalized normal vector in the given integration point. More...
 
double Quality (const QualityCriteria qualityCriteria) const
 
virtual void ComputeDihedralAngles (Vector &rDihedralAngles) const
 
virtual void ComputeSolidAngles (Vector &rSolidAngles) const
 
const PointsArrayTypePoints () const
 
PointsArrayTypePoints ()
 
const TPointType::Pointer pGetPoint (const int Index) const
 
TPointType::Pointer pGetPoint (const int Index)
 
TPointType const & GetPoint (const int Index) const
 
TPointType & GetPoint (const int Index)
 
virtual MatrixPointsLocalCoordinates (Matrix &rResult) const
 
virtual CoordinatesArrayTypePointLocalCoordinates (CoordinatesArrayType &rResult, const CoordinatesArrayType &rPoint) const
 Returns the local coordinates of a given arbitrary point. More...
 
virtual bool IsInside (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rResult, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Checks if given point in global space coordinates is inside the geometry boundaries. This function computes the local coordinates and checks then if this point lays within the boundaries. More...
 
virtual int IsInsideLocalSpace (const CoordinatesArrayType &rPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Checks if given point in local space coordinates of this geometry is inside the geometry boundaries. More...
 
virtual void SpansLocalSpace (std::vector< double > &rSpans, IndexType LocalDirectionIndex=0) const
 
virtual GeometriesArrayType GenerateBoundariesEntities () const
 This method gives you all boundaries entities of this geometry. More...
 
virtual GeometriesArrayType GeneratePoints () const
 This method gives you all points of this geometry. More...
 
virtual SizeType EdgesNumber () const
 This method gives you number of all edges of this geometry. More...
 
 KRATOS_DEPRECATED_MESSAGE ("This is legacy version (use GenerateEdges instead)") virtual GeometriesArrayType Edges(void)
 This method gives you all edges of this geometry. More...
 
virtual GeometriesArrayType GenerateEdges () const
 This method gives you all edges of this geometry. More...
 
virtual SizeType FacesNumber () const
 Returns the number of faces of the current geometry. More...
 
 KRATOS_DEPRECATED_MESSAGE ("This is legacy version (use GenerateFaces instead)") virtual GeometriesArrayType Faces(void)
 Returns all faces of the current geometry. More...
 
virtual GeometriesArrayType GenerateFaces () const
 Returns all faces of the current geometry. More...
 
virtual void NumberNodesInFaces (DenseVector< unsigned int > &rNumberNodesInFaces) const
 
virtual void NodesInFaces (DenseMatrix< unsigned int > &rNodesInFaces) const
 
SizeType IntegrationPointsNumber () const
 
SizeType IntegrationPointsNumber (IntegrationMethod ThisMethod) const
 
const IntegrationPointsArrayTypeIntegrationPoints () const
 
const IntegrationPointsArrayTypeIntegrationPoints (IntegrationMethod ThisMethod) const
 
virtual void CreateIntegrationPoints (IntegrationPointsArrayType &rIntegrationPoints, IntegrationInfo &rIntegrationInfo) const
 
virtual void CreateQuadraturePointGeometries (GeometriesArrayType &rResultGeometries, IndexType NumberOfShapeFunctionDerivatives, const IntegrationPointsArrayType &rIntegrationPoints, IntegrationInfo &rIntegrationInfo)
 
virtual void CreateQuadraturePointGeometries (GeometriesArrayType &rResultGeometries, IndexType NumberOfShapeFunctionDerivatives, IntegrationInfo &rIntegrationInfo)
 
void GlobalCoordinates (CoordinatesArrayType &rResult, IndexType IntegrationPointIndex) const
 
void GlobalCoordinates (CoordinatesArrayType &rResult, IndexType IntegrationPointIndex, const IntegrationMethod ThisMethod) const
 This method provides the global coordinates to the corresponding integration point. More...
 
virtual void GlobalSpaceDerivatives (std::vector< CoordinatesArrayType > &rGlobalSpaceDerivatives, const CoordinatesArrayType &rLocalCoordinates, const SizeType DerivativeOrder) const
 This method maps from dimension space to working space and computes the number of derivatives at the dimension parameter. More...
 
virtual void GlobalSpaceDerivatives (std::vector< CoordinatesArrayType > &rGlobalSpaceDerivatives, IndexType IntegrationPointIndex, const SizeType DerivativeOrder) const
 This method maps from dimension space to working space and computes the number of derivatives at the dimension parameter. More...
 
virtual int ProjectionPoint (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rProjectedPointGlobalCoordinates, CoordinatesArrayType &rProjectedPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Projects a certain point on the geometry, or finds the closest point, depending on the provided initial guess. The external point does not necessary lay on the geometry. It shall deal as the interface to the mathematical projection function e.g. the Newton-Raphson. Thus, the breaking criteria does not necessarily mean that it found a point on the surface, if it is really the closest if or not. It shows only if the breaking criteria, defined by the tolerance is reached. More...
 
virtual int ProjectionPointLocalToLocalSpace (const CoordinatesArrayType &rPointLocalCoordinates, CoordinatesArrayType &rProjectionPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Projects a point onto the geometry Projects a certain point on the geometry, or finds the closest point, depending on the provided initial guess. The external point does not necessary lay on the geometry. It shall deal as the interface to the mathematical projection function e.g. the Newton-Raphson. Thus, the breaking criteria does not necessarily mean that it found a point on the surface, if it is really the closest if or not. It shows only if the breaking criteria, defined by the tolerance is reached. This function requires an initial guess, provided by rProjectionPointLocalCoordinates. This function can be a very costly operation. More...
 
virtual int ProjectionPointGlobalToLocalSpace (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rProjectionPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Projects a point onto the geometry Projects a certain point on the geometry, or finds the closest point, depending on the provided initial guess. The external point does not necessary lay on the geometry. It shall deal as the interface to the mathematical projection function e.g. the Newton-Raphson. Thus, the breaking criteria does not necessarily mean that it found a point on the surface, if it is really the closest if or not. It shows only if the breaking criteria, defined by the tolerance is reached. This function requires an initial guess, provided by rProjectionPointLocalCoordinates. This function can be a very costly operation. More...
 
virtual int ClosestPoint (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rClosestPointGlobalCoordinates, CoordinatesArrayType &rClosestPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Returns all coordinates of the closest point on the geometry given to an arbitrary point in global coordinates. The basic concept is to first do a projection towards this geometry and second checking if the projection was successfull or if no point on the geometry was found. More...
 
virtual int ClosestPoint (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rClosestPointGlobalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Returns global coordinates of the closest point on the geometry given to an arbitrary point in global coordinates. The basic concept is to first do a projection towards this geometry and second checking if the projection was successfull or if no point on the geometry was found. More...
 
virtual int ClosestPointLocalCoordinates (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rClosestPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Returns local coordinates of the closest point on the geometry given to an arbitrary point in global coordinates. The basic concept is to first do a projection towards this geometry and second checking if the projection was successfull or if no point on the geometry was found. More...
 
virtual int ClosestPointLocalToLocalSpace (const CoordinatesArrayType &rPointLocalCoordinates, CoordinatesArrayType &rClosestPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Calculates the closes point projection This method calculates the closest point projection of a point in local space coordinates. More...
 
virtual int ClosestPointGlobalToLocalSpace (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rClosestPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Calculates the closes point projection This method calculates the closest point projection of a point in global space coordinates. More...
 
virtual double CalculateDistance (const CoordinatesArrayType &rPointGlobalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const
 Computes the distance between an point in global coordinates and the closest point of this geometry. If projection fails, double::max will be returned. More...
 
JacobiansTypeJacobian (JacobiansType &rResult) const
 
virtual JacobiansTypeJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod) const
 
virtual JacobiansTypeJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod, Matrix &DeltaPosition) const
 
MatrixJacobian (Matrix &rResult, IndexType IntegrationPointIndex) const
 
virtual MatrixJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
virtual MatrixJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod, const Matrix &rDeltaPosition) const
 
virtual MatrixJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates, Matrix &rDeltaPosition) const
 
VectorDeterminantOfJacobian (Vector &rResult) const
 
virtual VectorDeterminantOfJacobian (Vector &rResult, IntegrationMethod ThisMethod) const
 
double DeterminantOfJacobian (IndexType IntegrationPointIndex) const
 
virtual double DeterminantOfJacobian (IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
JacobiansTypeInverseOfJacobian (JacobiansType &rResult) const
 
virtual JacobiansTypeInverseOfJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod) const
 
MatrixInverseOfJacobian (Matrix &rResult, IndexType IntegrationPointIndex) const
 
virtual MatrixInverseOfJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
const MatrixShapeFunctionsValues () const
 
const MatrixShapeFunctionsValues (IntegrationMethod ThisMethod) const
 
double ShapeFunctionValue (IndexType IntegrationPointIndex, IndexType ShapeFunctionIndex) const
 
double ShapeFunctionValue (IndexType IntegrationPointIndex, IndexType ShapeFunctionIndex, IntegrationMethod ThisMethod) const
 
virtual double ShapeFunctionValue (IndexType ShapeFunctionIndex, const CoordinatesArrayType &rCoordinates) const
 
const ShapeFunctionsGradientsTypeShapeFunctionsLocalGradients () const
 
const ShapeFunctionsGradientsTypeShapeFunctionsLocalGradients (IntegrationMethod ThisMethod) const
 
const MatrixShapeFunctionLocalGradient (IndexType IntegrationPointIndex) const
 
const MatrixShapeFunctionLocalGradient (IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
const MatrixShapeFunctionLocalGradient (IndexType IntegrationPointIndex, IndexType ShapeFunctionIndex, IntegrationMethod ThisMethod) const
 
const MatrixShapeFunctionDerivatives (IndexType DerivativeOrderIndex, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const
 
const MatrixShapeFunctionDerivatives (IndexType DerivativeOrderIndex, IndexType IntegrationPointIndex) const
 
virtual ShapeFunctionsSecondDerivativesTypeShapeFunctionsSecondDerivatives (ShapeFunctionsSecondDerivativesType &rResult, const CoordinatesArrayType &rPoint) const
 
virtual ShapeFunctionsThirdDerivativesTypeShapeFunctionsThirdDerivatives (ShapeFunctionsThirdDerivativesType &rResult, const CoordinatesArrayType &rPoint) const
 
void ShapeFunctionsIntegrationPointsGradients (ShapeFunctionsGradientsType &rResult) const
 
virtual void ShapeFunctionsIntegrationPointsGradients (ShapeFunctionsGradientsType &rResult, IntegrationMethod ThisMethod) const
 
virtual void ShapeFunctionsIntegrationPointsGradients (ShapeFunctionsGradientsType &rResult, Vector &rDeterminantsOfJacobian, IntegrationMethod ThisMethod) const
 
virtual void ShapeFunctionsIntegrationPointsGradients (ShapeFunctionsGradientsType &rResult, Vector &rDeterminantsOfJacobian, IntegrationMethod ThisMethod, Matrix &ShapeFunctionsIntegrationPointsValues) const
 
virtual int Check () const
 
virtual std::string Name () const
 Returns name. More...
 
virtual void PrintName (std::ostream &rOstream) const
 Print name. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (Geometry)
 Pointer definition of Geometry. More...
 
bool empty () const
 
bool HasIntegrationMethod (IntegrationMethod ThisMethod) const
 
IntegrationMethod GetDefaultIntegrationMethod () const
 
virtual IntegrationInfo GetDefaultIntegrationInfo () const
 Provides the default integration per geometry. More...
 
virtual bool IsSymmetric () const
 
IndexType const & Id () const
 Id of this Geometry. More...
 
bool IsIdGeneratedFromString ()
 Returns if id was generated from a geometry name. More...
 
bool IsIdSelfAssigned ()
 Returns if id was generated by itself. More...
 
void SetId (const IndexType Id)
 Sets Id of this Geometry. More...
 
void SetId (const std::string &rName)
 Sets Id with the use of the name of this geometry. More...
 

Protected Member Functions

Constructor
 QuadraturePointGeometry ()
 Standard Constructor. More...
 
- Protected Member Functions inherited from Kratos::Geometry< TPointType >
void SetGeometryData (GeometryData const *pGeometryData)
 updates the pointer to GeometryData of the respective geometry. More...
 
virtual double InradiusToCircumradiusQuality () const
 Quality functions. More...
 
virtual double AreaToEdgeLengthRatio () const
 
virtual double ShortestAltitudeToEdgeLengthRatio () const
 
virtual double InradiusToLongestEdgeQuality () const
 
virtual double ShortestToLongestEdgeQuality () const
 
virtual double RegularityQuality () const
 
virtual double VolumeToSurfaceAreaQuality () const
 
virtual double VolumeToEdgeLengthQuality () const
 
virtual double VolumeToAverageEdgeLength () const
 
virtual double VolumeToRMSEdgeLength () const
 
virtual double MinDihedralAngle () const
 
virtual double MaxDihedralAngle () const
 
virtual double MinSolidAngle () const
 
bool AllPointsAreValid () const
 Checks if the geometry points are valid Checks if the geometry points are valid from the pointer value Points are not valid when the pointer value is null. More...
 

Serialization

class Serializer
 

Additional Inherited Members

- Static Public Member Functions inherited from Kratos::Geometry< TPointType >
static bool HasSameType (const GeometryType &rLHS, const GeometryType &rRHS)
 Checks if two GeometryType have the same type. More...
 
static bool HasSameType (const GeometryType *rLHS, const GeometryType *rRHS)
 Checks if two GeometryType have the same type (pointer version) More...
 
static bool HasSameGeometryType (const GeometryType &rLHS, const GeometryType &rRHS)
 Checks if two GeometryType have the same geometry type. More...
 
static bool HasSameGeometryType (const GeometryType *rLHS, const GeometryType *rRHS)
 Checks if two GeometryType have the same geometry type (pointer version) More...
 
static bool IsSame (const GeometryType &rLHS, const GeometryType &rRHS)
 Checks if two GeometryType are the same. More...
 
static bool IsSame (const GeometryType *rLHS, const GeometryType *rRHS)
 Checks if two GeometryType are the same (pointer version) More...
 
static IndexType GenerateId (const std::string &rName)
 Gets the corresponding hash-Id to a string name. More...
 
- Static Public Attributes inherited from Kratos::Geometry< TPointType >
static constexpr IndexType BACKGROUND_GEOMETRY_INDEX = std::numeric_limits<IndexType>::max()
 

Detailed Description

template<class TPointType, int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
class Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >

A sinlge quadrature point, that can be used for geometries without a predefined integration scheme, i.e. they can handle material point elements, isogeometric analysis elements or standard finite elements which are defined at a single quadrature point. This point defines a line segment described on a underlying surface. Shape functions and integration types have to be precomputed and are set from from outside. The parent pointer can provide the adress to the owner of this quadrature point.

A sinlge quadrature point, that can be used for geometries without a predefined integration scheme, i.e. they can handle material point elements, isogeometric analysis elements or standard finite elements which are defined at a single quadrature point. Shape functions and integration types are precomputed and are set from from outside. The parent pointer can provide the adress to the owner of this quadrature point.

A single quadrature point, that can be used for geometries without a predefined integration scheme, i.e. they can handle material point elements, isogeometric analysis elements or standard finite elements which are defined at a single quadrature point. Shape functions and integration types are precomputed and are set from from outside. The parent pointer can provide the adress to the owner of this quadrature point.

Member Typedef Documentation

◆ BaseType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef Geometry<TPointType> Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::BaseType

◆ CoordinatesArrayType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::CoordinatesArrayType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::CoordinatesArrayType

◆ GeometryShapeFunctionContainerType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryShapeFunctionContainer<GeometryData::IntegrationMethod> Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GeometryShapeFunctionContainerType

◆ GeometryType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef Geometry<TPointType> Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GeometryType

◆ IndexType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::IndexType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::IndexType

◆ IntegrationPointsArrayType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::IntegrationPointsArrayType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::IntegrationPointsArrayType

◆ IntegrationPointsContainerType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::IntegrationPointsContainerType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::IntegrationPointsContainerType

◆ IntegrationPointType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::IntegrationPointType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::IntegrationPointType

◆ PointsArrayType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::PointsArrayType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::PointsArrayType

◆ ShapeFunctionsGradientsType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryData::ShapeFunctionsGradientsType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::ShapeFunctionsGradientsType

◆ ShapeFunctionsLocalGradientsContainerType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::ShapeFunctionsLocalGradientsContainerType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::ShapeFunctionsLocalGradientsContainerType

◆ ShapeFunctionsValuesContainerType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::ShapeFunctionsValuesContainerType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::ShapeFunctionsValuesContainerType

◆ SizeType

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
typedef GeometryType::SizeType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::SizeType

Constructor & Destructor Documentation

◆ QuadraturePointGeometry() [1/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints,
const IntegrationPointsContainerType rIntegrationPoints,
const ShapeFunctionsValuesContainerType rShapeFunctionValues,
const ShapeFunctionsLocalGradientsContainerType rShapeFunctionsDerivativesVector 
)
inline

Constructor with points and all shape function containers separately.

◆ QuadraturePointGeometry() [2/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints,
const IntegrationPointsContainerType rIntegrationPoints,
const ShapeFunctionsValuesContainerType rShapeFunctionValues,
const ShapeFunctionsLocalGradientsContainerType rShapeFunctionsDerivativesVector,
GeometryType pGeometryParent 
)
inline

Constructor with points and all shape function containers separately including the parent.

◆ QuadraturePointGeometry() [3/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints,
const GeometryShapeFunctionContainerType ThisGeometryShapeFunctionContainer 
)
inline

Constructor with points and geometry shape function container.

◆ QuadraturePointGeometry() [4/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints,
const GeometryShapeFunctionContainerType ThisGeometryShapeFunctionContainer,
GeometryType pGeometryParent 
)
inline

Constructor with points, geometry shape function container, parent.

◆ QuadraturePointGeometry() [5/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints,
const IntegrationPointType ThisIntegrationPoint,
const Matrix ThisShapeFunctionsValues,
const DenseVector< Matrix > &  ThisShapeFunctionsDerivatives 
)
inline

Constructor with points, N, Vector<DN_De, ...>

◆ QuadraturePointGeometry() [6/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints,
const IntegrationPointType ThisIntegrationPoint,
const Matrix ThisShapeFunctionsValues,
const DenseVector< Matrix > &  ThisShapeFunctionsDerivatives,
GeometryType pGeometryParent 
)
inline

Constructor with points, N, Vector<DN_De, ...>, parent.

◆ QuadraturePointGeometry() [7/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const PointsArrayType ThisPoints)
delete

Constructor.

◆ QuadraturePointGeometry() [8/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const IndexType  GeometryId,
const PointsArrayType ThisPoints 
)
inline

Constructor with Geometry Id.

◆ QuadraturePointGeometry() [9/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( const std::string &  GeometryName,
const PointsArrayType ThisPoints 
)
inline

Constructor with Geometry Name.

◆ ~QuadraturePointGeometry()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::~QuadraturePointGeometry ( )
overridedefault

Destructor.

◆ QuadraturePointGeometry() [10/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > const &  rOther)
inline

Copy constructor.

◆ QuadraturePointGeometry() [11/11]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::QuadraturePointGeometry ( )
inlineprotected

Standard Constructor.

Member Function Documentation

◆ Calculate() [1/2]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
void Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Calculate ( const Variable< array_1d< double, 3 >> &  rVariable,
array_1d< double, 3 > &  rOutput 
) const
inlineoverridevirtual

Calculate with array_1d<double, 3>

Reimplemented from Kratos::Geometry< TPointType >.

◆ Calculate() [2/2]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
void Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Calculate ( const Variable< Vector > &  rVariable,
Vector rOutput 
) const
inlineoverridevirtual

Calculate with Vector.

Reimplemented from Kratos::Geometry< TPointType >.

◆ Center()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Point Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Center ( ) const
inlineoverridevirtual

Calculates global location of this integration point.

\[ c_i = \sum_j^N(x_j)*x_i \]

j is the index of the node and i the global direction (x,y,z).

Returns
Point which is the location of this quadrature point.

Reimplemented from Kratos::Geometry< TPointType >.

◆ Create() [1/3]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
BaseType::Pointer Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Create ( const IndexType  NewGeometryId,
const BaseType rGeometry 
) const
inlineoverride

Creates a new geometry pointer.

Parameters
NewGeometryIdthe ID of the new geometry
rGeometryreference to an existing geometry
Returns
Pointer to the new geometry

◆ Create() [2/3]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
BaseType::Pointer Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Create ( const IndexType  NewGeometryId,
PointsArrayType const &  rThisPoints 
) const
inlineoverridevirtual

Creates a new geometry pointer.

Parameters
NewGeometryIdthe ID of the new geometry
rThisPointsthe nodes of the new geometry
Returns
Pointer to the new geometry

Reimplemented from Kratos::Geometry< TPointType >.

◆ Create() [3/3]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
BaseType::Pointer Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Create ( PointsArrayType const &  ThisPoints) const
inlineoverridevirtual

Creates a new geometry pointer.

Parameters
ThisPointsthe nodes of the new geometry
Returns
Pointer to the new geometry

Reimplemented from Kratos::Geometry< TPointType >.

◆ DeterminantOfJacobian() [1/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual double Kratos::Geometry< TPointType >::DeterminantOfJacobian
inline

Determinant of jacobian in given point. This method calculate determinant of jacobian matrix in given point.

Parameters
rPointpoint which determinant of jacobians has to be calculated in it.
Returns
Determinamt of jacobian matrix \( |J| \) in given point.
See also
DeterminantOfJacobian
InverseOfJacobian

◆ DeterminantOfJacobian() [2/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
double Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::DeterminantOfJacobian ( const CoordinatesArrayType rPoint) const
inlineoverridevirtual

Determinant of jacobian in given point. Computed on parent geometry. Error if Parent is not assigned is only thrown in debug mode.

Parameters
rPointpoint which determinant of jacobians has to be calculated in it.
Returns
Determinamt of jacobian matrix \( |J| \) in given point.

Reimplemented from Kratos::Geometry< TPointType >.

◆ DeterminantOfJacobian() [3/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
double Kratos::Geometry< TPointType >::DeterminantOfJacobian
inline

Determinant of jacobian in specific integration point of default integration method. This method just call DeterminantOfJacobian(IndexType IntegrationPointIndex, enum IntegrationMethod ThisMethod) with default integration method.

Parameters
IntegrationPointIndexindex of integration point which determinant jacobians has to be calculated in it.
Returns
Determinamt of jacobian matrix \( |J|_i \) where \( i \) is the given integration point index of default integration method.
See also
Jacobian
InverseOfJacobian

◆ DeterminantOfJacobian() [4/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual double Kratos::Geometry< TPointType >::DeterminantOfJacobian
inline

Determinant of jacobian in specific integration point of given integration method. This method calculate determinant of jacobian in given integration point of given integration method.

Parameters
IntegrationPointIndexindex of integration point which jacobians has to be calculated in it.
IntegrationPointIndexindex of integration point which determinant of jacobians has to be calculated in it.
Returns
Determinamt of jacobian matrix \( |J|_i \) where \( i \) is the given integration point index of given integration method.
See also
Jacobian
InverseOfJacobian

◆ DeterminantOfJacobian() [5/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Vector& Kratos::Geometry< TPointType >::DeterminantOfJacobian
inline

Determinant of jacobians for default integration method. This method just call DeterminantOfJacobian(enum IntegrationMethod ThisMethod) with default integration method.

Returns
Vector of double which is vector of determinants of jacobians \( |J|_i \) where \( i=1,2,...,n \) is the integration point index of default integration method.
See also
Jacobian
InverseOfJacobian

◆ DeterminantOfJacobian() [6/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Vector& Kratos::Geometry< TPointType >::DeterminantOfJacobian
inline

Determinant of jacobians for given integration method. This method calculate determinant of jacobian in all integrations points of given integration method.

Returns
Vector of double which is vector of determinants of jacobians \( |J|_i \) where \( i=1,2,...,n \) is the integration point index of given integration method.
See also
Jacobian
InverseOfJacobian

◆ DeterminantOfJacobianParent()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Vector& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::DeterminantOfJacobianParent ( Vector rResult) const
inline

◆ DomainSize()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
double Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::DomainSize ( ) const
inlineoverridevirtual

Returns the domain size of this quadrature point.

Reimplemented from Kratos::Geometry< TPointType >.

◆ GetGeometryFamily()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
GeometryData::KratosGeometryFamily Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GetGeometryFamily ( ) const
inlineoverridevirtual

Reimplemented from Kratos::Geometry< TPointType >.

◆ GetGeometryParent()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
GeometryType& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GetGeometryParent ( IndexType  Index) const
inlineoverridevirtual

Some geometries require relations to other geometries. This is the case for e.g. quadrature points. To reach the parent geometry this function can be used.

Returns
Parent geometry of this geometry object.

Reimplemented from Kratos::Geometry< TPointType >.

◆ GetGeometryType()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
GeometryData::KratosGeometryType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GetGeometryType ( ) const
inlineoverridevirtual

Reimplemented from Kratos::Geometry< TPointType >.

◆ GlobalCoordinates() [1/2]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
CoordinatesArrayType& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GlobalCoordinates ( CoordinatesArrayType rResult,
CoordinatesArrayType const &  LocalCoordinates 
) const
inlineoverridevirtual

This method provides the global coordinates corresponding to the local coordinates. The mapping is done on the parent. Error if Parent is not assigned is only thrown in debug mode.

Reimplemented from Kratos::Geometry< TPointType >.

◆ GlobalCoordinates() [2/2]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
CoordinatesArrayType& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::GlobalCoordinates ( CoordinatesArrayType rResult,
CoordinatesArrayType const &  LocalCoordinates,
Matrix DeltaPosition 
) const
inlineoverridevirtual

This method provides the global coordinates corresponding to the local coordinates provided, considering additionally a certain increment in the coordinates

Parameters
rResultThe array containing the global coordinates corresponding to the local coordinates provided
LocalCoordinatesThe local coordinates provided
DeltaPositionThe increment of position considered
Returns
An array containing the global coordinates corresponding to the local coordinates provides
See also
PointLocalCoordinates

Reimplemented from Kratos::Geometry< TPointType >.

◆ Info()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
std::string Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Info ( ) const
inlineoverridevirtual

Turn back information as a string.

Reimplemented from Kratos::Geometry< TPointType >.

◆ InverseOfJacobian() [1/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
JacobiansType& Kratos::Geometry< TPointType >::InverseOfJacobian
inline

Inverse of jacobians for default integration method. This method just call InverseOfJacobian(enum IntegrationMethod ThisMethod) with default integration method.

Returns
Inverse of jacobian matrices \( J_i^{-1} \) where \( i=1,2,...,n \) is the integration point index of default integration method.
See also
Jacobian
DeterminantOfJacobian

◆ InverseOfJacobian() [2/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual JacobiansType& Kratos::Geometry< TPointType >::InverseOfJacobian
inline

Inverse of jacobians for given integration method. This method calculate inverse of jacobians matrices in all integrations points of given integration method.

Parameters
ThisMethodintegration method which inverse of jacobians has to be calculated in its integration points.
Returns
Inverse of jacobian matrices \( J^{-1}_i \) where \( i=1,2,...,n \) is the integration point index of given integration method.
See also
Jacobian
DeterminantOfJacobian

◆ InverseOfJacobian() [3/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::InverseOfJacobian
inline

Inverse of jacobian in given point. This method calculate inverse of jacobian matrix in given point.

Parameters
rPointpoint which inverse of jacobians has to be calculated in it.
Returns
Inverse of jacobian matrix \( J^{-1} \) in given point.
See also
DeterminantOfJacobian
InverseOfJacobian

◆ InverseOfJacobian() [4/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Matrix& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::InverseOfJacobian ( Matrix rResult,
const CoordinatesArrayType rCoordinates 
) const
inlineoverridevirtual

Inverse of jacobian in given point. This method calculate inverse of jacobian matrix in given point.

Parameters
rPointpoint which inverse of jacobians has to be calculated in it.
Returns
Inverse of jacobian matrix \( J^{-1} \) in given point.
See also
DeterminantOfJacobian
InverseOfJacobian

Reimplemented from Kratos::Geometry< TPointType >.

◆ InverseOfJacobian() [5/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Matrix& Kratos::Geometry< TPointType >::InverseOfJacobian
inline

Inverse of jacobian in specific integration point of default integration method. This method just call InverseOfJacobian(IndexType IntegrationPointIndex, enum IntegrationMethod ThisMethod) with default integration method.

Parameters
IntegrationPointIndexindex of integration point which inverse of jacobians has to be calculated in it.
Returns
Inverse of jacobian matrix \( J^{-1}_i \) where \( i \) is the given integration point index of default integration method.
See also
Jacobian
DeterminantOfJacobian

◆ InverseOfJacobian() [6/6]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::InverseOfJacobian
inline

Inverse of jacobian in specific integration point of given integration method. This method calculate Inverse of jacobian matrix in given integration point of given integration method.

Parameters
IntegrationPointIndexindex of integration point which inverse of jacobians has to be calculated in it.
ThisMethodintegration method which inverse of jacobians has to be calculated in its integration points.
Returns
Inverse of jacobian matrix \( J^{-1}_i \) where \( i \) is the given integration point index of given integration method.
See also
Jacobian
DeterminantOfJacobian

◆ Jacobian() [1/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
JacobiansType& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [2/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual JacobiansType& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [3/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual JacobiansType& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [4/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [5/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Matrix& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::Jacobian ( Matrix rResult,
const CoordinatesArrayType rCoordinates 
) const
inlineoverridevirtual

Jacobian in given point. Computed on parent geometry. Error if Parent is not assigned is only thrown in debug mode.

Parameters
rCoordinatespoint which jacobians has to be calculated in it.
Returns
jacobian matrix \( J \) in given point.

Reimplemented from Kratos::Geometry< TPointType >.

◆ Jacobian() [6/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [7/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Matrix& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [8/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ Jacobian() [9/9]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::Jacobian
inline

using base class functions

◆ KRATOS_CLASS_POINTER_DEFINITION()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::KRATOS_CLASS_POINTER_DEFINITION ( QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >  )

Pointer definition of QuadraturePointGeometry.

◆ operator=()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
QuadraturePointGeometry& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::operator= ( const QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > &  rOther)
inline

Assignment operator.

◆ PolynomialDegree()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
SizeType Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::PolynomialDegree ( IndexType  LocalDirectionIndex) const
inlineoverridevirtual

Returns the polynomial degree of the parent geometry.

Reimplemented from Kratos::Geometry< TPointType >.

◆ PrintData()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
void Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::PrintData ( std::ostream &  rOStream) const
inlineoverridevirtual

Print object's data.

Reimplemented from Kratos::Geometry< TPointType >.

◆ PrintInfo()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
void Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::PrintInfo ( std::ostream &  rOStream) const
inlineoverridevirtual

Print information about this object.

Reimplemented from Kratos::Geometry< TPointType >.

◆ SetGeometryParent()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
void Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::SetGeometryParent ( GeometryType pGeometryParent)
inlineoverridevirtual

Some geometries require relations to other geometries. This is the case for e.g. quadrature points. To set or change the parent geometry this function can be used.

Parameters
Parentgeometry of this geometry object.

Reimplemented from Kratos::Geometry< TPointType >.

◆ SetGeometryShapeFunctionContainer()

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
void Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::SetGeometryShapeFunctionContainer ( const GeometryShapeFunctionContainer< GeometryData::IntegrationMethod > &  rGeometryShapeFunctionContainer)
inlineoverridevirtual

Reimplemented from Kratos::Geometry< TPointType >.

◆ ShapeFunctionsLocalGradients() [1/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
const ShapeFunctionsGradientsType& Kratos::Geometry< TPointType >::ShapeFunctionsLocalGradients
inline

This method gives all shape functions gradients evaluated in all integration points of default integration method. It just call ShapeFunctionsLocalGradients(enum IntegrationMethod ThisMethod) with default integration method. There is no calculation and it just give it from shape functions values container.

Note
There is no control if there is any gradient calculated or not!
Returns
shape functions' gradients \( F_{ijk} \) where i is the integration point index and j is the shape function index and k is local coordinate index. In other word component \( f_{ijk} \) is k'th component of gradient of the shape function corresponding to node j evaluated in integration point i of default integration method.
See also
ShapeFunctionsValues
ShapeFunctionValue
ShapeFunctionLocalGradient

◆ ShapeFunctionsLocalGradients() [2/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
const ShapeFunctionsGradientsType& Kratos::Geometry< TPointType >::ShapeFunctionsLocalGradients
inline

This method gives all shape functions gradients evaluated in all integration points of given integration method. There is no calculation and it just give it from shape functions values container.

Note
There is no control if there is any gradient calculated or not!
Parameters
ThisMethodintegration method which shape functions gradients evaluated in its integration points.
Returns
shape functions' gradients \( F_{ijk} \) where i is the integration point index and j is the shape function index and k is local coordinate index. In other word component \( f_{ijk} \) is k'th component of gradient of the shape function corresponding to node j evaluated in integration point i of given integration method.
See also
ShapeFunctionsValues
ShapeFunctionValue
ShapeFunctionLocalGradient

◆ ShapeFunctionsLocalGradients() [3/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::Geometry< TPointType >::ShapeFunctionsLocalGradients
inline

This method gives gradient of all shape functions evaluated in given point. There is no calculation and it just give it from shape functions values container if they are existing. Otherwise it gives you error which this value is not exist.

Parameters
rResultthe given Container that will be overwritten by the solution
rPointthe given local coordinates the gradients will be evaluated for
Returns
a matrix of gradients for each shape function

◆ ShapeFunctionsLocalGradients() [4/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Matrix& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::ShapeFunctionsLocalGradients ( Matrix rResult,
const CoordinatesArrayType rPoint 
) const
inlineoverridevirtual

This method gives gradient of all shape functions evaluated in given point. There is no calculation and it just give it from shape functions values container if they are existing. Otherwise it gives you error which this value is not exist.

Parameters
rResultthe given Container that will be overwritten by the solution
rPointthe given local coordinates the gradients will be evaluated for
Returns
a matrix of gradients for each shape function

Reimplemented from Kratos::Geometry< TPointType >.

◆ ShapeFunctionsValues() [1/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
const Matrix& Kratos::Geometry< TPointType >::ShapeFunctionsValues
inline

This method gives all shape functions values evaluated in all integration points of default integration method. It just call ShapeFunctionsValues(enum IntegrationMethod ThisMethod) with default integration method.There is no calculation and it just give it from shape functions values container.

Note
There is no control if the return matrix is empty or not!
Returns
Matrix of values of shape functions \( F_{ij} \) where i is the integration point index and j is the shape function index. In other word component \( f_{ij} \) is value of the shape function corresponding to node j evaluated in integration point i of default integration method.
See also
ShapeFunctionValue
ShapeFunctionsLocalGradients
ShapeFunctionLocalGradient

◆ ShapeFunctionsValues() [2/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
const Matrix& Kratos::Geometry< TPointType >::ShapeFunctionsValues
inline

This method gives all shape functions values evaluated in all integration points of given integration method. There is no calculation and it just give it from shape functions values container.

Note
There is no control if the return matrix is empty or not!
Parameters
ThisMethodintegration method which shape functions evaluated in its integration points.
Returns
Matrix of values of shape functions \( F_{ij} \) where i is the integration point index and j is the shape function index. In other word component \( f_{ij} \) is value of the shape function corresponding to node j evaluated in integration point i of given integration method.
See also
ShapeFunctionValue
ShapeFunctionsLocalGradients
ShapeFunctionLocalGradient

◆ ShapeFunctionsValues() [3/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
virtual Vector& Kratos::Geometry< TPointType >::ShapeFunctionsValues
inline

This method gives all non-zero shape functions values evaluated at the rCoordinates provided

Note
There is no control if the return vector is empty or not!
Returns
Vector of values of shape functions \( F_{i} \) where i is the shape function index (for NURBS it is the index of the local enumeration in the element).
See also
ShapeFunctionValue
ShapeFunctionsLocalGradients
ShapeFunctionLocalGradient

◆ ShapeFunctionsValues() [4/4]

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
Vector& Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >::ShapeFunctionsValues ( Vector rResult,
const CoordinatesArrayType rCoordinates 
) const
inlineoverridevirtual

This method gives all non-zero shape functions values evaluated at the rCoordinates provided

Note
There is no control if the return vector is empty or not!
Returns
Vector of values of shape functions \( F_{i} \) where i is the shape function index (for NURBS it is the index of the local enumeration in the element).
See also
ShapeFunctionValue
ShapeFunctionsLocalGradients
ShapeFunctionLocalGradient

Reimplemented from Kratos::Geometry< TPointType >.

Friends And Related Function Documentation

◆ Serializer

template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension = TWorkingSpaceDimension, int TDimension = TLocalSpaceDimension>
friend class Serializer
friend

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