OGS
|
A class to simulate thermo-mechanical fracturing process using phase-field approach in solids described by.
\[ \mathrm{div} \left[ \left(d^2 + k \right) \boldsymbol{\sigma}_0^+ + \boldsymbol{\sigma}_0^- \right] + \varrho \boldsymbol{b} = \boldsymbol{0} \]
\[ 2d \psi^+(\boldsymbol{\epsilon}_\mathrm{el}) - \frac{1 - d}{2 \varepsilon} g_\mathrm{c} - 2 \varepsilon g_\mathrm{c} \mathrm{div}(\mathrm{grad} d) = 0 \]
\[ (\varrho c_\mathrm{p})_\mathrm{eff} \dfrac{\partial \vartheta}{\partial t} - \mathrm{div} \left(\boldsymbol{\kappa}_\mathrm{eff} \mathrm{grad}\,\vartheta \right) = 0 \]
where
\begin{eqnarray*} &d:& \mbox{order parameter,}\\ &\varrho:& \mbox{density,}\\ &g_\mathrm{c}:& \mbox{fracture energy,}\\ &\varepsilon:& \mbox{length scale}\\ &c_\mathrm{p}:& \mbox{specific heat capacity in constant pressure}\\ &\kappa_\mathrm{eff}:& \mbox{effectiev thermal conductivity}\\ \end{eqnarray*}
Detailed model description can refer [23].
Definition at line 53 of file ThermoMechanicalPhaseFieldProcess.h.
#include <ThermoMechanicalPhaseFieldProcess.h>
Public Member Functions | |
ThermoMechanicalPhaseFieldProcess (std::string name, MeshLib::Mesh &mesh, std::unique_ptr< ProcessLib::AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const ¶meters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, ThermoMechanicalPhaseFieldProcessData< DisplacementDim > &&process_data, SecondaryVariableCollection &&secondary_variables, int const mechanics_related_process_id, int const phase_field_process_id, int const heat_conduction_process_id) | |
MathLib::MatrixSpecifications | getMatrixSpecifications (const int process_id) const override |
NumLib::LocalToGlobalIndexMap const & | getDOFTable (const int process_id) const override |
ODESystem interface | |
bool | isLinear () const override |
Public Member Functions inherited from ProcessLib::Process | |
Process (std::string name_, MeshLib::Mesh &mesh, std::unique_ptr< AbstractJacobianAssembler > &&jacobian_assembler, std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const ¶meters, unsigned const integration_order, std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > &&process_variables, SecondaryVariableCollection &&secondary_variables, const bool use_monolithic_scheme=true) | |
void | preTimestep (std::vector< GlobalVector * > const &x, const double t, const double delta_t, const int process_id) |
Preprocessing before starting assembly for new timestep. | |
void | postTimestep (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, const double delta_t, int const process_id) |
Postprocessing after a complete timestep. | |
void | postNonLinearSolver (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, double const dt, int const process_id) |
void | preIteration (const unsigned iter, GlobalVector const &x) final |
void | computeSecondaryVariable (double const t, double const dt, std::vector< GlobalVector * > const &x, GlobalVector const &x_prev, int const process_id) |
compute secondary variables for the coupled equations or for output. | |
NumLib::IterationResult | postIteration (GlobalVector const &x) final |
void | initialize (std::map< int, std::shared_ptr< MaterialPropertyLib::Medium > > const &media) |
void | setInitialConditions (std::vector< GlobalVector * > &process_solutions, std::vector< GlobalVector * > const &process_solutions_prev, double const t, int const process_id) |
MathLib::MatrixSpecifications | getMatrixSpecifications (const int process_id) const override |
void | updateDeactivatedSubdomains (double const time, const int process_id) |
virtual bool | isMonolithicSchemeUsed () const |
virtual void | extrapolateIntegrationPointValuesToNodes (const double, std::vector< GlobalVector * > const &, std::vector< GlobalVector * > &) |
void | preAssemble (const double t, double const dt, GlobalVector const &x) final |
void | assemble (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b) final |
void | assembleWithJacobian (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac) final |
void | preOutput (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id) |
std::vector< NumLib::IndexValueVector< GlobalIndexType > > const * | getKnownSolutions (double const t, GlobalVector const &x, int const process_id) const final |
MeshLib::Mesh & | getMesh () const |
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > const & | getProcessVariables () const |
std::vector< std::reference_wrapper< ProcessVariable > > const & | getProcessVariables (const int process_id) const |
std::vector< std::size_t > const & | getActiveElementIDs () const |
SecondaryVariableCollection const & | getSecondaryVariables () const |
std::vector< std::unique_ptr< MeshLib::IntegrationPointWriter > > const & | getIntegrationPointWriters () const |
virtual Eigen::Vector3d | getFlux (std::size_t, MathLib::Point3d const &, double const, std::vector< GlobalVector * > const &) const |
virtual void | solveReactionEquation (std::vector< GlobalVector * > &, std::vector< GlobalVector * > const &, double const, double const, NumLib::EquationSystem &, int const) |
bool | requiresNormalization () const override |
Public Member Functions inherited from ProcessLib::SubmeshAssemblySupport | |
virtual std::vector< std::vector< std::string > > | initializeAssemblyOnSubmeshes (std::vector< std::reference_wrapper< MeshLib::Mesh > > const &meshes) |
virtual | ~SubmeshAssemblySupport ()=default |
Private Member Functions | |
void | constructDofTable () override |
void | initializeBoundaryConditions (std::map< int, std::shared_ptr< MaterialPropertyLib::Medium > > const &media) override |
void | initializeConcreteProcess (NumLib::LocalToGlobalIndexMap const &dof_table, MeshLib::Mesh const &mesh, unsigned const integration_order) override |
Process specific initialization called by initialize(). | |
void | assembleConcreteProcess (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalMatrix &M, GlobalMatrix &K, GlobalVector &b) override |
void | assembleWithJacobianConcreteProcess (const double t, double const dt, std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, int const process_id, GlobalVector &b, GlobalMatrix &Jac) override |
void | preTimestepConcreteProcess (std::vector< GlobalVector * > const &x, double const t, double const dt, const int process_id) override |
void | postTimestepConcreteProcess (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, double const t, double const dt, int const process_id) override |
void | postNonLinearSolverConcreteProcess (std::vector< GlobalVector * > const &x, std::vector< GlobalVector * > const &x_prev, const double t, double const dt, int const process_id) override |
NumLib::LocalToGlobalIndexMap & | getDOFTableByProcessID (const int process_id) const |
Private Attributes | |
ThermoMechanicalPhaseFieldProcessData< DisplacementDim > | _process_data |
std::vector< std::unique_ptr< ThermoMechanicalPhaseFieldLocalAssemblerInterface > > | _local_assemblers |
std::unique_ptr< NumLib::LocalToGlobalIndexMap > | _local_to_global_index_map_single_component |
GlobalSparsityPattern | _sparsity_pattern_with_single_component |
Sparsity pattern for the phase field equation, and it is initialized. | |
int const | _mechanics_related_process_id |
ID of the processes that contains mechanical process. | |
int const | _phase_field_process_id |
ID of phase field process. | |
int const | _heat_conduction_process_id |
ID of heat conduction process. | |
ProcessLib::ThermoMechanicalPhaseField::ThermoMechanicalPhaseFieldProcess< DisplacementDim >::ThermoMechanicalPhaseFieldProcess | ( | std::string | name, |
MeshLib::Mesh & | mesh, | ||
std::unique_ptr< ProcessLib::AbstractJacobianAssembler > && | jacobian_assembler, | ||
std::vector< std::unique_ptr< ParameterLib::ParameterBase > > const & | parameters, | ||
unsigned const | integration_order, | ||
std::vector< std::vector< std::reference_wrapper< ProcessVariable > > > && | process_variables, | ||
ThermoMechanicalPhaseFieldProcessData< DisplacementDim > && | process_data, | ||
SecondaryVariableCollection && | secondary_variables, | ||
int const | mechanics_related_process_id, | ||
int const | phase_field_process_id, | ||
int const | heat_conduction_process_id ) |
Definition at line 26 of file ThermoMechanicalPhaseFieldProcess.cpp.
|
overrideprivatevirtual |
Implements ProcessLib::Process.
Definition at line 192 of file ThermoMechanicalPhaseFieldProcess.cpp.
References ProcessLib::VectorMatrixAssembler::assemble(), DBUG(), and NumLib::SerialExecutor::executeSelectedMemberDereferenced().
|
overrideprivatevirtual |
Implements ProcessLib::Process.
Definition at line 212 of file ThermoMechanicalPhaseFieldProcess.cpp.
References ProcessLib::VectorMatrixAssembler::assembleWithJacobian(), DBUG(), and NumLib::SerialExecutor::executeSelectedMemberDereferenced().
|
overrideprivatevirtual |
This function is for general cases, in which all equations of the coupled processes have the same number of unknowns. For the general cases with the staggered scheme, all equations of the coupled processes share one DOF table hold by _local_to_global_index_map
. Other cases can be considered by overloading this member function in the derived class.
Reimplemented from ProcessLib::Process.
Definition at line 105 of file ThermoMechanicalPhaseFieldProcess.cpp.
References NumLib::BY_LOCATION, and NumLib::computeSparsityPattern().
|
overridevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 78 of file ThermoMechanicalPhaseFieldProcess.cpp.
|
private |
Definition at line 92 of file ThermoMechanicalPhaseFieldProcess.cpp.
|
override |
Definition at line 60 of file ThermoMechanicalPhaseFieldProcess.cpp.
|
overrideprivatevirtual |
Member function to initialize the boundary conditions for all coupled processes. It is called by initialize().
Reimplemented from ProcessLib::Process.
Definition at line 171 of file ThermoMechanicalPhaseFieldProcess.cpp.
|
overrideprivatevirtual |
Process specific initialization called by initialize().
Implements ProcessLib::Process.
Definition at line 129 of file ThermoMechanicalPhaseFieldProcess.cpp.
References ProcessLib::SmallDeformation::createLocalAssemblers(), NumLib::SerialExecutor::executeMemberOnDereferenced(), MeshLib::Mesh::getDimension(), MeshLib::Mesh::getElements(), ProcessLib::ThermoMechanicalPhaseField::ThermoMechanicalPhaseFieldLocalAssemblerInterface::getIntPtSigma(), ProcessLib::LocalAssemblerInterface::initialize(), MeshLib::Mesh::isAxiallySymmetric(), and ProcessLib::makeExtrapolator().
|
override |
Definition at line 53 of file ThermoMechanicalPhaseFieldProcess.cpp.
|
overrideprivatevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 295 of file ThermoMechanicalPhaseFieldProcess.cpp.
References DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), and ProcessLib::LocalAssemblerInterface::postNonLinearSolver().
|
overrideprivatevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 274 of file ThermoMechanicalPhaseFieldProcess.cpp.
References DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), and ProcessLib::LocalAssemblerInterface::postTimestep().
|
overrideprivatevirtual |
Reimplemented from ProcessLib::Process.
Definition at line 254 of file ThermoMechanicalPhaseFieldProcess.cpp.
References DBUG(), NumLib::SerialExecutor::executeSelectedMemberOnDereferenced(), and ProcessLib::LocalAssemblerInterface::preTimestep().
|
private |
ID of heat conduction process.
Definition at line 145 of file ThermoMechanicalPhaseFieldProcess.h.
|
private |
Definition at line 129 of file ThermoMechanicalPhaseFieldProcess.h.
|
private |
Definition at line 132 of file ThermoMechanicalPhaseFieldProcess.h.
|
private |
ID of the processes that contains mechanical process.
Definition at line 139 of file ThermoMechanicalPhaseFieldProcess.h.
|
private |
ID of phase field process.
Definition at line 142 of file ThermoMechanicalPhaseFieldProcess.h.
|
private |
Definition at line 125 of file ThermoMechanicalPhaseFieldProcess.h.
|
private |
Sparsity pattern for the phase field equation, and it is initialized.
Definition at line 136 of file ThermoMechanicalPhaseFieldProcess.h.