16 use,
intrinsic :: iso_c_binding
20 use mpi_f08,
only : mpi_allreduce, mpi_integer, mpi_sum, mpi_exscan
26 integer :: nelv_2d = 0
27 integer :: glb_nelv_2d = 0
28 integer :: offset_el_2d = 0
31 integer,
allocatable :: idx_2d(:)
32 integer,
allocatable :: el_idx_2d(:)
36 type(
coef_t),
pointer :: coef => null()
42 real(kind=
rp) :: domain_height
47 generic :: init => init_int, init_char
50 generic :: average => average_list, average_file
56 class(
map_2d_t),
intent(inout) :: this
57 type(
coef_t),
intent(inout),
target :: coef
58 integer,
intent(in) :: dir
59 real(kind=
rp),
intent(in) :: tol
60 real(kind=
rp) :: el_dim(3,3), el_h
61 integer :: i, e, j, ierr, k, lx, lxy, n
62 call this%map_1d%init(coef,dir,tol)
67 call this%u%init(this%dof)
68 call this%old_u%init(this%dof)
69 call this%avg_u%init(this%dof)
70 call this%el_heights%init(this%dof)
77 do i = 1, this%msh%nelv
78 if (this%map_1d%el_lvl(i) .eq. 1)
then
79 this%nelv_2d = this%nelv_2d + 1
83 call mpi_allreduce(this%nelv_2d, this%glb_nelv_2d, 1, &
87 call mpi_exscan(this%nelv_2d, this%offset_el_2d, 1, &
89 allocate(this%el_idx_2d(this%nelv_2d))
90 do i = 1, this%nelv_2d
91 this%el_idx_2d(i) = this%offset_el_2d + i
93 this%n_2d = this%nelv_2d*lxy
94 allocate(this%idx_2d(this%n_2d))
97 do e = 1, this%msh%nelv
98 if (this%map_1d%el_lvl(e) .eq. 1)
then
99 if (this%map_1d%dir_el(e) .eq. 1)
then
104 if (this%map_1d%dir_el(e) .eq. 2)
then
107 this%idx_2d(j*lxy+k+lx*(i-1)) =
linear_index(k,1,i,e,lx,lx,lx)
111 if (this%map_1d%dir_el(e) .eq. 3)
then
119 do i = 1, this%msh%nelv
124 el_dim(1,:) = abs(this%msh%elements(i)%e%pts(1)%p%x-&
125 this%msh%elements(i)%e%pts(2)%p%x)
126 el_dim(2,:) = abs(this%msh%elements(i)%e%pts(1)%p%x-&
127 this%msh%elements(i)%e%pts(3)%p%x)
128 el_dim(3,:) = abs(this%msh%elements(i)%e%pts(1)%p%x-&
129 this%msh%elements(i)%e%pts(5)%p%x)
131 el_h = el_dim(this%map_1d%dir_el(i),dir)
132 this%el_heights%x(:,:,:,i) = el_h
137 call copy(this%u%x,this%el_heights%x,n)
138 call copy(this%old_u%x,this%el_heights%x,n)
139 call copy(this%avg_u%x,this%el_heights%x,n)
141 this%map_1d%n_el_lvls, &
142 this%map_1d%dir_el,this%coef%gs_h, this%coef%mult, this%msh%nelv, lx)
143 this%domain_height = this%u%x(1,1,1,1)
149 type(
coef_t),
intent(inout),
target :: coef
150 character(len=*),
intent(in) :: dir
151 real(kind=
rp),
intent(in) :: tol
154 if (trim(dir) .eq.
'x')
then
156 else if (trim(dir) .eq.
'y')
then
158 else if (trim(dir) .eq.
'z')
then
161 call neko_error(
'Direction not supported, map_2d')
164 call this%init(coef,idir,tol)
169 class(
map_2d_t),
intent(inout) :: this
171 if (
allocated(this%idx_2d))
then
172 deallocate(this%idx_2d)
175 if (
allocated(this%el_idx_2d))
then
176 deallocate(this%el_idx_2d)
190 class(
map_2d_t),
intent(inout) :: this
193 real(kind=
rp),
pointer,
contiguous,
dimension(:,:,:,:) :: x_ptr, y_ptr
197 integer :: i, j, lx, lxy
199 call fld_data2d%init(this%nelv_2d, this%offset_el_2d)
201 fld_data2d%lx = this%dof%Xh%lx
202 fld_data2d%ly = this%dof%Xh%ly
205 fld_data2d%glb_nelv = this%glb_nelv_2d
206 lxy = fld_data2d%lx*fld_data2d%ly
207 n_2d = lxy*this%nelv_2d
209 call fld_data2d%x%init(n_2d)
210 call fld_data2d%y%init(n_2d)
211 allocate(fld_data2d%idx(this%nelv_2d))
213 if (this%dir .eq. 1)
then
217 if (this%dir .eq. 2)
then
221 if (this%dir .eq. 3)
then
225 do j = 1, this%nelv_2d
226 fld_data2d%idx(j) = this%el_idx_2d(j)
229 fld_data2d%x%x(j) = x_ptr(this%idx_2d(j),1,1,1)
230 fld_data2d%y%x(j) = y_ptr(this%idx_2d(j),1,1,1)
232 allocate(fields2d(fld_data3d%size()))
234 call fld_data2d%init_n_fields(fld_data3d%size(), n_2d)
238 do i = 1, fld_data3d%size()
239 call copy(this%old_u%x, fld_data3d%items(i)%ptr%x, n)
241 this%el_heights, this%domain_height, &
242 this%map_1d%dir_el, this%coef, this%msh%nelv, lx)
243 call copy(this%old_u%x, this%u%x, n)
244 call copy(this%avg_u%x, this%u%x, n)
246 this%old_u, this%map_1d%n_el_lvls, &
247 this%map_1d%dir_el,this%coef%gs_h, this%coef%mult, &
249 call copy(fld_data3d%items(i)%ptr%x, this%u%x, n)
251 call fld_data2d%get_list(fields2d, fld_data2d%size())
252 do i = 1, fld_data3d%size()
254 fields2d(i)%ptr%x(j) = fld_data3d%items(i)%ptr%x(this%idx_2d(j),1,1,1)
266 class(
map_2d_t),
intent(inout) :: this
269 real(kind=
rp),
pointer,
dimension(:,:,:,:) :: x_ptr, y_ptr
271 type(
vector_ptr_t),
allocatable :: fields3d(:), fields2d(:)
273 integer :: i, j, lx, lxy
275 call fld_data2d%init(this%nelv_2d, this%offset_el_2d)
277 fld_data2d%lx = this%dof%Xh%lx
278 fld_data2d%ly = this%dof%Xh%ly
281 fld_data2d%glb_nelv = this%glb_nelv_2d
282 lxy = fld_data2d%lx*fld_data2d%ly
283 n_2d = lxy*this%nelv_2d
285 call fld_data2d%x%init(n_2d)
286 call fld_data2d%y%init(n_2d)
287 allocate(fld_data2d%idx(n_2d))
289 if (this%dir .eq. 1)
then
293 if (this%dir .eq. 2)
then
297 if (this%dir .eq. 3)
then
302 fld_data2d%idx(j) = this%idx_2d(j)
303 fld_data2d%x%x(j) = x_ptr(this%idx_2d(j),1,1,1)
304 fld_data2d%y%x(j) = y_ptr(this%idx_2d(j),1,1,1)
306 allocate(fields3d(fld_data3d%size()))
307 allocate(fields2d(fld_data3d%size()))
309 call fld_data2d%init_n_fields(fld_data3d%size(), n_2d)
310 call fld_data3d%get_list(fields3d,fld_data3d%size())
315 do i = 1, fld_data3d%size()
316 call copy(this%old_u%x, fields3d(i)%ptr%x, n)
318 this%el_heights, this%domain_height, &
319 this%map_1d%dir_el, this%coef, this%msh%nelv, lx)
320 call copy(this%old_u%x, this%u%x,n)
321 call copy(this%avg_u%x, this%u%x,n)
323 this%old_u, this%map_1d%n_el_lvls, &
324 this%map_1d%dir_el, this%coef%gs_h,&
325 this%coef%mult, this%msh%nelv, lx)
326 call copy(fields3d(i)%ptr%x, this%u%x, n)
328 call fld_data2d%get_list(fields2d, fld_data2d%size())
329 do i = 1, fld_data3d%size()
331 fields2d(i)%ptr%x(j) = fields3d(i)%ptr%x(this%idx_2d(j))
337 hom_dir_el, gs_h, mult, nelv, lx)
338 type(
field_t),
intent(inout) :: u, avg_u, old_u
339 type(
gs_t),
intent(inout) :: gs_h
340 integer,
intent(in) :: n_levels, nelv, lx
341 integer,
intent(in) :: hom_dir_el(nelv)
342 real(kind=
rp),
intent(in) :: mult(nelv*lx**3)
343 real(kind=
rp) :: temp_el(lx,lx,lx)
344 integer :: n, i, j, e
353 call gs_h%op(u,gs_op_add)
356 call col2(u%x,mult,n)
359 temp_el = 2.0*u%x(:,:,:,e)-old_u%x(:,:,:,e)
360 if (hom_dir_el(e) .eq. 1)
then
361 u%x(1,:,:,e) = temp_el(lx,:,:)
362 avg_u%x(1,:,:,e) = avg_u%x(1,:,:,e)+temp_el(1,:,:)
363 u%x(lx,:,:,e) = temp_el(1,:,:)
364 else if (hom_dir_el(e) .eq. 2)
then
365 u%x(:,1,:,e) = temp_el(:,lx,:)
366 avg_u%x(:,1,:,e) = avg_u%x(:,1,:,e)+temp_el(:,1,:)
367 u%x(:,lx,:,e) = temp_el(:,1,:)
368 else if (hom_dir_el(e) .eq. 3)
then
369 u%x(:,:,1,e) = temp_el(:,:,lx)
370 avg_u%x(:,:,1,e) = avg_u%x(:,:,1,e)+temp_el(:,:,1)
371 u%x(:,:,lx,e) = temp_el(:,:,1)
373 old_u%x(:,:,:,e) = u%x(:,:,:,e)
379 if (hom_dir_el(e) .eq. 1)
then
380 u%x(:,i,j,e) = avg_u%x(1,i,j,e)
381 else if (hom_dir_el(e) .eq. 2)
then
382 u%x(i,:,j,e) = avg_u%x(i,1,j,e)
383 else if (hom_dir_el(e) .eq. 3)
then
384 u%x(i,j,:,e) = avg_u%x(i,j,1,e)
392 hom_dir_el, coef, nelv, lx)
393 type(
field_t),
intent(inout) :: u, u_out, el_heights
394 type(
coef_t),
intent(inout) :: coef
395 integer,
intent(in) :: nelv, lx
396 integer,
intent(in) :: hom_dir_el(nelv)
397 real(kind=
rp),
intent(in) :: domain_height
399 integer :: n, i, j, e, k
403 call col2(u%x,el_heights%x,n)
404 call cmult(u%x, 1.0_rp/(2.0*domain_height),n)
405 call rzero(u_out%x,n)
413 if (hom_dir_el(e) .eq. 1)
then
414 u_out%x(1,i,j,e) = u_out%x(1,i,j,e)+wt*u%x(k,i,j,e)
415 else if (hom_dir_el(e) .eq. 2)
then
416 u_out%x(i,1,j,e) = u_out%x(i,1,j,e)+wt*u%x(i,k,j,e)
417 else if (hom_dir_el(e) .eq. 3)
then
418 u_out%x(i,j,1,e) = u_out%x(i,j,1,e)+wt*u%x(i,j,k,e)
428 if (hom_dir_el(e) .eq. 1)
then
429 u_out%x(:,i,j,e) = u_out%x(1,i,j,e)
430 else if (hom_dir_el(e) .eq. 2)
then
431 u_out%x(i,:,j,e) = u_out%x(i,1,j,e)
432 else if (hom_dir_el(e) .eq. 3)
then
433 u_out%x(i,j,:,e) = u_out%x(i,j,1,e)
Copy data between host and device (or device and device)
type(mpi_comm), public neko_comm
MPI communicator.
Device abstraction, common interface for various accelerators.
integer, parameter, public host_to_device
integer, parameter, public device_to_host
Defines a mapping of the degrees of freedom.
Simple module to handle fld file series. Provides an interface to the different fields sotred in a fl...
Creates a 1d GLL point map along a specified direction based on the connectivity in the mesh.
Maps a 3D dofmap to a 2D spectral element grid.
subroutine map_2d_free(this)
subroutine perform_local_summation(u_out, u, el_heights, domain_height, hom_dir_el, coef, nelv, lx)
subroutine perform_global_summation(u, avg_u, old_u, n_levels, hom_dir_el, gs_h, mult, nelv, lx)
subroutine map_2d_init(this, coef, dir, tol)
subroutine map_2d_init_char(this, coef, dir, tol)
subroutine map_2d_average_field_list(this, fld_data2d, fld_data3d)
Computes average if field list in one direction and outputs 2D field with averaged values.
subroutine map_2d_average(this, fld_data2d, fld_data3d)
Computes average if field list in one direction and outputs 2D field with averaged values.
subroutine, public cmult(a, c, n)
Multiplication by constant c .
subroutine, public col2(a, b, n)
Vector multiplication .
subroutine, public copy(a, b, n)
Copy a vector .
subroutine, public rzero(a, n)
Zero a real vector.
integer, parameter neko_bcknd_device
integer, parameter, public rp
Global precision used in computations.
pure integer function, public linear_index(i, j, k, l, lx, ly, lz)
Compute the address of a (i,j,k,l) array with sizes (1:lx, 1:ly, 1:lz, :)
Coefficients defined on a given (mesh, ) tuple. Arrays use indices (i,j,k,e): element e,...
field_list_t, To be able to group fields together
Type that encapsulates a mapping from each gll point in the mesh to its corresponding (global) GLL po...