65 template<
class TPo
intType>
222 typename PointType::Pointer pSecondPoint,
223 typename PointType::Pointer pThirdPoint,
224 typename PointType::Pointer pFourthPoint,
225 typename PointType::Pointer pFifthPoint,
226 typename PointType::Pointer pSixthPoint
239 :
BaseType( ThisPoints, &msGeometryData )
251 ) :
BaseType( GeometryId, rThisPoints, &msGeometryData )
258 const std::string& rGeometryName,
260 ) :
BaseType( rGeometryName, rThisPoints, &msGeometryData )
343 template<
class TOtherPo
intType>
363 return typename BaseType::Pointer(
new Triangle2D6( rThisPoints ) );
377 return typename BaseType::Pointer(
new Triangle2D6( NewGeometryId, rThisPoints ) );
389 auto p_geometry =
typename BaseType::Pointer(
new Triangle2D6( rGeometry.
Points() ) );
390 p_geometry->SetData(rGeometry.
GetData());
405 auto p_geometry =
typename BaseType::Pointer(
new Triangle2D6( NewGeometryId, rGeometry.
Points() ) );
406 p_geometry->SetData(rGeometry.
GetData());
417 rResult.
resize( 6, 2,
false );
419 rResult( 0, 0 ) = 0.0;
420 rResult( 0, 1 ) = 0.0;
421 rResult( 1, 0 ) = 1.0;
422 rResult( 1, 1 ) = 0.0;
423 rResult( 2, 0 ) = 0.0;
424 rResult( 2, 1 ) = 1.0;
425 rResult( 3, 0 ) = 0.5;
426 rResult( 3, 1 ) = 0.0;
427 rResult( 4, 0 ) = 0.5;
428 rResult( 4, 1 ) = 0.5;
429 rResult( 5, 0 ) = 0.0;
430 rResult( 5, 1 ) = 0.5;
459 return std::sqrt( std::abs(
Area() ) );
514 const double Tolerance = std::numeric_limits<double>::epsilon()
519 if ( (rResult[0] >= (0.0-Tolerance)) && (rResult[0] <= (1.0+Tolerance)) )
521 if ( (rResult[1] >= (0.0-Tolerance)) && (rResult[1] <= (1.0+Tolerance)) )
523 if ( (rResult[0] + rResult[1]) <= (1.0+Tolerance) )
545 if (rResult.size() != 6)
547 const double thirdCoord = 1.0 - rCoordinates[0] - rCoordinates[1];
548 rResult[0] = thirdCoord * (2.0 * thirdCoord - 1.0);
549 rResult[1] = rCoordinates[0] * (2.0 * rCoordinates[0] - 1.0);
550 rResult[2] = rCoordinates[1] * (2.0 * rCoordinates[1] - 1.0);
551 rResult[3] = 4.0 * thirdCoord * rCoordinates[0];
552 rResult[4] = 4.0 * rCoordinates[0] * rCoordinates[1];
553 rResult[5] = 4.0 * rCoordinates[1] * thirdCoord;
570 double thirdCoord = 1 - rPoint[0] - rPoint[1];
572 switch ( ShapeFunctionIndex )
575 return( thirdCoord*( 2*thirdCoord - 1 ) );
577 return( rPoint[0]*( 2*rPoint[0] - 1 ) );
579 return( rPoint[1]*( 2*rPoint[1] - 1 ) );
581 return( 4*thirdCoord*rPoint[0] );
583 return( 4*rPoint[0]*rPoint[1] );
585 return( 4*rPoint[1]*thirdCoord );
588 KRATOS_ERROR <<
"Wrong index of shape function!" << *
this << std::endl;
605 std::string
Info()
const override
607 return "2 dimensional triangle with six nodes in 2D space";
618 rOStream <<
"2 dimensional triangle with six nodes in 2D space";
639 std::cout << std::endl;
645 rOStream <<
" Jacobian in the origin\t : " << jacobian;
738 = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod );
739 const int integration_points_number
743 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
745 Result[pnt] = localGradients[pnt];
759 = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod );
760 const int integration_points_number
764 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
766 Result[pnt] = localGradients[pnt];
784 rResult.
resize( 6, 2 ,
false);
785 double thirdCoord = 1 - rPoint[0] - rPoint[1];
786 double thirdCoord_DX = -1;
787 double thirdCoord_DY = -1;
790 rResult( 0, 0 ) = ( 4 * thirdCoord - 1 ) * thirdCoord_DX;
791 rResult( 0, 1 ) = ( 4 * thirdCoord - 1 ) * thirdCoord_DY;
792 rResult( 1, 0 ) = 4 * rPoint[0] - 1;
795 rResult( 2, 1 ) = 4 * rPoint[1] - 1;
796 rResult( 3, 0 ) = 4 * thirdCoord_DX * rPoint[0] + 4 * thirdCoord;
797 rResult( 3, 1 ) = 4 * thirdCoord_DY * rPoint[0];
798 rResult( 4, 0 ) = 4 * rPoint[1];
799 rResult( 4, 1 ) = 4 * rPoint[0];
800 rResult( 5, 0 ) = 4 * rPoint[1] * thirdCoord_DX;
801 rResult( 5, 1 ) = 4 * rPoint[1] * thirdCoord_DY + 4 * thirdCoord;
818 rResult.
resize( 6, 2 ,
false);
819 double thirdCoord = 1 - rPoint[0] - rPoint[1];
820 double thirdCoord_DX = -1;
821 double thirdCoord_DY = -1;
824 rResult( 0, 0 ) = ( 4 * thirdCoord - 1 ) * thirdCoord_DX;
825 rResult( 0, 1 ) = ( 4 * thirdCoord - 1 ) * thirdCoord_DY;
826 rResult( 1, 0 ) = 4 * rPoint[0] - 1;
829 rResult( 2, 1 ) = 4 * rPoint[1] - 1;
830 rResult( 3, 0 ) = 4 * thirdCoord_DX * rPoint[0] + 4 * thirdCoord;
831 rResult( 3, 1 ) = 4 * thirdCoord_DY * rPoint[0];
832 rResult( 4, 0 ) = 4 * rPoint[1];
833 rResult( 4, 1 ) = 4 * rPoint[0];
834 rResult( 5, 0 ) = 4 * rPoint[1] * thirdCoord_DX;
835 rResult( 5, 1 ) = 4 * rPoint[1] * thirdCoord_DY + 4 * thirdCoord;
847 if ( rResult.size() != this->PointsNumber() )
855 rResult[0].
resize( 2, 2 ,
false);
856 rResult[1].
resize( 2, 2 ,
false);
857 rResult[2].
resize( 2, 2 ,
false);
858 rResult[3].
resize( 2, 2 ,
false);
859 rResult[4].
resize( 2, 2 ,
false);
860 rResult[5].
resize( 2, 2 ,
false);
862 rResult[0]( 0, 0 ) = 4.0;
863 rResult[0]( 0, 1 ) = 4.0;
864 rResult[0]( 1, 0 ) = 4.0;
865 rResult[0]( 1, 1 ) = 4.0;
866 rResult[1]( 0, 0 ) = 4.0;
867 rResult[1]( 0, 1 ) = 0.0;
868 rResult[1]( 1, 0 ) = 0.0;
869 rResult[1]( 1, 1 ) = 0.0;
870 rResult[2]( 0, 0 ) = 0.0;
871 rResult[2]( 0, 1 ) = 0.0;
872 rResult[2]( 1, 0 ) = 0.0;
873 rResult[2]( 1, 1 ) = 4.0;
874 rResult[3]( 0, 0 ) = -8.0;
875 rResult[3]( 0, 1 ) = -4.0;
876 rResult[3]( 1, 0 ) = -4.0;
877 rResult[3]( 1, 1 ) = 0.0;
878 rResult[4]( 0, 0 ) = 0.0;
879 rResult[4]( 0, 1 ) = 4.0;
880 rResult[4]( 1, 0 ) = 4.0;
881 rResult[4]( 1, 1 ) = 0.0;
882 rResult[5]( 0, 0 ) = 0.0;
883 rResult[5]( 0, 1 ) = -4.0;
884 rResult[5]( 1, 0 ) = -4.0;
885 rResult[5]( 1, 1 ) = -8.0;
898 if ( rResult.size() != this->PointsNumber() )
913 rResult[0][0].
resize( 2, 2 ,
false);
915 rResult[0][1].
resize( 2, 2 ,
false);
916 rResult[1][0].
resize( 2, 2 ,
false);
917 rResult[1][1].
resize( 2, 2 ,
false);
918 rResult[2][0].
resize( 2, 2 ,
false);
919 rResult[2][1].
resize( 2, 2 ,
false);
920 rResult[3][0].
resize( 2, 2 ,
false);
921 rResult[3][1].
resize( 2, 2 ,
false);
922 rResult[4][0].
resize( 2, 2 ,
false);
923 rResult[4][1].
resize( 2, 2 ,
false);
924 rResult[5][0].
resize( 2, 2 ,
false);
925 rResult[5][1].
resize( 2, 2 ,
false);
928 for (
int i = 0;
i < 6;
i++ )
930 rResult[
i][0]( 0, 0 ) = 0.0;
931 rResult[
i][0]( 0, 1 ) = 0.0;
932 rResult[
i][0]( 1, 0 ) = 0.0;
933 rResult[
i][0]( 1, 1 ) = 0.0;
934 rResult[
i][1]( 0, 0 ) = 0.0;
935 rResult[
i][1]( 0, 1 ) = 0.0;
936 rResult[
i][1]( 1, 0 ) = 0.0;
937 rResult[
i][1]( 1, 1 ) = 0.0;
968 void save(
Serializer& rSerializer )
const override
1001 static Matrix CalculateShapeFunctionsIntegrationPointsValues(
1005 AllIntegrationPoints();
1008 const int integration_points_number = integration_points.size();
1010 const int points_number = 6;
1012 Matrix shape_function_values( integration_points_number, points_number );
1015 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
1017 double thirdCoord = 1 - integration_points[pnt].X() - integration_points[pnt].Y();
1019 shape_function_values( pnt, 0 ) = thirdCoord * ( 2 * thirdCoord - 1 ) ;
1020 shape_function_values( pnt, 1 ) = integration_points[pnt].X() * ( 2 * integration_points[pnt].X() - 1 ) ;
1021 shape_function_values( pnt, 2 ) = integration_points[pnt].Y() * ( 2 * integration_points[pnt].Y() - 1 ) ;
1022 shape_function_values( pnt, 3 ) = 4 * thirdCoord * integration_points[pnt].X();
1023 shape_function_values( pnt, 4 ) = 4 * integration_points[pnt].X() * integration_points[pnt].Y();
1024 shape_function_values( pnt, 5 ) = 4 * integration_points[pnt].Y() * thirdCoord;
1028 return shape_function_values;
1041 CalculateShapeFunctionsIntegrationPointsLocalGradients(
1045 AllIntegrationPoints();
1048 const int integration_points_number = integration_points.size();
1054 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
1057 double thirdCoord = 1 - integration_points[pnt].X() - integration_points[pnt].Y();
1058 double thirdCoord_DX = -1;
1059 double thirdCoord_DY = -1;
1062 result( 0, 0 ) = ( 4 * thirdCoord - 1 ) * thirdCoord_DX;
1063 result( 0, 1 ) = ( 4 * thirdCoord - 1 ) * thirdCoord_DY;
1064 result( 1, 0 ) = 4 * integration_points[pnt].X() - 1;
1067 result( 2, 1 ) = 4 * integration_points[pnt].Y() - 1;
1068 result( 3, 0 ) = 4 * thirdCoord_DX * integration_points[pnt].X() + 4 * thirdCoord;
1069 result( 3, 1 ) = 4 * thirdCoord_DY * integration_points[pnt].X();
1070 result( 4, 0 ) = 4 * integration_points[pnt].Y();
1071 result( 4, 1 ) = 4 * integration_points[pnt].X();
1072 result( 5, 0 ) = 4 * integration_points[pnt].Y() * thirdCoord_DX;
1073 result( 5, 1 ) = 4 * integration_points[pnt].Y() * thirdCoord_DY + 4 * thirdCoord;
1075 d_shape_f_values[pnt] = result;
1078 return d_shape_f_values;
1089 Quadrature<TriangleGaussLegendreIntegrationPoints1, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1090 Quadrature<TriangleGaussLegendreIntegrationPoints2, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1091 Quadrature<TriangleGaussLegendreIntegrationPoints3, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1092 Quadrature<TriangleGaussLegendreIntegrationPoints4, 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1095 return integration_points;
1103 Triangle2D6<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1105 Triangle2D6<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1107 Triangle2D6<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1109 Triangle2D6<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1113 return shape_functions_values;
1117 AllShapeFunctionsLocalGradients()
1128 return shape_functions_local_gradients;
1167 std::istream& rIStream,
1173 std::ostream& rOStream,
1177 rOStream << std::endl;
1184 template<
class TPo
intType>
const
1185 GeometryData Triangle2D6<TPointType>::msGeometryData(
1188 Triangle2D6<TPointType>::AllIntegrationPoints(),
1189 Triangle2D6<TPointType>::AllShapeFunctionsValues(),
1190 AllShapeFunctionsLocalGradients()
1193 template<
class TPo
intType>
Definition: geometry_data.h:60
KratosGeometryType
Definition: geometry_data.h:110
SizeType IntegrationPointsNumber() const
Definition: geometry_data.h:430
IntegrationMethod
Definition: geometry_data.h:76
KratosGeometryFamily
Definition: geometry_data.h:91
IntegrationMethod DefaultIntegrationMethod() const
Definition: geometry_data.h:425
Definition: geometry_dimension.h:42
Geometry base class.
Definition: geometry.h:71
SizeType PointsNumber() const
Definition: geometry.h:528
virtual void PrintData(std::ostream &rOStream) const
Print object's data.
Definition: geometry.h:3834
Geometry & operator=(const Geometry &rOther)
Definition: geometry.h:400
std::vector< IntegrationPointType > IntegrationPointsArrayType
Definition: geometry.h:161
DataValueContainer & GetData()
Definition: geometry.h:591
std::size_t SizeType
Definition: geometry.h:144
const TPointType::Pointer pGetPoint(const int Index) const
Definition: geometry.h:1790
std::size_t IndexType
Definition: geometry.h:137
std::array< Matrix, static_cast< int >GeometryData::IntegrationMethod::NumberOfIntegrationMethods)> ShapeFunctionsValuesContainerType
Definition: geometry.h:172
virtual CoordinatesArrayType & PointLocalCoordinates(CoordinatesArrayType &rResult, const CoordinatesArrayType &rPoint) const
Returns the local coordinates of a given arbitrary point.
Definition: geometry.h:1854
const PointsArrayType & Points() const
Definition: geometry.h:1768
bool AllPointsAreValid() const
Checks if the geometry points are valid Checks if the geometry points are valid from the pointer valu...
Definition: geometry.h:4093
std::array< IntegrationPointsArrayType, static_cast< int >GeometryData::IntegrationMethod::NumberOfIntegrationMethods)> IntegrationPointsContainerType
Definition: geometry.h:167
JacobiansType & Jacobian(JacobiansType &rResult) const
Definition: geometry.h:2901
GeometryData::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
Definition: geometry.h:177
GeometryData::IntegrationMethod IntegrationMethod
Definition: geometry.h:122
Short class definition.
Definition: integration_point.h:52
static double ComputeArea2DGeometry(const Geometry< TPointType > &rGeometry)
This method calculates and returns the volume of the geometry from a 3D geometry.
Definition: integration_utilities.h:107
Definition: amatrix_interface.h:41
void swap(Matrix &Other)
Definition: amatrix_interface.h:289
void resize(std::size_t NewSize1, std::size_t NewSize2, bool preserve=0)
Definition: amatrix_interface.h:224
An three node 2D line geometry with quadratic shape functions.
Definition: line_2d_3.h:63
PointerVector is a container like stl vector but using a vector to store pointers to its data.
Definition: pointer_vector.h:72
void push_back(const TPointerType &x)
Definition: pointer_vector.h:270
The serialization consists in storing the state of an object into a storage format like data file or ...
Definition: serializer.h:123
A six node 2D triangular geometry with quadratic shape functions.
Definition: triangle_2d_6.h:68
BaseType::ShapeFunctionsValuesContainerType ShapeFunctionsValuesContainerType
Definition: triangle_2d_6.h:157
TPointType PointType
Definition: triangle_2d_6.h:103
Triangle2D6(Triangle2D6 const &rOther)
Definition: triangle_2d_6.h:274
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients()
Definition: triangle_2d_6.h:755
BaseType::ShapeFunctionsGradientsType ShapeFunctionsGradientsType
Definition: triangle_2d_6.h:177
virtual Matrix & ShapeFunctionsGradients(Matrix &rResult, CoordinatesArrayType &rPoint)
Definition: triangle_2d_6.h:816
BaseType::ShapeFunctionsSecondDerivativesType ShapeFunctionsSecondDerivativesType
Definition: triangle_2d_6.h:185
Triangle2D6(const std::string &rGeometryName, const PointsArrayType &rThisPoints)
Constructor with Geometry Name.
Definition: triangle_2d_6.h:257
GeometryData::KratosGeometryFamily GetGeometryFamily() const override
Definition: triangle_2d_6.h:301
BaseType::CoordinatesArrayType CoordinatesArrayType
Definition: triangle_2d_6.h:129
void NumberNodesInFaces(DenseVector< unsigned int > &NumberNodesInFaces) const override
Definition: triangle_2d_6.h:693
Triangle2D6(Triangle2D6< TOtherPointType > const &rOther)
Definition: triangle_2d_6.h:291
BaseType::IndexType IndexType
Definition: triangle_2d_6.h:111
GeometryData::IntegrationMethod IntegrationMethod
Definition: triangle_2d_6.h:92
BaseType::JacobiansType JacobiansType
Definition: triangle_2d_6.h:170
Triangle2D6 & operator=(Triangle2D6< TOtherPointType > const &rOther)
Definition: triangle_2d_6.h:344
SizeType FacesNumber() const override
Returns the number of faces of the current geometry.
Definition: triangle_2d_6.h:687
Matrix & PointsLocalCoordinates(Matrix &rResult) const override
Definition: triangle_2d_6.h:415
BaseType::SizeType SizeType
Definition: triangle_2d_6.h:118
friend class Triangle2D6
Definition: triangle_2d_6.h:1145
Triangle2D6 & operator=(const Triangle2D6 &rOther)
Definition: triangle_2d_6.h:326
Geometry< TPointType > BaseType
Definition: triangle_2d_6.h:77
double ShapeFunctionValue(IndexType ShapeFunctionIndex, const CoordinatesArrayType &rPoint) const override
Definition: triangle_2d_6.h:566
Triangle2D6(typename PointType::Pointer pFirstPoint, typename PointType::Pointer pSecondPoint, typename PointType::Pointer pThirdPoint, typename PointType::Pointer pFourthPoint, typename PointType::Pointer pFifthPoint, typename PointType::Pointer pSixthPoint)
Definition: triangle_2d_6.h:221
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients(IntegrationMethod ThisMethod)
Definition: triangle_2d_6.h:734
BaseType::GeometriesArrayType GeometriesArrayType
Definition: triangle_2d_6.h:98
bool IsInside(const CoordinatesArrayType &rPoint, CoordinatesArrayType &rResult, const double Tolerance=std::numeric_limits< double >::epsilon()) const override
Returns whether given arbitrary point is inside the Geometry and the respective local point for the g...
Definition: triangle_2d_6.h:511
BaseType::IntegrationPointsArrayType IntegrationPointsArrayType
Definition: triangle_2d_6.h:144
void NodesInFaces(DenseMatrix< unsigned int > &NodesInFaces) const override
Definition: triangle_2d_6.h:705
BaseType::Pointer Create(const BaseType &rGeometry) const override
Creates a new geometry pointer.
Definition: triangle_2d_6.h:385
KRATOS_CLASS_POINTER_DEFINITION(Triangle2D6)
double Area() const override
This method calculates and returns area or surface area of this geometry depending to it's dimension.
Definition: triangle_2d_6.h:471
void PrintData(std::ostream &rOStream) const override
Definition: triangle_2d_6.h:635
BaseType::ShapeFunctionsThirdDerivativesType ShapeFunctionsThirdDerivativesType
Definition: triangle_2d_6.h:193
BaseType::PointsArrayType PointsArrayType
Definition: triangle_2d_6.h:124
BaseType::IntegrationPointsContainerType IntegrationPointsContainerType
Definition: triangle_2d_6.h:151
double Length() const override
Definition: triangle_2d_6.h:457
std::string Info() const override
Definition: triangle_2d_6.h:605
SizeType EdgesNumber() const override
This method gives you number of all edges of this geometry.
Definition: triangle_2d_6.h:664
Matrix & ShapeFunctionsLocalGradients(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: triangle_2d_6.h:781
Vector & ShapeFunctionsValues(Vector &rResult, const CoordinatesArrayType &rCoordinates) const override
Returns vector of shape function values at local coordinate.
Definition: triangle_2d_6.h:543
ShapeFunctionsSecondDerivativesType & ShapeFunctionsSecondDerivatives(ShapeFunctionsSecondDerivativesType &rResult, const CoordinatesArrayType &rPoint) const override
Definition: triangle_2d_6.h:845
BaseType::Pointer Create(PointsArrayType const &rThisPoints) const override
Creates a new geometry pointer.
Definition: triangle_2d_6.h:359
~Triangle2D6() override
Definition: triangle_2d_6.h:299
GeometriesArrayType GenerateEdges() const override
This method gives you all edges of this geometry.
Definition: triangle_2d_6.h:677
BaseType::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
Definition: triangle_2d_6.h:163
double DomainSize() const override
This method calculates and returns length, area or volume of this geometry depending to it's dimensio...
Definition: triangle_2d_6.h:498
void PrintInfo(std::ostream &rOStream) const override
Definition: triangle_2d_6.h:616
ShapeFunctionsThirdDerivativesType & ShapeFunctionsThirdDerivatives(ShapeFunctionsThirdDerivativesType &rResult, const CoordinatesArrayType &rPoint) const override
Definition: triangle_2d_6.h:896
BaseType::Pointer Create(const IndexType NewGeometryId, const BaseType &rGeometry) const override
Creates a new geometry pointer.
Definition: triangle_2d_6.h:400
Triangle2D6(const PointsArrayType &ThisPoints)
Definition: triangle_2d_6.h:238
Triangle2D6(const IndexType GeometryId, const PointsArrayType &rThisPoints)
Constructor with Geometry Id.
Definition: triangle_2d_6.h:248
Line2D3< TPointType > EdgeType
Definition: triangle_2d_6.h:82
BaseType::IntegrationPointType IntegrationPointType
Definition: triangle_2d_6.h:135
BaseType::NormalType NormalType
Definition: triangle_2d_6.h:198
BaseType::Pointer Create(const IndexType NewGeometryId, PointsArrayType const &rThisPoints) const override
Creates a new geometry pointer.
Definition: triangle_2d_6.h:372
GeometryData::KratosGeometryType GetGeometryType() const override
Definition: triangle_2d_6.h:306
Short class definition.
Definition: array_1d.h:61
#define KRATOS_SERIALIZE_SAVE_BASE_CLASS(Serializer, BaseType)
Definition: define.h:812
#define KRATOS_SERIALIZE_LOAD_BASE_CLASS(Serializer, BaseType)
Definition: define.h:815
#define KRATOS_ERROR
Definition: exception.h:161
#define KRATOS_ERROR_IF(conditional)
Definition: exception.h:162
REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES.
Definition: mesh_condition.cpp:21
KratosZeroMatrix< double > ZeroMatrix
Definition: amatrix_interface.h:559
const GeometryData Triangle2D6< TPointType >::msGeometryData & msGeometryDimension(), Triangle2D6< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
Definition: brep_curve.h:483
Internals::Matrix< double, AMatrix::dynamic, AMatrix::dynamic > Matrix
Definition: amatrix_interface.h:470
std::istream & operator>>(std::istream &rIStream, LinearMasterSlaveConstraint &rThis)
input stream function
const GeometryData BrepCurve< TContainerPointType, TContainerPointEmbeddedType >::msGeometryData & msGeometryDimension
Definition: brep_curve.h:483
T & noalias(T &TheMatrix)
Definition: amatrix_interface.h:484
std::ostream & operator<<(std::ostream &rOStream, const LinearMasterSlaveConstraint &rThis)
output stream function
Definition: linear_master_slave_constraint.h:432
def load(f)
Definition: ode_solve.py:307
float temp
Definition: rotating_cone.py:85
integer i
Definition: TensorModule.f:17