|
|
| BrepSurface (typename NurbsSurfaceType::Pointer pSurface) |
| Constructor for untrimmed patch. More...
|
|
| BrepSurface (typename NurbsSurfaceType::Pointer pSurface, BrepCurveOnSurfaceLoopArrayType &BrepOuterLoopArray, BrepCurveOnSurfaceLoopArrayType &BrepInnerLoopArray) |
| Constructor for trimmed patch. More...
|
|
| BrepSurface (typename NurbsSurfaceType::Pointer pSurface, BrepCurveOnSurfaceLoopArrayType &BrepOuterLoopArray, BrepCurveOnSurfaceLoopArrayType &BrepInnerLoopArray, bool IsTrimmed) |
| Constructor for trimmed patch including IsTrimmed. More...
|
|
| BrepSurface (const PointsArrayType &ThisPoints) |
|
| BrepSurface (BrepSurface const &rOther) |
| Copy constructor. More...
|
|
template<class TOtherContainerPointType , class TOtherContainerPointEmbeddedType > |
| BrepSurface (BrepSurface< TOtherContainerPointType, TOtherContainerPointEmbeddedType > const &rOther) |
| Copy constructor from a geometry with different point type. More...
|
|
| ~BrepSurface () override=default |
| Destructor. More...
|
|
|
BrepSurface & | operator= (const BrepSurface &rOther) |
| Assignment operator. More...
|
|
template<class TOtherContainerPointType , class TOtherContainerPointEmbeddedType > |
BrepSurface & | operator= (BrepSurface< TOtherContainerPointType, TOtherContainerPointEmbeddedType > const &rOther) |
| Assignment operator for geometries with different point type. More...
|
|
|
BaseType::Pointer | Create (PointsArrayType const &ThisPoints) const override |
|
|
GeometryPointer | pGetGeometryPart (const IndexType Index) override |
| This function returns the pointer of the geometry which is corresponding to the trim index. Surface of the geometry is accessable with SURFACE_INDEX. More...
|
|
const GeometryPointer | pGetGeometryPart (const IndexType Index) const override |
| This function returns the pointer of the geometry which is corresponding to the trim index. Surface of the geometry is accessable with GeometryType::BACKGROUND_GEOMETRY_INDEX. More...
|
|
bool | HasGeometryPart (const IndexType Index) const override |
| This function is used to check if this BrepSurface has certain trim or surface object. More...
|
|
void | AddEmbeddedEdges (BrepCurveOnSurfaceArrayType EmbeddedEdges) |
| Used to add the embedded edges to the brep surface. More...
|
|
const BrepCurveOnSurfaceLoopArrayType & | GetOuterLoops () const |
| Access the nested loop of outer loops. More...
|
|
const BrepCurveOnSurfaceLoopArrayType & | GetInnerLoops () const |
| Access the nested loop of inner loops. More...
|
|
const BrepCurveOnSurfaceArrayType & | GetEmbeddedEdges () const |
| Access the array of embedded edges. More...
|
|
|
void | Calculate (const Variable< array_1d< double, 3 >> &rVariable, array_1d< double, 3 > &rOutput) const override |
| Calculate with array_1d<double, 3> More...
|
|
|
SizeType | PolynomialDegree (IndexType LocalDirectionIndex) const override |
| Return polynomial degree of the nurbs surface. More...
|
|
|
bool | IsTrimmed () const |
|
SizeType | PointsNumberInDirection (IndexType DirectionIndex) const override |
| Returns number of points of NurbsSurface. More...
|
|
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...
|
|
|
Point | Center () const override |
| Provides the center of the underlying surface. More...
|
|
int | ProjectionPointGlobalToLocalSpace (const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rProjectedPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const override |
| Calls projection of its nurbs surface. 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...
|
|
CoordinatesArrayType & | GlobalCoordinates (CoordinatesArrayType &rResult, const CoordinatesArrayType &rLocalCoordinates) const override |
|
|
IntegrationInfo | GetDefaultIntegrationInfo () const override |
| Provides the default integration dependent on the polynomial degree. More...
|
|
|
void | CreateIntegrationPoints (IntegrationPointsArrayType &rIntegrationPoints, IntegrationInfo &rIntegrationInfo) const override |
|
|
void | CreateQuadraturePointGeometries (GeometriesArrayType &rResultGeometries, IndexType NumberOfShapeFunctionDerivatives, const IntegrationPointsArrayType &rIntegrationPoints, IntegrationInfo &rIntegrationInfo) override |
|
|
Vector & | ShapeFunctionsValues (Vector &rResult, const CoordinatesArrayType &rCoordinates) const override |
|
Matrix & | ShapeFunctionsLocalGradients (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const override |
|
|
GeometryData::KratosGeometryFamily | GetGeometryFamily () const override |
|
GeometryData::KratosGeometryType | GetGeometryType () const override |
|
| 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...
|
|
| Geometry (Geometry< TOtherPointType > const &rOther) |
| Copy constructor with TOtherPointType. More...
|
|
virtual | ~Geometry () |
| Destructor. Do nothing!!! More...
|
|
Geometry & | operator= (const Geometry &rOther) |
|
Geometry & | operator= (Geometry< TOtherPointType > const &rOther) |
|
| operator PointsArrayType & () |
|
TContainerPointType::value_type & | operator[] (const SizeType &i) |
|
TContainerPointType::value_type const & | operator[] (const SizeType &i) const |
|
PointPointerType & | operator() (const SizeType &i) |
|
ConstPointPointerType & | operator() (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 |
|
SizeType | max_size () const |
|
void | swap (GeometryType &rOther) |
|
void | push_back (PointPointerType x) |
|
void | clear () |
|
void | reserve (int dim) |
|
int | capacity () |
|
PointPointerContainerType & | GetContainer () |
| ** Gives a reference to underly normal container. */ More...
|
|
const PointPointerContainerType & | GetContainer () const |
|
DataValueContainer & | GetData () |
|
DataValueContainer const & | GetData () const |
|
void | SetData (DataValueContainer const &rThisData) |
|
bool | Has (const Variable< TDataType > &rThisVariable) const |
|
void | SetValue (const TVariableType &rThisVariable, typename TVariableType::Type const &rValue) |
|
TVariableType::Type & | GetValue (const TVariableType &rThisVariable) |
|
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< Vector > &rVariable, Vector &rOutput) const |
| Calculate with Vector. More...
|
|
virtual void | Calculate (const Variable< Matrix > &rVariable, Matrix &rOutput) const |
| Calculate with Matrix. More...
|
|
virtual Pointer | Create (PointsArrayType const &rThisPoints) const |
| Creates a new geometry pointer. More...
|
|
virtual Pointer | Create (const IndexType NewGeometryId, PointsArrayType const &rThisPoints) const |
| Creates a new geometry pointer. 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 Vector & | LumpingFactors (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 void | SetGeometryShapeFunctionContainer (const GeometryShapeFunctionContainer< GeometryData::IntegrationMethod > &rGeometryShapeFunctionContainer) |
|
virtual GeometryType & | GetGeometryParent (IndexType Index) const |
| 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...
|
|
virtual void | SetGeometryParent (GeometryType *pGeometryParent) |
| 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...
|
|
virtual GeometryType & | GetGeometryPart (const IndexType Index) |
| Used for composite geometries. It returns the the geometry part, corresponding to the Index. More...
|
|
virtual const GeometryType & | GetGeometryPart (const IndexType Index) const |
| Used for composite geometries. It returns the the 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 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 | DomainSize () const |
| This method calculate and return length, area or volume of this geometry depending to it's dimension. 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 (TContainerPointType::value_type &rLowPoint, TContainerPointType::value_type &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 PointsArrayType & | Points () const |
|
PointsArrayType & | Points () |
|
const TPointType::Pointer | pGetPoint (const int Index) const |
|
TPointType::Pointer | pGetPoint (const int Index) |
|
TContainerPointType::value_type const & | GetPoint (const int Index) const |
|
TContainerPointType::value_type & | GetPoint (const int Index) |
|
virtual Matrix & | PointsLocalCoordinates (Matrix &rResult) const |
|
virtual CoordinatesArrayType & | PointLocalCoordinates (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...
|
|
| KRATOS_DEPRECATED_MESSAGE ("This is legacy version (use GenerateFaces instead)") virtual GeometriesArrayType Faces(void) |
| Returns all faces of the current geometry. More...
|
|
virtual SizeType | FacesNumber () const |
| Returns the number of 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 IntegrationPointsArrayType & | IntegrationPoints () const |
|
const IntegrationPointsArrayType & | IntegrationPoints (IntegrationMethod ThisMethod) const |
|
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 CoordinatesArrayType & | GlobalCoordinates (CoordinatesArrayType &rResult, CoordinatesArrayType const &LocalCoordinates, Matrix &DeltaPosition) const |
|
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 | 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...
|
|
JacobiansType & | Jacobian (JacobiansType &rResult) const |
|
virtual JacobiansType & | Jacobian (JacobiansType &rResult, IntegrationMethod ThisMethod) const |
|
virtual JacobiansType & | Jacobian (JacobiansType &rResult, IntegrationMethod ThisMethod, Matrix &DeltaPosition) const |
|
Matrix & | Jacobian (Matrix &rResult, IndexType IntegrationPointIndex) const |
|
virtual Matrix & | Jacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const |
|
virtual Matrix & | Jacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod, const Matrix &rDeltaPosition) const |
|
virtual Matrix & | Jacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const |
|
virtual Matrix & | Jacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates, Matrix &rDeltaPosition) const |
|
Vector & | DeterminantOfJacobian (Vector &rResult) const |
|
virtual Vector & | DeterminantOfJacobian (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 |
|
JacobiansType & | InverseOfJacobian (JacobiansType &rResult) const |
|
virtual JacobiansType & | InverseOfJacobian (JacobiansType &rResult, IntegrationMethod ThisMethod) const |
|
Matrix & | InverseOfJacobian (Matrix &rResult, IndexType IntegrationPointIndex) const |
|
virtual Matrix & | InverseOfJacobian (Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const |
|
virtual Matrix & | InverseOfJacobian (Matrix &rResult, const CoordinatesArrayType &rCoordinates) const |
|
const Matrix & | ShapeFunctionsValues () const |
|
const Matrix & | ShapeFunctionsValues (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 ShapeFunctionsGradientsType & | ShapeFunctionsLocalGradients () const |
|
const ShapeFunctionsGradientsType & | ShapeFunctionsLocalGradients (IntegrationMethod ThisMethod) const |
|
const Matrix & | ShapeFunctionLocalGradient (IndexType IntegrationPointIndex) const |
|
const Matrix & | ShapeFunctionLocalGradient (IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const |
|
const Matrix & | ShapeFunctionLocalGradient (IndexType IntegrationPointIndex, IndexType ShapeFunctionIndex, IntegrationMethod ThisMethod) const |
|
const Matrix & | ShapeFunctionDerivatives (IndexType DerivativeOrderIndex, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const |
|
const Matrix & | ShapeFunctionDerivatives (IndexType DerivativeOrderIndex, IndexType IntegrationPointIndex) const |
|
virtual ShapeFunctionsSecondDerivativesType & | ShapeFunctionsSecondDerivatives (ShapeFunctionsSecondDerivativesType &rResult, const CoordinatesArrayType &rPoint) const |
|
virtual ShapeFunctionsThirdDerivativesType & | ShapeFunctionsThirdDerivatives (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 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...
|
|