GEOS
StabilizedFluxComputeKernel.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_FLUIDFLOW_COMPOSITIONAL_STABILIZEDFLUXCOMPUTEKERNEL_HPP
21 #define GEOS_PHYSICSSOLVERS_FLUIDFLOW_COMPOSITIONAL_STABILIZEDFLUXCOMPUTEKERNEL_HPP
22 
24 #include "constitutive/relativePermeability/RelativePermeabilityBase.hpp"
25 #include "constitutive/relativePermeability/RelativePermeabilityFields.hpp"
26 
27 
28 namespace geos
29 {
30 
31 namespace stabilizedCompositionalMultiphaseFVMKernels
32 {
33 
34 /******************************** FluxComputeKernel ********************************/
35 
43 template< integer NUM_COMP, integer NUM_DOF, typename STENCILWRAPPER >
44 class FluxComputeKernel : public isothermalCompositionalMultiphaseFVMKernels::FluxComputeKernel< NUM_COMP, NUM_DOF, STENCILWRAPPER >
45 {
46 public:
47 
54  template< typename VIEWTYPE >
56 
58  using DofNumberAccessor = AbstractBase::DofNumberAccessor;
63 
64  using StabCompFlowAccessors =
65  StencilAccessors< fields::flow::macroElementIndex,
66  fields::flow::elementStabConstant,
67  fields::flow::pressure_n >;
68 
70  StencilMaterialAccessors< constitutive::MultiFluidBase,
71  fields::multifluid::phaseDensity_n,
72  fields::multifluid::phaseCompFraction_n >;
73 
74  using RelPermAccessors =
76 
77  using AbstractBase::m_dt;
79  using AbstractBase::m_kernelFlags;
83  using AbstractBase::m_gravCoef;
87 
89  using Base::numComp;
90  using Base::numDof;
91  using Base::numEqn;
93  using Base::maxNumElems;
94  using Base::maxNumConns;
96  using Base::m_phaseMob;
97  using Base::m_dPhaseMassDens;
99  using Base::m_seri;
100  using Base::m_sesri;
101  using Base::m_sei;
102 
121  FluxComputeKernel( integer const numPhases,
122  globalIndex const rankOffset,
123  STENCILWRAPPER const & stencilWrapper,
124  DofNumberAccessor const & dofNumberAccessor,
125  CompFlowAccessors const & compFlowAccessors,
126  StabCompFlowAccessors const & stabCompFlowAccessors,
127  MultiFluidAccessors const & multiFluidAccessors,
128  StabMultiFluidAccessors const & stabMultiFluidAccessors,
129  CapPressureAccessors const & capPressureAccessors,
130  PermeabilityAccessors const & permeabilityAccessors,
131  RelPermAccessors const & relPermAccessors,
132  real64 const & dt,
133  CRSMatrixView< real64, globalIndex const > const & localMatrix,
134  arrayView1d< real64 > const & localRhs,
135  BitFlags< isothermalCompositionalMultiphaseFVMKernels::KernelFlags > kernelFlags )
136  : Base( numPhases,
137  rankOffset,
138  stencilWrapper,
139  dofNumberAccessor,
140  compFlowAccessors,
141  multiFluidAccessors,
142  capPressureAccessors,
143  permeabilityAccessors,
144  dt,
145  localMatrix,
146  localRhs,
147  kernelFlags ),
148  m_pres_n( stabCompFlowAccessors.get( fields::flow::pressure_n {} ) ),
149  m_phaseDens_n( stabMultiFluidAccessors.get( fields::multifluid::phaseDensity_n {} ) ),
150  m_phaseCompFrac_n( stabMultiFluidAccessors.get( fields::multifluid::phaseCompFraction_n {} ) ),
151  m_phaseRelPerm_n( relPermAccessors.get( fields::relperm::phaseRelPerm_n {} ) ),
152  m_macroElementIndex( stabCompFlowAccessors.get( fields::flow::macroElementIndex {} ) ),
153  m_elementStabConstant( stabCompFlowAccessors.get( fields::flow::elementStabConstant {} ) )
154  {}
155 
157  {
158 public:
159 
161  StackVariables( localIndex const size, localIndex numElems )
162  : Base::StackVariables( size, numElems )
163  {}
164 
172 
175 
176  };
177 
184  void computeFlux( localIndex const iconn,
185  StackVariables & stack ) const
186  {
187 
188  m_stencilWrapper.computeStabilizationWeights( iconn,
189  stack.stabTransmissibility );
190 
191  // ***********************************************
192  // First, we call the base computeFlux to compute:
193  // 1) compFlux and its derivatives,
194  //
195  // We use the lambda below (called **inside** the phase loop of the base computeFlux) to compute stabilization terms
196  Base::computeFlux( iconn, stack, [&] ( integer const ip,
197  integer const GEOS_UNUSED_PARAM( checkPhasePresenceInGravity ),
198  localIndex const (&k)[2],
199  localIndex const (&seri)[2],
200  localIndex const (&sesri)[2],
201  localIndex const (&sei)[2],
202  localIndex const connectionIndex,
203  localIndex const k_up,
204  localIndex const er_up,
205  localIndex const esr_up,
206  localIndex const ei_up,
207  real64 const potGrad,
208  real64 const phaseFlux,
209  real64 const (&dPhaseFlux_dP)[2],
210  real64 const (&dPhaseFlux_dC)[2][numComp] )
211  {
212  GEOS_UNUSED_VAR( k_up, potGrad, phaseFlux, dPhaseFlux_dP, dPhaseFlux_dC, er_up, esr_up, ei_up );
213 
215  real64 stabFlux[numComp]{};
216  real64 dStabFlux_dP[numFluxSupportPoints][numComp]{};
217 
218  real64 const stabTrans[numFluxSupportPoints] = { stack.stabTransmissibility[connectionIndex][0],
219  stack.stabTransmissibility[connectionIndex][1] };
220 
221  // we are in the loop over phases, ip provides the current phase index.
222 
223  real64 dPresGradStab = 0.0;
224  integer stencilMacroElements[numFluxSupportPoints]{};
225 
226  // Step 1: compute the pressure jump at the interface
227  for( integer ke = 0; ke < numFluxSupportPoints; ++ke )
228  {
229  localIndex const er = seri[ke];
230  localIndex const esr = sesri[ke];
231  localIndex const ei = sei[ke];
232 
233  stencilMacroElements[ke] = m_macroElementIndex[er][esr][ei];
234 
235  // use the jump in *delta* pressure in the stabilization term
236  dPresGradStab +=
237  m_elementStabConstant[er][esr][ei] * stabTrans[ke] * (m_pres[er][esr][ei] - m_pres_n[er][esr][ei]);
238  }
239 
240  // Step 2: compute the stabilization flux
241  integer const k_up_stab = (dPresGradStab >= 0) ? 0 : 1;
242 
243  localIndex const er_up_stab = seri[k_up_stab];
244  localIndex const esr_up_stab = sesri[k_up_stab];
245  localIndex const ei_up_stab = sei[k_up_stab];
246 
247  bool const areInSameMacroElement = stencilMacroElements[0] == stencilMacroElements[1];
248  bool const isStabilizationActive = stencilMacroElements[0] >= 0 && stencilMacroElements[1] >= 0;
249  if( isStabilizationActive && areInSameMacroElement )
250  {
251 
252  for( integer ic = 0; ic < numComp; ++ic )
253  {
254  real64 const laggedUpwindCoef = m_phaseDens_n[er_up_stab][esr_up_stab][ei_up_stab][0][ip]
255  * m_phaseCompFrac_n[er_up_stab][esr_up_stab][ei_up_stab][0][ip][ic]
256  * m_phaseRelPerm_n[er_up_stab][esr_up_stab][ei_up_stab][0][ip];
257  stabFlux[ic] += dPresGradStab * laggedUpwindCoef;
258 
259  for( integer ke = 0; ke < numFluxSupportPoints; ++ke )
260  {
261  real64 const tauStab = m_elementStabConstant[seri[ke]][sesri[ke]][sei[ke]];
262  dStabFlux_dP[ke][ic] += tauStab * stabTrans[ke] * laggedUpwindCoef;
263  }
264  }
265  }
266 
267  // Step 3: add the stabilization flux and its derivatives to the residual and Jacobian
268  for( integer ic = 0; ic < numComp; ++ic )
269  {
270  integer const eqIndex0 = k[0] * numEqn + ic;
271  integer const eqIndex1 = k[1] * numEqn + ic;
272 
273  stack.localFlux[eqIndex0] += stabFlux[ic];
274  stack.localFlux[eqIndex1] += -stabFlux[ic];
275 
276  for( integer ke = 0; ke < numFluxSupportPoints; ++ke )
277  {
278  localIndex const localDofIndexPres = k[ke] * numDof;
279  stack.localFluxJacobian[eqIndex0][localDofIndexPres] += dStabFlux_dP[ke][ic];
280  stack.localFluxJacobian[eqIndex1][localDofIndexPres] += -dStabFlux_dP[ke][ic];
281  }
282  }
283 
284  } ); // end call to Base::computeFlux
285 
286  }
287 
288 protected:
289 
295 
298  ElementViewConst< arrayView1d< real64 const > > const m_elementStabConstant;
299 
300 };
301 
306 {
307 public:
308 
325  template< typename POLICY, typename STENCILWRAPPER >
326  static void
327  createAndLaunch( integer const numComps,
328  integer const numPhases,
329  globalIndex const rankOffset,
330  string const & dofKey,
331  BitFlags< isothermalCompositionalMultiphaseFVMKernels::KernelFlags > kernelFlags,
332  string const & solverName,
333  ElementRegionManager const & elemManager,
334  STENCILWRAPPER const & stencilWrapper,
335  real64 const dt,
336  CRSMatrixView< real64, globalIndex const > const & localMatrix,
337  arrayView1d< real64 > const & localRhs )
338  {
339  isothermalCompositionalMultiphaseBaseKernels::
340  internal::kernelLaunchSelectorCompSwitch( numComps, [&]( auto NC )
341  {
342  integer constexpr NUM_COMP = NC();
343  integer constexpr NUM_DOF = NC() + 1;
344 
346  elemManager.constructArrayViewAccessor< globalIndex, 1 >( dofKey );
347  dofNumberAccessor.setName( solverName + "/accessors/" + dofKey );
348 
350  typename KERNEL_TYPE::CompFlowAccessors compFlowAccessors( elemManager, solverName );
351  typename KERNEL_TYPE::MultiFluidAccessors multiFluidAccessors( elemManager, solverName );
352  typename KERNEL_TYPE::StabCompFlowAccessors stabCompFlowAccessors( elemManager, solverName );
353  typename KERNEL_TYPE::StabMultiFluidAccessors stabMultiFluidAccessors( elemManager, solverName );
354  typename KERNEL_TYPE::CapPressureAccessors capPressureAccessors( elemManager, solverName );
355  typename KERNEL_TYPE::PermeabilityAccessors permeabilityAccessors( elemManager, solverName );
356  typename KERNEL_TYPE::RelPermAccessors relPermAccessors( elemManager, solverName );
357 
358  KERNEL_TYPE kernel( numPhases, rankOffset, stencilWrapper, dofNumberAccessor,
359  compFlowAccessors, stabCompFlowAccessors, multiFluidAccessors, stabMultiFluidAccessors,
360  capPressureAccessors, permeabilityAccessors, relPermAccessors,
361  dt, localMatrix, localRhs, kernelFlags );
362  KERNEL_TYPE::template launch< POLICY >( stencilWrapper.size(), kernel );
363  } );
364  }
365 };
366 
367 } // namespace stabilizedCompositionalMultiphaseFVMKernels
368 
369 } // namespace geos
370 
371 
372 #endif //GEOS_PHYSICSSOLVERS_FLUIDFLOW_COMPOSITIONAL_STABILIZEDFLUXCOMPUTEKERNEL_HPP
#define GEOS_HOST_DEVICE
Marks a host-device function.
Definition: GeosxMacros.hpp:49
#define GEOS_UNUSED_VAR(...)
Mark an unused variable and silence compiler warnings.
Definition: GeosxMacros.hpp:84
#define GEOS_UNUSED_PARAM(X)
Mark an unused argument and silence compiler warnings.
Definition: GeosxMacros.hpp:72
The ElementRegionManager class provides an interface to ObjectManagerBase in order to manage ElementR...
ElementViewAccessor< ArrayView< T const, NDIM, getUSD< PERM > > > constructArrayViewAccessor(string const &name, string const &neighborName=string()) const
This is a function to construct a ElementViewAccessor to access array data registered on the mesh.
array1d< array1d< VIEWTYPE > > ElementViewAccessor
The ElementViewAccessor at the ElementRegionManager level is an array of array of VIEWTYPE.
typename ElementViewAccessor< VIEWTYPE >::NestedViewTypeConst ElementViewConst
The ElementViewAccessor at the ElementRegionManager level is the type resulting from ElementViewAcces...
A struct to automatically construct and store element view accessors.
A struct to automatically construct and store element view accessors.
Base class for FluxComputeKernel that holds all data not dependent on template parameters (like stenc...
ElementViewConst< arrayView1d< globalIndex const > > const m_dofNumber
Views on dof numbers.
ElementViewConst< arrayView1d< real64 const > > const m_pres
Views on pressure.
ElementViewConst< arrayView1d< integer const > > const m_ghostRank
Views on ghost rank numbers and gravity coefficients.
ElementViewConst< arrayView4d< real64 const, constitutive::multifluid::USD_PHASE_COMP > > const m_phaseCompFrac
Views on phase component fractions.
ElementViewConst< arrayView3d< real64 const, compflow::USD_COMP_DC > > const m_dCompFrac_dCompDens
Views on derivatives of comp fractions.
Define the interface for the assembly kernel in charge of flux terms.
static constexpr localIndex maxStencilSize
Maximum number of points in the stencil.
GEOS_HOST_DEVICE void computeFlux(localIndex const iconn, StackVariables &stack, FUNC &&compFluxKernelOp=NoOpFunc{}) const
Compute the local flux contributions to the residual and Jacobian.
static constexpr integer numFluxSupportPoints
Number of flux support points (hard-coded for TFPA)
static constexpr integer numEqn
Compute time value for the number of equations (all of them, except the volume balance equation)
static constexpr integer numComp
Compile time value for the number of components.
ElementViewConst< arrayView2d< real64 const, compflow::USD_PHASE > > const m_phaseMob
Views on phase mobilities.
STENCILWRAPPER::IndexContainerViewConstType const m_seri
Connection to element maps.
static constexpr localIndex maxNumElems
Maximum number of elements at the face.
static constexpr integer numDof
Compute time value for the number of degrees of freedom.
STENCILWRAPPER const m_stencilWrapper
Reference to the stencil wrapper.
static constexpr localIndex maxNumConns
Maximum number of connections at the face.
static void createAndLaunch(integer const numComps, integer const numPhases, globalIndex const rankOffset, string const &dofKey, BitFlags< isothermalCompositionalMultiphaseFVMKernels::KernelFlags > kernelFlags, string const &solverName, ElementRegionManager const &elemManager, STENCILWRAPPER const &stencilWrapper, real64 const dt, CRSMatrixView< real64, globalIndex const > const &localMatrix, arrayView1d< real64 > const &localRhs)
Create a new kernel and launch.
Define the interface for the assembly kernel in charge of flux terms.
ElementViewConst< arrayView1d< real64 const > > const m_pres_n
Views on flow properties at the previous converged time step.
ElementViewConst< arrayView1d< integer const > > const m_macroElementIndex
Views on the macroelement indices and stab constant.
ElementViewConst< arrayView1d< real64 const > > const m_pres
Views on pressure.
static constexpr integer numFluxSupportPoints
Number of flux support points (hard-coded for TFPA)
static constexpr integer numEqn
Compute time value for the number of equations (all of them, except the volume balance equation)
static constexpr integer numComp
Compile time value for the number of components.
GEOS_HOST_DEVICE void computeFlux(localIndex const iconn, StackVariables &stack) const
Compute the local flux contributions to the residual and Jacobian, including stabilization.
FluxComputeKernel(integer const numPhases, globalIndex const rankOffset, STENCILWRAPPER const &stencilWrapper, DofNumberAccessor const &dofNumberAccessor, CompFlowAccessors const &compFlowAccessors, StabCompFlowAccessors const &stabCompFlowAccessors, MultiFluidAccessors const &multiFluidAccessors, StabMultiFluidAccessors const &stabMultiFluidAccessors, CapPressureAccessors const &capPressureAccessors, PermeabilityAccessors const &permeabilityAccessors, RelPermAccessors const &relPermAccessors, real64 const &dt, CRSMatrixView< real64, globalIndex const > const &localMatrix, arrayView1d< real64 > const &localRhs, BitFlags< isothermalCompositionalMultiphaseFVMKernels::KernelFlags > kernelFlags)
Constructor for the kernel interface.
ElementRegionManager::ElementViewConst< VIEWTYPE > ElementViewConst
The type for element-based data. Consists entirely of ArrayView's.
static constexpr integer numDof
Compute time value for the number of degrees of freedom.
STENCILWRAPPER const m_stencilWrapper
Reference to the stencil wrapper.
static constexpr localIndex maxNumConns
Maximum number of connections at the face.
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
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
Kernel variables (dof numbers, jacobian and residual) located on the stack.
real64 dTrans_dPres[maxNumConns][numFluxSupportPoints]
Derivatives of transmissibility with respect to pressure.
stackArray1d< globalIndex, maxNumElems *numDof > dofColIndices
Indices of the matrix rows/columns corresponding to the dofs in this face.
stackArray2d< real64, maxNumElems *numEqn *maxStencilSize *numDof > localFluxJacobian
Storage for the face local Jacobian matrix.
stackArray1d< real64, maxNumElems *numEqn > localFlux
Storage for the face local residual vector (all equations except volume balance)
localIndex const numConnectedElems
Number of elements connected at a given connection.
real64 transmissibility[maxNumConns][numFluxSupportPoints]
Transmissibility.
real64 stabTransmissibility[maxNumConns][numFluxSupportPoints]
Stabilization transmissibility.