21 #ifndef GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSSOLVER_HPP_
22 #define GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSSOLVER_HPP_
28 #include "constitutive/solid/CoupledSolidBase.hpp"
29 #include "constitutive/solid/PorousSolid.hpp"
30 #include "constitutive/solid/PorousDamageSolid.hpp"
31 #include "constitutive/contact/HydraulicApertureBase.hpp"
34 #include "codingUtilities/Utilities.hpp"
39 namespace stabilization
55 template<
typename FLOW_SOLVER,
typename MECHANICS_SOLVER = Sol
idMechanicsLagrangianFEM >
83 :
Base( name, parent ),
88 setApplyDefaultValue( 0 ).
90 setDescription(
"Flag indicating whether the problem is thermal or not. Set isThermal=\"1\" to enable the thermal coupling" );
94 setDescription(
"StabilizationType. Options are:\n" +
95 toString( stabilization::StabilizationType::None ) +
"- Add no stabilization to mass equation \n" +
96 toString( stabilization::StabilizationType::Global ) +
"- Add jump stabilization to all faces \n" +
97 toString( stabilization::StabilizationType::Local ) +
"- Add jump stabilization on interior of macro elements" );
100 setRTTypeName( rtTypes::CustomTypes::groupNameRefArray ).
102 setDescription(
"Regions where stabilization is applied." );
105 setApplyDefaultValue( 1.0 ).
107 setDescription(
"Constant multiplier of stabilization strength" );
115 GEOS_FMT(
"{} {}: The attribute `{}` of the flow solver `{}` must be set to 1 since the poromechanics solver is thermal",
130 hydraulicApertureModelName = PhysicsSolverBase::getConstitutiveName< constitutive::HydraulicApertureBase >( subRegion );
131 GEOS_ERROR_IF( hydraulicApertureModelName.empty(), GEOS_FMT(
"{}: HydraulicApertureBase model not found on subregion {}",
143 ": Local stabilization has been temporarily disabled",
146 DomainPartition & domain = this->
template getGroupByPath< DomainPartition >(
"/Problem/domain" );
152 ElementRegionManager & elementRegionManager = mesh.getElemManager();
153 elementRegionManager.forElementSubRegions< CellElementSubRegion >( regionNames,
154 [&]( localIndex const,
155 ElementSubRegionBase & subRegion )
157 string & porousName = subRegion.getReference< string >( viewKeyStruct::porousMaterialNamesString() );
158 porousName = this->template getConstitutiveName< constitutive::CoupledSolidBase >( subRegion );
159 GEOS_THROW_IF( porousName.empty(),
160 GEOS_FMT(
"{} {} : Solid model not found on subregion {}",
161 this->getCatalogName(), this->getDataContext().toString(), subRegion.getName() ),
164 string & porosityModelName = subRegion.getReference< string >( constitutive::CoupledSolidBase::viewKeyStruct::porosityModelNameString() );
165 porosityModelName = this->template getConstitutiveName< constitutive::PorosityBase >( subRegion );
166 GEOS_THROW_IF( porosityModelName.empty(),
167 GEOS_FMT(
"{} {} : Porosity model not found on subregion {}",
168 this->getCatalogName(), this->getDataContext().toString(), subRegion.getName() ),
171 if( subRegion.hasField< fields::poromechanics::bulkDensity >() )
174 constitutive::CoupledSolidBase const & solid = this->template getConstitutiveModel< constitutive::CoupledSolidBase >( subRegion, porousName );
175 subRegion.getField< fields::poromechanics::bulkDensity >().resizeDimension< 1 >( solid.getDensity().size( 1 ) );
188 solidMechanicsSolver()->enableFixedStressPoromechanicsUpdate();
190 flowSolver()->enableFixedStressPoromechanicsUpdate();
193 if( m_stabilizationType == stabilization::StabilizationType::Global || m_stabilizationType == stabilization::StabilizationType::Local )
195 flowSolver()->enableJumpStabilization();
208 subRegion.registerWrapper<
string >( viewKeyStruct::porousMaterialNamesString() ).
211 setSizedFromParent( 0 );
214 subRegion.registerWrapper<
string >( constitutive::CoupledSolidBase::viewKeyStruct::porosityModelNameString() ).
217 setSizedFromParent( 0 );
221 subRegion.registerField< fields::poromechanics::bulkDensity >( this->getName() );
223 if( m_stabilizationType == stabilization::StabilizationType::Global || m_stabilizationType == stabilization::StabilizationType::Local )
225 subRegion.registerField< fields::flow::macroElementIndex >( this->getName());
226 subRegion.registerField< fields::flow::elementStabConstant >( this->getName());
236 flowSolver()->setKeepVariablesConstantDuringInitStep( m_performStressInitialization );
238 if( this->m_stabilizationType == stabilization::StabilizationType::Global || this->m_stabilizationType == stabilization::StabilizationType::Local )
240 this->updateStabilizationParameters( domain );
243 Base::implicitStepSetup( time_n, dt, domain );
252 solidMechanicsSolver()->setupDofs( domain, dofManager );
253 flowSolver()->setupDofs( domain, dofManager );
254 this->setupCoupling( domain, dofManager );
257 virtual bool checkSequentialConvergence(
int const & iter,
263 auto & subcycling = this->getNonlinearSolverParameters().m_subcyclingOption;
264 auto const subcycling_orig = subcycling;
265 if( m_performStressInitialization )
268 bool isConverged = Base::checkSequentialConvergence( iter, time_n, dt, domain );
271 subcycling = subcycling_orig;
282 return std::get< toUnderlying( SolverType::SolidMechanics ) >( m_solvers );
291 return std::get< toUnderlying( SolverType::Flow ) >( m_solvers );
298 void setStressInitialization(
bool const performStressInitialization )
300 m_performStressInitialization = performStressInitialization;
301 solidMechanicsSolver()->setStressInitialization( performStressInitialization );
330 for(
string const & regionName : m_stabilizationRegionNames )
332 regionFilter.insert( regionName );
336 this->
template forDiscretizationOnMeshTargets( domain.
getMeshBodies(), [&] (
string const &,
341 string_array filteredTargetRegionNames;
342 filteredTargetRegionNames.reserve( targetRegionNames.size() );
344 for( string const & targetRegionName : targetRegionNames )
346 if( regionFilter.count( targetRegionName ) )
348 filteredTargetRegionNames.emplace_back( targetRegionName );
353 mesh.getElemManager().forElementSubRegions( filteredTargetRegionNames, [&](
localIndex const,
354 ElementSubRegionBase & subRegion )
356 arrayView1d< integer > const macroElementIndex = subRegion.getField< fields::flow::macroElementIndex >();
357 arrayView1d< real64 > const elementStabConstant = subRegion.getField< fields::flow::elementStabConstant >();
359 geos::constitutive::CoupledSolidBase const & porousSolid =
360 this->template getConstitutiveModel< geos::constitutive::CoupledSolidBase >( subRegion, subRegion.getReference< string >( viewKeyStruct::porousMaterialNamesString() ) );
362 arrayView1d< real64 const > const bulkModulus = porousSolid.getBulkModulus();
363 arrayView1d< real64 const > const shearModulus = porousSolid.getShearModulus();
364 arrayView1d< real64 const > const biotCoefficient = porousSolid.getBiotCoefficient();
366 real64 const stabilizationMultiplier = m_stabilizationMultiplier;
368 forAll< parallelDevicePolicy<> >( subRegion.size(), [bulkModulus,
371 stabilizationMultiplier,
373 elementStabConstant] GEOS_HOST_DEVICE ( localIndex const ei )
376 real64 const bM = bulkModulus[ei];
377 real64 const sM = shearModulus[ei];
378 real64 const bC = biotCoefficient[ei];
380 macroElementIndex[ei] = 1;
381 elementStabConstant[ei] = stabilizationMultiplier * 9.0 * (bC * bC) / (32.0 * (10.0 * sM / 3.0 + bM));
388 void updateBulkDensity( DomainPartition & domain )
390 this->
template forDiscretizationOnMeshTargets( domain.getMeshBodies(), [&](
string const &,
394 mesh.getElemManager().forElementSubRegions< CellElementSubRegion >( regionNames, [&]( localIndex const,
400 updateBulkDensity( subRegion );
407 template<
typename CONSTITUTIVE_BASE,
408 typename KERNEL_WRAPPER,
409 typename ... PARAMS >
410 real64 assemblyLaunch( MeshLevel & mesh,
411 DofManager
const & dofManager,
413 string const & materialNamesString,
414 CRSMatrixView< real64, globalIndex const >
const & localMatrix,
415 arrayView1d< real64 >
const & localRhs,
417 PARAMS && ... params )
421 NodeManager
const & nodeManager = mesh.getNodeManager();
423 string const dofKey = dofManager.getKey( fields::solidMechanics::totalDisplacement::key() );
424 arrayView1d< globalIndex const >
const & dofNumber = nodeManager.getReference<
globalIndex_array >( dofKey );
426 real64 const gravityVectorData[3] = LVARRAY_TENSOROPS_INIT_LOCAL_3( PhysicsSolverBase::gravityVector() );
428 KERNEL_WRAPPER kernelWrapper( dofNumber,
429 dofManager.rankOffset(),
434 std::forward< PARAMS >( params )... );
436 return finiteElement::
437 regionBasedKernelApplication< parallelDevicePolicy< >,
439 CellElementSubRegion >( mesh,
441 this->solidMechanicsSolver()->getDiscretizationName(),
448 void recordAverageMeanTotalStressIncrement( DomainPartition & domain,
449 array1d< real64 > & averageMeanTotalStressIncrement )
451 averageMeanTotalStressIncrement.resize( 0 );
452 PhysicsSolverBase::forDiscretizationOnMeshTargets( domain.getMeshBodies(), [&](
string const &,
455 mesh.getElemManager().forElementSubRegions< CellElementSubRegion >( regionNames, [&]( localIndex const,
458 string const solidName = subRegion.template getReference< string >(
"porousMaterialNames" );
459 constitutive::CoupledSolidBase & solid = PhysicsSolverBase::getConstitutiveModel< constitutive::CoupledSolidBase >(
460 subRegion, solidName );
462 arrayView1d< const real64 > const & averageMeanTotalStressIncrement_k = solid.getAverageMeanTotalStressIncrement_k();
463 for( localIndex k = 0; k < localIndex( averageMeanTotalStressIncrement_k.size()); k++ )
465 averageMeanTotalStressIncrement.emplace_back( averageMeanTotalStressIncrement_k[k] );
471 void applyAcceleratedAverageMeanTotalStressIncrement( DomainPartition & domain,
472 array1d< real64 > & averageMeanTotalStressIncrement )
475 PhysicsSolverBase::forDiscretizationOnMeshTargets( domain.getMeshBodies(), [&](
string const &,
478 mesh.getElemManager().forElementSubRegions< CellElementSubRegion >( regionNames, [&]( localIndex const,
481 string const solidName = subRegion.template getReference< string >(
"porousMaterialNames" );
482 constitutive::CoupledSolidBase & solid = PhysicsSolverBase::getConstitutiveModel< constitutive::CoupledSolidBase >(
483 subRegion, solidName );
484 auto & porosityModel = dynamic_cast< constitutive::BiotPorosity const & >( solid.getBasePorosityModel());
485 arrayView1d< real64 > const & averageMeanTotalStressIncrement_k = solid.getAverageMeanTotalStressIncrement_k();
486 for( localIndex k = 0; k < localIndex( averageMeanTotalStressIncrement_k.size()); k++ )
488 porosityModel.updateAverageMeanTotalStressIncrement( k, averageMeanTotalStressIncrement[i] );
495 real64 computeAitkenRelaxationFactor( array1d< real64 >
const & s0,
496 array1d< real64 >
const & s1,
497 array1d< real64 >
const & s1_tilde,
498 array1d< real64 >
const & s2_tilde,
501 array1d< real64 > r1 = axpy( s1_tilde, s0, -1.0 );
502 array1d< real64 > r2 = axpy( s2_tilde, s1, -1.0 );
505 array1d< real64 > diff = axpy( r2, r1, -1.0 );
507 real64 const denom = dot( diff, diff );
508 real64 const numer = dot( r1, diff );
511 if( !isZero( denom ))
513 omega1 = -1.0 * omega0 * numer / denom;
518 array1d< real64 > computeUpdate( array1d< real64 >
const & s1,
519 array1d< real64 >
const & s2_tilde,
522 return axpy( scale( s1, 1.0 - omega1 ),
523 scale( s2_tilde, omega1 ),
527 void startSequentialIteration(
integer const & iter,
528 DomainPartition & domain )
override
530 if( this->getNonlinearSolverParameters().m_nonlinearAccelerationType == NonlinearSolverParameters::NonlinearAccelerationType::Aitken )
534 recordAverageMeanTotalStressIncrement( domain, m_s1 );
540 m_s1_tilde = m_s2_tilde;
546 void finishSequentialIteration(
integer const & iter,
547 DomainPartition & domain )
override
549 if( this->getNonlinearSolverParameters().m_nonlinearAccelerationType == NonlinearSolverParameters::NonlinearAccelerationType::Aitken )
558 m_omega1 = computeAitkenRelaxationFactor( m_s0, m_s1, m_s1_tilde, m_s2_tilde, m_omega0 );
559 m_s2 = computeUpdate( m_s1, m_s2_tilde, m_omega1 );
560 applyAcceleratedAverageMeanTotalStressIncrement( domain, m_s2 );
570 if( solverType ==
static_cast< integer >( SolverType::Flow ) )
572 updateBulkDensity( domain );
576 if( solverType ==
static_cast< integer >( SolverType::SolidMechanics )
577 && !m_performStressInitialization )
580 averageMeanTotalStressIncrement( domain );
582 this->
template forDiscretizationOnMeshTargets( domain.
getMeshBodies(), [&](
string const &,
587 mesh.getElemManager().forElementSubRegions< CellElementSubRegion >( regionNames, [&]( localIndex const,
592 flowSolver()->updatePorosityAndPermeability( subRegion );
594 updateBulkDensity( subRegion );
600 if( solverType ==
static_cast< integer >( SolverType::SolidMechanics ) &&
601 this->getNonlinearSolverParameters().m_nonlinearAccelerationType== NonlinearSolverParameters::NonlinearAccelerationType::Aitken )
603 recordAverageMeanTotalStressIncrement( domain, m_s2_tilde );
613 this->
template forDiscretizationOnMeshTargets( domain.
getMeshBodies(), [&](
string const &,
617 mesh.getElemManager().forElementSubRegions< CellElementSubRegion >( regionNames, [&]( localIndex const,
621 string const solidName = subRegion.template getReference< string >( viewKeyStruct::porousMaterialNamesString() );
622 constitutive::CoupledSolidBase & solid = this->template getConstitutiveModel< constitutive::CoupledSolidBase >( subRegion, solidName );
624 arrayView2d< real64 const > const meanTotalStressIncrement_k = solid.getMeanTotalStressIncrement_k();
625 arrayView1d< real64 > const averageMeanTotalStressIncrement_k = solid.getAverageMeanTotalStressIncrement_k();
627 finiteElement::FiniteElementBase & subRegionFE =
628 subRegion.template getReference< finiteElement::FiniteElementBase >( solidMechanicsSolver()->getDiscretizationName() );
631 finiteElement::FiniteElementDispatchHandler< BASE_FE_TYPES >::
632 dispatch3D( subRegionFE, [&] ( auto const finiteElement )
634 using FE_TYPE = decltype( finiteElement );
637 AverageOverQuadraturePoints1DKernelFactory::
638 createAndLaunch< CellElementSubRegion,
640 parallelDevicePolicy<> >( mesh.getNodeManager(),
641 mesh.getEdgeManager(),
642 mesh.getFaceManager(),
645 meanTotalStressIncrement_k,
646 averageMeanTotalStressIncrement_k );
652 virtual void updateBulkDensity( ElementSubRegionBase & subRegion ) = 0;
654 virtual void validateNonlinearAcceleration()
override
658 GEOS_ERROR(
"Nonlinear acceleration is not implemented for MPI runs" );
#define GEOS_ERROR(msg)
Raise a hard error and terminate the program.
#define GEOS_ERROR_IF(EXP, msg)
Conditionally raise a hard error and terminate the program.
#define GEOS_THROW_IF(EXP, msg, TYPE)
Conditionally throw an exception.
#define GEOS_MARK_FUNCTION
Mark function with both Caliper and NVTX if enabled.
std::tuple< SOLVERS *... > m_solvers
Pointers of the single-physics solvers.
The DoFManager is responsible for allocating global dofs, constructing sparsity patterns,...
Partition of the decomposed physical domain. It also manages the connexion information to its neighbo...
Group const & getMeshBodies() const
Get the mesh bodies, const version.
The ElementRegionManager class provides an interface to ObjectManagerBase in order to manage ElementR...
void forElementSubRegions(LAMBDA &&lambda)
This function is used to launch kernel function over the element subregions of all the subregion type...
Class facilitating the representation of a multi-level discretization of a MeshBody.
ElementRegionManager const & getElemManager() const
Get the element region manager.
@ Sequential
Sequential coupling.
virtual void registerDataOnMesh(Group &MeshBodies) override
Register wrappers that contain data on the mesh objects.
virtual string getCatalogName() const =0
void forDiscretizationOnMeshTargets(Group const &meshBodies, LAMBDA &&lambda) const
Loop over the target discretization on all mesh targets and apply callback.
CRSMatrix< real64, globalIndex > m_localMatrix
Local system matrix and rhs.
DofManager m_dofManager
Data structure to handle degrees of freedom.
ParallelVector m_solution
System solution vector.
ParallelVector m_rhs
System right-hand side vector.
array1d< real64 > m_s0
Member variables needed for Nonlinear Acceleration ( Aitken ). Naming convention follows ( Jiang & Tc...
virtual void implicitStepSetup(real64 const &time_n, real64 const &dt, DomainPartition &domain) override
function to perform setup for implicit timestep
real64 m_stabilizationMultiplier
Stabilization Multiplier.
virtual void initializePreSubGroups() override
Called by Initialize() prior to initializing sub-Groups.
stabilization::StabilizationType m_stabilizationType
Type of stabilization used.
FLOW_SOLVER * flowSolver() const
accessor for the pointer to the flow solver
PoromechanicsSolver(const string &name, dataRepository::Group *const parent)
main constructor for CoupledSolver Objects
virtual void initializePostInitialConditionsPreSubGroups() override
Called by InitializePostInitialConditions() prior to initializing sub-Groups.
virtual void setConstitutiveNamesCallSuper(ElementSubRegionBase &subRegion) const override final
This function sets constitutive name fields on an ElementSubRegionBase, and calls the base function i...
MECHANICS_SOLVER * solidMechanicsSolver() const
accessor for the pointer to the solid mechanics solver
virtual void mapSolutionBetweenSolvers(DomainPartition &domain, integer const solverType) override
Maps the solution obtained from one solver to the fields used by the other solver(s)
integer m_isThermal
Flag to determine whether or not this is a thermal simulation.
bool m_performStressInitialization
Flag to indicate that the solver is going to perform stress initialization.
string_array m_stabilizationRegionNames
Names of regions where stabilization applied.
virtual void setupDofs(DomainPartition const &domain, DofManager &dofManager) const override
Populate degree-of-freedom manager with fields relevant to this solver.
virtual void registerDataOnMesh(dataRepository::Group &meshBodies) override
Register wrappers that contain data on the mesh objects.
void averageMeanTotalStressIncrement(DomainPartition &domain)
Helper function to average the mean total stress increment over quadrature points.
static string coupledSolverAttributePrefix()
String used to form the solverName used to register solvers in CoupledSolver.
virtual void initializePreSubGroups()
Called by Initialize() prior to initializing sub-Groups.
Wrapper< TBASE > & registerWrapper(string const &name, wrapperMap::KeyIndex::index_type *const rkey=nullptr)
Create and register a Wrapper around a new object.
DataContext const & getDataContext() const
void setRestartFlags(RestartFlags flags)
Set flags that control restart output of this group.
string const & getName() const
Get group name.
Group & setSizedFromParent(int val)
Set whether this wrapper is resized when its parent is resized.
DataContext const & getWrapperDataContext(KEY key) const
virtual void initializePostInitialConditionsPreSubGroups()
Called by InitializePostInitialConditions() prior to initializing sub-Groups.
@ NOPLOT
Do not ever write to plot file.
@ OPTIONAL
Optional in input.
@ NO_WRITE
Do not write into restart.
int MPI_COMM_GEOS
Global MPI communicator used by GEOSX.
array1d< globalIndex > globalIndex_array
A 1-dimensional array of geos::globalIndex types.
ENUM_STRINGS(LinearSolverParameters::SolverType, "direct", "cg", "gmres", "fgmres", "bicgstab", "preconditioner")
Declare strings associated with enumeration values.
std::set< T > set
A set of local indices.
double real64
64-bit floating point type.
GEOS_LOCALINDEX_TYPE localIndex
Local index type (for indexing objects within an MPI partition).
std::int32_t integer
Signed integer type.
@ None
No Schur complement - just block-GS/block-Jacobi preconditioner.
std::vector< string > string_array
A 1-dimensional array of geos::string types.
Array< T, 1 > array1d
Alias for 1D array.
constexpr static char const * porousMaterialNamesString()
Names of the porous materials.
constexpr static const char * stabilizationRegionNamesString()
Name of regions on which stabilization applied.
static constexpr char const * hydraulicApertureRelationNameString()
Name of the hydraulicApertureRelationName.
constexpr static char const * isThermalString()
Flag to indicate that the simulation is thermal.
constexpr static char const * stabilizationTypeString()
Type of pressure stabilization.
constexpr static const char * stabilizationMultiplierString()
Multiplier on stabilization strength.
Structure to hold scoped key names.