62 template<
class TPo
intType>
175 Line2D2(
typename PointType::Pointer pFirstPoint,
typename PointType::Pointer pSecondPoint )
184 :
BaseType( ThisPoints, &msGeometryData )
194 ) :
BaseType( GeometryId, rThisPoints, &msGeometryData)
201 const std::string& rGeometryName,
203 ) :
BaseType(rGeometryName, rThisPoints, &msGeometryData)
282 template<
class TOtherPo
intType>
305 return typename BaseType::Pointer(
new Line2D2( NewGeometryId, rThisPoints ) );
319 auto p_geometry =
typename BaseType::Pointer(
new Line2D2( NewGeometryId, rGeometry.
Points() ) );
320 p_geometry->SetData(rGeometry.
GetData());
337 if(rResult.size() != 2)
338 rResult.
resize( 2,
false );
365 const double lx = FirstPoint.X() - SecondPoint.X();
366 const double ly = FirstPoint.Y() - SecondPoint.Y();
368 const double length = lx * lx + ly * ly;
370 return std::sqrt( length );
436 std::fill( rResult.
begin(), rResult.
end(), jacobian );
471 std::fill( rResult.
begin(), rResult.
end(), jacobian );
495 rResult.
resize( 2, 1,
false );
515 rResult.
resize( 2, 1,
false );
536 if(rResult.size() != integration_points_number)
538 rResult.
resize(integration_points_number,
false);
541 const double detJ = 0.5*(this->
Length());
543 for (
unsigned int pnt = 0; pnt < integration_points_number; pnt++ )
570 return 0.5*(this->
Length());
587 return 0.5*(this->
Length());
746 if(rResult.size() != 2)
751 rResult[0] = 0.5 * ( 1.0 - rCoordinates[0]);
752 rResult[1] = 0.5 * ( 1.0 + rCoordinates[0]);
769 switch ( ShapeFunctionIndex )
772 return( 0.5 * ( 1.0 - rPoint[0] ) );
774 return( 0.5 * ( 1.0 + rPoint[0] ) );
776 KRATOS_ERROR <<
"Wrong index of shape function!" << *
this << std::endl;
792 std::string
Info()
const override
794 return "1 dimensional line in 2D space";
805 rOStream <<
"1 dimensional line in 2D space";
820 std::cout << std::endl;
826 rOStream <<
" Jacobian\t : " << jacobian;
838 = CalculateShapeFunctionsIntegrationPointsLocalGradients( ThisMethod );
839 const int integration_points_number
843 for (
int pnt = 0; pnt < integration_points_number; pnt++ )
845 Result[pnt] = localGradients[pnt];
864 if(rResult.size1() != 2 || rResult.size2() != 1)
866 rResult.
resize( 2, 1,
false );
869 rResult( 0, 0 ) = - 0.5;
870 rResult( 1, 0 ) = 0.5;
890 normal[0] = second_point[1] - first_point[1];
891 normal[1] = first_point[0] - second_point[0];
904 if(rResult.size1() != 2 || rResult.size2() != 1)
906 rResult.
resize( 2, 1,
false );
909 rResult( 0, 0 ) = -1.0;
910 rResult( 1, 0 ) = 1.0;
924 if(rResult.size1() != 2 || rResult.size2() != 1)
926 rResult.
resize( 2, 1,
false );
930 rResult( 0, 0 ) = - 0.5;
931 rResult( 1, 0 ) = 0.5;
946 const double Tolerance = std::numeric_limits<double>::epsilon()
950 const Point point_to_project(rPoint);
951 Point point_projected;
955 if (std::abs(distance) > std::numeric_limits<double>::epsilon()) {
956 if (std::abs(distance) > 1.0e-6 *
Length()) {
957 KRATOS_WARNING_FIRST_N(
"Line2D2", 10) <<
"The point of coordinates X: " << rPoint[0] <<
"\tY: " << rPoint[1] <<
" it is in a distance: " << std::abs(distance) << std::endl;
964 if ( std::abs( rResult[0] ) <= (1.0 + Tolerance) ) {
979 const double tolerance = std::numeric_limits<double>::epsilon();
985 const TPointType& first_point_other = *rOtherGeometry(0);
986 const TPointType& second_point_other = *rOtherGeometry(1);
989 const double numerator = ( (first_point[0]-first_point_other[0])*(first_point_other[1] - second_point_other[1]) - (first_point[1]-first_point_other[1])*(first_point_other[0]-second_point_other[0]) );
990 const double denominator = ( (first_point[0]-second_point[0])*(first_point_other[1] - second_point_other[1]) - (first_point[1]-second_point[1])*(first_point_other[0]-second_point_other[0]) );
991 if (std::abs(denominator) < tolerance)
993 const double t = numerator / denominator;
995 return (0.0-tolerance<=
t) && (
t<=1.0+tolerance);
1008 const double tolerance = std::numeric_limits<double>::epsilon();
1014 ( (first_point[0] >= rLowPoint[0] && first_point[0] <= rHighPoint[0])
1015 && (first_point[1] >= rLowPoint[1] && first_point[1] <= rHighPoint[1]) )
1017 ( (second_point[0] >= rLowPoint[0] && second_point[0] <= rHighPoint[0])
1018 && (second_point[1] >= rLowPoint[1] && second_point[1] <= rHighPoint[1]) )
1022 const double high_x = rHighPoint[0];
1023 const double high_y = rHighPoint[1];
1024 const double low_x = rLowPoint[0];
1025 const double low_y = rLowPoint[1];
1027 const double denominator = ( second_point[0] - first_point[0] );
1028 const double numerator = (second_point[1] - first_point[1]);
1029 const double slope = std::abs(denominator) > tolerance ? std::abs(numerator) > tolerance ? numerator / denominator : 1.0e-12 : 1.0e12;
1032 const double y_1 = slope*( low_x - first_point[0] ) + first_point[1];
1033 if(y_1 >= low_y - tolerance && y_1 <= high_y+tolerance)
1036 const double y_2 = slope*( high_x - first_point[0] ) + first_point[1];
1037 if(y_2 >= low_y - tolerance && y_2 <= high_y+tolerance)
1040 const double x_1 = first_point[0] + ( (low_y - first_point[1]) / slope );
1041 if(x_1 >= low_x-tolerance && x_1 <= high_x+tolerance)
1044 const double x_2 = first_point[0] + ( (high_y - first_point[1]) / slope );
1045 if(x_2 >= low_x-tolerance && x_2 <= high_x+tolerance)
1070 const double tolerance = 1
e-14;
1072 const double length =
Length();
1074 const double length_1 = std::sqrt( std::pow(rPoint[0] - r_first_point[0], 2)
1075 + std::pow(rPoint[1] - r_first_point[1], 2));
1077 const double length_2 = std::sqrt( std::pow(rPoint[0] - r_second_point[0], 2)
1078 + std::pow(rPoint[1] - r_second_point[1], 2));
1080 if (length_1 <= (length + tolerance) && length_2 <= (length + tolerance)) {
1081 rResult[0] = 2.0 * length_1/(length + tolerance) - 1.0;
1083 if (length_1 > length_2) {
1084 rResult[0] = 2.0 * length_1/(length + tolerance) - 1.0;
1086 rResult[0] = -2.0 * length_1/(length + tolerance) - 1.0;
1126 KRATOS_DEPRECATED_MESSAGE(
"This method is deprecated. Use either \'ProjectionPointLocalToLocalSpace\' or \'ProjectionPointGlobalToLocalSpace\' instead.")
1131 const double Tolerance =
std::numeric_limits<
double>::epsilon()
1134 KRATOS_WARNING(
"ProjectionPoint") <<
"This method is deprecated. Use either \'ProjectionPointLocalToLocalSpace\' or \'ProjectionPointGlobalToLocalSpace\' instead." << std::endl;
1138 this->
GlobalCoordinates(rProjectedPointGlobalCoordinates, rProjectedPointLocalCoordinates);
1146 const double Tolerance = std::numeric_limits<double>::epsilon()
1160 const double Tolerance = std::numeric_limits<double>::epsilon()
1234 void save(
Serializer& rSerializer )
const override
1260 Matrix N( integration_points_number, 2 );
1262 for (
int it_gp = 0; it_gp < integration_points_number; it_gp++ )
1265 N( it_gp, 0 ) = 0.5 * ( 1 -
e );
1266 N( it_gp, 1 ) = 0.5 * ( 1 +
e );
1281 aux_mat(0, 0) = -0.5;
1282 aux_mat(1, 0) = 0.5;
1283 DN_De[it_gp] = aux_mat;
1293 Quadrature<LineGaussLegendreIntegrationPoints1, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1294 Quadrature<LineGaussLegendreIntegrationPoints2, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1295 Quadrature<LineGaussLegendreIntegrationPoints3, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1296 Quadrature<LineGaussLegendreIntegrationPoints4, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1297 Quadrature<LineGaussLegendreIntegrationPoints5, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1298 Quadrature<LineCollocationIntegrationPoints1, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1299 Quadrature<LineCollocationIntegrationPoints2, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1300 Quadrature<LineCollocationIntegrationPoints3, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1301 Quadrature<LineCollocationIntegrationPoints4, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1302 Quadrature<LineCollocationIntegrationPoints5, 1, IntegrationPoint<3> >::GenerateIntegrationPoints()
1305 return integration_points;
1323 return shape_functions_values;
1341 return shape_functions_local_gradients;
1358 template<
class TOtherPo
intType>
friend class Line2D2;
1382 template<
class TPo
intType>
1387 template<
class TPo
intType>
1392 rOStream << std::endl;
1401 template<
class TPo
intType>
1402 const GeometryData Line2D2<TPointType>::msGeometryData(
1405 Line2D2<TPointType>::AllIntegrationPoints(),
1406 Line2D2<TPointType>::AllShapeFunctionsValues(),
1407 AllShapeFunctionsLocalGradients() );
1409 template<
class TPo
intType>
static double FastProjectOnLine2D(const TGeometryType &rGeometry, const TPointClass1 &rPointToProject, TPointClass2 &rPointProjected)
Project a point over a line (2D only)
Definition: geometrical_projection_utilities.h:267
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
virtual CoordinatesArrayType & GlobalCoordinates(CoordinatesArrayType &rResult, CoordinatesArrayType const &LocalCoordinates) const
Definition: geometry.h:2377
std::vector< IntegrationPointType > IntegrationPointsArrayType
Definition: geometry.h:161
DataValueContainer & GetData()
Definition: geometry.h:591
KRATOS_DEPRECATED_MESSAGE("This is legacy version (use GenerateEdges instead)") virtual GeometriesArrayType Edges(void)
This method gives you all edges of this geometry.
Definition: geometry.h:2106
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
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
LumpingMethods
This defines the different methods to compute the lumping methods.
Definition: geometry.h:109
const IntegrationPointsArrayType & IntegrationPoints() const
Definition: geometry.h:2284
TPointType const & GetPoint(const int Index) const
Definition: geometry.h:1816
GeometryData::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
Definition: geometry.h:177
SizeType IntegrationPointsNumber() const
Definition: geometry.h:2257
GeometryData::IntegrationMethod IntegrationMethod
Definition: geometry.h:122
Short class definition.
Definition: integration_point.h:52
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
iterator end()
Definition: amatrix_interface.h:243
iterator begin()
Definition: amatrix_interface.h:241
An two node 2D line geometry with linear shape functions.
Definition: line_2d_2.h:65
BaseType::IndexType IndexType
Definition: line_2d_2.h:98
double ShapeFunctionValue(IndexType ShapeFunctionIndex, const CoordinatesArrayType &rPoint) const override
This method gives value of given shape function evaluated in given point.
Definition: line_2d_2.h:766
GeometryData::KratosGeometryFamily GetGeometryFamily() const override
Definition: line_2d_2.h:241
Line2D2(const std::string &rGeometryName, const PointsArrayType &rThisPoints)
Constructor with Geometry Name.
Definition: line_2d_2.h:200
Matrix & InverseOfJacobian(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: line_2d_2.h:647
double DomainSize() const override
Definition: line_2d_2.h:400
JacobiansType & Jacobian(JacobiansType &rResult, IntegrationMethod ThisMethod, Matrix &DeltaPosition) const override
Definition: line_2d_2.h:458
int ProjectionPoint(const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rProjectedPointGlobalCoordinates, CoordinatesArrayType &rProjectedPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const override
Projects a certain point on the geometry, or finds the closest point, depending on the provided initi...
Definition: line_2d_2.h:1127
JacobiansType & Jacobian(JacobiansType &rResult, IntegrationMethod ThisMethod) const override
Definition: line_2d_2.h:423
double Length() const override
Definition: line_2d_2.h:361
Matrix & InverseOfJacobian(Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const override
Definition: line_2d_2.h:629
void NodesInFaces(DenseMatrix< unsigned int > &NodesInFaces) const override
Definition: line_2d_2.h:717
BaseType::IntegrationPointsContainerType IntegrationPointsContainerType
Definition: line_2d_2.h:129
std::string Info() const override
Definition: line_2d_2.h:792
Vector & ShapeFunctionsValues(Vector &rResult, const CoordinatesArrayType &rCoordinates) const override
This method gives all non-zero shape functions values evaluated at the rCoordinates provided.
Definition: line_2d_2.h:744
SizeType FacesNumber() const override
Returns the number of faces of the current geometry.
Definition: line_2d_2.h:700
Line2D2(Line2D2< TOtherPointType > const &rOther)
Definition: line_2d_2.h:233
double Area() const override
Definition: line_2d_2.h:384
array_1d< double, 3 > Normal(const CoordinatesArrayType &rPointLocalCoordinates) const override
It returns a vector that is normal to its corresponding geometry in the given local point.
Definition: line_2d_2.h:880
BaseType::JacobiansType JacobiansType
Definition: line_2d_2.h:145
friend class Line2D2
Definition: line_2d_2.h:1358
virtual Matrix & ShapeFunctionsGradients(Matrix &rResult, CoordinatesArrayType &rPoint)
Definition: line_2d_2.h:922
~Line2D2() override
Destructor. Do nothing!!!
Definition: line_2d_2.h:239
Line2D2(typename PointType::Pointer pFirstPoint, typename PointType::Pointer pSecondPoint)
Definition: line_2d_2.h:175
double DeterminantOfJacobian(IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const override
Definition: line_2d_2.h:568
BaseType::GeometriesArrayType GeometriesArrayType
Definition: line_2d_2.h:88
BaseType::NormalType NormalType
Definition: line_2d_2.h:155
BaseType::IntegrationPointsArrayType IntegrationPointsArrayType
Definition: line_2d_2.h:123
Line2D2 & operator=(Line2D2< TOtherPointType > const &rOther)
Definition: line_2d_2.h:283
int ProjectionPointLocalToLocalSpace(const CoordinatesArrayType &rPointLocalCoordinates, CoordinatesArrayType &rProjectionPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const override
Projects a point onto the geometry Projects a certain point on the geometry, or finds the closest poi...
Definition: line_2d_2.h:1143
Line2D2 & operator=(const Line2D2 &rOther)
Definition: line_2d_2.h:265
bool HasIntersection(const BaseType &rOtherGeometry) const override
Definition: line_2d_2.h:977
void NumberNodesInFaces(DenseVector< unsigned int > &NumberNodesInFaces) const override
Definition: line_2d_2.h:706
Line2D2(const IndexType GeometryId, const PointsArrayType &rThisPoints)
Constructor with Geometry Id.
Definition: line_2d_2.h:191
int ProjectionPointGlobalToLocalSpace(const CoordinatesArrayType &rPointGlobalCoordinates, CoordinatesArrayType &rProjectionPointLocalCoordinates, const double Tolerance=std::numeric_limits< double >::epsilon()) const override
Projects a point onto the geometry Projects a certain point on the geometry, or finds the closest poi...
Definition: line_2d_2.h:1157
BaseType::CoordinatesArrayType CoordinatesArrayType
Definition: line_2d_2.h:160
BaseType::IntegrationPointType IntegrationPointType
Definition: line_2d_2.h:116
BaseType::PointsArrayType PointsArrayType
Definition: line_2d_2.h:110
void PrintInfo(std::ostream &rOStream) const override
Definition: line_2d_2.h:803
BaseType::SizeType SizeType
Definition: line_2d_2.h:105
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients()
Definition: line_2d_2.h:834
Vector & LumpingFactors(Vector &rResult, const typename BaseType::LumpingMethods LumpingMethod=BaseType::LumpingMethods::ROW_SUM) const override
Lumping factors for the calculation of the lumped mass matrix.
Definition: line_2d_2.h:332
Matrix & ShapeFunctionsLocalGradients(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: line_2d_2.h:860
CoordinatesArrayType & PointLocalCoordinates(CoordinatesArrayType &rResult, const CoordinatesArrayType &rPoint) const override
Returns the local coordinates of a given arbitrary point.
Definition: line_2d_2.h:1059
BaseType::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
Definition: line_2d_2.h:139
double DeterminantOfJacobian(const CoordinatesArrayType &rPoint) const override
Definition: line_2d_2.h:585
GeometryData::IntegrationMethod IntegrationMethod
Definition: line_2d_2.h:83
Line2D2(Line2D2 const &rOther)
Definition: line_2d_2.h:216
Geometry< TPointType > BaseType
Geometry as base class.
Definition: line_2d_2.h:72
BaseType::Pointer Create(const IndexType NewGeometryId, const BaseType &rGeometry) const override
Creates a new geometry pointer.
Definition: line_2d_2.h:314
Matrix & Jacobian(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: line_2d_2.h:513
JacobiansType & InverseOfJacobian(JacobiansType &rResult, IntegrationMethod ThisMethod) const override
Definition: line_2d_2.h:605
BaseType::Pointer Create(const IndexType NewGeometryId, PointsArrayType const &rThisPoints) const override
Creates a new geometry pointer.
Definition: line_2d_2.h:300
GeometriesArrayType GenerateEdges() const override
This method gives you all edges of this geometry.
Definition: line_2d_2.h:682
BaseType::ShapeFunctionsGradientsType ShapeFunctionsGradientsType
Definition: line_2d_2.h:151
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: line_2d_2.h:943
bool HasIntersection(const Point &rLowPoint, const Point &rHighPoint) const override
Definition: line_2d_2.h:1006
Line2D2(const PointsArrayType &ThisPoints)
Definition: line_2d_2.h:183
KRATOS_CLASS_POINTER_DEFINITION(Line2D2)
Pointer definition of Line2D2.
TPointType PointType
Definition: line_2d_2.h:92
Matrix & PointsLocalCoordinates(Matrix &rResult) const override
Definition: line_2d_2.h:902
Line2D2< TPointType > EdgeType
Type of edge geometry.
Definition: line_2d_2.h:79
SizeType EdgesNumber() const override
This method gives you number of all edges of this geometry.
Definition: line_2d_2.h:669
BaseType::ShapeFunctionsValuesContainerType ShapeFunctionsValuesContainerType
Definition: line_2d_2.h:134
Vector & DeterminantOfJacobian(Vector &rResult, IntegrationMethod ThisMethod) const override
Definition: line_2d_2.h:533
Matrix & Jacobian(Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const override
Definition: line_2d_2.h:493
void PrintData(std::ostream &rOStream) const override
Definition: line_2d_2.h:816
GeometryData::KratosGeometryType GetGeometryType() const override
Definition: line_2d_2.h:246
Various mathematical utilitiy functions.
Definition: math_utils.h:62
static double Norm3(const TVectorType &a)
Calculates the norm of vector "a" which is assumed to be of size 3.
Definition: math_utils.h:691
Point class.
Definition: point.h:59
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
Short class definition.
Definition: array_1d.h:61
BOOST_UBLAS_INLINE void clear()
Definition: array_1d.h:325
#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
#define KRATOS_WARNING_FIRST_N(label, logger_count)
Definition: logger.h:272
REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES.
Definition: mesh_condition.cpp:21
const GeometryData Line2D2< TPointType >::msGeometryData & msGeometryDimension(), Line2D2< 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
REACTION_CHECK_STIFFNESS_FACTOR int
Definition: contact_structural_mechanics_application_variables.h:75
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
tuple const
Definition: ode_solve.py:403
int t
Definition: ode_solve.py:392
float temp
Definition: rotating_cone.py:85
N
Definition: sensitivityMatrix.py:29
namespace
Definition: array_1d.h:793
e
Definition: run_cpp_mpi_tests.py:31