GEOS
FluxComputeKernel.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_FLUXCOMPUTEKERNEL_HPP
21 #define GEOS_PHYSICSSOLVERS_FLUIDFLOW_COMPOSITIONAL_FLUXCOMPUTEKERNEL_HPP
22 
24 
25 #include "codingUtilities/Utilities.hpp"
26 #include "common/DataLayouts.hpp"
27 #include "common/DataTypes.hpp"
28 #include "common/GEOS_RAJA_Interface.hpp"
29 #include "constitutive/fluid/multifluid/MultiFluidFields.hpp"
34 #include "physicsSolvers/fluidFlow/kernels/compositional/KernelLaunchSelectors.hpp"
38 #include "physicsSolvers/fluidFlow/kernels/compositional/HU2PhaseFlux.hpp"
40 
41 namespace geos
42 {
43 
44 namespace isothermalCompositionalMultiphaseFVMKernels
45 {
46 
54 template< integer NUM_COMP, integer NUM_DOF, typename STENCILWRAPPER >
56 {
57 public:
58 
60  static constexpr integer numComp = NUM_COMP;
61 
63  static constexpr integer numDof = NUM_DOF;
64 
66  static constexpr integer numEqn = NUM_DOF-1;
67 
69  static constexpr localIndex maxNumElems = STENCILWRAPPER::maxNumPointsInFlux;
70 
72  static constexpr localIndex maxNumConns = STENCILWRAPPER::maxNumConnections;
73 
75  static constexpr localIndex maxStencilSize = STENCILWRAPPER::maxStencilSize;
76 
78  static constexpr integer numFluxSupportPoints = 2;
79 
95  FluxComputeKernel( integer const numPhases,
96  globalIndex const rankOffset,
97  STENCILWRAPPER const & stencilWrapper,
98  DofNumberAccessor const & dofNumberAccessor,
99  CompFlowAccessors const & compFlowAccessors,
100  MultiFluidAccessors const & multiFluidAccessors,
101  CapPressureAccessors const & capPressureAccessors,
102  PermeabilityAccessors const & permeabilityAccessors,
103  real64 const dt,
104  CRSMatrixView< real64, globalIndex const > const & localMatrix,
105  arrayView1d< real64 > const & localRhs,
106  BitFlags< KernelFlags > kernelFlags )
107  : FluxComputeKernelBase( numPhases,
108  rankOffset,
109  dofNumberAccessor,
110  compFlowAccessors,
111  multiFluidAccessors,
112  dt,
113  localMatrix,
114  localRhs,
115  kernelFlags ),
116  m_permeability( permeabilityAccessors.get( fields::permeability::permeability {} ) ),
117  m_dPerm_dPres( permeabilityAccessors.get( fields::permeability::dPerm_dPressure {} ) ),
118  m_phaseMob( compFlowAccessors.get( fields::flow::phaseMobility {} ) ),
119  m_dPhaseMob( compFlowAccessors.get( fields::flow::dPhaseMobility {} ) ),
120  m_phaseMassDens( multiFluidAccessors.get( fields::multifluid::phaseMassDensity {} ) ),
121  m_dPhaseMassDens( multiFluidAccessors.get( fields::multifluid::dPhaseMassDensity {} ) ),
122  m_phaseCapPressure( capPressureAccessors.get( fields::cappres::phaseCapPressure {} ) ),
123  m_dPhaseCapPressure_dPhaseVolFrac( capPressureAccessors.get( fields::cappres::dPhaseCapPressure_dPhaseVolFraction {} ) ),
124  m_stencilWrapper( stencilWrapper ),
125  m_seri( stencilWrapper.getElementRegionIndices() ),
126  m_sesri( stencilWrapper.getElementSubRegionIndices() ),
127  m_sei( stencilWrapper.getElementIndices() )
128  { }
129 
135  {
136 public:
137 
144  StackVariables( localIndex const size, localIndex numElems )
145  : stencilSize( size ),
146  numConnectedElems( numElems ),
147  dofColIndices( size * numDof ),
148  localFlux( numElems * numEqn ),
149  localFluxJacobian( numElems * numEqn, size * numDof )
150  {}
151 
152  // Stencil information
153 
158 
159  // Transmissibility and derivatives
160 
165 
166  // Local degrees of freedom and local residual/jacobian
167 
170 
175  };
176 
177 
184  inline
185  localIndex stencilSize( localIndex const iconn ) const { return m_sei[iconn].size(); }
186 
193  inline
194  localIndex numPointsInFlux( localIndex const iconn ) const { return m_stencilWrapper.numPointsInFlux( iconn ); }
195 
196 
203  inline
204  void setup( localIndex const iconn,
205  StackVariables & stack ) const
206  {
207  // set degrees of freedom indices for this face
208  for( integer i = 0; i < stack.stencilSize; ++i )
209  {
210  globalIndex const offset = m_dofNumber[m_seri( iconn, i )][m_sesri( iconn, i )][m_sei( iconn, i )];
211 
212  for( integer jdof = 0; jdof < numDof; ++jdof )
213  {
214  stack.dofColIndices[i * numDof + jdof] = offset + jdof;
215  }
216  }
217  }
218 
226  template< typename FUNC = NoOpFunc >
228  inline
229  void computeFlux( localIndex const iconn,
230  StackVariables & stack,
231  FUNC && compFluxKernelOp = NoOpFunc{} ) const
232  {
233  using namespace isothermalCompositionalMultiphaseFVMKernelUtilities;
234 
235  // first, compute the transmissibilities at this face
236  m_stencilWrapper.computeWeights( iconn,
238  m_dPerm_dPres,
239  stack.transmissibility,
240  stack.dTrans_dPres );
241 
242 
244  localIndex connectionIndex = 0;
245  for( k[0] = 0; k[0] < stack.numConnectedElems; ++k[0] )
246  {
247  for( k[1] = k[0] + 1; k[1] < stack.numConnectedElems; ++k[1] )
248  {
250  localIndex const seri[numFluxSupportPoints] = {m_seri( iconn, k[0] ), m_seri( iconn, k[1] )};
251  localIndex const sesri[numFluxSupportPoints] = {m_sesri( iconn, k[0] ), m_sesri( iconn, k[1] )};
252  localIndex const sei[numFluxSupportPoints] = {m_sei( iconn, k[0] ), m_sei( iconn, k[1] )};
253 
254  // clear working arrays
255  real64 compFlux[numComp]{};
256  real64 dCompFlux_dP[numFluxSupportPoints][numComp]{};
257  real64 dCompFlux_dC[numFluxSupportPoints][numComp][numComp]{};
258  real64 dCompFlux_dTrans[numComp]{};
259 
260  real64 const trans[numFluxSupportPoints] = { stack.transmissibility[connectionIndex][0],
261  stack.transmissibility[connectionIndex][1] };
262 
263  real64 const dTrans_dPres[numFluxSupportPoints] = { stack.dTrans_dPres[connectionIndex][0],
264  stack.dTrans_dPres[connectionIndex][1] };
265 
266  //***** calculation of flux *****
267  // loop over phases, compute and upwind phase flux and sum contributions to each component's flux
268  for( integer ip = 0; ip < m_numPhases; ++ip )
269  {
270  // create local work arrays
271  real64 potGrad = 0.0;
272  real64 phaseFlux = 0.0;
273  real64 dPhaseFlux_dP[numFluxSupportPoints]{};
274  real64 dPhaseFlux_dC[numFluxSupportPoints][numComp]{};
275  real64 dPhaseFlux_dTrans = 0.0; // not really used
276 
277  if( m_kernelFlags.isSet( KernelFlags::C1PPU ) )
278  {
279  C1PPUPhaseFlux::compute< numComp, numFluxSupportPoints >
280  ( m_numPhases,
281  ip,
282  m_kernelFlags.isSet( KernelFlags::CapPressure ),
283  m_kernelFlags.isSet( KernelFlags::CheckPhasePresenceInGravity ),
284  seri, sesri, sei,
285  trans,
286  dTrans_dPres,
287  m_pres,
288  m_gravCoef,
289  m_phaseMob, m_dPhaseMob,
290  m_phaseVolFrac, m_dPhaseVolFrac,
292  m_phaseMassDens, m_dPhaseMassDens,
293  m_phaseCapPressure, m_dPhaseCapPressure_dPhaseVolFrac,
294  potGrad,
295  phaseFlux,
296  dPhaseFlux_dP,
297  dPhaseFlux_dC );
298  }
299  else if( m_kernelFlags.isSet( KernelFlags::IHU ) )
300  {
301  IHUPhaseFlux::compute< numComp, numFluxSupportPoints >
302  ( m_numPhases,
303  ip,
304  m_kernelFlags.isSet( KernelFlags::CapPressure ),
305  m_kernelFlags.isSet( KernelFlags::CheckPhasePresenceInGravity ),
306  seri, sesri, sei,
307  trans,
308  dTrans_dPres,
309  m_pres,
310  m_gravCoef,
311  m_phaseMob, m_dPhaseMob,
312  m_phaseVolFrac, m_dPhaseVolFrac,
314  m_phaseMassDens, m_dPhaseMassDens,
315  m_phaseCapPressure, m_dPhaseCapPressure_dPhaseVolFrac,
316  potGrad,
317  phaseFlux,
318  dPhaseFlux_dP,
319  dPhaseFlux_dC );
320  }
321  else if( m_kernelFlags.isSet( KernelFlags::HU2PH ) )
322  {
323  HU2PhaseFlux::compute< numComp, numFluxSupportPoints >
324  ( m_numPhases,
325  ip,
326  m_kernelFlags.isSet( KernelFlags::CapPressure ),
327  m_kernelFlags.isSet( KernelFlags::CheckPhasePresenceInGravity ),
328  seri, sesri, sei,
329  trans,
330  dTrans_dPres,
331  m_pres,
332  m_gravCoef,
333  m_phaseMob, m_dPhaseMob,
334  m_phaseVolFrac, m_dPhaseVolFrac,
336  m_phaseMassDens, m_dPhaseMassDens,
337  m_phaseCapPressure, m_dPhaseCapPressure_dPhaseVolFrac,
338  potGrad,
339  phaseFlux,
340  dPhaseFlux_dP,
341  dPhaseFlux_dC );
342  }
343  else
344  {
345  PPUPhaseFlux::compute< numComp, numFluxSupportPoints >
346  ( m_numPhases,
347  ip,
348  m_kernelFlags.isSet( KernelFlags::CapPressure ),
349  m_kernelFlags.isSet( KernelFlags::CheckPhasePresenceInGravity ),
350  seri, sesri, sei,
351  trans,
352  dTrans_dPres,
353  m_pres,
354  m_gravCoef,
355  m_phaseMob, m_dPhaseMob,
356  m_phaseVolFrac, m_dPhaseVolFrac,
358  m_phaseMassDens, m_dPhaseMassDens,
359  m_phaseCapPressure, m_dPhaseCapPressure_dPhaseVolFrac,
360  potGrad,
361  phaseFlux,
362  dPhaseFlux_dP,
363  dPhaseFlux_dC,
364  dPhaseFlux_dTrans );
365  }
366 
367  // choose upstream cell for composition upwinding
368  localIndex const k_up = (phaseFlux >= 0) ? 0 : 1;
369 
370  // distribute on phaseComponentFlux here
371  PhaseComponentFlux::compute( ip, k_up, seri, sesri, sei,
372  m_phaseCompFrac, m_dPhaseCompFrac, m_dCompFrac_dCompDens,
373  phaseFlux, dPhaseFlux_dP, dPhaseFlux_dC, dPhaseFlux_dTrans,
374  compFlux, dCompFlux_dP, dCompFlux_dC, dCompFlux_dTrans );
375 
376  // call the lambda in the phase loop to allow the reuse of the phase fluxes and their derivatives
377  // possible use: assemble the derivatives wrt temperature, and the flux term of the energy equation for this phase
378  compFluxKernelOp( ip, m_kernelFlags.isSet( KernelFlags::CheckPhasePresenceInGravity ),
379  k, seri, sesri, sei, connectionIndex,
380  k_up, seri[k_up], sesri[k_up], sei[k_up], potGrad,
381  phaseFlux, dPhaseFlux_dP, dPhaseFlux_dC );
382 
383  } // loop over phases
384 
386  for( integer ic = 0; ic < numComp; ++ic )
387  {
388  integer const eqIndex0 = k[0] * numEqn + ic;
389  integer const eqIndex1 = k[1] * numEqn + ic;
390 
391  stack.localFlux[eqIndex0] += m_dt * compFlux[ic];
392  stack.localFlux[eqIndex1] -= m_dt * compFlux[ic];
393 
394  for( integer ke = 0; ke < numFluxSupportPoints; ++ke )
395  {
396  localIndex const localDofIndexPres = k[ke] * numDof;
397  stack.localFluxJacobian[eqIndex0][localDofIndexPres] += m_dt * dCompFlux_dP[ke][ic];
398  stack.localFluxJacobian[eqIndex1][localDofIndexPres] -= m_dt * dCompFlux_dP[ke][ic];
399 
400  for( integer jc = 0; jc < numComp; ++jc )
401  {
402  localIndex const localDofIndexComp = localDofIndexPres + jc + 1;
403  stack.localFluxJacobian[eqIndex0][localDofIndexComp] += m_dt * dCompFlux_dC[ke][ic][jc];
404  stack.localFluxJacobian[eqIndex1][localDofIndexComp] -= m_dt * dCompFlux_dC[ke][ic][jc];
405  }
406  }
407  }
408  connectionIndex++;
409  } // loop over k[1]
410  } // loop over k[0]
411 
412  }
413 
419  template< typename FUNC = NoOpFunc >
421  inline
422  void complete( localIndex const iconn,
423  StackVariables & stack,
424  FUNC && assemblyKernelOp = NoOpFunc{} ) const
425  {
426  using namespace compositionalMultiphaseUtilities;
427 
428  if( m_kernelFlags.isSet( KernelFlags::TotalMassEquation ) )
429  {
430  // Apply equation/variable change transformation(s)
432  shiftBlockRowsAheadByOneAndReplaceFirstRowWithColumnSum( numComp, numEqn, numDof * stack.stencilSize, stack.numConnectedElems,
433  stack.localFluxJacobian, work );
434  shiftBlockElementsAheadByOneAndReplaceFirstElementWithSum( numComp, numEqn, stack.numConnectedElems,
435  stack.localFlux );
436  }
437 
438  // add contribution to residual and jacobian into:
439  // - the component mass balance equations (i = 0 to i = numComp-1)
440  // note that numDof includes derivatives wrt temperature if this class is derived in ThermalKernels
441  for( integer i = 0; i < stack.numConnectedElems; ++i )
442  {
443  if( m_ghostRank[m_seri( iconn, i )][m_sesri( iconn, i )][m_sei( iconn, i )] < 0 )
444  {
445  globalIndex const globalRow = m_dofNumber[m_seri( iconn, i )][m_sesri( iconn, i )][m_sei( iconn, i )];
446  localIndex const localRow = LvArray::integerConversion< localIndex >( globalRow - m_rankOffset );
447  GEOS_ASSERT_GE( localRow, 0 );
448  GEOS_ASSERT_GT( m_localMatrix.numRows(), localRow + numComp );
449 
450  for( integer ic = 0; ic < numComp; ++ic )
451  {
452  RAJA::atomicAdd( parallelDeviceAtomic{}, &m_localRhs[localRow + ic],
453  stack.localFlux[i * numEqn + ic] );
454  m_localMatrix.addToRowBinarySearchUnsorted< parallelDeviceAtomic >
455  ( localRow + ic,
456  stack.dofColIndices.data(),
457  stack.localFluxJacobian[i * numEqn + ic].dataIfContiguous(),
458  stack.stencilSize * numDof );
459  }
460 
461  // call the lambda to assemble additional terms, such as thermal terms
462  assemblyKernelOp( i, localRow );
463  }
464  }
465  }
466 
474  template< typename POLICY, typename KERNEL_TYPE >
475  static void
476  launch( localIndex const numConnections,
477  KERNEL_TYPE const & kernelComponent )
478  {
480  forAll< POLICY >( numConnections, [=] GEOS_HOST_DEVICE ( localIndex const iconn )
481  {
482  typename KERNEL_TYPE::StackVariables stack( kernelComponent.stencilSize( iconn ),
483  kernelComponent.numPointsInFlux( iconn ) );
484 
485  kernelComponent.setup( iconn, stack );
486  kernelComponent.computeFlux( iconn, stack );
487  kernelComponent.complete( iconn, stack );
488  } );
489  }
490 
491 protected:
492 
495  ElementViewConst< arrayView3d< real64 const > > const m_dPerm_dPres;
496 
500 
504 
508 
509  // Stencil information
510 
512  STENCILWRAPPER const m_stencilWrapper;
513 
515  typename STENCILWRAPPER::IndexContainerViewConstType const m_seri;
516  typename STENCILWRAPPER::IndexContainerViewConstType const m_sesri;
517  typename STENCILWRAPPER::IndexContainerViewConstType const m_sei;
518 
519 };
520 
525 {
526 public:
527 
544  template< typename POLICY, typename STENCILWRAPPER >
545  static void
546  createAndLaunch( integer const numComps,
547  integer const numPhases,
548  globalIndex const rankOffset,
549  string const & dofKey,
550  BitFlags< KernelFlags > kernelFlags,
551  string const & solverName,
552  ElementRegionManager const & elemManager,
553  STENCILWRAPPER const & stencilWrapper,
554  real64 const dt,
555  CRSMatrixView< real64, globalIndex const > const & localMatrix,
556  arrayView1d< real64 > const & localRhs )
557  {
558  isothermalCompositionalMultiphaseBaseKernels::internal::kernelLaunchSelectorCompSwitch( numComps, [&]( auto NC )
559  {
560  integer constexpr NUM_COMP = NC();
561  integer constexpr NUM_DOF = NC() + 1;
562 
564  elemManager.constructArrayViewAccessor< globalIndex, 1 >( dofKey );
565  dofNumberAccessor.setName( solverName + "/accessors/" + dofKey );
566 
568  typename kernelType::CompFlowAccessors compFlowAccessors( elemManager, solverName );
569  typename kernelType::MultiFluidAccessors multiFluidAccessors( elemManager, solverName );
570  typename kernelType::CapPressureAccessors capPressureAccessors( elemManager, solverName );
571  typename kernelType::PermeabilityAccessors permeabilityAccessors( elemManager, solverName );
572 
573  kernelType kernel( numPhases, rankOffset, stencilWrapper, dofNumberAccessor,
574  compFlowAccessors, multiFluidAccessors, capPressureAccessors, permeabilityAccessors,
575  dt, localMatrix, localRhs, kernelFlags );
576  kernelType::template launch< POLICY >( stencilWrapper.size(), kernel );
577  } );
578  }
579 };
580 
581 } // namespace isothermalCompositionalMultiphaseFVMKernels
582 
583 } // namespace geos
584 
585 #endif //GEOS_PHYSICSSOLVERS_FLUIDFLOW_COMPOSITIONAL_FLUXCOMPUTEKERNEL_HPP
#define GEOS_HOST_DEVICE
Marks a host-device function.
Definition: GeosxMacros.hpp:49
#define GEOS_ASSERT_GT(lhs, rhs)
Assert that one value compares greater than the other in debug builds.
Definition: Logger.hpp:440
#define GEOS_ASSERT_GE(lhs, rhs)
Assert that one value compares greater than or equal to the other in debug builds.
Definition: Logger.hpp:455
#define GEOS_MARK_FUNCTION
Mark function with both Caliper and NVTX if enabled.
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.
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< arrayView2d< real64 const, compflow::USD_PHASE > > const m_phaseVolFrac
Views on phase volume fractions.
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.
CRSMatrixView< real64, globalIndex const > const m_localMatrix
View on the local CRS matrix.
ElementRegionManager::ElementViewConst< VIEWTYPE > ElementViewConst
The type for element-based data. Consists entirely of ArrayView's.
ElementViewConst< arrayView3d< real64 const, compflow::USD_COMP_DC > > const m_dCompFrac_dCompDens
Views on derivatives of comp fractions.
static void createAndLaunch(integer const numComps, integer const numPhases, globalIndex const rankOffset, string const &dofKey, BitFlags< 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.
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.
GEOS_HOST_DEVICE localIndex numPointsInFlux(localIndex const iconn) const
Getter for the number of elements at this connection.
GEOS_HOST_DEVICE void complete(localIndex const iconn, StackVariables &stack, FUNC &&assemblyKernelOp=NoOpFunc{}) const
Performs the complete phase for the kernel.
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)
GEOS_HOST_DEVICE localIndex stencilSize(localIndex const iconn) const
Getter for the stencil size at this connection.
static constexpr integer numComp
Compile time value for the number of components.
ElementViewConst< arrayView3d< real64 const, constitutive::multifluid::USD_PHASE > > const m_phaseMassDens
Views on phase mass densities.
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.
FluxComputeKernel(integer const numPhases, globalIndex const rankOffset, STENCILWRAPPER const &stencilWrapper, DofNumberAccessor const &dofNumberAccessor, CompFlowAccessors const &compFlowAccessors, MultiFluidAccessors const &multiFluidAccessors, CapPressureAccessors const &capPressureAccessors, PermeabilityAccessors const &permeabilityAccessors, real64 const dt, CRSMatrixView< real64, globalIndex const > const &localMatrix, arrayView1d< real64 > const &localRhs, BitFlags< KernelFlags > kernelFlags)
Constructor for the kernel interface.
ElementViewConst< arrayView3d< real64 const, constitutive::cappres::USD_CAPPRES > > const m_phaseCapPressure
Views on phase capillary pressure.
static constexpr integer numDof
Compute time value for the number of degrees of freedom.
ElementViewConst< arrayView3d< real64 const > > const m_permeability
Views on permeability.
STENCILWRAPPER const m_stencilWrapper
Reference to the stencil wrapper.
GEOS_HOST_DEVICE void setup(localIndex const iconn, StackVariables &stack) const
Performs the setup phase for the kernel.
static void launch(localIndex const numConnections, KERNEL_TYPE const &kernelComponent)
Performs the kernel launch.
static constexpr localIndex maxNumConns
Maximum number of connections at the face.
ArrayView< T, 1 > arrayView1d
Alias for 1D array view.
Definition: DataTypes.hpp:180
StackArray< T, 2, MAXSIZE > stackArray2d
Alias for 2D stack array.
Definition: DataTypes.hpp:204
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
StackArray< T, 1, MAXSIZE > stackArray1d
Alias for 1D stack array.
Definition: DataTypes.hpp:188
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.
GEOS_HOST_DEVICE StackVariables(localIndex const size, localIndex numElems)
Constructor for the stack variables.