GEOS
ThermalSinglePhasePoromechanics_impl.hpp
Go to the documentation of this file.
1 /*
2  * ------------------------------------------------------------------------------------------------------------
3  * SPDX-License-Identifier: LGPL-2.1-only
4  *
5  * Copyright (c) 2016-2024 Lawrence Livermore National Security LLC
6  * Copyright (c) 2018-2024 TotalEnergies
7  * Copyright (c) 2018-2024 The Board of Trustees of the Leland Stanford Junior University
8  * Copyright (c) 2023-2024 Chevron
9  * Copyright (c) 2019- GEOS/GEOSX Contributors
10  * All rights reserved
11  *
12  * See top level LICENSE, COPYRIGHT, CONTRIBUTORS, NOTICE, and ACKNOWLEDGEMENTS files for details.
13  * ------------------------------------------------------------------------------------------------------------
14  */
15 
20 #ifndef GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSKERNELS_THERMALSINGLEPHASEPOROMECHANICS_IMPL_HPP_
21 #define GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSKERNELS_THERMALSINGLEPHASEPOROMECHANICS_IMPL_HPP_
22 
23 #include "constitutive/fluid/singlefluid/SingleFluidBase.hpp"
25 
26 namespace geos
27 {
28 
29 namespace thermalPoromechanicsKernels
30 {
31 
32 template< typename SUBREGION_TYPE,
33  typename CONSTITUTIVE_TYPE,
34  typename FE_TYPE >
36 ThermalSinglePhasePoromechanics( NodeManager const & nodeManager,
37  EdgeManager const & edgeManager,
38  FaceManager const & faceManager,
39  localIndex const targetRegionIndex,
40  SUBREGION_TYPE const & elementSubRegion,
41  FE_TYPE const & finiteElementSpace,
42  CONSTITUTIVE_TYPE & inputConstitutiveType,
43  arrayView1d< globalIndex const > const inputDispDofNumber,
44  globalIndex const rankOffset,
46  arrayView1d< real64 > const inputRhs,
47  real64 const inputDt,
48  real64 const (&gravityVector)[3],
49  string const inputFlowDofKey,
50  integer const performStressInitialization,
51  string const fluidModelKey ):
52  Base( nodeManager,
53  edgeManager,
54  faceManager,
55  targetRegionIndex,
56  elementSubRegion,
57  finiteElementSpace,
58  inputConstitutiveType,
59  inputDispDofNumber,
60  rankOffset,
61  inputMatrix,
62  inputRhs,
63  inputDt,
64  gravityVector,
65  inputFlowDofKey,
66  performStressInitialization,
67  fluidModelKey ),
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 >() )
77 {}
78 
79 template< typename SUBREGION_TYPE,
80  typename CONSTITUTIVE_TYPE,
81  typename FE_TYPE >
85 setup( localIndex const k,
86  StackVariables & stack ) const
87 {
88  Base::setup( k, stack );
89  stack.localTemperatureDofIndex = m_flowDofNumber[k]+1;
90  stack.temperature = m_temperature[k];
91  stack.deltaTemperatureFromLastStep = m_temperature[k] - m_temperature_n[k];
92 }
93 
94 template< typename SUBREGION_TYPE,
95  typename CONSTITUTIVE_TYPE,
96  typename FE_TYPE >
101  localIndex const q,
102  StackVariables & stack ) const
103 {
104  real64 porosity = 0.0;
105  real64 porosity_n = 0.0;
106  real64 dPorosity_dVolStrain = 0.0;
107  real64 dPorosity_dPressure = 0.0;
108  real64 dPorosity_dTemperature = 0.0;
109  real64 dSolidDensity_dPressure = 0.0;
110 
111  // Step 1: call the constitutive model to evaluate the total stress and compute porosity
112  m_constitutiveUpdate.smallStrainUpdatePoromechanics( k, q,
113  m_dt,
114  m_pressure[k],
115  m_pressure_n[k],
116  stack.temperature,
117  stack.deltaTemperatureFromLastStep,
118  stack.strainIncrement,
119  stack.totalStress,
120  stack.dTotalStress_dPressure,
121  stack.dTotalStress_dTemperature,
122  stack.stiffness,
123  m_performStressInitialization,
124  porosity,
125  porosity_n,
126  dPorosity_dVolStrain,
127  dPorosity_dPressure,
128  dPorosity_dTemperature,
129  dSolidDensity_dPressure );
130 
131  // Step 2: compute the body force
132  computeBodyForce( k, q,
133  porosity,
134  dPorosity_dVolStrain,
135  dPorosity_dPressure,
136  dPorosity_dTemperature,
137  dSolidDensity_dPressure,
138  stack );
139 
140  // Step 3: compute fluid mass increment
141  computeFluidIncrement( k, q,
142  porosity,
143  porosity_n,
144  dPorosity_dVolStrain,
145  dPorosity_dPressure,
146  dPorosity_dTemperature,
147  stack );
148 }
149 
150 template< typename SUBREGION_TYPE,
151  typename CONSTITUTIVE_TYPE,
152  typename FE_TYPE >
157  localIndex const q,
158  real64 const & porosity,
159  real64 const & dPorosity_dVolStrain,
160  real64 const & dPorosity_dPressure,
161  real64 const & dPorosity_dTemperature,
162  real64 const & dSolidDensity_dPressure,
163  StackVariables & stack ) const
164 {
165  Base::computeBodyForce( k, q,
166  porosity,
167  dPorosity_dVolStrain,
168  dPorosity_dPressure,
169  dPorosity_dTemperature,
170  dSolidDensity_dPressure,
171  stack );
172 
173  real64 const dMixtureDens_dTemperature =
174  dPorosity_dTemperature * ( -m_solidDensity( k, q ) + m_fluidDensity( k, q ) )
175  + porosity * m_dFluidDensity( k, q, DerivOffset::dT );
176 
177  LvArray::tensorOps::scaledCopy< 3 >( stack.dBodyForce_dTemperature, m_gravityVector, dMixtureDens_dTemperature );
178 }
179 
180 template< typename SUBREGION_TYPE,
181  typename CONSTITUTIVE_TYPE,
182  typename FE_TYPE >
187  localIndex const q,
188  real64 const & porosity,
189  real64 const & porosity_n,
190  real64 const & dPorosity_dVolStrain,
191  real64 const & dPorosity_dPressure,
192  real64 const & dPorosity_dTemperature,
193  StackVariables & stack ) const
194 {
195  // Step 1: compute fluid mass increment and its derivatives wrt vol strain and pressure
196  Base::computeFluidIncrement( k, q,
197  porosity,
198  porosity_n,
199  dPorosity_dVolStrain,
200  dPorosity_dPressure,
201  dPorosity_dTemperature,
202  stack );
203 
204  // Step 2: compute derivative of fluid mass increment wrt temperature
205  stack.dFluidMassIncrement_dTemperature = dPorosity_dTemperature * m_fluidDensity( k, q ) + porosity * m_dFluidDensity( k, q, DerivOffset::dT );
206  // tag
207 
208  // Step 3: compute fluid energy increment and its derivatives wrt vol strain, pressure, and temperature
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 );
212  stack.energyIncrement = fluidEnergy - fluidEnergy_n;
213 
214  stack.dEnergyIncrement_dVolStrainIncrement = stack.dFluidMassIncrement_dVolStrainIncrement * m_fluidInternalEnergy( k, q );
215  stack.dEnergyIncrement_dPressure = stack.dFluidMassIncrement_dPressure * m_fluidInternalEnergy( k, q )
216  + fluidMass * m_dFluidInternalEnergy( k, q, DerivOffset::dP );
217  stack.dEnergyIncrement_dTemperature = stack.dFluidMassIncrement_dTemperature * m_fluidInternalEnergy( k, q )
218  + fluidMass * m_dFluidInternalEnergy( k, q, DerivOffset::dT );
219 
220 
221  // Step 4: assemble the solid part of the accumulation term
222  real64 const oneMinusPoro = 1 - porosity;
223 
224  stack.energyIncrement += oneMinusPoro * m_rockInternalEnergy( k, 0 ) - ( 1 - porosity_n ) * m_rockInternalEnergy_n( k, 0 );
225  stack.dEnergyIncrement_dVolStrainIncrement += -dPorosity_dVolStrain * m_rockInternalEnergy( k, 0 );
226  stack.dEnergyIncrement_dPressure += -dPorosity_dPressure * m_rockInternalEnergy( k, 0 );
227  stack.dEnergyIncrement_dTemperature += -dPorosity_dTemperature * m_rockInternalEnergy( k, 0 ) + oneMinusPoro * m_dRockInternalEnergy_dTemperature( k, 0 );
228 }
229 
230 template< typename SUBREGION_TYPE,
231  typename CONSTITUTIVE_TYPE,
232  typename FE_TYPE >
236 assembleMomentumBalanceTerms( real64 const ( &N )[numNodesPerElem],
237  real64 const ( &dNdX )[numNodesPerElem][3],
238  real64 const & detJxW,
239  StackVariables & stack ) const
240 {
241  using namespace PDEUtilities;
242 
243  Base::assembleMomentumBalanceTerms( N, dNdX, detJxW, stack );
244 
245  constexpr FunctionSpace displacementTrialSpace = FE_TYPE::template getFunctionSpace< numDofPerTrialSupportPoint >();
246  constexpr FunctionSpace displacementTestSpace = displacementTrialSpace;
247  constexpr FunctionSpace pressureTrialSpace = FunctionSpace::P0;
248 
249  // compute local linear momentum balance residual derivatives with respect to temperature
250 
251  BilinearFormUtilities::compute< displacementTestSpace,
252  pressureTrialSpace,
253  DifferentialOperator::SymmetricGradient,
254  DifferentialOperator::Identity >
255  (
257  dNdX,
258  stack.dTotalStress_dTemperature,
259  1.0,
260  -detJxW );
261 
262  BilinearFormUtilities::compute< displacementTestSpace,
263  pressureTrialSpace,
264  DifferentialOperator::Identity,
265  DifferentialOperator::Identity >
266  (
268  N,
270  1.0,
271  detJxW );
272 }
273 
274 template< typename SUBREGION_TYPE,
275  typename CONSTITUTIVE_TYPE,
276  typename FE_TYPE >
280 assembleElementBasedFlowTerms( real64 const ( &dNdX )[numNodesPerElem][3],
281  real64 const & detJxW,
282  StackVariables & stack ) const
283 {
284 
285  using namespace PDEUtilities;
286 
287  Base::assembleElementBasedFlowTerms( dNdX, detJxW, stack );
288 
289  constexpr FunctionSpace displacementTrialSpace = FE_TYPE::template getFunctionSpace< numDofPerTrialSupportPoint >();
290  constexpr FunctionSpace pressureTrialSpace = FunctionSpace::P0;
291  constexpr FunctionSpace pressureTestSpace = pressureTrialSpace;
292 
293  // Step 1: compute local mass balance residual derivatives with respect to temperature
294 
295  BilinearFormUtilities::compute< pressureTestSpace,
296  pressureTrialSpace,
297  DifferentialOperator::Identity,
298  DifferentialOperator::Identity >
299  (
301  1.0,
303  1.0,
304  detJxW );
305 
306  // Step 2: compute local energy balance residual and its derivatives
307 
308  LinearFormUtilities::compute< pressureTestSpace,
309  DifferentialOperator::Identity >
310  (
311  stack.localResidualEnergy,
312  1.0,
313  stack.energyIncrement,
314  detJxW );
315 
316  BilinearFormUtilities::compute< pressureTestSpace,
317  displacementTrialSpace,
318  DifferentialOperator::Identity,
319  DifferentialOperator::Divergence >
320  (
322  1.0,
324  dNdX,
325  detJxW );
326 
327  BilinearFormUtilities::compute< pressureTestSpace,
328  pressureTrialSpace,
329  DifferentialOperator::Identity,
330  DifferentialOperator::Identity >
331  (
333  1.0,
335  1.0,
336  detJxW );
337 
338  BilinearFormUtilities::compute< pressureTestSpace,
339  pressureTrialSpace,
340  DifferentialOperator::Identity,
341  DifferentialOperator::Identity >
342  (
344  1.0,
346  1.0,
347  detJxW );
348 }
349 
350 template< typename SUBREGION_TYPE,
351  typename CONSTITUTIVE_TYPE,
352  typename FE_TYPE >
357  localIndex const q,
358  StackVariables & stack ) const
359 {
360  // Step 1: compute displacement finite element basis functions (N), basis function derivatives (dNdX), and
361  // determinant of the Jacobian transformation matrix times the quadrature weight (detJxW)
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 );
367 
368  // Step 2: compute strain increment
369  LvArray::tensorOps::fill< 6 >( stack.strainIncrement, 0.0 );
370  FE_TYPE::symmetricGradient( dNdX, stack.uhat_local, stack.strainIncrement );
371 
372  // Step 3: compute 1) the total stress, 2) the body force terms, and 3) the fluidMassIncrement
373  // using quantities returned by the PorousSolid constitutive model.
374  // This function also computes the derivatives of these three quantities wrt primary variables
375  smallStrainUpdate( k, q, stack );
376 
377  // Step 4: use the total stress and the body force to increment the local momentum balance residual
378  // This function also fills the local Jacobian rows corresponding to the momentum balance.
379  assembleMomentumBalanceTerms( N, dNdX, detJxW, stack );
380 
381  // Step 5: use the fluid mass increment to increment the local mass balance residual
382  // This function also fills the local Jacobian rows corresponding to the mass balance.
383  assembleElementBasedFlowTerms( dNdX, detJxW, stack );
384 }
385 
386 template< typename SUBREGION_TYPE,
387  typename CONSTITUTIVE_TYPE,
388  typename FE_TYPE >
392 complete( localIndex const k,
393  StackVariables & stack ) const
394 {
395  real64 const maxForce = Base::complete( k, stack );
396 
397  localIndex const numSupportPoints =
398  m_finiteElementSpace.template numSupportPoints< FE_TYPE >( stack.feStack );
399  integer numDisplacementDofs = numSupportPoints * numDofPerTestSupportPoint;
400 
401  // Step 1: assemble the derivatives of linear momentum balance wrt temperature into the global matrix
402 
403  for( int localNode = 0; localNode < numSupportPoints; ++localNode )
404  {
405  for( integer dim = 0; dim < numDofPerTestSupportPoint; ++dim )
406  {
407  localIndex const dof = LvArray::integerConversion< localIndex >( stack.localRowDofIndex[numDofPerTestSupportPoint*localNode + dim] - m_dofRankOffset );
408 
409  // we need this check to filter out ghost nodes in the assembly
410  if( dof < 0 || dof >= m_matrix.numRows() )
411  {
412  continue;
413  }
414 
415  m_matrix.template addToRowBinarySearchUnsorted< parallelDeviceAtomic >( dof,
417  stack.dLocalResidualMomentum_dTemperature[numDofPerTestSupportPoint * localNode + dim],
418  1 );
419  }
420  }
421 
422  // Step 2: assemble the derivatives of mass balance residual wrt temperature into the global matrix
423 
424  localIndex const massDof = LvArray::integerConversion< localIndex >( stack.localPressureDofIndex - m_dofRankOffset );
425 
426  // we need this check to filter out ghost cells in the assembly
427  if( 0 <= massDof && massDof < m_matrix.numRows() )
428  {
429  m_matrix.template addToRow< serialAtomic >( massDof,
432  1 );
433  }
434 
435  // Step 3: assemble the energy balance and its derivatives into the global matrix
436 
437  localIndex const energyDof = LvArray::integerConversion< localIndex >( stack.localTemperatureDofIndex - m_dofRankOffset );
438 
439  // we need this check to filter out ghost cells in the assembly
440  if( 0 <= energyDof && energyDof < m_matrix.numRows() )
441  {
442  m_matrix.template addToRowBinarySearchUnsorted< serialAtomic >( energyDof,
443  stack.localRowDofIndex,
445  numDisplacementDofs );
446  m_matrix.template addToRow< serialAtomic >( energyDof,
447  &stack.localPressureDofIndex,
449  1 );
450  m_matrix.template addToRow< serialAtomic >( energyDof,
453  1 );
454 
455  RAJA::atomicAdd< serialAtomic >( &m_rhs[energyDof], stack.localResidualEnergy[0] );
456  }
457 
458  return maxForce;
459 }
460 
461 template< typename SUBREGION_TYPE,
462  typename CONSTITUTIVE_TYPE,
463  typename FE_TYPE >
464 template< typename POLICY,
465  typename KERNEL_TYPE >
467 kernelLaunch( localIndex const numElems,
468  KERNEL_TYPE const & kernelComponent )
469 {
471 
472  // Define a RAJA reduction variable to get the maximum residual contribution.
473  RAJA::ReduceMax< ReducePolicy< POLICY >, real64 > maxResidual( 0 );
474 
475  forAll< POLICY >( numElems,
476  [=] GEOS_HOST_DEVICE ( localIndex const k )
477  {
478  typename KERNEL_TYPE::StackVariables stack;
479 
480  kernelComponent.setup( k, stack );
481  for( integer q=0; q<KERNEL_TYPE::numQuadraturePointsPerElem; ++q )
482  {
483  kernelComponent.quadraturePointKernel( k, q, stack );
484  }
485  maxResidual.max( kernelComponent.complete( k, stack ) );
486  } );
487  return maxResidual.get();
488 }
489 
490 
491 } // namespace thermalPoromechanicsKernels
492 
493 } // namespace geos
494 
495 #endif // GEOS_PHYSICSSOLVERS_MULTIPHYSICS_POROMECHANICSKERNELS_THERMALSINGLEPHASEPOROMECHANICS_HPP_
#define GEOS_HOST_DEVICE
Marks a host-device function.
Definition: GeosxMacros.hpp:49
#define GEOS_FORCE_INLINE
Marks a function or lambda for inlining.
Definition: GeosxMacros.hpp:51
#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.
Definition: EdgeManager.hpp:43
The FaceManager class provides an interface to ObjectManagerBase in order to manage face data.
Definition: FaceManager.hpp:44
The NodeManager class provides an interface to ObjectManagerBase in order to manage node data.
Definition: NodeManager.hpp:46
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.
Definition: DataTypes.hpp:180
LvArray::CRSMatrixView< T, COL_INDEX, localIndex const, LvArray::ChaiBuffer > CRSMatrixView
Alias for CRS Matrix View.
Definition: DataTypes.hpp:310
GEOS_GLOBALINDEX_TYPE globalIndex
Global index type (for indexing objects across MPI partitions).
Definition: DataTypes.hpp:88
std::string string
String type.
Definition: DataTypes.hpp:91
double real64
64-bit floating point type.
Definition: DataTypes.hpp:99
GEOS_LOCALINDEX_TYPE localIndex
Local index type (for indexing objects within an MPI partition).
Definition: DataTypes.hpp:85
std::int32_t integer
Signed integer type.
Definition: DataTypes.hpp:82
real64 dLocalResidualEnergy_dDisplacement[1][numDispDofPerElem]
Derivative of energy balance residual wrt displacement.
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 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 dLocalResidualEnergy_dTemperature[1][1]
Derivative of energy balance residual wrt temperature.