|  | OGS
    | 
Definition at line 37 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
#include <SmallDeformationLocalAssemblerMatrixNearFracture.h>
| Public Types | |
| using | ShapeMatricesType | 
| using | NodalMatrixType = typename ShapeMatricesType::NodalMatrixType | 
| using | NodalVectorType = typename ShapeMatricesType::NodalVectorType | 
| using | ShapeMatrices = typename ShapeMatricesType::ShapeMatrices | 
| using | BMatricesType = BMatrixPolicyType<ShapeFunction, DisplacementDim> | 
| using | BBarMatrixType = typename BMatricesType::BBarMatrixType | 
| using | BMatrixType = typename BMatricesType::BMatrixType | 
| using | StiffnessMatrixType = typename BMatricesType::StiffnessMatrixType | 
| using | NodalForceVectorType = typename BMatricesType::NodalForceVectorType | 
| using | NodalDisplacementVectorType | 
| Public Member Functions | |
| SmallDeformationLocalAssemblerMatrixNearFracture (SmallDeformationLocalAssemblerMatrixNearFracture const &)=delete | |
| SmallDeformationLocalAssemblerMatrixNearFracture (SmallDeformationLocalAssemblerMatrixNearFracture &&)=delete | |
| SmallDeformationLocalAssemblerMatrixNearFracture (MeshLib::Element const &e, std::size_t const n_variables, std::size_t const local_matrix_size, std::vector< unsigned > const &dofIndex_to_localIndex, NumLib::GenericIntegrationMethod const &integration_method, bool const is_axially_symmetric, SmallDeformationProcessData< DisplacementDim > &process_data) | |
| void | assemble (double const, double const, std::vector< double > const &, std::vector< double > const &, std::vector< double > &, std::vector< double > &, std::vector< double > &) override | 
| void | assembleWithJacobian (double const t, double const dt, Eigen::VectorXd const &local_u, Eigen::VectorXd &local_b, Eigen::MatrixXd &local_J) override | 
| void | preTimestepConcrete (std::vector< double > const &, double const, double const) override | 
| void | computeSecondaryVariableConcreteWithVector (double const t, Eigen::VectorXd const &local_x) override | 
| Eigen::Map< const Eigen::RowVectorXd > | getShapeMatrix (const unsigned integration_point) const override | 
| Provides the shape matrix at the given integration point. | |
| std::vector< double > const & | getIntPtSigma (const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const override | 
| std::vector< double > const & | getIntPtEpsilon (const double t, std::vector< GlobalVector * > const &x, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_table, std::vector< double > &cache) const override | 
| std::vector< double > const & | getIntPtFractureStress (const double, std::vector< GlobalVector * > const &, std::vector< NumLib::LocalToGlobalIndexMap const * > const &, std::vector< double > &cache) const override | 
| std::vector< double > const & | getIntPtFractureAperture (const double, std::vector< GlobalVector * > const &, std::vector< NumLib::LocalToGlobalIndexMap const * > const &, std::vector< double > &cache) const override | 
|  Public Member Functions inherited from ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface | |
| SmallDeformationLocalAssemblerInterface () | |
| SmallDeformationLocalAssemblerInterface (std::size_t n_local_size, std::vector< unsigned > dofIndex_to_localIndex) | |
| void | assembleWithJacobian (double const t, double const dt, std::vector< double > const &local_x_, std::vector< double > const &, std::vector< double > &local_b_data, std::vector< double > &local_Jac_data) override | 
| void | computeSecondaryVariableConcrete (double const t, double const, Eigen::VectorXd const &local_x, Eigen::VectorXd const &) override | 
|  Public Member Functions inherited from ProcessLib::LocalAssemblerInterface | |
| virtual | ~LocalAssemblerInterface ()=default | 
| virtual void | setInitialConditions (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, double const t, int const process_id) | 
| virtual void | initialize (std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table) | 
| virtual void | preAssemble (double const, double const, std::vector< double > const &) | 
| virtual void | assembleForStaggeredScheme (double const t, double const dt, Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, int const process_id, std::vector< double > &local_M_data, std::vector< double > &local_K_data, std::vector< double > &local_b_data) | 
| virtual void | assembleWithJacobianForStaggeredScheme (double const t, double const dt, Eigen::VectorXd const &local_x, Eigen::VectorXd const &local_x_prev, int const process_id, std::vector< double > &local_b_data, std::vector< double > &local_Jac_data) | 
| virtual void | computeSecondaryVariable (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id) | 
| virtual void | preTimestep (std::size_t const mesh_item_id, NumLib::LocalToGlobalIndexMap const &dof_table, GlobalVector const &x, double const t, double const delta_t) | 
| virtual void | postTimestep (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id) | 
| void | postNonLinearSolver (std::size_t const mesh_item_id, std::vector< NumLib::LocalToGlobalIndexMap const * > const &dof_tables, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id) | 
| virtual Eigen::Vector3d | getFlux (MathLib::Point3d const &, double const, std::vector< double > const &) const | 
| virtual Eigen::Vector3d | getFlux (MathLib::Point3d const &, double const, std::vector< std::vector< double > > const &) const | 
| Fits to staggered scheme. | |
| virtual std::optional< VectorSegment > | getVectorDeformationSegment () const | 
|  Public Member Functions inherited from NumLib::ExtrapolatableElement | |
| virtual | ~ExtrapolatableElement ()=default | 
| Private Types | |
| using | IntegrationPointDataType | 
| Private Member Functions | |
| std::optional< BBarMatrixType > | getDilatationalBBarMatrix () const | 
| Private Attributes | |
| SmallDeformationProcessData< DisplacementDim > & | _process_data | 
| std::vector< FractureProperty * > | _fracture_props | 
| std::vector< JunctionProperty * > | _junction_props | 
| std::unordered_map< int, int > | _fracID_to_local | 
| std::vector< IntegrationPointDataType, Eigen::aligned_allocator< IntegrationPointDataType > > | _ip_data | 
| NumLib::GenericIntegrationMethod const & | _integration_method | 
| MeshLib::Element const & | _element | 
| bool const | _is_axially_symmetric | 
| SecondaryData< typename ShapeMatrices::ShapeType > | _secondary_data | 
| Additional Inherited Members | 
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::BBarMatrixType = typename BMatricesType::BBarMatrixType | 
Definition at line 47 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::BMatricesType = BMatrixPolicyType<ShapeFunction, DisplacementDim> | 
Definition at line 46 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::BMatrixType = typename BMatricesType::BMatrixType | 
Definition at line 49 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| 
 | private | 
Definition at line 149 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::NodalDisplacementVectorType | 
Definition at line 52 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::NodalForceVectorType = typename BMatricesType::NodalForceVectorType | 
Definition at line 51 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::NodalMatrixType = typename ShapeMatricesType::NodalMatrixType | 
Definition at line 43 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::NodalVectorType = typename ShapeMatricesType::NodalVectorType | 
Definition at line 44 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::ShapeMatrices = typename ShapeMatricesType::ShapeMatrices | 
Definition at line 45 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::ShapeMatricesType | 
Definition at line 41 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| using ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::StiffnessMatrixType = typename BMatricesType::StiffnessMatrixType | 
Definition at line 50 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| 
 | delete | 
| 
 | delete | 
| ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::SmallDeformationLocalAssemblerMatrixNearFracture | ( | MeshLib::Element const & | e, | 
| std::size_t const | n_variables, | ||
| std::size_t const | local_matrix_size, | ||
| std::vector< unsigned > const & | dofIndex_to_localIndex, | ||
| NumLib::GenericIntegrationMethod const & | integration_method, | ||
| bool const | is_axially_symmetric, | ||
| SmallDeformationProcessData< DisplacementDim > & | process_data ) | 
Definition at line 47 of file SmallDeformationLocalAssemblerMatrixNearFracture-impl.h.
References ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_fracID_to_local, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_fracture_props, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_integration_method, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_ip_data, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_junction_props, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_process_data, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_secondary_data, MeshLib::Element::getID(), NumLib::GenericIntegrationMethod::getNumberOfPoints(), MathLib::WeightedPoint::getWeight(), NumLib::GenericIntegrationMethod::getWeightedPoint(), NumLib::initShapeMatrices(), MathLib::KelvinVector::kelvin_vector_dimensions(), ProcessLib::LIE::SmallDeformation::SecondaryData< ShapeMatrixType >::N, MaterialLib::Solids::selectSolidConstitutiveRelation(), ProcessLib::LIE::SmallDeformation::SmallDeformationProcessData< DisplacementDim >::vec_ele_connected_fractureIDs, and ProcessLib::LIE::SmallDeformation::SmallDeformationProcessData< DisplacementDim >::vec_ele_connected_junctionIDs.
| 
 | inlineoverridevirtual | 
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 69 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
References OGS_FATAL.
| 
 | overridevirtual | 
Reimplemented from ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface.
Definition at line 122 of file SmallDeformationLocalAssemblerMatrixNearFracture-impl.h.
References ProcessLib::LinearBMatrix::computeBMatrixPossiblyWithBbar(), ProcessLib::LIE::computePhysicalCoordinates(), NumLib::interpolateXCoordinate(), MaterialPropertyLib::VariableArray::mechanical_strain, OGS_FATAL, ParameterLib::SpatialPosition::setElementID(), MaterialPropertyLib::VariableArray::stress, MaterialPropertyLib::VariableArray::temperature, and ProcessLib::LIE::uGlobalEnrichments().
| 
 | overridevirtual | 
Implements ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface.
Definition at line 307 of file SmallDeformationLocalAssemblerMatrixNearFracture-impl.h.
References MathLib::KelvinVector::kelvinVectorToSymmetricTensor().
| 
 | inlineprivate | 
Definition at line 163 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
References ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_element, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_integration_method, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_ip_data, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_is_axially_symmetric, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_process_data, and ProcessLib::LinearBMatrix::computeDilatationalBbar().
| 
 | overridevirtual | 
Implements ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface.
Definition at line 343 of file SmallDeformationLocalAssemblerMatrixNearFracture-impl.h.
References ProcessLib::getIntegrationPointKelvinVectorData().
| 
 | inlineoverridevirtual | 
Implements ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface.
Definition at line 133 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| 
 | inlineoverridevirtual | 
Implements ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface.
Definition at line 123 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
| 
 | overridevirtual | 
Implements ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerInterface.
Definition at line 331 of file SmallDeformationLocalAssemblerMatrixNearFracture-impl.h.
References ProcessLib::getIntegrationPointKelvinVectorData().
| 
 | inlineoverridevirtual | 
Provides the shape matrix at the given integration point.
Implements NumLib::ExtrapolatableElement.
Definition at line 102 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
References ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_secondary_data, and ProcessLib::LIE::SmallDeformation::SecondaryData< ShapeMatrixType >::N.
| 
 | inlineoverridevirtual | 
Reimplemented from ProcessLib::LocalAssemblerInterface.
Definition at line 86 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
References ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_integration_method, ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::_ip_data, and NumLib::GenericIntegrationMethod::getNumberOfPoints().
| 
 | private | 
| 
 | private | 
| 
 | private | 
| 
 | private | 
Definition at line 157 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
Referenced by ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::SmallDeformationLocalAssemblerMatrixNearFracture(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::getDilatationalBBarMatrix(), and ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::preTimestepConcrete().
| 
 | private | 
Definition at line 155 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
Referenced by ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::SmallDeformationLocalAssemblerMatrixNearFracture(), ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::getDilatationalBBarMatrix(), and ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::preTimestepConcrete().
| 
 | private | 
| 
 | private | 
| 
 | private | 
Definition at line 144 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
Referenced by ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::SmallDeformationLocalAssemblerMatrixNearFracture(), and ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::getDilatationalBBarMatrix().
| 
 | private | 
Definition at line 161 of file SmallDeformationLocalAssemblerMatrixNearFracture.h.
Referenced by ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::SmallDeformationLocalAssemblerMatrixNearFracture(), and ProcessLib::LIE::SmallDeformation::SmallDeformationLocalAssemblerMatrixNearFracture< ShapeFunction, DisplacementDim >::getShapeMatrix().