Neko  0.8.99
A portable framework for high-order spectral element flow simulations
fluid_volflow.f90
Go to the documentation of this file.
1 ! Copyright (c) 2008-2020, UCHICAGO ARGONNE, LLC.
2 !
3 ! The UChicago Argonne, LLC as Operator of Argonne National
4 ! Laboratory holds copyright in the Software. The copyright holder
5 ! reserves all rights except those expressly granted to licensees,
6 ! and U.S. Government license rights.
7 !
8 ! Redistribution and use in source and binary forms, with or without
9 ! modification, are permitted provided that the following conditions
10 ! are met:
11 !
12 ! 1. Redistributions of source code must retain the above copyright
13 ! notice, this list of conditions and the disclaimer below.
14 !
15 ! 2. Redistributions in binary form must reproduce the above copyright
16 ! notice, this list of conditions and the disclaimer (as noted below)
17 ! in the documentation and/or other materials provided with the
18 ! distribution.
19 !
20 ! 3. Neither the name of ANL nor the names of its contributors
21 ! may be used to endorse or promote products derived from this software
22 ! without specific prior written permission.
23 !
24 ! THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS
25 ! "AS IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT
26 ! LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS
27 ! FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL
28 ! UCHICAGO ARGONNE, LLC, THE U.S. DEPARTMENT OF
29 ! ENERGY OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL,
30 ! SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED
31 ! TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE,
32 ! DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY
33 ! THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT
34 ! (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE
35 ! OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
36 !
37 ! Additional BSD Notice
38 ! ---------------------
39 ! 1. This notice is required to be provided under our contract with
40 ! the U.S. Department of Energy (DOE). This work was produced at
41 ! Argonne National Laboratory under Contract
42 ! No. DE-AC02-06CH11357 with the DOE.
43 !
44 ! 2. Neither the United States Government nor UCHICAGO ARGONNE,
45 ! LLC nor any of their employees, makes any warranty,
46 ! express or implied, or assumes any liability or responsibility for the
47 ! accuracy, completeness, or usefulness of any information, apparatus,
48 ! product, or process disclosed, or represents that its use would not
49 ! infringe privately-owned rights.
50 !
51 ! 3. Also, reference herein to any specific commercial products, process,
52 ! or services by trade name, trademark, manufacturer or otherwise does
53 ! not necessarily constitute or imply its endorsement, recommendation,
54 ! or favoring by the United States Government or UCHICAGO ARGONNE LLC.
55 ! The views and opinions of authors expressed
56 ! herein do not necessarily state or reflect those of the United States
57 ! Government or UCHICAGO ARGONNE, LLC, and shall
58 ! not be used for advertising or product endorsement purposes.
59 !
61  use operators, only : opgrad, cdtp
62  use num_types, only : rp
63  use mathops, only : opchsign
64  use krylov, only : ksp_t, ksp_monitor_t
65  use precon, only : pc_t
66  use dofmap, only : dofmap_t
67  use field, only : field_t
68  use coefs, only : coef_t
70  use math, only : copy, glsc2, glmin, glmax, add2, add2s2
71  use comm
72  use neko_config, only : neko_bcknd_device
76  use gather_scatter, only : gs_t, gs_op_add
77  use json_module, only : json_file
78  use json_utils, only: json_get
81  use ax_product, only : ax_t
82  implicit none
83  private
84 
86  type, public :: fluid_volflow_t
87  integer :: flow_dir
88  logical :: avflow
89  real(kind=rp) :: flow_rate
90  real(kind=rp) :: dtlag = 0d0
91  real(kind=rp) :: bdlag = 0d0
92  type(field_t) :: u_vol, v_vol, w_vol, p_vol
93  real(kind=rp) :: domain_length, base_flow
95  type(scratch_registry_t) :: scratch
96  contains
97  procedure, pass(this) :: init => fluid_vol_flow_init
98  procedure, pass(this) :: free => fluid_vol_flow_free
99  procedure, pass(this) :: adjust => fluid_vol_flow
100  procedure, private, pass(this) :: compute => fluid_vol_flow_compute
101  end type fluid_volflow_t
102 
103 contains
104 
105  subroutine fluid_vol_flow_init(this, dm_Xh, params)
106  class(fluid_volflow_t), intent(inout) :: this
107  type(dofmap_t), target, intent(inout) :: dm_Xh
108  type(json_file), intent(inout) :: params
109  logical average
110  integer :: direction
111  real(kind=rp) :: rate
112 
113  call this%free()
114 
115  !Initialize vol_flow (if there is a forced volume flow)
116  call json_get(params, 'case.fluid.flow_rate_force.direction', direction)
117  call json_get(params, 'case.fluid.flow_rate_force.value', rate)
118  call json_get(params, 'case.fluid.flow_rate_force.use_averaged_flow',&
119  average)
120 
121  this%flow_dir = direction
122  this%avflow = average
123  this%flow_rate = rate
124 
125  if (this%flow_dir .ne. 0) then
126  call this%u_vol%init(dm_xh, 'u_vol')
127  call this%v_vol%init(dm_xh, 'v_vol')
128  call this%w_vol%init(dm_xh, 'w_vol')
129  call this%p_vol%init(dm_xh, 'p_vol')
130  end if
131 
132  this%scratch = scratch_registry_t(dm_xh, 3, 1)
133 
134  end subroutine fluid_vol_flow_init
135 
136  subroutine fluid_vol_flow_free(this)
137  class(fluid_volflow_t), intent(inout) :: this
138 
139  call this%u_vol%free()
140  call this%v_vol%free()
141  call this%w_vol%free()
142  call this%p_vol%free()
143 
144  call this%scratch%free()
145 
146  end subroutine fluid_vol_flow_free
147 
151  subroutine fluid_vol_flow_compute(this, u_res, v_res, w_res, p_res, &
152  ext_bdf, gs_Xh, c_Xh, rho, mu, bd, dt, &
153  bclst_dp, bclst_du, bclst_dv, bclst_dw, bclst_vel_res, &
154  Ax, ksp_prs, ksp_vel, pc_prs, pc_vel, prs_max_iter, vel_max_iter)
155  class(fluid_volflow_t), intent(inout) :: this
156  type(field_t), intent(inout) :: u_res, v_res, w_res, p_res
157  type(coef_t), intent(inout) :: c_Xh
158  type(gs_t), intent(inout) :: gs_Xh
159  type(time_scheme_controller_t), intent(inout) :: ext_bdf
160  type(bc_list_t), intent(inout) :: bclst_dp, bclst_du, bclst_dv, bclst_dw
161  type(bc_list_t), intent(inout) :: bclst_vel_res
162  class(ax_t), intent(inout) :: Ax
163  class(ksp_t), intent(inout) :: ksp_prs, ksp_vel
164  class(pc_t), intent(inout) :: pc_prs, pc_vel
165  real(kind=rp), intent(inout) :: bd
166  real(kind=rp), intent(in) :: rho, mu, dt
167  integer, intent(in) :: vel_max_iter, prs_max_iter
168  integer :: n, i
169  real(kind=rp) :: xlmin, xlmax
170  real(kind=rp) :: ylmin, ylmax
171  real(kind=rp) :: zlmin, zlmax
172  type(ksp_monitor_t) :: ksp_result
173  type(field_t), pointer :: ta1, ta2, ta3
174  integer :: temp_indices(3)
175 
176  call this%scratch%request_field(ta1, temp_indices(1))
177  call this%scratch%request_field(ta2, temp_indices(2))
178  call this%scratch%request_field(ta3, temp_indices(3))
179 
180 
181  associate(msh => c_xh%msh, p_vol => this%p_vol, &
182  u_vol => this%u_vol, v_vol => this%v_vol, w_vol => this%w_vol)
183 
184  n = c_xh%dof%size()
185  xlmin = glmin(c_xh%dof%x, n)
186  xlmax = glmax(c_xh%dof%x, n)
187  ylmin = glmin(c_xh%dof%y, n) ! for Y!
188  ylmax = glmax(c_xh%dof%y, n)
189  zlmin = glmin(c_xh%dof%z, n) ! for Z!
190  zlmax = glmax(c_xh%dof%z, n)
191  if (this%flow_dir .eq. 1) then
192  this%domain_length = xlmax - xlmin
193  end if
194  if (this%flow_dir .eq. 2) then
195  this%domain_length = ylmax - ylmin
196  end if
197  if (this%flow_dir .eq. 3) then
198  this%domain_length = zlmax - zlmin
199  end if
200 
201  if (neko_bcknd_device .eq. 1) then
202  call device_cfill(c_xh%h1_d, 1.0_rp/rho, n)
203  call device_rzero(c_xh%h2_d, n)
204  else
205  do i = 1, n
206  c_xh%h1(i,1,1,1) = 1.0_rp / rho
207  c_xh%h2(i,1,1,1) = 0.0_rp
208  end do
209  end if
210  c_xh%ifh2 = .false.
211 
212  ! Compute pressure
213 
214  if (this%flow_dir .eq. 1) then
215  call cdtp(p_res%x, c_xh%h1, c_xh%drdx, c_xh%dsdx, c_xh%dtdx, c_xh)
216  end if
217 
218  if (this%flow_dir .eq. 2) then
219  call cdtp(p_res%x, c_xh%h1, c_xh%drdy, c_xh%dsdy, c_xh%dtdy, c_xh)
220  end if
221 
222  if (this%flow_dir .eq. 3) then
223  call cdtp(p_res%x, c_xh%h1, c_xh%drdz, c_xh%dsdz, c_xh%dtdz, c_xh)
224  end if
225 
226  call gs_xh%op(p_res, gs_op_add)
227  call bc_list_apply_scalar(bclst_dp, p_res%x, n)
228  call pc_prs%update()
229  ksp_result = ksp_prs%solve(ax, p_vol, p_res%x, n, &
230  c_xh, bclst_dp, gs_xh, prs_max_iter)
231 
232  ! Compute velocity
233 
234  call opgrad(u_res%x, v_res%x, w_res%x, p_vol%x, c_xh)
235 
236  if ((neko_bcknd_hip .eq. 1) .or. (neko_bcknd_cuda .eq. 1) .or. &
237  (neko_bcknd_opencl .eq. 1)) then
238  call device_opchsign(u_res%x_d, v_res%x_d, w_res%x_d, msh%gdim, n)
239  call device_copy(ta1%x_d, c_xh%B_d, n)
240  call device_copy(ta2%x_d, c_xh%B_d, n)
241  call device_copy(ta3%x_d, c_xh%B_d, n)
242  else
243  call opchsign(u_res%x, v_res%x, w_res%x, msh%gdim, n)
244  call copy(ta1%x, c_xh%B, n)
245  call copy(ta2%x, c_xh%B, n)
246  call copy(ta3%x, c_xh%B, n)
247  end if
248  call bc_list_apply_vector(bclst_vel_res,&
249  ta1%x, ta2%x, ta3%x, n)
250 
251  ! add forcing
252 
253  if (neko_bcknd_device .eq. 1) then
254  if (this%flow_dir .eq. 1) then
255  call device_add2(u_res%x_d, ta1%x_d, n)
256  else if (this%flow_dir .eq. 2) then
257  call device_add2(v_res%x_d, ta2%x_d, n)
258  else if (this%flow_dir .eq. 3) then
259  call device_add2(w_res%x_d, ta3%x_d, n)
260  end if
261  else
262  if (this%flow_dir .eq. 1) then
263  call add2(u_res%x, ta1%x, n)
264  else if (this%flow_dir .eq. 2) then
265  call add2(v_res%x, ta2%x, n)
266  else if (this%flow_dir .eq. 3) then
267  call add2(w_res%x, ta3%x, n)
268  end if
269  end if
270 
271  if (neko_bcknd_device .eq. 1) then
272  call device_cfill(c_xh%h1_d, mu, n)
273  call device_cfill(c_xh%h2_d, rho * (bd / dt), n)
274  else
275  do i = 1, n
276  c_xh%h1(i,1,1,1) = mu
277  c_xh%h2(i,1,1,1) = rho * (bd / dt)
278  end do
279  end if
280  c_xh%ifh2 = .true.
281 
282  call gs_xh%op(u_res, gs_op_add)
283  call gs_xh%op(v_res, gs_op_add)
284  call gs_xh%op(w_res, gs_op_add)
285 
286  call bc_list_apply_vector(bclst_vel_res,&
287  u_res%x, v_res%x, w_res%x, n)
288  call pc_vel%update()
289 
290  ksp_result = ksp_vel%solve(ax, u_vol, u_res%x, n, &
291  c_xh, bclst_du, gs_xh, vel_max_iter)
292  ksp_result = ksp_vel%solve(ax, v_vol, v_res%x, n, &
293  c_xh, bclst_dv, gs_xh, vel_max_iter)
294  ksp_result = ksp_vel%solve(ax, w_vol, w_res%x, n, &
295  c_xh, bclst_dw, gs_xh, vel_max_iter)
296 
297  if (neko_bcknd_device .eq. 1) then
298  if (this%flow_dir .eq. 1) then
299  this%base_flow = &
300  device_glsc2(u_vol%x_d, c_xh%B_d, n) / this%domain_length
301  end if
302 
303  if (this%flow_dir .eq. 2) then
304  this%base_flow = &
305  device_glsc2(v_vol%x_d, c_xh%B_d, n) / this%domain_length
306  end if
307 
308  if (this%flow_dir .eq. 3) then
309  this%base_flow = &
310  device_glsc2(w_vol%x_d, c_xh%B_d, n) / this%domain_length
311  end if
312  else
313  if (this%flow_dir .eq. 1) then
314  this%base_flow = glsc2(u_vol%x, c_xh%B, n) / this%domain_length
315  end if
316 
317  if (this%flow_dir .eq. 2) then
318  this%base_flow = glsc2(v_vol%x, c_xh%B, n) / this%domain_length
319  end if
320 
321  if (this%flow_dir .eq. 3) then
322  this%base_flow = glsc2(w_vol%x, c_xh%B, n) / this%domain_length
323  end if
324  end if
325  end associate
326 
327  call this%scratch%relinquish_field(temp_indices)
328  end subroutine fluid_vol_flow_compute
329 
339  subroutine fluid_vol_flow(this, u, v, w, p, u_res, v_res, w_res, p_res, &
340  c_Xh, gs_Xh, ext_bdf, rho, mu, dt, &
341  bclst_dp, bclst_du, bclst_dv, bclst_dw, bclst_vel_res, &
342  Ax, ksp_prs, ksp_vel, pc_prs, pc_vel, prs_max_iter, vel_max_iter)
343 
344  class(fluid_volflow_t), intent(inout) :: this
345  type(field_t), intent(inout) :: u, v, w, p
346  type(field_t), intent(inout) :: u_res, v_res, w_res, p_res
347  type(coef_t), intent(inout) :: c_Xh
348  type(gs_t), intent(inout) :: gs_Xh
349  type(time_scheme_controller_t), intent(inout) :: ext_bdf
350  real(kind=rp), intent(in) :: rho, mu, dt
351  type(bc_list_t), intent(inout) :: bclst_dp, bclst_du, bclst_dv, bclst_dw
352  type(bc_list_t), intent(inout) :: bclst_vel_res
353  class(ax_t), intent(inout) :: Ax
354  class(ksp_t), intent(inout) :: ksp_prs, ksp_vel
355  class(pc_t), intent(inout) :: pc_prs, pc_vel
356  integer, intent(in) :: prs_max_iter, vel_max_iter
357  real(kind=rp) :: ifcomp, flow_rate, xsec
358  real(kind=rp) :: current_flow, delta_flow, scale
359  integer :: n, ierr, i
360  type(field_t), pointer :: ta1, ta2, ta3
361 
362  associate(u_vol => this%u_vol, v_vol => this%v_vol, &
363  w_vol => this%w_vol, p_vol => this%p_vol)
364 
365  n = c_xh%dof%size()
366 
367  ! If either dt or the backwards difference coefficient change,
368  ! then recompute base flow solution corresponding to unit forcing:
369 
370  ifcomp = 0.0_rp
371 
372  if (dt .ne. this%dtlag .or. &
373  ext_bdf%diffusion_coeffs(1) .ne. this%bdlag) then
374  ifcomp = 1.0_rp
375  end if
376 
377  this%dtlag = dt
378  this%bdlag = ext_bdf%diffusion_coeffs(1)
379 
380  call mpi_allreduce(mpi_in_place, ifcomp, 1, &
381  mpi_real_precision, mpi_sum, neko_comm, ierr)
382 
383  if (ifcomp .gt. 0d0) then
384  call this%compute(u_res, v_res, w_res, p_res, &
385  ext_bdf, gs_xh, c_xh, rho, mu, ext_bdf%diffusion_coeffs(1), dt, &
386  bclst_dp, bclst_du, bclst_dv, bclst_dw, bclst_vel_res, &
387  ax, ksp_prs, ksp_vel, pc_prs, pc_vel, prs_max_iter, vel_max_iter)
388  end if
389 
390  if (neko_bcknd_device .eq. 1) then
391  if (this%flow_dir .eq. 1) then
392  current_flow = &
393  device_glsc2(u%x_d, c_xh%B_d, n) / this%domain_length ! for X
394  else if (this%flow_dir .eq. 2) then
395  current_flow = &
396  device_glsc2(v%x_d, c_xh%B_d, n) / this%domain_length ! for Y
397  else if (this%flow_dir .eq. 3) then
398  current_flow = &
399  device_glsc2(w%x_d, c_xh%B_d, n) / this%domain_length ! for Z
400  end if
401  else
402  if (this%flow_dir .eq. 1) then
403  current_flow = glsc2(u%x, c_xh%B, n) / this%domain_length ! for X
404  else if (this%flow_dir .eq. 2) then
405  current_flow = glsc2(v%x, c_xh%B, n) / this%domain_length ! for Y
406  else if (this%flow_dir .eq. 3) then
407  current_flow = glsc2(w%x, c_xh%B, n) / this%domain_length ! for Z
408  end if
409  end if
410 
411  if (this%avflow) then
412  xsec = c_xh%volume / this%domain_length
413  flow_rate = this%flow_rate*xsec
414  else
415  flow_rate = this%flow_rate
416  end if
417 
418  delta_flow = flow_rate - current_flow
419  scale = delta_flow / this%base_flow
420 
421  if (neko_bcknd_device .eq. 1) then
422  call device_add2s2(u%x_d, u_vol%x_d, scale, n)
423  call device_add2s2(v%x_d, v_vol%x_d, scale, n)
424  call device_add2s2(w%x_d, w_vol%x_d, scale, n)
425  call device_add2s2(p%x_d, p_vol%x_d, scale, n)
426  else
427  do concurrent(i = 1: n)
428  u%x(i,1,1,1) = u%x(i,1,1,1) + scale * u_vol%x(i,1,1,1)
429  v%x(i,1,1,1) = v%x(i,1,1,1) + scale * v_vol%x(i,1,1,1)
430  w%x(i,1,1,1) = w%x(i,1,1,1) + scale * w_vol%x(i,1,1,1)
431  p%x(i,1,1,1) = p%x(i,1,1,1) + scale * p_vol%x(i,1,1,1)
432  end do
433  end if
434  end associate
435 
436  end subroutine fluid_vol_flow
437 
438 
439 end module fluid_volflow
Retrieves a parameter by name or throws an error.
Definition: json_utils.f90:44
Defines a Matrix-vector product.
Definition: ax.f90:34
Defines a boundary condition.
Definition: bc.f90:34
subroutine, public bc_list_apply_vector(bclst, x, y, z, n, t, tstep)
Apply a list of boundary conditions to a vector field.
Definition: bc.f90:583
subroutine, public bc_list_apply_scalar(bclst, x, n, t, tstep)
Apply a list of boundary conditions to a scalar field.
Definition: bc.f90:526
Coefficients.
Definition: coef.f90:34
Definition: comm.F90:1
subroutine, public device_add2(a_d, b_d, n)
Vector addition .
subroutine, public device_rzero(a_d, n)
Zero a real vector.
subroutine, public device_add2s2(a_d, b_d, c1, n)
Vector addition with scalar multiplication (multiplication on first argument)
real(kind=rp) function, public device_glsc2(a_d, b_d, n)
Weighted inner product .
subroutine, public device_copy(a_d, b_d, n)
Copy a vector .
subroutine, public device_cfill(a_d, c, n)
Set all elements to a constant c .
subroutine, public device_opchsign(a1_d, a2_d, a3_d, gdim, n)
Defines a mapping of the degrees of freedom.
Definition: dofmap.f90:35
Defines a field.
Definition: field.f90:34
subroutine fluid_vol_flow_init(this, dm_Xh, params)
subroutine fluid_vol_flow_compute(this, u_res, v_res, w_res, p_res, ext_bdf, gs_Xh, c_Xh, rho, mu, bd, dt, bclst_dp, bclst_du, bclst_dv, bclst_dw, bclst_vel_res, Ax, ksp_prs, ksp_vel, pc_prs, pc_vel, prs_max_iter, vel_max_iter)
Compute flow adjustment.
subroutine fluid_vol_flow(this, u, v, w, p, u_res, v_res, w_res, p_res, c_Xh, gs_Xh, ext_bdf, rho, mu, dt, bclst_dp, bclst_du, bclst_dv, bclst_dw, bclst_vel_res, Ax, ksp_prs, ksp_vel, pc_prs, pc_vel, prs_max_iter, vel_max_iter)
Adjust flow volume.
subroutine fluid_vol_flow_free(this)
Gather-scatter.
Utilities for retrieving parameters from the case files.
Definition: json_utils.f90:34
Implements the base abstract type for Krylov solvers plus helper types.
Definition: krylov.f90:34
Definition: math.f90:60
real(kind=rp) function, public glsc2(a, b, n)
Weighted inner product .
Definition: math.f90:836
subroutine, public add2(a, b, n)
Vector addition .
Definition: math.f90:547
real(kind=rp) function, public glmax(a, n)
Max of a vector of length n.
Definition: math.f90:341
subroutine, public copy(a, b, n)
Copy a vector .
Definition: math.f90:228
subroutine, public add2s2(a, b, c1, n)
Vector addition with scalar multiplication (multiplication on second argument)
Definition: math.f90:633
real(kind=rp) function, public glmin(a, n)
Min of a vector of length n.
Definition: math.f90:369
Collection of vector field operations operating on and . Note that in general the indices and ....
Definition: mathops.f90:65
subroutine, public opchsign(a1, a2, a3, gdim, n)
for and .
Definition: mathops.f90:76
Build configurations.
Definition: neko_config.f90:34
integer, parameter neko_bcknd_device
Definition: neko_config.f90:44
integer, parameter, public rp
Global precision used in computations.
Definition: num_types.f90:12
Operators.
Definition: operators.f90:34
subroutine, public opgrad(ux, uy, uz, u, coef, es, ee)
Compute the weak gradient of a scalar field, i.e. the gradient multiplied by the mass matrix.
Definition: operators.f90:169
subroutine, public cdtp(dtx, x, dr, ds, dt, coef, es, ee)
Apply D^T to a scalar field, where D is the derivative matrix.
Definition: operators.f90:228
Krylov preconditioner.
Definition: precon.f90:34
Defines a registry for storing and requesting temporary fields This can be used when you have a funct...
Compound scheme for the advection and diffusion operators in a transport equation.
Base type for a matrix-vector product providing .
Definition: ax.f90:43
A list of boundary conditions.
Definition: bc.f90:104
Coefficients defined on a given (mesh, ) tuple. Arrays use indices (i,j,k,e): element e,...
Definition: coef.f90:55
Type for storing initial and final residuals in a Krylov solver.
Definition: krylov.f90:56
Base abstract type for a canonical Krylov method, solving .
Definition: krylov.f90:66
Defines a canonical Krylov preconditioner.
Definition: precon.f90:40
Implements the logic to compute the time coefficients for the advection and diffusion operators in a ...