222 typename PointType::Pointer pSecondPoint,
223 typename PointType::Pointer pThirdPoint,
224 typename PointType::Pointer pFourthPoint )
234 :
BaseType( rThisPoints, &msGeometryData )
244 ) :
BaseType(GeometryId, rThisPoints, &msGeometryData)
251 const std::string& rGeometryName,
253 ) :
BaseType(rGeometryName, rThisPoints, &msGeometryData)
336 template<
class TOtherPo
intType>
358 return typename BaseType::Pointer(
new Quadrilateral2D4( NewGeometryId, rThisPoints ) );
372 auto p_geometry =
typename BaseType::Pointer(
new Quadrilateral2D4( NewGeometryId, rGeometry.
Points() ) );
373 p_geometry->SetData(rGeometry.
GetData());
380 if ((LocalDirectionIndex == 0) || (LocalDirectionIndex == 1)) {
383 KRATOS_ERROR <<
"Possible direction index reaches from 0-1. Given direction index: "
384 << LocalDirectionIndex << std::endl;
394 if (rResult.size1() != 4 || rResult.size2() != 2)
395 rResult.
resize(4, 2,
false);
396 rResult(0, 0) = -1.0;
397 rResult(0, 1) = -1.0;
399 rResult(1, 1) = -1.0;
402 rResult(3, 0) = -1.0;
433 double length = 0.000;
434 length = sqrt( fabs(
Area() ) );
463 KRATOS_WARNING(
"Quadrilateral2D4") <<
"Method not well defined. Replace with DomainSize() instead. This method preserves current behaviour but will be changed in June 2023 (returning error instead)" << std::endl;
495 const double Tolerance = std::numeric_limits<double>::epsilon()
500 if ( std::abs(rResult[0]) <= (1.0+Tolerance) )
502 if ( std::abs(rResult[1]) <= (1.0+Tolerance) )
569 else if ( triangle_1.
HasIntersection(rLowPoint, rHighPoint) )
return true;
589 switch ( ShapeFunctionIndex )
592 return( 0.25*( 1.0 - rPoint[0] )*( 1.0 - rPoint[1] ) );
594 return( 0.25*( 1.0 + rPoint[0] )*( 1.0 - rPoint[1] ) );
596 return( 0.25*( 1.0 + rPoint[0] )*( 1.0 + rPoint[1] ) );
598 return( 0.25*( 1.0 - rPoint[0] )*( 1.0 + rPoint[1] ) );
600 KRATOS_ERROR <<
"Wrong index of shape function!" << *
this << std::endl;
619 if(rResult.size() != 4) rResult.
resize(4,
false);
620 rResult[0] = 0.25*( 1.0 - rCoordinates[0] )*( 1.0 - rCoordinates[1] );
621 rResult[1] = 0.25*( 1.0 + rCoordinates[0] )*( 1.0 - rCoordinates[1] );
622 rResult[2] = 0.25*( 1.0 + rCoordinates[0] )*( 1.0 + rCoordinates[1] );
623 rResult[3] = 0.25*( 1.0 - rCoordinates[0] )*( 1.0 + rCoordinates[1] );
641 std::string
Info()
const override
643 return "2 dimensional quadrilateral with four nodes in 2D space";
654 rOStream <<
"2 dimensional quadrilateral with four nodes in 2D space";
675 std::cout << std::endl;
681 rOStream <<
" Jacobian in the origin\t : " << jacobian;
693 = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod );
694 const int integration_points_number
698 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
700 Result[pnt] = localGradients[pnt];
714 = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod );
715 const int integration_points_number
719 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
721 Result[pnt] = localGradients[pnt];
739 rResult.
resize( 4, 2 ,
false);
741 rResult( 0, 0 ) = -0.25 * ( 1.0 - rPoint[1] );
742 rResult( 0, 1 ) = -0.25 * ( 1.0 - rPoint[0] );
743 rResult( 1, 0 ) = 0.25 * ( 1.0 - rPoint[1] );
744 rResult( 1, 1 ) = -0.25 * ( 1.0 + rPoint[0] );
745 rResult( 2, 0 ) = 0.25 * ( 1.0 + rPoint[1] );
746 rResult( 2, 1 ) = 0.25 * ( 1.0 + rPoint[0] );
747 rResult( 3, 0 ) = -0.25 * ( 1.0 + rPoint[1] );
748 rResult( 3, 1 ) = 0.25 * ( 1.0 - rPoint[0] );
765 rResult.
resize( 4, 2 ,
false);
766 rResult( 0, 0 ) = -0.25 * ( 1.0 - rPoint.
Y() );
767 rResult( 0, 1 ) = -0.25 * ( 1.0 - rPoint.
X() );
768 rResult( 1, 0 ) = 0.25 * ( 1.0 - rPoint.
Y() );
769 rResult( 1, 1 ) = -0.25 * ( 1.0 + rPoint.
X() );
770 rResult( 2, 0 ) = 0.25 * ( 1.0 + rPoint.
Y() );
771 rResult( 2, 1 ) = 0.25 * ( 1.0 + rPoint.
X() );
772 rResult( 3, 0 ) = -0.25 * ( 1.0 + rPoint.
Y() );
773 rResult( 3, 1 ) = 0.25 * ( 1.0 - rPoint.
X() );
785 if ( rResult.size() != this->PointsNumber() )
793 rResult[0].
resize( 2, 2 ,
false);
794 rResult[1].
resize( 2, 2 ,
false);
795 rResult[2].
resize( 2, 2 ,
false);
796 rResult[3].
resize( 2, 2 ,
false);
798 rResult[0]( 0, 0 ) = 0.0;
799 rResult[0]( 0, 1 ) = 0.25;
800 rResult[0]( 1, 0 ) = 0.25;
801 rResult[0]( 1, 1 ) = 0.0;
803 rResult[1]( 0, 0 ) = 0.0;
804 rResult[1]( 0, 1 ) = -0.25;
805 rResult[1]( 1, 0 ) = -0.25;
806 rResult[1]( 1, 1 ) = 0.0;
808 rResult[2]( 0, 0 ) = 0.0;
809 rResult[2]( 0, 1 ) = 0.25;
810 rResult[2]( 1, 0 ) = 0.25;
811 rResult[2]( 1, 1 ) = 0.0;
813 rResult[3]( 0, 0 ) = 0.0;
814 rResult[3]( 0, 1 ) = -0.25;
815 rResult[3]( 1, 0 ) = -0.25;
816 rResult[3]( 1, 1 ) = 0.0;
829 if ( rResult.size() != this->PointsNumber() )
846 for (
unsigned int j = 0;
j < 2;
j++ )
848 rResult[
i][
j].
resize( 2, 2 ,
false);
862 for (
int i = 0;
i < 4;
i++ )
864 rResult[
i][0]( 0, 0 ) = 0.0;
865 rResult[
i][0]( 0, 1 ) = 0.0;
866 rResult[
i][0]( 1, 0 ) = 0.0;
867 rResult[
i][0]( 1, 1 ) = 0.0;
868 rResult[
i][1]( 0, 0 ) = 0.0;
869 rResult[
i][1]( 0, 1 ) = 0.0;
870 rResult[
i][1]( 1, 0 ) = 0.0;
871 rResult[
i][1]( 1, 1 ) = 0.0;
907 void save(
Serializer& rSerializer )
const override
936 static Matrix CalculateShapeFunctionsIntegrationPointsValues(
940 AllIntegrationPoints();
943 const int integration_points_number = integration_points.size();
945 const int points_number = 4;
947 Matrix shape_function_values( integration_points_number, points_number );
950 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
952 shape_function_values( pnt, 0 ) =
953 0.25 * ( 1.0 - integration_points[pnt].X() )
954 * ( 1.0 - integration_points[pnt].
Y() );
955 shape_function_values( pnt, 1 ) =
956 0.25 * ( 1.0 + integration_points[pnt].X() )
957 * ( 1.0 - integration_points[pnt].
Y() );
958 shape_function_values( pnt, 2 ) =
959 0.25 * ( 1.0 + integration_points[pnt].X() )
960 * ( 1.0 + integration_points[pnt].
Y() );
961 shape_function_values( pnt, 3 ) =
962 0.25 * ( 1.0 - integration_points[pnt].X() )
963 * ( 1.0 + integration_points[pnt].
Y() );
966 return shape_function_values;
979 CalculateShapeFunctionsIntegrationPointsLocalGradients(
983 AllIntegrationPoints();
986 const int integration_points_number = integration_points.size();
992 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
995 result( 0, 0 ) = -0.25 * ( 1.0 - integration_points[pnt].Y() );
996 result( 0, 1 ) = -0.25 * ( 1.0 - integration_points[pnt].X() );
997 result( 1, 0 ) = 0.25 * ( 1.0 - integration_points[pnt].Y() );
998 result( 1, 1 ) = -0.25 * ( 1.0 + integration_points[pnt].X() );
999 result( 2, 0 ) = 0.25 * ( 1.0 + integration_points[pnt].Y() );
1000 result( 2, 1 ) = 0.25 * ( 1.0 + integration_points[pnt].X() );
1001 result( 3, 0 ) = -0.25 * ( 1.0 + integration_points[pnt].Y() );
1002 result( 3, 1 ) = 0.25 * ( 1.0 - integration_points[pnt].X() );
1003 d_shape_f_values[pnt] = result;
1006 return d_shape_f_values;
1017 Quadrature < QuadrilateralGaussLegendreIntegrationPoints1,
1018 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1019 Quadrature < QuadrilateralGaussLegendreIntegrationPoints2,
1020 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1021 Quadrature < QuadrilateralGaussLegendreIntegrationPoints3,
1022 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1023 Quadrature < QuadrilateralGaussLegendreIntegrationPoints4,
1024 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1025 Quadrature < QuadrilateralGaussLegendreIntegrationPoints5,
1026 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1027 Quadrature < QuadrilateralCollocationIntegrationPoints1,
1028 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1029 Quadrature < QuadrilateralCollocationIntegrationPoints2,
1030 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1031 Quadrature < QuadrilateralCollocationIntegrationPoints3,
1032 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1033 Quadrature < QuadrilateralCollocationIntegrationPoints4,
1034 2, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1035 Quadrature < QuadrilateralCollocationIntegrationPoints5,
1036 2, IntegrationPoint<3> >::GenerateIntegrationPoints()
1039 return integration_points;
1050 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1052 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1054 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1056 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1058 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1060 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1062 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1064 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1066 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1068 Quadrilateral2D4<TPointType>::CalculateShapeFunctionsIntegrationPointsValues(
1072 return shape_functions_values;
1079 AllShapeFunctionsLocalGradients()
1096 return shape_functions_local_gradients;
1135 std::istream& rIStream,
1141 std::ostream& rOStream,
1145 rOStream << std::endl;
1152 template<
class TPo
intType>
const
1153 GeometryData Quadrilateral2D4<TPointType>::msGeometryData(
1156 Quadrilateral2D4<TPointType>::AllIntegrationPoints(),
1157 Quadrilateral2D4<TPointType>::AllShapeFunctionsValues(),
1158 AllShapeFunctionsLocalGradients()
1161 template<
class TPo
intType>
const
Definition: geometry_data.h:60
KratosGeometryType
Definition: geometry_data.h:110
@ Kratos_Quadrilateral2D4
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 two node 2D line geometry with linear shape functions.
Definition: line_2d_2.h:65
This class defines the node.
Definition: node.h:65
Point class.
Definition: point.h:59
double Y() const
Definition: point.h:187
double X() const
Definition: point.h:181
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
A four node 2D quadrilateral geometry with bi-linear shape functions.
Definition: quadrilateral_2d_4.h:73
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: quadrilateral_2d_4.h:492
double ShapeFunctionValue(IndexType ShapeFunctionIndex, const CoordinatesArrayType &rPoint) const override
Definition: quadrilateral_2d_4.h:586
BaseType::IntegrationPointType IntegrationPointType
Definition: quadrilateral_2d_4.h:140
Matrix & PointsLocalCoordinates(Matrix &rResult) const override
Definition: quadrilateral_2d_4.h:392
Quadrilateral2D4(Quadrilateral2D4 const &rOther)
Definition: quadrilateral_2d_4.h:267
BaseType::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
Definition: quadrilateral_2d_4.h:168
virtual Matrix & ShapeFunctionsGradients(Matrix &rResult, PointType &rPoint)
Definition: quadrilateral_2d_4.h:763
BaseType::ShapeFunctionsGradientsType ShapeFunctionsGradientsType
Definition: quadrilateral_2d_4.h:182
BaseType::CoordinatesArrayType CoordinatesArrayType
Definition: quadrilateral_2d_4.h:134
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients(IntegrationMethod ThisMethod)
Definition: quadrilateral_2d_4.h:689
double Volume() const override
This method calculates and returns the volume of this geometry.
Definition: quadrilateral_2d_4.h:461
GeometryData::KratosGeometryFamily GetGeometryFamily() const override
Definition: quadrilateral_2d_4.h:294
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients()
Definition: quadrilateral_2d_4.h:710
BaseType::IndexType IndexType
Definition: quadrilateral_2d_4.h:116
Quadrilateral2D4(const std::string &rGeometryName, const PointsArrayType &rThisPoints)
Constructor with Geometry Name.
Definition: quadrilateral_2d_4.h:250
GeometryData::KratosGeometryType GetGeometryType() const override
Definition: quadrilateral_2d_4.h:299
void PrintInfo(std::ostream &rOStream) const override
Definition: quadrilateral_2d_4.h:652
friend class Quadrilateral2D4
Definition: quadrilateral_2d_4.h:1113
double Area() const override
This method calculates and returns area or surface area of this geometry depending to it's dimension.
Definition: quadrilateral_2d_4.h:449
BaseType::Pointer Create(const IndexType NewGeometryId, PointsArrayType const &rThisPoints) const override
Creates a new geometry pointer.
Definition: quadrilateral_2d_4.h:353
ShapeFunctionsThirdDerivativesType & ShapeFunctionsThirdDerivatives(ShapeFunctionsThirdDerivativesType &rResult, const CoordinatesArrayType &rPoint) const override
Definition: quadrilateral_2d_4.h:827
Quadrilateral2D4(typename PointType::Pointer pFirstPoint, typename PointType::Pointer pSecondPoint, typename PointType::Pointer pThirdPoint, typename PointType::Pointer pFourthPoint)
Definition: quadrilateral_2d_4.h:221
~Quadrilateral2D4() override
Definition: quadrilateral_2d_4.h:292
bool HasIntersection(const Point &rLowPoint, const Point &rHighPoint) const override
Definition: quadrilateral_2d_4.h:557
BaseType::IntegrationPointsContainerType IntegrationPointsContainerType
Definition: quadrilateral_2d_4.h:156
BaseType::NormalType NormalType
Definition: quadrilateral_2d_4.h:203
std::string Info() const override
Definition: quadrilateral_2d_4.h:641
KRATOS_CLASS_POINTER_DEFINITION(Quadrilateral2D4)
ShapeFunctionsSecondDerivativesType & ShapeFunctionsSecondDerivatives(ShapeFunctionsSecondDerivativesType &rResult, const CoordinatesArrayType &rPoint) const override
Definition: quadrilateral_2d_4.h:783
Line2D2< TPointType > EdgeType
Definition: quadrilateral_2d_4.h:87
BaseType::SizeType SizeType
Definition: quadrilateral_2d_4.h:123
BaseType::Pointer Create(const IndexType NewGeometryId, const BaseType &rGeometry) const override
Creates a new geometry pointer.
Definition: quadrilateral_2d_4.h:367
BaseType::ShapeFunctionsSecondDerivativesType ShapeFunctionsSecondDerivativesType
Definition: quadrilateral_2d_4.h:190
Quadrilateral2D4 & operator=(const Quadrilateral2D4 &rOther)
Definition: quadrilateral_2d_4.h:319
Quadrilateral2D4(const IndexType GeometryId, const PointsArrayType &rThisPoints)
Constructor with Geometry Name.
Definition: quadrilateral_2d_4.h:241
BaseType::PointsArrayType PointsArrayType
Definition: quadrilateral_2d_4.h:129
BaseType::ShapeFunctionsThirdDerivativesType ShapeFunctionsThirdDerivativesType
Definition: quadrilateral_2d_4.h:198
BaseType::ShapeFunctionsValuesContainerType ShapeFunctionsValuesContainerType
Definition: quadrilateral_2d_4.h:162
void PrintData(std::ostream &rOStream) const override
Definition: quadrilateral_2d_4.h:671
GeometryData::IntegrationMethod IntegrationMethod
Definition: quadrilateral_2d_4.h:97
Quadrilateral2D4(const PointsArrayType &rThisPoints)
Definition: quadrilateral_2d_4.h:233
SizeType EdgesNumber() const override
This method gives you number of all edges of this geometry.
Definition: quadrilateral_2d_4.h:526
TPointType PointType
Definition: quadrilateral_2d_4.h:108
SizeType PointsNumberInDirection(IndexType LocalDirectionIndex) const override
Returns number of points per direction.
Definition: quadrilateral_2d_4.h:378
Vector & ShapeFunctionsValues(Vector &rResult, const CoordinatesArrayType &rCoordinates) const override
Definition: quadrilateral_2d_4.h:617
BaseType::IntegrationPointsArrayType IntegrationPointsArrayType
Definition: quadrilateral_2d_4.h:149
GeometriesArrayType GenerateEdges() const override
This method gives you all edges of this geometry.
Definition: quadrilateral_2d_4.h:539
Geometry< TPointType > BaseType
Definition: quadrilateral_2d_4.h:82
Quadrilateral2D4 & operator=(Quadrilateral2D4< TOtherPointType > const &rOther)
Definition: quadrilateral_2d_4.h:337
BaseType::JacobiansType JacobiansType
Definition: quadrilateral_2d_4.h:175
Quadrilateral2D4(Quadrilateral2D4< TOtherPointType > const &rOther)
Definition: quadrilateral_2d_4.h:284
Matrix & ShapeFunctionsLocalGradients(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: quadrilateral_2d_4.h:736
double Length() const override
Definition: quadrilateral_2d_4.h:430
double DomainSize() const override
This method calculates and returns length, area or volume of this geometry depending to it's dimensio...
Definition: quadrilateral_2d_4.h:479
BaseType::GeometriesArrayType GeometriesArrayType
Definition: quadrilateral_2d_4.h:103
The serialization consists in storing the state of an object into a storage format like data file or ...
Definition: serializer.h:123
A three node 2D triangle geometry with linear shape functions.
Definition: triangle_2d_3.h:74
bool HasIntersection(const BaseType &rThisGeometry) const override
Detect if this triangle is intersected with another geometry.
Definition: triangle_2d_3.h:518
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
#define KRATOS_WARNING(label)
Definition: logger.h:265
REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES.
Definition: mesh_condition.cpp:21
const GeometryData Quadrilateral2D4< TPointType >::msGeometryData & msGeometryDimension(), Quadrilateral2D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
Definition: brep_curve.h:483
KratosZeroMatrix< double > ZeroMatrix
Definition: amatrix_interface.h:559
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
int j
Definition: quadrature.py:648
float temp
Definition: rotating_cone.py:85
integer i
Definition: TensorModule.f:17