20 #ifndef GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSKERNELS_THERMALSINGLEPHASEPOROMECHANICS_IMPL_HPP_
21 #define GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSKERNELS_THERMALSINGLEPHASEPOROMECHANICS_IMPL_HPP_
23 #include "constitutive/fluid/singlefluid/SingleFluidBase.hpp"
29 namespace thermalPoromechanicsKernels
32 template<
typename SUBREGION_TYPE,
33 typename CONSTITUTIVE_TYPE,
40 SUBREGION_TYPE
const & elementSubRegion,
41 FE_TYPE
const & finiteElementSpace,
42 CONSTITUTIVE_TYPE & inputConstitutiveType,
48 real64 const (&gravityVector)[3],
49 string const inputFlowDofKey,
50 integer const performStressInitialization,
51 string const fluidModelKey ):
58 inputConstitutiveType,
66 performStressInitialization,
68 m_fluidInternalEnergy_n( elementSubRegion.template getConstitutiveModel< constitutive::SingleFluidBase >( elementSubRegion.template getReference<
string >( fluidModelKey ) ).internalEnergy_n() ),
69 m_fluidInternalEnergy( elementSubRegion.template getConstitutiveModel< constitutive::SingleFluidBase >( elementSubRegion.template getReference<
string >( fluidModelKey ) ).internalEnergy() ),
70 m_dFluidInternalEnergy( elementSubRegion.template getConstitutiveModel< constitutive::SingleFluidBase >( elementSubRegion.template getReference<
string >(
71 fluidModelKey ) ).dInternalEnergy() ),
72 m_rockInternalEnergy_n( inputConstitutiveType.getInternalEnergy_n() ),
73 m_rockInternalEnergy( inputConstitutiveType.getInternalEnergy() ),
74 m_dRockInternalEnergy_dTemperature( inputConstitutiveType.getDinternalEnergy_dTemperature() ),
75 m_temperature_n( elementSubRegion.template getField< fields::flow::temperature_n >() ),
76 m_temperature( elementSubRegion.template getField< fields::flow::temperature >() )
79 template<
typename SUBREGION_TYPE,
80 typename CONSTITUTIVE_TYPE,
88 Base::setup( k, stack );
90 stack.temperature = m_temperature[k];
91 stack.deltaTemperatureFromLastStep = m_temperature[k] - m_temperature_n[k];
94 template<
typename SUBREGION_TYPE,
95 typename CONSTITUTIVE_TYPE,
106 real64 dPorosity_dVolStrain = 0.0;
107 real64 dPorosity_dPressure = 0.0;
108 real64 dPorosity_dTemperature = 0.0;
109 real64 dSolidDensity_dPressure = 0.0;
112 m_constitutiveUpdate.smallStrainUpdatePoromechanics( k, q,
117 stack.deltaTemperatureFromLastStep,
118 stack.strainIncrement,
120 stack.dTotalStress_dPressure,
121 stack.dTotalStress_dTemperature,
123 m_performStressInitialization,
126 dPorosity_dVolStrain,
128 dPorosity_dTemperature,
129 dSolidDensity_dPressure );
132 computeBodyForce( k, q,
134 dPorosity_dVolStrain,
136 dPorosity_dTemperature,
137 dSolidDensity_dPressure,
141 computeFluidIncrement( k, q,
144 dPorosity_dVolStrain,
146 dPorosity_dTemperature,
150 template<
typename SUBREGION_TYPE,
151 typename CONSTITUTIVE_TYPE,
159 real64 const & dPorosity_dVolStrain,
160 real64 const & dPorosity_dPressure,
161 real64 const & dPorosity_dTemperature,
162 real64 const & dSolidDensity_dPressure,
165 Base::computeBodyForce( k, q,
167 dPorosity_dVolStrain,
169 dPorosity_dTemperature,
170 dSolidDensity_dPressure,
173 real64 const dMixtureDens_dTemperature =
174 dPorosity_dTemperature * ( -m_solidDensity( k, q ) + m_fluidDensity( k, q ) )
175 + porosity * m_dFluidDensity( k, q, DerivOffset::dT );
177 LvArray::tensorOps::scaledCopy< 3 >( stack.
dBodyForce_dTemperature, m_gravityVector, dMixtureDens_dTemperature );
180 template<
typename SUBREGION_TYPE,
181 typename CONSTITUTIVE_TYPE,
189 real64 const & porosity_n,
190 real64 const & dPorosity_dVolStrain,
191 real64 const & dPorosity_dPressure,
192 real64 const & dPorosity_dTemperature,
196 Base::computeFluidIncrement( k, q,
199 dPorosity_dVolStrain,
201 dPorosity_dTemperature,
209 real64 const fluidMass = porosity * m_fluidDensity( k, q );
210 real64 const fluidEnergy = fluidMass * m_fluidInternalEnergy( k, q );
211 real64 const fluidEnergy_n = porosity_n * m_fluidDensity_n( k, q ) * m_fluidInternalEnergy_n( k, q );
216 + fluidMass * m_dFluidInternalEnergy( k, q, DerivOffset::dP );
218 + fluidMass * m_dFluidInternalEnergy( k, q, DerivOffset::dT );
222 real64 const oneMinusPoro = 1 - porosity;
224 stack.
energyIncrement += oneMinusPoro * m_rockInternalEnergy( k, 0 ) - ( 1 - porosity_n ) * m_rockInternalEnergy_n( k, 0 );
227 stack.
dEnergyIncrement_dTemperature += -dPorosity_dTemperature * m_rockInternalEnergy( k, 0 ) + oneMinusPoro * m_dRockInternalEnergy_dTemperature( k, 0 );
230 template<
typename SUBREGION_TYPE,
231 typename CONSTITUTIVE_TYPE,
237 real64 const ( &dNdX )[numNodesPerElem][3],
241 using namespace PDEUtilities;
243 Base::assembleMomentumBalanceTerms( N, dNdX, detJxW, stack );
245 constexpr FunctionSpace displacementTrialSpace = FE_TYPE::template getFunctionSpace< numDofPerTrialSupportPoint >();
246 constexpr FunctionSpace displacementTestSpace = displacementTrialSpace;
247 constexpr FunctionSpace pressureTrialSpace = FunctionSpace::P0;
251 BilinearFormUtilities::compute< displacementTestSpace,
253 DifferentialOperator::SymmetricGradient,
254 DifferentialOperator::Identity >
258 stack.dTotalStress_dTemperature,
262 BilinearFormUtilities::compute< displacementTestSpace,
264 DifferentialOperator::Identity,
265 DifferentialOperator::Identity >
274 template<
typename SUBREGION_TYPE,
275 typename CONSTITUTIVE_TYPE,
285 using namespace PDEUtilities;
287 Base::assembleElementBasedFlowTerms( dNdX, detJxW, stack );
289 constexpr FunctionSpace displacementTrialSpace = FE_TYPE::template getFunctionSpace< numDofPerTrialSupportPoint >();
290 constexpr FunctionSpace pressureTrialSpace = FunctionSpace::P0;
291 constexpr FunctionSpace pressureTestSpace = pressureTrialSpace;
295 BilinearFormUtilities::compute< pressureTestSpace,
297 DifferentialOperator::Identity,
298 DifferentialOperator::Identity >
308 LinearFormUtilities::compute< pressureTestSpace,
309 DifferentialOperator::Identity >
316 BilinearFormUtilities::compute< pressureTestSpace,
317 displacementTrialSpace,
318 DifferentialOperator::Identity,
319 DifferentialOperator::Divergence >
327 BilinearFormUtilities::compute< pressureTestSpace,
329 DifferentialOperator::Identity,
330 DifferentialOperator::Identity >
338 BilinearFormUtilities::compute< pressureTestSpace,
340 DifferentialOperator::Identity,
341 DifferentialOperator::Identity >
350 template<
typename SUBREGION_TYPE,
351 typename CONSTITUTIVE_TYPE,
358 StackVariables & stack )
const
362 real64 N[numNodesPerElem]{};
363 real64 dNdX[numNodesPerElem][3]{};
364 FE_TYPE::calcN( q, stack.feStack, N );
365 real64 const detJxW = m_finiteElementSpace.template getGradN< FE_TYPE >( k, q, stack.xLocal,
366 stack.feStack, dNdX );
369 LvArray::tensorOps::fill< 6 >( stack.strainIncrement, 0.0 );
370 FE_TYPE::symmetricGradient( dNdX, stack.uhat_local, stack.strainIncrement );
375 smallStrainUpdate( k, q, stack );
379 assembleMomentumBalanceTerms( N, dNdX, detJxW, stack );
383 assembleElementBasedFlowTerms( dNdX, detJxW, stack );
386 template<
typename SUBREGION_TYPE,
387 typename CONSTITUTIVE_TYPE,
395 real64 const maxForce = Base::complete( k, stack );
398 m_finiteElementSpace.template numSupportPoints< FE_TYPE >( stack.feStack );
399 integer numDisplacementDofs = numSupportPoints * numDofPerTestSupportPoint;
403 for(
int localNode = 0; localNode < numSupportPoints; ++localNode )
405 for(
integer dim = 0; dim < numDofPerTestSupportPoint; ++dim )
407 localIndex const dof = LvArray::integerConversion< localIndex >( stack.localRowDofIndex[numDofPerTestSupportPoint*localNode + dim] - m_dofRankOffset );
410 if( dof < 0 || dof >= m_matrix.numRows() )
415 m_matrix.template addToRowBinarySearchUnsorted< parallelDeviceAtomic >( dof,
424 localIndex const massDof = LvArray::integerConversion< localIndex >( stack.localPressureDofIndex - m_dofRankOffset );
427 if( 0 <= massDof && massDof < m_matrix.numRows() )
429 m_matrix.template addToRow< serialAtomic >( massDof,
440 if( 0 <= energyDof && energyDof < m_matrix.numRows() )
442 m_matrix.template addToRowBinarySearchUnsorted< serialAtomic >( energyDof,
443 stack.localRowDofIndex,
445 numDisplacementDofs );
446 m_matrix.template addToRow< serialAtomic >( energyDof,
447 &stack.localPressureDofIndex,
450 m_matrix.template addToRow< serialAtomic >( energyDof,
461 template<
typename SUBREGION_TYPE,
462 typename CONSTITUTIVE_TYPE,
464 template<
typename POLICY,
465 typename KERNEL_TYPE >
468 KERNEL_TYPE
const & kernelComponent )
473 RAJA::ReduceMax< ReducePolicy< POLICY >,
real64 > maxResidual( 0 );
475 forAll< POLICY >( numElems,
478 typename KERNEL_TYPE::StackVariables stack;
480 kernelComponent.setup( k, stack );
481 for(
integer q=0; q<KERNEL_TYPE::numQuadraturePointsPerElem; ++q )
483 kernelComponent.quadraturePointKernel( k, q, stack );
485 maxResidual.max( kernelComponent.complete( k, stack ) );
487 return maxResidual.get();
#define GEOS_HOST_DEVICE
Marks a host-device function.
#define GEOS_FORCE_INLINE
Marks a function or lambda for inlining.
#define GEOS_MARK_FUNCTION
Mark function with both Caliper and NVTX if enabled.
This class provides an interface to ObjectManagerBase in order to manage edge data.
The FaceManager class provides an interface to ObjectManagerBase in order to manage face data.
The NodeManager class provides an interface to ObjectManagerBase in order to manage node data.
Implements kernels for solving quasi-static thermal single-phase poromechanics.
GEOS_HOST_DEVICE void assembleElementBasedFlowTerms(real64 const (&dNdX)[numNodesPerElem][3], real64 const &detJxW, StackVariables &stack) const
Assemble the local mass/energy balance residual and derivatives using fluid mass/energy increment.
static real64 kernelLaunch(localIndex const numElems, KERNEL_TYPE const &kernelComponent)
Kernel Launcher.
GEOS_HOST_DEVICE void computeFluidIncrement(localIndex const k, localIndex const q, real64 const &porosity, real64 const &porosity_n, real64 const &dPorosity_dVolStrain, real64 const &dPorosity_dPressure, real64 const &dPorosity_dTemperature, StackVariables &stack) const
Helper function to compute the fluid mass/energy increment and its derivatives wrt primary variables.
GEOS_HOST_DEVICE void setup(localIndex const k, StackVariables &stack) const
Copy global values from primary field to a local stack array.
GEOS_HOST_DEVICE void computeBodyForce(localIndex const k, localIndex const q, real64 const &porosity, real64 const &dPorosity_dVolStrain, real64 const &dPorosity_dPressure, real64 const &dPorosity_dTemperature, real64 const &dSolidDensity_dPressure, StackVariables &stack) const
Helper function to compute the body force term (\rho g) and its derivatives wrt primary variables.
GEOS_HOST_DEVICE real64 complete(localIndex const k, StackVariables &stack) const
Performs the complete phase for the kernel.
GEOS_HOST_DEVICE void assembleMomentumBalanceTerms(real64 const (&N)[numNodesPerElem], real64 const (&dNdX)[numNodesPerElem][3], real64 const &detJxW, StackVariables &stack) const
Assemble the local linear momentum balance residual and derivatives using total stress and body force...
ThermalSinglePhasePoromechanics(NodeManager const &nodeManager, EdgeManager const &edgeManager, FaceManager const &faceManager, localIndex const targetRegionIndex, SUBREGION_TYPE const &elementSubRegion, FE_TYPE const &finiteElementSpace, CONSTITUTIVE_TYPE &inputConstitutiveType, arrayView1d< globalIndex const > const inputDispDofNumber, globalIndex const rankOffset, CRSMatrixView< real64, globalIndex const > const inputMatrix, arrayView1d< real64 > const inputRhs, real64 const inputDt, real64 const (&gravityVector)[3], string const inputFlowDofKey, integer const performStressInitialization, string const fluidModelKey)
Constructor.
GEOS_HOST_DEVICE void smallStrainUpdate(localIndex const k, localIndex const q, StackVariables &stack) const
Helper function to compute 1) the total stress, 2) the body force term, and 3) the fluidMass/EnergyIn...
ArrayView< T, 1 > arrayView1d
Alias for 1D array view.
LvArray::CRSMatrixView< T, COL_INDEX, localIndex const, LvArray::ChaiBuffer > CRSMatrixView
Alias for CRS Matrix View.
GEOS_GLOBALINDEX_TYPE globalIndex
Global index type (for indexing objects across MPI partitions).
std::string string
String type.
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.
Kernel variables allocated on the stack.
real64 dLocalResidualEnergy_dDisplacement[1][numDispDofPerElem]
Derivative of energy balance residual wrt displacement.
real64 dEnergyIncrement_dPressure
Derivative of energy accumulation wrt pressure.
real64 dFluidMassIncrement_dTemperature
Derivative of mass accumulation wrt temperature.
globalIndex localTemperatureDofIndex
C-array storage for the element local row degrees of freedom.
real64 dEnergyIncrement_dVolStrainIncrement
Derivative of energy accumulation wrt volumetric strain increment.
real64 energyIncrement
Energy accumulation.
real64 dEnergyIncrement_dTemperature
Derivative of energy accumulation wrt temperature.
real64 localResidualEnergy[1]
Energy balance residual.
real64 dLocalResidualMass_dTemperature[1][1]
Derivative of mass balance residual wrt pressure.
real64 dLocalResidualEnergy_dPressure[1][1]
Derivative of energy balance residual wrt pressure.
real64 dLocalResidualMomentum_dTemperature[numDispDofPerElem][1]
Derivative of linear momentum balance residual wrt temperature.
real64 dBodyForce_dTemperature[3]
Derivative of body force wrt temperature.
real64 dLocalResidualEnergy_dTemperature[1][1]
Derivative of energy balance residual wrt temperature.