MODFLOW 6  version 6.7.0.dev1
USGS Modular Hydrologic Model
gweestmodule Module Reference

@ brief Energy Storage and Transfer (EST) Module More...

Data Types

type  gweesttype
 @ brief Energy storage and transfer More...
 

Enumerations

enum  {
  decay_off = 0 , decay_zero_order = 2 , decay_water = 1 , decay_solid = 2 ,
  decay_both = 3
}
 Enumerator that defines the decay options. More...
 

Functions/Subroutines

subroutine, public est_cr (estobj, name_model, inunit, iout, fmi, eqnsclfac, gwecommon)
 @ brief Create a new EST package object More...
 
subroutine est_ar (this, dis, ibound)
 @ brief Allocate and read method for package More...
 
subroutine est_fc (this, nodes, cold, nja, matrix_sln, idxglo, cnew, rhs, kiter)
 @ brief Fill coefficient method for package More...
 
subroutine est_fc_sto (this, nodes, cold, nja, matrix_sln, idxglo, rhs)
 @ brief Fill storage coefficient method for package More...
 
subroutine est_fc_dcy_water (this, nodes, cold, cnew, nja, matrix_sln, idxglo, rhs, kiter)
 @ brief Fill decay coefficient method for package More...
 
subroutine est_fc_dcy_solid (this, nodes, cold, nja, matrix_sln, idxglo, rhs, cnew, kiter)
 @ brief Fill solid decay coefficient method for package More...
 
subroutine est_cq (this, nodes, cnew, cold, flowja)
 @ brief Calculate flows for package More...
 
subroutine est_cq_sto (this, nodes, cnew, cold, flowja)
 @ brief Calculate storage terms for package More...
 
subroutine est_cq_dcy (this, nodes, cnew, cold, flowja)
 @ brief Calculate decay terms for aqueous phase More...
 
subroutine est_cq_dcy_solid (this, nodes, cnew, cold, flowja)
 @ brief Calculate decay terms for solid phase More...
 
subroutine est_bd (this, isuppress_output, model_budget)
 @ brief Calculate budget terms for package More...
 
subroutine est_ot_flow (this, icbcfl, icbcun)
 @ brief Output flow terms for package More...
 
subroutine est_da (this)
 Deallocate memory. More...
 
subroutine allocate_scalars (this)
 @ brief Allocate scalar variables for package More...
 
subroutine allocate_arrays (this, nodes)
 @ brief Allocate arrays for package More...
 
subroutine read_options (this)
 @ brief Read options for package More...
 
subroutine read_data (this)
 @ brief Read data for package More...
 

Variables

integer(i4b), parameter nbditems = 3
 
character(len=lenbudtxt), dimension(nbditemsbudtxt
 

Detailed Description

The GweEstModule contains the GweEstType, which is related to GwtEstModule; however, there are some important differences owing to the fact that a sorbed phase is not considered. Instead, a single temperature is simulated for each grid cell and is representative of both the aqueous and solid phases (i.e., instantaneous thermal equilibrium is assumed). Also, "thermal bleeding" is accommodated, where conductive processes can transport into, through, or out of dry cells that are part of the active domain.

Enumeration Type Documentation

◆ anonymous enum

anonymous enum
Enumerator
decay_off 

Decay (or production) of thermal energy inactive (default)

decay_zero_order 

Zeroth-order decay.

decay_water 

Zeroth-order decay in water only.

decay_solid 

Zeroth-order decay in solid only.

decay_both 

Zeroth-order decay in water and solid.

Definition at line 36 of file gwe-est.f90.

Function/Subroutine Documentation

◆ allocate_arrays()

subroutine gweestmodule::allocate_arrays ( class(gweesttype this,
integer(i4b), intent(in)  nodes 
)

Method to allocate arrays for the package.

Parameters
thisGweEstType object
[in]nodesnumber of nodes

Definition at line 679 of file gwe-est.f90.

680  ! -- modules
682  use constantsmodule, only: dzero
683  ! -- dummy
684  class(GweEstType) :: this !< GweEstType object
685  integer(I4B), intent(in) :: nodes !< number of nodes
686  ! -- local
687  integer(I4B) :: n
688  !
689  ! -- Allocate
690  ! -- sto
691  call mem_allocate(this%porosity, nodes, 'POROSITY', this%memoryPath)
692  call mem_allocate(this%ratesto, nodes, 'RATESTO', this%memoryPath)
693  call mem_allocate(this%cps, nodes, 'CPS', this%memoryPath)
694  call mem_allocate(this%rhos, nodes, 'RHOS', this%memoryPath)
695  !
696  ! -- dcy
697  if (this%idcy == decay_off) then
698  call mem_allocate(this%ratedcyw, 1, 'RATEDCYW', this%memoryPath)
699  call mem_allocate(this%ratedcys, 1, 'RATEDCYS', this%memoryPath)
700  call mem_allocate(this%decay_water, 1, 'DECAY_WATER', this%memoryPath)
701  call mem_allocate(this%decay_solid, 1, 'DECAY_SOLID', this%memoryPath)
702  call mem_allocate(this%decaylastw, 1, 'DECAYLASTW', this%memoryPath)
703  call mem_allocate(this%decaylasts, 1, 'DECAYLAST', this%memoryPath)
704  else
705  call mem_allocate(this%ratedcyw, this%dis%nodes, 'RATEDCYW', &
706  this%memoryPath)
707  call mem_allocate(this%ratedcys, this%dis%nodes, 'RATEDCYS', &
708  this%memoryPath)
709  call mem_allocate(this%decay_water, nodes, 'DECAY_WATER', this%memoryPath)
710  call mem_allocate(this%decay_solid, nodes, 'DECAY_SOLID', this%memoryPath)
711  call mem_allocate(this%decaylastw, nodes, 'DECAYLASTW', this%memoryPath)
712  call mem_allocate(this%decaylasts, nodes, 'DECAYLASTS', this%memoryPath)
713  end if
714  !
715  ! -- Initialize
716  do n = 1, nodes
717  this%porosity(n) = dzero
718  this%ratesto(n) = dzero
719  this%cps(n) = dzero
720  this%rhos(n) = dzero
721  end do
722  do n = 1, size(this%decay_water)
723  this%decay_water(n) = dzero
724  this%decay_solid(n) = dzero
725  this%ratedcyw(n) = dzero
726  this%ratedcys(n) = dzero
727  this%decaylastw(n) = dzero
728  this%decaylasts(n) = dzero
729  end do
This module contains simulation constants.
Definition: Constants.f90:9
real(dp), parameter dzero
real constant zero
Definition: Constants.f90:65

◆ allocate_scalars()

subroutine gweestmodule::allocate_scalars ( class(gweesttype this)

Method to allocate scalar variables for the package.

Parameters
thisGweEstType object

Definition at line 651 of file gwe-est.f90.

652  ! -- modules
654  ! -- dummy
655  class(GweEstType) :: this !< GweEstType object
656  !
657  ! -- Allocate scalars in NumericalPackageType
658  call this%NumericalPackageType%allocate_scalars()
659  !
660  ! -- Allocate
661  call mem_allocate(this%cpw, 'CPW', this%memoryPath)
662  call mem_allocate(this%rhow, 'RHOW', this%memoryPath)
663  call mem_allocate(this%latheatvap, 'LATHEATVAP', this%memoryPath)
664  call mem_allocate(this%idcy, 'IDCY', this%memoryPath)
665  call mem_allocate(this%idcysrc, 'IDCYSRC', this%memoryPath)
666  !
667  ! -- Initialize
668  this%cpw = dzero
669  this%rhow = dzero
670  this%latheatvap = dzero
671  this%idcy = izero
672  this%idcysrc = izero

◆ est_ar()

subroutine gweestmodule::est_ar ( class(gweesttype), intent(inout)  this,
class(disbasetype), intent(in), pointer  dis,
integer(i4b), dimension(:), pointer, contiguous  ibound 
)

Method to allocate and read static data for the package.

Parameters
[in,out]thisGweEstType object
[in]dispointer to dis package
iboundpointer to GWE ibound array

Definition at line 136 of file gwe-est.f90.

137  ! -- modules
139  ! -- dummy
140  class(GweEstType), intent(inout) :: this !< GweEstType object
141  class(DisBaseType), pointer, intent(in) :: dis !< pointer to dis package
142  integer(I4B), dimension(:), pointer, contiguous :: ibound !< pointer to GWE ibound array
143  ! -- formats
144  character(len=*), parameter :: fmtest = &
145  "(1x,/1x,'EST -- ENERGY STORAGE AND TRANSFER PACKAGE, VERSION 1, &
146  &7/29/2020 INPUT READ FROM UNIT ', i0, //)"
147  !
148  ! --print a message identifying the energy storage and transfer package.
149  write (this%iout, fmtest) this%inunit
150  !
151  ! -- Read options
152  call this%read_options()
153  !
154  ! -- store pointers to arguments that were passed in
155  this%dis => dis
156  this%ibound => ibound
157  !
158  ! -- Allocate arrays
159  call this%allocate_arrays(dis%nodes)
160  !
161  ! -- read the gridded data
162  call this%read_data()
163  !
164  ! -- set data required by other packages
165  call this%gwecommon%set_gwe_dat_ptrs(this%rhow, this%cpw, this%latheatvap, &
166  this%rhos, this%cps)
subroutine, public set_gwe_dat_ptrs(this, gwerhow, gwecpw, gwelatheatvap, gwerhos, gwecps)
Allocate and read data from EST.
Here is the call graph for this function:

◆ est_bd()

subroutine gweestmodule::est_bd ( class(gweesttype this,
integer(i4b), intent(in)  isuppress_output,
type(budgettype), intent(inout)  model_budget 
)

Method to calculate budget terms for the package.

Parameters
thisGweEstType object
[in]isuppress_outputflag to suppress output
[in,out]model_budgetmodel budget object

Definition at line 525 of file gwe-est.f90.

526  ! -- modules
527  use tdismodule, only: delt
529  ! -- dummy
530  class(GweEstType) :: this !< GweEstType object
531  integer(I4B), intent(in) :: isuppress_output !< flag to suppress output
532  type(BudgetType), intent(inout) :: model_budget !< model budget object
533  ! -- local
534  real(DP) :: rin
535  real(DP) :: rout
536  !
537  ! -- sto
538  call rate_accumulator(this%ratesto, rin, rout)
539  call model_budget%addentry(rin, rout, delt, budtxt(1), &
540  isuppress_output, rowlabel=this%packName)
541  !
542  ! -- dcy
543  if (this%idcy == decay_zero_order) then
544  if (this%idcysrc == decay_water .or. this%idcysrc == decay_both) then
545  ! -- aqueous phase
546  call rate_accumulator(this%ratedcyw, rin, rout)
547  call model_budget%addentry(rin, rout, delt, budtxt(2), &
548  isuppress_output, rowlabel=this%packName)
549  end if
550  if (this%idcysrc == decay_solid .or. this%idcysrc == decay_both) then
551  ! -- solid phase
552  call rate_accumulator(this%ratedcys, rin, rout)
553  call model_budget%addentry(rin, rout, delt, budtxt(3), &
554  isuppress_output, rowlabel=this%packName)
555  end if
556  end if
This module contains the BudgetModule.
Definition: Budget.f90:20
subroutine, public rate_accumulator(flow, rin, rout)
@ brief Rate accumulator subroutine
Definition: Budget.f90:632
real(dp), pointer, public delt
length of the current time step
Definition: tdis.f90:29
Derived type for the Budget object.
Definition: Budget.f90:39
Here is the call graph for this function:

◆ est_cq()

subroutine gweestmodule::est_cq ( class(gweesttype this,
integer(i4b), intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cnew,
real(dp), dimension(nodes), intent(in)  cold,
real(dp), dimension(:), intent(inout), contiguous  flowja 
)

Method to calculate flows for the package.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]cnewtemperature at end of this time step
[in]coldtemperature at end of last time step
[in,out]flowjaflow between two connected control volumes

Definition at line 347 of file gwe-est.f90.

348  ! -- dummy
349  class(GweEstType) :: this !< GweEstType object
350  integer(I4B), intent(in) :: nodes !< number of nodes
351  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
352  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
353  real(DP), dimension(:), contiguous, intent(inout) :: flowja !< flow between two connected control volumes
354  ! -- local
355  !
356  ! - storage
357  call this%est_cq_sto(nodes, cnew, cold, flowja)
358  !
359  ! -- decay
360  if (this%idcy == decay_zero_order) then
361  if (this%idcysrc == decay_water .or. this%idcysrc == decay_both) then
362  call this%est_cq_dcy(nodes, cnew, cold, flowja)
363  end if
364  if (this%idcysrc == decay_solid .or. this%idcysrc == decay_both) then
365  call this%est_cq_dcy_solid(nodes, cnew, cold, flowja)
366  end if
367  end if

◆ est_cq_dcy()

subroutine gweestmodule::est_cq_dcy ( class(gweesttype this,
integer(i4b), intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cnew,
real(dp), dimension(nodes), intent(in)  cold,
real(dp), dimension(:), intent(inout), contiguous  flowja 
)

Method to calculate decay terms for the aqueous phase.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]cnewtemperature at end of this time step
[in]coldtemperature at end of last time step
[in,out]flowjaflow between two connected control volumes

Definition at line 426 of file gwe-est.f90.

427  ! -- dummy
428  class(GweEstType) :: this !< GweEstType object
429  integer(I4B), intent(in) :: nodes !< number of nodes
430  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
431  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
432  real(DP), dimension(:), contiguous, intent(inout) :: flowja !< flow between two connected control volumes
433  ! -- local
434  integer(I4B) :: n
435  integer(I4B) :: idiag
436  real(DP) :: rate
437  real(DP) :: swtpdt
438  real(DP) :: hhcof, rrhs
439  real(DP) :: vcell
440  real(DP) :: decay_rate
441  !
442  ! -- Calculate decay change
443  do n = 1, nodes
444  !
445  ! -- skip if transport inactive
446  this%ratedcyw(n) = dzero
447  if (this%ibound(n) <= 0) cycle
448  !
449  ! -- calculate new and old water volumes
450  vcell = this%dis%area(n) * (this%dis%top(n) - this%dis%bot(n))
451  swtpdt = this%fmi%gwfsat(n)
452  !
453  ! -- calculate decay gains and losses
454  rate = dzero
455  hhcof = dzero
456  rrhs = dzero
457  ! -- zero order decay aqueous phase
458  if (this%idcy == decay_zero_order .and. &
459  (this%idcysrc == decay_water .or. this%idcysrc == decay_both)) then
460  decay_rate = this%decay_water(n)
461  ! -- this term does NOT get multiplied by eqnsclfac for cq purposes
462  ! because it should already be a rate of energy
463  rrhs = decay_rate * vcell * swtpdt * this%porosity(n)
464  end if
465  rate = hhcof * cnew(n) - rrhs
466  this%ratedcyw(n) = rate
467  idiag = this%dis%con%ia(n)
468  flowja(idiag) = flowja(idiag) + rate
469  !
470  end do

◆ est_cq_dcy_solid()

subroutine gweestmodule::est_cq_dcy_solid ( class(gweesttype this,
integer(i4b), intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cnew,
real(dp), dimension(nodes), intent(in)  cold,
real(dp), dimension(:), intent(inout), contiguous  flowja 
)

Method to calculate decay terms for the solid phase.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]cnewtemperature at end of this time step
[in]coldtemperature at end of last time step
[in,out]flowjaflow between two connected control volumes

Definition at line 477 of file gwe-est.f90.

478  ! -- dummy
479  class(GweEstType) :: this !< GweEstType object
480  integer(I4B), intent(in) :: nodes !< number of nodes
481  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
482  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
483  real(DP), dimension(:), contiguous, intent(inout) :: flowja !< flow between two connected control volumes
484  ! -- local
485  integer(I4B) :: n
486  integer(I4B) :: idiag
487  real(DP) :: rate
488  real(DP) :: hhcof, rrhs
489  real(DP) :: vcell
490  real(DP) :: decay_rate
491  !
492  ! -- calculate decay change
493  do n = 1, nodes
494  !
495  ! -- skip if transport inactive
496  this%ratedcys(n) = dzero
497  if (this%ibound(n) <= 0) cycle
498  !
499  ! -- calculate new and old water volumes
500  vcell = this%dis%area(n) * (this%dis%top(n) - this%dis%bot(n))
501  !
502  ! -- calculate decay gains and losses
503  rate = dzero
504  hhcof = dzero
505  rrhs = dzero
506  ! -- first-order decay (idcy=1) is not supported for temperature modeling
507  if (this%idcy == decay_zero_order .and. &
508  (this%idcysrc == decay_solid .or. this%idcysrc == decay_both)) then ! zero order decay in the solid phase
509  decay_rate = this%decay_solid(n)
510  ! -- this term does NOT get multiplied by eqnsclfac for cq purposes
511  ! because it should already be a rate of energy
512  rrhs = decay_rate * vcell * (1 - this%porosity(n)) * this%rhos(n)
513  end if
514  rate = hhcof * cnew(n) - rrhs
515  this%ratedcys(n) = rate
516  idiag = this%dis%con%ia(n)
517  flowja(idiag) = flowja(idiag) + rate
518  end do

◆ est_cq_sto()

subroutine gweestmodule::est_cq_sto ( class(gweesttype this,
integer(i4b), intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cnew,
real(dp), dimension(nodes), intent(in)  cold,
real(dp), dimension(:), intent(inout), contiguous  flowja 
)

Method to calculate storage terms for the package.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]cnewtemperature at end of this time step
[in]coldtemperature at end of last time step
[in,out]flowjaflow between two connected control volumes

Definition at line 374 of file gwe-est.f90.

375  ! -- modules
376  use tdismodule, only: delt
377  ! -- dummy
378  class(GweEstType) :: this !< GweEstType object
379  integer(I4B), intent(in) :: nodes !< number of nodes
380  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
381  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
382  real(DP), dimension(:), contiguous, intent(inout) :: flowja !< flow between two connected control volumes
383  ! -- local
384  integer(I4B) :: n
385  integer(I4B) :: idiag
386  real(DP) :: rate
387  real(DP) :: tled
388  real(DP) :: vwatnew, vwatold, vcell, vsolid, term
389  real(DP) :: hhcof, rrhs
390  !
391  ! -- initialize
392  tled = done / delt
393  !
394  ! -- Calculate storage change
395  do n = 1, nodes
396  this%ratesto(n) = dzero
397  !
398  ! -- skip if transport inactive
399  if (this%ibound(n) <= 0) cycle
400  !
401  ! -- calculate new and old water volumes and solid volume
402  vcell = this%dis%area(n) * (this%dis%top(n) - this%dis%bot(n))
403  vwatnew = vcell * this%fmi%gwfsat(n) * this%porosity(n)
404  vwatold = vwatnew
405  if (this%fmi%igwfstrgss /= 0) vwatold = vwatold + this%fmi%gwfstrgss(n) &
406  * delt
407  if (this%fmi%igwfstrgsy /= 0) vwatold = vwatold + this%fmi%gwfstrgsy(n) &
408  * delt
409  vsolid = vcell * (done - this%porosity(n))
410  !
411  ! -- calculate rate
412  term = (this%rhos(n) * this%cps(n)) * vsolid
413  hhcof = -(this%eqnsclfac * vwatnew + term) * tled
414  rrhs = -(this%eqnsclfac * vwatold + term) * tled * cold(n)
415  rate = hhcof * cnew(n) - rrhs
416  this%ratesto(n) = rate
417  idiag = this%dis%con%ia(n)
418  flowja(idiag) = flowja(idiag) + rate
419  end do

◆ est_cr()

subroutine, public gweestmodule::est_cr ( type(gweesttype), pointer  estobj,
character(len=*), intent(in)  name_model,
integer(i4b), intent(in)  inunit,
integer(i4b), intent(in)  iout,
type(tspfmitype), intent(in), target  fmi,
real(dp), intent(in), pointer  eqnsclfac,
type(gweinputdatatype), intent(in), target  gwecommon 
)

Create a new EST package

Parameters
estobjunallocated new est object to create
[in]name_modelname of the model
[in]inunitunit number of WEL package input file
[in]ioutunit number of model listing file
[in]fmifmi package for this GWE model
[in]eqnsclfacgoverning equation scale factor
[in]gwecommonshared data container for use by multiple GWE packages

Definition at line 102 of file gwe-est.f90.

103  ! -- dummy
104  type(GweEstType), pointer :: estobj !< unallocated new est object to create
105  character(len=*), intent(in) :: name_model !< name of the model
106  integer(I4B), intent(in) :: inunit !< unit number of WEL package input file
107  integer(I4B), intent(in) :: iout !< unit number of model listing file
108  type(TspFmiType), intent(in), target :: fmi !< fmi package for this GWE model
109  real(DP), intent(in), pointer :: eqnsclfac !< governing equation scale factor
110  type(GweInputDataType), intent(in), target :: gwecommon !< shared data container for use by multiple GWE packages
111  !
112  ! -- Create the object
113  allocate (estobj)
114  !
115  ! -- create name and memory path
116  call estobj%set_names(1, name_model, 'EST', 'EST')
117  !
118  ! -- Allocate scalars
119  call estobj%allocate_scalars()
120  !
121  ! -- Set variables
122  estobj%inunit = inunit
123  estobj%iout = iout
124  estobj%fmi => fmi
125  estobj%eqnsclfac => eqnsclfac
126  estobj%gwecommon => gwecommon
127  !
128  ! -- Initialize block parser
129  call estobj%parser%Initialize(estobj%inunit, estobj%iout)
Here is the caller graph for this function:

◆ est_da()

subroutine gweestmodule::est_da ( class(gweesttype this)

Method to deallocate memory for the package.

Parameters
thisGweEstType object

Definition at line 616 of file gwe-est.f90.

617  ! -- modules
619  ! -- dummy
620  class(GweEstType) :: this !< GweEstType object
621  !
622  ! -- Deallocate arrays if package was active
623  if (this%inunit > 0) then
624  call mem_deallocate(this%porosity)
625  call mem_deallocate(this%ratesto)
626  call mem_deallocate(this%idcy)
627  call mem_deallocate(this%idcysrc)
628  call mem_deallocate(this%decay_water)
629  call mem_deallocate(this%decay_solid)
630  call mem_deallocate(this%ratedcyw)
631  call mem_deallocate(this%ratedcys)
632  call mem_deallocate(this%decaylastw)
633  call mem_deallocate(this%decaylasts)
634  call mem_deallocate(this%cpw)
635  call mem_deallocate(this%cps)
636  call mem_deallocate(this%rhow)
637  call mem_deallocate(this%rhos)
638  call mem_deallocate(this%latheatvap)
639  this%ibound => null()
640  this%fmi => null()
641  end if
642  !
643  ! -- deallocate parent
644  call this%NumericalPackageType%da()

◆ est_fc()

subroutine gweestmodule::est_fc ( class(gweesttype this,
integer, intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cold,
integer(i4b), intent(in)  nja,
class(matrixbasetype), pointer  matrix_sln,
integer(i4b), dimension(nja), intent(in)  idxglo,
real(dp), dimension(nodes), intent(in)  cnew,
real(dp), dimension(nodes), intent(inout)  rhs,
integer(i4b), intent(in)  kiter 
)

Method to calculate and fill coefficients for the package.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]coldtemperature at end of last time step
[in]njanumber of GWE connections
matrix_slnsolution matrix
[in]idxglomapping vector for model (local) to solution (global)
[in,out]rhsright-hand side vector for model
[in]cnewtemperature at end of this time step
[in]kitersolution outer iteration number

Definition at line 173 of file gwe-est.f90.

175  ! -- dummy
176  class(GweEstType) :: this !< GweEstType object
177  integer, intent(in) :: nodes !< number of nodes
178  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
179  integer(I4B), intent(in) :: nja !< number of GWE connections
180  class(MatrixBaseType), pointer :: matrix_sln !< solution matrix
181  integer(I4B), intent(in), dimension(nja) :: idxglo !< mapping vector for model (local) to solution (global)
182  real(DP), intent(inout), dimension(nodes) :: rhs !< right-hand side vector for model
183  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
184  integer(I4B), intent(in) :: kiter !< solution outer iteration number
185  !
186  ! -- storage contribution
187  call this%est_fc_sto(nodes, cold, nja, matrix_sln, idxglo, rhs)
188  !
189  ! -- decay contribution
190  if (this%idcy == decay_zero_order) then
191  call this%est_fc_dcy_water(nodes, cold, cnew, nja, matrix_sln, idxglo, &
192  rhs, kiter)
193  call this%est_fc_dcy_solid(nodes, cold, nja, matrix_sln, idxglo, rhs, &
194  cnew, kiter)
195  end if

◆ est_fc_dcy_solid()

subroutine gweestmodule::est_fc_dcy_solid ( class(gweesttype this,
integer, intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cold,
integer(i4b), intent(in)  nja,
class(matrixbasetype), pointer  matrix_sln,
integer(i4b), dimension(nja), intent(in)  idxglo,
real(dp), dimension(nodes), intent(inout)  rhs,
real(dp), dimension(nodes), intent(in)  cnew,
integer(i4b), intent(in)  kiter 
)

Method to calculate and fill energy decay coefficients for the solid phase.

Parameters
thisGwtMstType object
[in]nodesnumber of nodes
[in]coldtemperature at end of last time step
[in]njanumber of GWE connections
matrix_slnsolution coefficient matrix
[in]idxglomapping vector for model (local) to solution (global)
[in,out]rhsright-hand side vector for model
[in]cnewtemperature at end of this time step
[in]kitersolution outer iteration number

Definition at line 298 of file gwe-est.f90.

300  ! -- dummy
301  class(GweEstType) :: this !< GwtMstType object
302  integer, intent(in) :: nodes !< number of nodes
303  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
304  integer(I4B), intent(in) :: nja !< number of GWE connections
305  class(MatrixBaseType), pointer :: matrix_sln !< solution coefficient matrix
306  integer(I4B), intent(in), dimension(nja) :: idxglo !< mapping vector for model (local) to solution (global)
307  real(DP), intent(inout), dimension(nodes) :: rhs !< right-hand side vector for model
308  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
309  integer(I4B), intent(in) :: kiter !< solution outer iteration number
310  ! -- local
311  integer(I4B) :: n
312  real(DP) :: rrhs
313  real(DP) :: vcell
314  real(DP) :: decay_rate
315  !
316  ! -- loop through and calculate sorption contribution to hcof and rhs
317  do n = 1, this%dis%nodes
318  !
319  ! -- skip if transport inactive
320  if (this%ibound(n) <= 0) cycle
321  !
322  ! -- set variables
323  rrhs = dzero
324  vcell = this%dis%area(n) * (this%dis%top(n) - this%dis%bot(n))
325  !
326  ! -- account for zero-order decay rate terms in rhs
327  if (this%idcy == decay_zero_order .and. (this%idcysrc == decay_solid .or. &
328  this%idcysrc == decay_both)) then
329  !
330  ! -- negative temps are currently not checked for or prevented since a
331  ! user can define a temperature scale of their own choosing. if
332  ! negative temps result from the specified zero-order decay value,
333  ! it is up to the user to decide if the calculated temperatures are
334  ! acceptable
335  decay_rate = this%decay_solid(n)
336  this%decaylasts(n) = decay_rate
337  rrhs = decay_rate * vcell * (1 - this%porosity(n)) * this%rhos(n)
338  rhs(n) = rhs(n) + rrhs
339  end if
340  end do

◆ est_fc_dcy_water()

subroutine gweestmodule::est_fc_dcy_water ( class(gweesttype this,
integer, intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cold,
real(dp), dimension(nodes), intent(in)  cnew,
integer(i4b), intent(in)  nja,
class(matrixbasetype), pointer  matrix_sln,
integer(i4b), dimension(nja), intent(in)  idxglo,
real(dp), dimension(nodes), intent(inout)  rhs,
integer(i4b), intent(in)  kiter 
)

Method to calculate and fill decay coefficients for the package.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]coldtemperature at end of last time step
[in]cnewtemperature at end of this time step
[in]njanumber of GWE connections
matrix_slnsolution coefficient matrix
[in]idxglomapping vector for model (local) to solution (global)
[in,out]rhsright-hand side vector for model
[in]kitersolution outer iteration number

Definition at line 250 of file gwe-est.f90.

252  ! -- dummy
253  class(GweEstType) :: this !< GweEstType object
254  integer, intent(in) :: nodes !< number of nodes
255  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
256  real(DP), intent(in), dimension(nodes) :: cnew !< temperature at end of this time step
257  integer(I4B), intent(in) :: nja !< number of GWE connections
258  class(MatrixBaseType), pointer :: matrix_sln !< solution coefficient matrix
259  integer(I4B), intent(in), dimension(nja) :: idxglo !< mapping vector for model (local) to solution (global)
260  real(DP), intent(inout), dimension(nodes) :: rhs !< right-hand side vector for model
261  integer(I4B), intent(in) :: kiter !< solution outer iteration number
262  ! -- local
263  integer(I4B) :: n
264  real(DP) :: rrhs
265  real(DP) :: swtpdt
266  real(DP) :: vcell
267  real(DP) :: decay_rate
268  !
269  ! -- loop through and calculate decay contribution to hcof and rhs
270  do n = 1, this%dis%nodes
271  !
272  ! -- skip if transport inactive
273  if (this%ibound(n) <= 0) cycle
274  !
275  ! -- calculate new and old water volumes
276  vcell = this%dis%area(n) * (this%dis%top(n) - this%dis%bot(n))
277  swtpdt = this%fmi%gwfsat(n)
278  !
279  ! -- add zero-order decay rate terms to accumulators
280  if (this%idcy == decay_zero_order .and. (this%idcysrc == decay_water .or. &
281  this%idcysrc == decay_both)) then
282  !
283  decay_rate = this%decay_water(n)
284  ! -- This term does get divided by eqnsclfac for fc purposes because it
285  ! should start out being a rate of energy
286  this%decaylastw(n) = decay_rate
287  rrhs = decay_rate * vcell * swtpdt * this%porosity(n)
288  rhs(n) = rhs(n) + rrhs
289  end if
290  !
291  end do

◆ est_fc_sto()

subroutine gweestmodule::est_fc_sto ( class(gweesttype this,
integer, intent(in)  nodes,
real(dp), dimension(nodes), intent(in)  cold,
integer(i4b), intent(in)  nja,
class(matrixbasetype), pointer  matrix_sln,
integer(i4b), dimension(nja), intent(in)  idxglo,
real(dp), dimension(nodes), intent(inout)  rhs 
)

Method to calculate and fill storage coefficients for the package.

Parameters
thisGweEstType object
[in]nodesnumber of nodes
[in]coldtemperature at end of last time step
[in]njanumber of GWE connections
matrix_slnsolution coefficient matrix
[in]idxglomapping vector for model (local) to solution (global)
[in,out]rhsright-hand side vector for model

Definition at line 202 of file gwe-est.f90.

203  ! -- modules
204  use tdismodule, only: delt
205  ! -- dummy
206  class(GweEstType) :: this !< GweEstType object
207  integer, intent(in) :: nodes !< number of nodes
208  real(DP), intent(in), dimension(nodes) :: cold !< temperature at end of last time step
209  integer(I4B), intent(in) :: nja !< number of GWE connections
210  class(MatrixBaseType), pointer :: matrix_sln !< solution coefficient matrix
211  integer(I4B), intent(in), dimension(nja) :: idxglo !< mapping vector for model (local) to solution (global)
212  real(DP), intent(inout), dimension(nodes) :: rhs !< right-hand side vector for model
213  ! -- local
214  integer(I4B) :: n, idiag
215  real(DP) :: tled
216  real(DP) :: hhcof, rrhs
217  real(DP) :: vnew, vold, vcell, vsolid, term
218  !
219  ! -- set variables
220  tled = done / delt
221  !
222  ! -- loop through and calculate storage contribution to hcof and rhs
223  do n = 1, this%dis%nodes
224  !
225  ! -- skip if transport inactive
226  if (this%ibound(n) <= 0) cycle
227  !
228  ! -- calculate new and old water volumes and solid volume
229  vcell = this%dis%area(n) * (this%dis%top(n) - this%dis%bot(n))
230  vnew = vcell * this%fmi%gwfsat(n) * this%porosity(n)
231  vold = vnew
232  if (this%fmi%igwfstrgss /= 0) vold = vold + this%fmi%gwfstrgss(n) * delt
233  if (this%fmi%igwfstrgsy /= 0) vold = vold + this%fmi%gwfstrgsy(n) * delt
234  vsolid = vcell * (done - this%porosity(n))
235  !
236  ! -- add terms to diagonal and rhs accumulators
237  term = (this%rhos(n) * this%cps(n)) * vsolid
238  hhcof = -(this%eqnsclfac * vnew + term) * tled
239  rrhs = -(this%eqnsclfac * vold + term) * tled * cold(n)
240  idiag = this%dis%con%ia(n)
241  call matrix_sln%add_value_pos(idxglo(idiag), hhcof)
242  rhs(n) = rhs(n) + rrhs
243  end do

◆ est_ot_flow()

subroutine gweestmodule::est_ot_flow ( class(gweesttype this,
integer(i4b), intent(in)  icbcfl,
integer(i4b), intent(in)  icbcun 
)

Method to output terms for the package.

Parameters
thisGweEstType object
[in]icbcflflag and unit number for cell-by-cell output
[in]icbcunflag indication if cell-by-cell data should be saved

Definition at line 563 of file gwe-est.f90.

564  ! -- dummy
565  class(GweEstType) :: this !< GweEstType object
566  integer(I4B), intent(in) :: icbcfl !< flag and unit number for cell-by-cell output
567  integer(I4B), intent(in) :: icbcun !< flag indication if cell-by-cell data should be saved
568  ! -- local
569  integer(I4B) :: ibinun
570  integer(I4B) :: iprint, nvaluesp, nwidthp
571  character(len=1) :: cdatafmp = ' ', editdesc = ' '
572  real(DP) :: dinact
573  !
574  ! -- Set unit number for binary output
575  if (this%ipakcb < 0) then
576  ibinun = icbcun
577  elseif (this%ipakcb == 0) then
578  ibinun = 0
579  else
580  ibinun = this%ipakcb
581  end if
582  if (icbcfl == 0) ibinun = 0
583  !
584  ! -- Record the storage rate if requested
585  if (ibinun /= 0) then
586  iprint = 0
587  dinact = dzero
588  !
589  ! -- sto
590  call this%dis%record_array(this%ratesto, this%iout, iprint, -ibinun, &
591  budtxt(1), cdatafmp, nvaluesp, &
592  nwidthp, editdesc, dinact)
593  !
594  ! -- dcy
595  if (this%idcy == decay_zero_order) then
596  if (this%idcysrc == decay_water .or. this%idcysrc == decay_both) then
597  ! -- aqueous phase
598  call this%dis%record_array(this%ratedcyw, this%iout, iprint, &
599  -ibinun, budtxt(2), cdatafmp, nvaluesp, &
600  nwidthp, editdesc, dinact)
601  end if
602  if (this%idcysrc == decay_solid .or. this%idcysrc == decay_both) then
603  ! -- solid phase
604  call this%dis%record_array(this%ratedcys, this%iout, iprint, &
605  -ibinun, budtxt(3), cdatafmp, nvaluesp, &
606  nwidthp, editdesc, dinact)
607  end if
608  end if
609  end if

◆ read_data()

subroutine gweestmodule::read_data ( class(gweesttype this)

Method to read data for the package.

Parameters
thisGweEstType object

Definition at line 836 of file gwe-est.f90.

837  ! -- modules
838  use constantsmodule, only: linelength
840  ! -- dummy
841  class(GweEstType) :: this !< GweEstType object
842  ! -- local
843  character(len=LINELENGTH) :: keyword
844  character(len=:), allocatable :: line
845  integer(I4B) :: istart, istop, lloc, ierr
846  logical :: isfound, endOfBlock
847  logical, dimension(5) :: lname
848  character(len=24), dimension(5) :: aname
849  ! -- formats
850  ! -- data
851  data aname(1)/' MOBILE DOMAIN POROSITY'/
852  data aname(2)/'DECAY RATE AQUEOUS PHASE'/
853  data aname(3)/' DECAY RATE SOLID PHASE'/
854  data aname(4)/' HEAT CAPACITY OF SOLIDS'/
855  data aname(5)/' DENSITY OF SOLIDS'/
856  !
857  ! -- initialize
858  isfound = .false.
859  lname(:) = .false.
860  !
861  ! -- get griddata block
862  call this%parser%GetBlock('GRIDDATA', isfound, ierr)
863  if (isfound) then
864  write (this%iout, '(1x,a)') 'PROCESSING GRIDDATA'
865  do
866  call this%parser%GetNextLine(endofblock)
867  if (endofblock) exit
868  call this%parser%GetStringCaps(keyword)
869  call this%parser%GetRemainingLine(line)
870  lloc = 1
871  select case (keyword)
872  case ('POROSITY')
873  call this%dis%read_grid_array(line, lloc, istart, istop, this%iout, &
874  this%parser%iuactive, this%porosity, &
875  aname(1))
876  lname(1) = .true.
877  case ('DECAY_WATER')
878  if (this%idcy == decay_off) &
879  call mem_reallocate(this%decay_water, this%dis%nodes, 'DECAY_WATER', &
880  trim(this%memoryPath))
881  call this%dis%read_grid_array(line, lloc, istart, istop, this%iout, &
882  this%parser%iuactive, this%decay_water, &
883  aname(2))
884  lname(2) = .true.
885  case ('DECAY_SOLID')
886  if (this%idcy == decay_off) &
887  call mem_reallocate(this%decay_solid, this%dis%nodes, 'DECAY_SOLID', &
888  trim(this%memoryPath))
889  call this%dis%read_grid_array(line, lloc, istart, istop, this%iout, &
890  this%parser%iuactive, this%decay_solid, &
891  aname(3))
892  lname(3) = .true.
893  case ('HEAT_CAPACITY_SOLID')
894  call this%dis%read_grid_array(line, lloc, istart, istop, this%iout, &
895  this%parser%iuactive, this%cps, &
896  aname(4))
897  lname(4) = .true.
898  case ('DENSITY_SOLID')
899  call this%dis%read_grid_array(line, lloc, istart, istop, this%iout, &
900  this%parser%iuactive, this%rhos, &
901  aname(5))
902  lname(5) = .true.
903  case default
904  write (errmsg, '(a,a)') 'Unknown griddata tag: ', trim(keyword)
905  call store_error(errmsg)
906  call this%parser%StoreErrorUnit()
907  end select
908  end do
909  write (this%iout, '(1x,a)') 'END PROCESSING GRIDDATA'
910  else
911  write (errmsg, '(a)') 'Required griddata block not found.'
912  call store_error(errmsg)
913  call this%parser%StoreErrorUnit()
914  end if
915  !
916  ! -- Check for required porosity
917  if (.not. lname(1)) then
918  write (errmsg, '(a)') 'Porosity not specified in griddata block.'
919  call store_error(errmsg)
920  end if
921  if (.not. lname(4)) then
922  write (errmsg, '(a)') 'HEAT_CAPACITY_SOLID not specified in griddata block.'
923  call store_error(errmsg)
924  end if
925  if (.not. lname(5)) then
926  write (errmsg, '(a)') 'DENSITY_SOLID not specified in griddata block.'
927  call store_error(errmsg)
928  end if
929  !
930  ! -- Check for required decay/production rate coefficients
931  if (this%idcy == decay_zero_order) then
932  if (.not. lname(2) .and. .not. lname(3)) then
933  write (errmsg, '(a)') 'Zero order decay in either the aqueous &
934  &or solid phase is active but the corresponding zero-order &
935  &rate coefficient is not specified. Either DECAY_WATER or &
936  &DECAY_SOLID must be specified in the griddata block.'
937  call store_error(errmsg)
938  end if
939  else
940  if (lname(2)) then
941  write (warnmsg, '(a)') 'Zero order decay in the aqueous phase has &
942  &not been activated but DECAY_WATER has been specified. Zero &
943  &order decay in the aqueous phase will have no affect on &
944  &simulation results.'
945  call store_warning(warnmsg)
946  write (this%iout, '(1x,a)') 'WARNING. '//warnmsg
947  else if (lname(3)) then
948  write (warnmsg, '(a)') 'Zero order decay in the solid phase has not &
949  &been activated but DECAY_SOLID has been specified. Zero order &
950  &decay in the solid phase will have no affect on simulation &
951  &results.'
952  call store_warning(warnmsg)
953  write (this%iout, '(1x,a)') 'WARNING. '//warnmsg
954  end if
955  end if
956  !
957  ! -- terminate if errors
958  if (count_errors() > 0) then
959  call this%parser%StoreErrorUnit()
960  end if
integer(i4b), parameter linelength
maximum length of a standard line
Definition: Constants.f90:45
Here is the call graph for this function:

◆ read_options()

subroutine gweestmodule::read_options ( class(gweesttype this)

Method to read options for the package.

Parameters
thisGweEstType object

Definition at line 736 of file gwe-est.f90.

737  ! -- modules
738  use constantsmodule, only: linelength
739  ! -- dummy
740  class(GweEstType) :: this !< GweEstType object
741  ! -- local
742  character(len=LINELENGTH) :: keyword
743  integer(I4B) :: ierr
744  logical :: isfound, endOfBlock
745  ! -- formats
746  character(len=*), parameter :: fmtisvflow = &
747  &"(4x,'CELL-BY-CELL FLOW INFORMATION WILL BE SAVED TO BINARY "// &
748  &"FILE WHENEVER ICBCFL IS NOT ZERO.')"
749  character(len=*), parameter :: fmtidcy1 = &
750  "(4x,'FIRST-ORDER DECAY IS ACTIVE. ')"
751  character(len=*), parameter :: fmtidcy2 = &
752  "(4x,'ZERO-ORDER DECAY IN THE AQUEOUS "// &
753  &"PHASE IS ACTIVE. ')"
754  character(len=*), parameter :: fmtidcy3 = &
755  "(4x,'ZERO-ORDER DECAY IN THE SOLID "// &
756  &"PHASE IS ACTIVE. ')"
757  !
758  ! -- get options block
759  call this%parser%GetBlock('OPTIONS', isfound, ierr, blockrequired=.false., &
760  supportopenclose=.true.)
761  !
762  ! -- parse options block if detected
763  if (isfound) then
764  write (this%iout, '(1x,a)') 'PROCESSING ENERGY STORAGE AND TRANSFER OPTIONS'
765  do
766  call this%parser%GetNextLine(endofblock)
767  if (endofblock) exit
768  call this%parser%GetStringCaps(keyword)
769  select case (keyword)
770  case ('SAVE_FLOWS')
771  this%ipakcb = -1
772  write (this%iout, fmtisvflow)
773  case ('ZERO_ORDER_DECAY_WATER')
774  this%idcy = decay_zero_order
775  ! -- idcysrc > 0 indicates decay in the solid phase is active
776  ! in which case the idcysrc should now be upgraded to both phases
777  if (this%idcysrc > izero) then
778  this%idcysrc = decay_both
779  else
780  this%idcysrc = decay_water
781  end if
782  write (this%iout, fmtidcy2)
783  case ('ZERO_ORDER_DECAY_SOLID')
784  this%idcy = decay_zero_order
785  ! -- idcysrc > 0 indicates decay in active in water in which case
786  ! the idcysrc should now be upgraded to both phases
787  if (this%idcysrc > izero) then
788  this%idcysrc = decay_both
789  else
790  this%idcysrc = decay_solid
791  end if
792  write (this%iout, fmtidcy3)
793  case ('HEAT_CAPACITY_WATER')
794  this%cpw = this%parser%GetDouble()
795  if (this%cpw <= 0.0) then
796  write (errmsg, '(a)') 'Specified value for the heat capacity of &
797  &water must be greater than 0.0.'
798  call store_error(errmsg)
799  call this%parser%StoreErrorUnit()
800  else
801  write (this%iout, '(4x,a,1pg15.6)') &
802  'Heat capacity of the water has been set to: ', &
803  this%cpw
804  end if
805  case ('DENSITY_WATER')
806  this%rhow = this%parser%GetDouble()
807  if (this%rhow <= 0.0) then
808  write (errmsg, '(a)') 'Specified value for the density of &
809  &water must be greater than 0.0.'
810  call store_error(errmsg)
811  call this%parser%StoreErrorUnit()
812  else
813  write (this%iout, '(4x,a,1pg15.6)') &
814  'Density of the water has been set to: ', &
815  this%rhow
816  end if
817  case ('LATENT_HEAT_VAPORIZATION')
818  this%latheatvap = this%parser%GetDouble()
819  write (this%iout, '(4x,a,1pg15.6)') &
820  'Latent heat of vaporization of the water has been set to: ', &
821  this%latheatvap
822  case default
823  write (errmsg, '(a,a)') 'Unknown EST option: ', trim(keyword)
824  call store_error(errmsg)
825  call this%parser%StoreErrorUnit()
826  end select
827  end do
828  write (this%iout, '(1x,a)') 'END OF ENERGY STORAGE AND TRANSFER OPTIONS'
829  end if
Here is the call graph for this function:

Variable Documentation

◆ budtxt

character(len=lenbudtxt), dimension(nbditems) gweestmodule::budtxt

Definition at line 31 of file gwe-est.f90.

31  character(len=LENBUDTXT), dimension(NBDITEMS) :: budtxt

◆ nbditems

integer(i4b), parameter gweestmodule::nbditems = 3

Definition at line 30 of file gwe-est.f90.

30  integer(I4B), parameter :: NBDITEMS = 3