60 template<
class TPo
intType>
167 Line2D4(
typename PointType::Pointer pPoint01,
typename PointType::Pointer pPoint02,
168 typename PointType::Pointer pPoint03,
typename PointType::Pointer pPoint04)
185 :
BaseType(GeometryId, rThisPoints, &msGeometryData)
193 :
BaseType(rGeometryName, rThisPoints, &msGeometryData)
264 template<
class TOtherPo
intType>
284 return typename BaseType::Pointer(
new Line2D4(NewGeometryId, rThisPoints));
295 auto p_geometry =
typename BaseType::Pointer(
new Line2D4(NewGeometryId, rGeometry.
Points()));
296 p_geometry->SetData(rGeometry.
GetData());
312 if (rResult.size() != 4) rResult.
resize(4,
false);
342 for (std::size_t
i = 0;
i < r_integration_points.size(); ++
i) {
343 length +=
temp[
i] * r_integration_points[
i].Weight();
387 const double Tolerance = std::numeric_limits<double>::epsilon())
const override
390 if (std::abs(rResult[0]) <= (1.0 + Tolerance)) {
410 X(0,
i) = r_node.X();
411 X(1,
i) = r_node.Y();
412 X(2,
i) = r_node.Z();
415 static constexpr
double MaxNormPointLocalCoordinates = 300.0;
416 static constexpr std::size_t MaxIteratioNumberPointLocalCoordinates = 500;
417 static constexpr
double MaxTolerancePointLocalCoordinates = 1.0e-8;
423 if (rResult.
size() != 3) rResult.
resize(3,
false);
425 double delta_xi = 0.0;
431 for (
IndexType k = 0;
k < MaxIteratioNumberPointLocalCoordinates; ++
k) {
432 noalias(current_global_coords) = zero_array;
435 noalias(current_global_coords) = rPoint - current_global_coords;
438 Matrix shape_functions_gradients;
445 invJ(0, 0) = 1.0 /
J(0, 0);
447 delta_xi = invJ(0, 0) *
res[0];
449 rResult[0] += delta_xi;
451 if (delta_xi > MaxNormPointLocalCoordinates) {
452 KRATOS_WARNING_IF(
"Line2D4",
k > 0) <<
"detJ =\t" <<
J(0, 0) <<
" DeltaX =\t" << delta_xi <<
" stopping calculation. Iteration:\t" <<
k << std::endl;
456 if (delta_xi < MaxTolerancePointLocalCoordinates)
485 = CalculateShapeFunctionsIntegrationPointsLocalGradients(ThisMethod);
487 if (rResult.size() != number_of_integration_points) {
492 for (std::size_t pnt = 0; pnt < number_of_integration_points; ++pnt) {
498 rResult[pnt](0, 0) += r_node.X() * shape_functions_gradients[pnt](
i, 0);
499 rResult[pnt](1, 0) += r_node.Y() * shape_functions_gradients[pnt](
i, 0);
523 Matrix& rDeltaPosition)
const override
527 = CalculateShapeFunctionsIntegrationPointsLocalGradients(ThisMethod);
530 Matrix shape_functions_values = CalculateShapeFunctionsIntegrationPointsValues(ThisMethod);
531 if (rResult.size() != number_of_integration_points) {
536 for (std::size_t pnt = 0; pnt < number_of_integration_points; ++pnt) {
542 rResult[pnt](0, 0) += (r_node.X() - rDeltaPosition(
i, 0)) * shape_functions_gradients[pnt](
i, 0);
543 rResult[pnt](1, 0) += (r_node.Y() - rDeltaPosition(
i, 1)) * shape_functions_gradients[pnt](
i, 0);
569 rResult.
resize(2, 1,
false);
573 = CalculateShapeFunctionsIntegrationPointsLocalGradients(ThisMethod);
574 Matrix shape_function_gradient_in_integration_point = shape_functions_gradients(IntegrationPointIndex);
577 ShapeFunctionsValuesInIntegrationPoint =
row(CalculateShapeFunctionsIntegrationPointsValues(ThisMethod), IntegrationPointIndex);
582 rResult(0, 0) += r_node.X() * shape_function_gradient_in_integration_point(
i, 0);
583 rResult(1, 0) += r_node.Y() * shape_function_gradient_in_integration_point(
i, 0);
598 rResult.
resize(2, 1,
false);
601 Matrix shape_functions_gradients;
607 rResult(0, 0) += r_node.X() * shape_functions_gradients(
i, 0);
608 rResult(1, 0) += r_node.Y() * shape_functions_gradients(
i, 0);
623 if (rResult.size() != number_of_integration_points)
624 rResult.
resize(number_of_integration_points,
false);
626 for (std::size_t pnt = 0; pnt < number_of_integration_points; ++pnt) {
628 rResult[pnt] = std::sqrt(std::pow(
J(0, 0), 2) + std::pow(
J(1, 0), 2));
645 this->
Jacobian(J, IntegrationPointIndex, ThisMethod);
646 return std::sqrt(std::pow(
J(0, 0), 2) + std::pow(
J(1, 0), 2));
660 return std::sqrt(std::pow(
J(0, 0), 2) + std::pow(
J(1, 0), 2));
693 if (rResult.size() != 4) rResult.
resize(4,
false);
695 const double xi = rCoordinates[0];
696 const double fx1 = 1.0 - xi;
697 const double fx2 = 1.0 + xi;
698 const double fx3 = fx1 * fx2;
699 const double gx1 = 1.0 - 3.0 * xi;
700 const double gx2 = 1.0 + 3.0 * xi;
701 const double gx3 = gx1 * gx2;
703 rResult[0] = -0.0625 * fx1 * gx3;
704 rResult[1] = -0.0625 * fx2 * gx3;
705 rResult[2] = 0.5625 * fx3 * gx1;
706 rResult[3] = 0.5625 * fx3 * gx2;
722 const double xi = rPoint[0];
723 const double fx1 = 1.0 - xi;
724 const double fx2 = 1.0 + xi;
725 const double fx3 = fx1 * fx2;
726 const double gx1 = 1.0 - 3.0 * xi;
727 const double gx2 = 1.0 + 3.0 * xi;
728 const double gx3 = gx1 * gx2;
731 switch (ShapeFunctionIndex)
734 shape = -0.0625 * fx1 * gx3;
737 shape = -0.0625 * fx2 * gx3;
740 shape = 0.5625 * fx3 * gx1;
743 shape = 0.5625 * fx3 * gx2;
746 KRATOS_ERROR <<
"Wrong index of shape function!" << *
this << std::endl;
777 std::string
Info()
const override
779 return "1 dimensional line with 4 nodes in 2D space";
789 rOStream <<
"1 dimensional line with 4 nodes in 2D space";
802 std::cout << std::endl;
808 rOStream <<
" Jacobian\t : " << jacobian;
817 = CalculateShapeFunctionsIntegrationPointsLocalGradients(ThisMethod);
821 for (
int pnt = 0; pnt < integration_points_number; ++pnt)
823 Result[pnt] = localGradients[pnt];
835 = CalculateShapeFunctionsIntegrationPointsLocalGradients(ThisMethod);
839 for (
int pnt = 0; pnt < integration_points_number; ++pnt)
841 Result[pnt] = localGradients[pnt];
857 if (rResult.size1() != 4 || rResult.size2() != 1) rResult.
resize(4, 1,
false);
860 const double xi = rPoint[0];
861 const double fx1 = 1.0 - xi;
862 const double fx2 = 1.0 + xi;
863 const double fx3 = fx1 * fx2;
864 const double gx1 = 1.0 - 3.0 * xi;
865 const double gx2 = 1.0 + 3.0 * xi;
866 const double gx3 = gx1 * gx2;
868 rResult(0, 0) = 0.0625 * (18.0 * xi * fx1 + gx3);
869 rResult(1, 0) = 0.0625 * (18.0 * xi * fx2 - gx3);
870 rResult(2, 0) = -0.5625 * (3.0 * fx3 + 2.0 * xi * gx1);
871 rResult(3, 0) = 0.5625 * (3.0 * fx3 - 2.0 * xi * gx2);
883 if (rResult.size1() != 4 || rResult.size2() != 1) rResult.
resize(4, 1,
false);
886 rResult(0, 0) = -1.0;
888 rResult(2, 0) = -1.0 / 3.0;
889 rResult(3, 0) = 1.0 / 3.0;
904 if (rResult.size1() != 4 || rResult.size2() != 1) rResult.
resize(4, 1,
false);
907 const double xi = rPoint[0];
908 const double fx1 = 1.0 - xi;
909 const double fx2 = 1.0 + xi;
910 const double fx3 = fx1 * fx2;
911 const double gx1 = 1.0 - 3.0 * xi;
912 const double gx2 = 1.0 + 3.0 * xi;
913 const double gx3 = gx1 * gx2;
915 rResult(0, 0) = 0.0625 * (18.0 * xi * fx1 + gx3);
916 rResult(1, 0) = 0.0625 * (18.0 * xi * fx2 - gx3);
917 rResult(2, 0) = -0.5625 * (3.0 * fx3 + 2.0 * xi * gx1);
918 rResult(3, 0) = 0.5625 * (3.0 * fx3 - 2.0 * xi * gx2);
977 void save(
Serializer& rSerializer)
const override
1002 Matrix shape_function_values(integration_points_number, 4);
1004 for (
int pnt = 0; pnt < integration_points_number; ++pnt)
1007 const double fx1 = 1.0 - xi;
1008 const double fx2 = 1.0 + xi;
1009 const double fx3 = fx1 * fx2;
1010 const double gx1 = 1.0 - 3.0 * xi;
1011 const double gx2 = 1.0 + 3.0 * xi;
1012 const double gx3 = gx1 * gx2;
1014 shape_function_values(pnt, 0) = -0.0625 * fx1 * gx3;
1015 shape_function_values(pnt, 1) = -0.0625 * fx2 * gx3;
1016 shape_function_values(pnt, 2) = 0.5625 * fx3 * gx1;
1017 shape_function_values(pnt, 3) = 0.5625 * fx3 * gx2;
1019 return shape_function_values;
1028 std::fill(DN_De.begin(), DN_De.end(),
Matrix(4, 1));
1033 const double fx1 = 1.0 - xi;
1034 const double fx2 = 1.0 + xi;
1035 const double fx3 = fx1 * fx2;
1036 const double gx1 = 1.0 - 3.0 * xi;
1037 const double gx2 = 1.0 + 3.0 * xi;
1038 const double gx3 = gx1 * gx2;
1040 DN_De[pnt](0, 0) = 0.0625 * (18.0 * xi * fx1 + gx3);
1041 DN_De[pnt](1, 0) = 0.0625 * (18.0 * xi * fx2 - gx3);
1042 DN_De[pnt](2, 0) = -0.5625 * (3.0 * fx3 + 2.0 * xi * gx1);
1043 DN_De[pnt](3, 0) = 0.5625 * (3.0 * fx3 - 2.0 * xi * gx2);
1051 Quadrature<LineGaussLegendreIntegrationPoints1, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1052 Quadrature<LineGaussLegendreIntegrationPoints2, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1053 Quadrature<LineGaussLegendreIntegrationPoints3, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1054 Quadrature<LineGaussLegendreIntegrationPoints4, 1, IntegrationPoint<3> >::GenerateIntegrationPoints(),
1055 Quadrature<LineGaussLegendreIntegrationPoints5, 1, IntegrationPoint<3> >::GenerateIntegrationPoints()
1058 return integration_points;
1071 return shape_functions_values;
1084 return shape_functions_local_gradients;
1099 template<
class TOtherPo
intType>
friend class Line2D4;
1119 template<
class TPo
intType>
1123 template<
class TPo
intType>
1127 rOStream << std::endl;
1134 template<
class TPo
intType>
1135 const GeometryData Line2D4<TPointType>::msGeometryData(
1138 Line2D4<TPointType>::AllIntegrationPoints(),
1139 Line2D4<TPointType>::AllShapeFunctionsValues(),
1140 AllShapeFunctionsLocalGradients());
1142 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
SizeType size() const
Definition: geometry.h:518
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
std::size_t SizeType
Definition: geometry.h:144
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
static GeometryData::IntegrationMethod GetIntegrationMethodForExactMassMatrixEvaluation(const Geometry< TPointType > &rGeometry)
This method returns the integration order for the exact mass matrix evaluation.
Definition: integration_utilities.h:42
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 cubic shape functions.
Definition: line_2d_4.h:62
BaseType::CoordinatesArrayType CoordinatesArrayType
Definition: line_2d_4.h:152
double DeterminantOfJacobian(const CoordinatesArrayType &rPoint) const override
Determinant of jacobian in given point. This method calculate determinant of jacobian matrix in given...
Definition: line_2d_4.h:656
std::string Info() const override
Definition: line_2d_4.h:777
BaseType::IntegrationPointType IntegrationPointType
Definition: line_2d_4.h:108
TPointType PointType
Definition: line_2d_4.h:85
double DomainSize() const override
Definition: line_2d_4.h:373
double ShapeFunctionValue(const IndexType ShapeFunctionIndex, const CoordinatesArrayType &rPoint) const override
This method gives value of given shape function evaluated in given point.
Definition: line_2d_4.h:720
Matrix & Jacobian(Matrix &rResult, IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const override
Definition: line_2d_4.h:565
Line2D4(Line2D4 const &rOther)
Definition: line_2d_4.h:206
Line2D4(const PointType &Point01, const PointType &Point02, const PointType &Point03, const PointType &Point04)
Definition: line_2d_4.h:158
CoordinatesArrayType & PointLocalCoordinates(CoordinatesArrayType &rResult, const CoordinatesArrayType &rPoint) const override
Returns the local coordinates of a given arbitrary point.
Definition: line_2d_4.h:402
BaseType::IntegrationPointsArrayType IntegrationPointsArrayType
Definition: line_2d_4.h:115
BaseType::ShapeFunctionsLocalGradientsContainerType ShapeFunctionsLocalGradientsContainerType
Definition: line_2d_4.h:131
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_4.h:691
void PrintData(std::ostream &rOStream) const override
Definition: line_2d_4.h:798
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_4.h:309
BaseType::JacobiansType JacobiansType
Definition: line_2d_4.h:137
friend class Line2D4
Definition: line_2d_4.h:1099
BaseType::GeometriesArrayType GeometriesArrayType
Definition: line_2d_4.h:81
double Length() const override
Definition: line_2d_4.h:334
BaseType::PointsArrayType PointsArrayType
Definition: line_2d_4.h:102
void ShapeFunctionsIntegrationPointsGradients(ShapeFunctionsGradientsType &rResult, Vector &rDeterminantsOfJacobian, IntegrationMethod ThisMethod) const override
Definition: line_2d_4.h:762
BaseType::Pointer Create(const IndexType NewGeometryId, const BaseType &rGeometry) const override
Creates a new geometry pointer.
Definition: line_2d_4.h:293
Line2D4 & operator=(Line2D4< TOtherPointType > const &rOther)
Definition: line_2d_4.h:265
Line2D4(const PointsArrayType &rThisPoints)
Definition: line_2d_4.h:177
BaseType::ShapeFunctionsValuesContainerType ShapeFunctionsValuesContainerType
Definition: line_2d_4.h:126
Matrix & ShapeFunctionsLocalGradients(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: line_2d_4.h:854
BaseType::IntegrationPointsContainerType IntegrationPointsContainerType
Definition: line_2d_4.h:121
virtual Matrix & ShapeFunctionsGradients(Matrix &rResult, CoordinatesArrayType &rPoint)
Definition: line_2d_4.h:902
Vector & DeterminantOfJacobian(Vector &rResult, IntegrationMethod ThisMethod) const override
Determinant of jacobians for given integration method.
Definition: line_2d_4.h:620
BaseType::ShapeFunctionsGradientsType ShapeFunctionsGradientsType
Definition: line_2d_4.h:143
double DeterminantOfJacobian(IndexType IntegrationPointIndex, IntegrationMethod ThisMethod) const override
Determinant of jacobian in specific integration point of given integration method....
Definition: line_2d_4.h:641
Geometry< TPointType > BaseType
Geometry as base class.
Definition: line_2d_4.h:69
GeometryData::KratosGeometryType GetGeometryType() const override
Definition: line_2d_4.h:233
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients()
Definition: line_2d_4.h:831
void ShapeFunctionsIntegrationPointsGradients(ShapeFunctionsGradientsType &rResult, IntegrationMethod ThisMethod) const override
Definition: line_2d_4.h:756
KRATOS_CLASS_POINTER_DEFINITION(Line2D4)
Pointer definition of Line2D4.
~Line2D4() override
Destructor. Do nothing!!!
Definition: line_2d_4.h:226
JacobiansType & Jacobian(JacobiansType &rResult, IntegrationMethod ThisMethod) const override
Definition: line_2d_4.h:481
Line2D4(typename PointType::Pointer pPoint01, typename PointType::Pointer pPoint02, typename PointType::Pointer pPoint03, typename PointType::Pointer pPoint04)
Definition: line_2d_4.h:167
Matrix & PointsLocalCoordinates(Matrix &rResult) const override
Definition: line_2d_4.h:881
Line2D4(Line2D4< TOtherPointType > const &rOther)
Definition: line_2d_4.h:220
Line2D4(const std::string &rGeometryName, const PointsArrayType &rThisPoints)
Constructor with Geometry Name.
Definition: line_2d_4.h:192
GeometryData::KratosGeometryFamily GetGeometryFamily() const override
Definition: line_2d_4.h:228
Line2D4(const IndexType GeometryId, const PointsArrayType &rThisPoints)
Constructor with Geometry Id.
Definition: line_2d_4.h:184
BaseType::NormalType NormalType
Definition: line_2d_4.h:147
BaseType::Pointer Create(const IndexType NewGeometryId, PointsArrayType const &rThisPoints) const override
Creates a new geometry pointer.
Definition: line_2d_4.h:281
JacobiansType & Jacobian(JacobiansType &rResult, IntegrationMethod ThisMethod, Matrix &rDeltaPosition) const override
Definition: line_2d_4.h:522
GeometryData::IntegrationMethod IntegrationMethod
Definition: line_2d_4.h:76
BaseType::SizeType SizeType
Definition: line_2d_4.h:97
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_4.h:386
Line2D4 & operator=(const Line2D4 &rOther)
Definition: line_2d_4.h:250
double Area() const override
Definition: line_2d_4.h:358
SizeType EdgesNumber() const override
Definition: line_2d_4.h:666
virtual ShapeFunctionsGradientsType ShapeFunctionsLocalGradients(IntegrationMethod &ThisMethod)
Definition: line_2d_4.h:814
Matrix & Jacobian(Matrix &rResult, const CoordinatesArrayType &rPoint) const override
Definition: line_2d_4.h:595
SizeType FacesNumber() const override
Definition: line_2d_4.h:674
BaseType::IndexType IndexType
Definition: line_2d_4.h:91
void PrintInfo(std::ostream &rOStream) const override
Definition: line_2d_4.h:787
This class defines the node.
Definition: node.h:65
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 resize(size_type array_size, bool preserve=true)
Definition: array_1d.h:242
BOOST_UBLAS_INLINE size_type size() const
Definition: array_1d.h:370
#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_IF(label, conditional)
Definition: logger.h:266
REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES.
Definition: mesh_condition.cpp:21
KratosZeroVector< double > ZeroVector
Definition: amatrix_interface.h:561
const GeometryData Line2D4< TPointType >::msGeometryData & msGeometryDimension(), Line2D4< 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
AMatrix::MatrixProductExpression< TExpression1Type, TExpression2Type > prod(AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &First, AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &Second)
Definition: amatrix_interface.h:568
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
AMatrix::MatrixRow< const TExpressionType > row(AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression, std::size_t RowIndex)
Definition: amatrix_interface.h:649
AMatrix::TransposeMatrix< const T > trans(const T &TheMatrix)
Definition: amatrix_interface.h:486
std::ostream & operator<<(std::ostream &rOStream, const LinearMasterSlaveConstraint &rThis)
output stream function
Definition: linear_master_slave_constraint.h:432
res
Definition: generate_convection_diffusion_explicit_element.py:211
DN
Definition: generate_convection_diffusion_explicit_element.py:98
def load(f)
Definition: ode_solve.py:307
int k
Definition: quadrature.py:595
float temp
Definition: rotating_cone.py:85
J
Definition: sensitivityMatrix.py:58
integer i
Definition: TensorModule.f:17