47 use json_module,
only : json_file, json_value, json_core
56 use,
intrinsic :: iso_c_binding
60 use mpi_f08,
only : mpi_allreduce, mpi_integer, mpi_sum, mpi_double_precision
66 real(kind=
rp) :: start_time
68 integer :: n_fields = 0
71 integer :: n_global_probes
73 integer :: n_probes_offset
75 real(kind=
rp),
allocatable :: xyz(:,:)
77 real(kind=
rp),
allocatable :: out_values(:,:)
78 type(c_ptr),
allocatable :: out_values_d(:)
79 real(kind=
rp),
allocatable :: out_vals_trsp(:,:)
81 integer :: n_local_probes
84 character(len=20),
allocatable :: which_fields(:)
86 integer,
allocatable :: n_local_probes_tot_offset(:)
87 integer,
allocatable :: n_local_probes_tot(:)
90 real(kind=
rp),
allocatable :: global_output_values(:,:)
98 procedure, pass(this) :: init_from_components => &
129 class(
probes_t),
intent(inout),
target :: this
130 type(json_file),
intent(inout) :: json
131 class(
case_t),
intent(inout),
target :: case
132 character(len=:),
allocatable :: output_file
133 character(len=:),
allocatable :: input_file
137 character(len=:),
allocatable :: point_type
138 type(json_value),
pointer :: json_point_list
139 type(json_file) :: json_point
140 type(json_core) :: core
141 integer :: idx, n_point_children
145 call this%init_base(json,
case)
148 call json%info(
'fields', n_children = this%n_fields)
149 call json_get(json,
'fields', this%which_fields)
150 call json_get(json,
'output_file', output_file)
153 call this%sampled_fields%init(this%n_fields)
154 do i = 1, this%n_fields
156 call this%sampled_fields%assign(i, &
161 this%n_local_probes = 0
162 this%n_global_probes = 0
165 if (json%valid_path(
'points_file'))
then
168 call json_get(json,
'points_file', input_file)
173 this%n_global_probes, input_file)
177 call json%get(
'points', json_point_list)
178 call json%info(
'points', n_children = n_point_children)
180 do idx = 1, n_point_children
184 select case (point_type)
187 call this%read_file(json_point)
189 call this%read_point(json_point)
191 call this%read_line(json_point)
193 call neko_error(
'Plane probes not implemented yet.')
195 call this%read_circle(json_point)
197 call this%read_point_zone(json_point,
case%fluid%dm_Xh)
199 call json_point%print()
202 call neko_error(
'Unknown region type ' // point_type)
206 call mpi_allreduce(this%n_local_probes, this%n_global_probes, 1, &
210 call this%init_from_components(
case%fluid%dm_Xh, output_file)
222 class(
probes_t),
intent(inout) :: this
223 type(json_file),
intent(inout) :: json
224 character(len=:),
allocatable :: input_file
225 real(kind=
rp),
dimension(:,:),
allocatable :: point_list
227 integer :: n_local, n_global
231 call json_get(json,
'file_name', input_file)
235 call this%add_points(point_list)
243 class(
probes_t),
intent(inout) :: this
244 type(json_file),
intent(inout) :: json
246 real(kind=
rp),
dimension(:,:),
allocatable :: point_list
247 real(kind=
rp),
dimension(:),
allocatable :: rp_list_reader
251 call json_get(json,
'coordinates', rp_list_reader)
253 if (mod(
size(rp_list_reader), 3) /= 0)
then
254 call neko_error(
'Invalid number of coordinates.')
258 allocate(point_list(3,
size(rp_list_reader)/3))
259 point_list = reshape(rp_list_reader, [3,
size(rp_list_reader)/3])
261 call this%add_points(point_list)
268 class(
probes_t),
intent(inout) :: this
269 type(json_file),
intent(inout) :: json
271 real(kind=
rp),
dimension(:,:),
allocatable :: point_list
272 real(kind=
rp),
dimension(:),
allocatable :: start,
end
273 real(kind=
rp),
dimension(3) :: direction
276 integer :: n_points, i
282 call json_get(json,
"amount", n_points)
285 if (
size(start) /= 3 .or.
size(
end) /= 3) then
286 call neko_error(
'Invalid start or end coordinates.')
290 allocate(point_list(3, n_points))
293 direction =
end - start
295 t =
real(i - 1, kind = rp) /
real(n_points - 1, kind = rp)
296 point_list(:, i) = start + direction * t
299 call this%add_points(point_list)
312 class(
probes_t),
intent(inout) :: this
313 type(json_file),
intent(inout) :: json
315 real(kind=rp),
dimension(:,:),
allocatable :: point_list
316 real(kind=rp),
dimension(:),
allocatable :: center, normal
317 real(kind=rp) :: radius
318 real(kind=rp) :: angle
319 integer :: n_points, i
320 character(len=:),
allocatable :: axis
322 real(kind=rp),
dimension(3) :: zero_line, cross_line, temp
326 if (pe_rank .ne. 0)
return
327 call json_get(json,
"center", center)
328 call json_get(json,
"normal", normal)
329 call json_get(json,
"radius", radius)
330 call json_get(json,
"amount", n_points)
331 call json_get(json,
"axis", axis)
334 if (
size(center) /= 3 .or.
size(normal) /= 3)
then
335 call neko_error(
'Invalid center or normal coordinates.')
337 if (axis /=
'x' .and. axis /=
'y' .and. axis /=
'z')
then
338 call neko_error(
'Invalid axis.')
340 if (radius <= 0)
then
341 call neko_error(
'Invalid radius.')
343 if (n_points <= 0)
then
344 call neko_error(
'Invalid number of points.')
348 normal = normal / norm2(normal)
351 if (axis .eq.
'x') zero_line = [1.0, 0.0, 0.0]
352 if (axis .eq.
'y') zero_line = [0.0, 1.0, 0.0]
353 if (axis .eq.
'z') zero_line = [0.0, 0.0, 1.0]
355 if (1.0_rp - dot_product(zero_line, normal) .le. 1e-6)
then
356 call neko_error(
'Invalid axis and normal.')
359 zero_line = zero_line - dot_product(zero_line, normal) * normal
360 zero_line = zero_line / norm2(zero_line)
362 cross_line(1) = normal(2) * zero_line(3) - normal(3) * zero_line(2)
363 cross_line(2) = normal(3) * zero_line(1) - normal(1) * zero_line(3)
364 cross_line(3) = normal(1) * zero_line(2) - normal(2) * zero_line(1)
367 allocate(point_list(3, n_points))
369 pi = 4.0_rp * atan(1.0_rp)
373 angle = 2.0_rp * pi *
real(i - 1, kind = rp) /
real(n_points, kind = rp)
374 temp = cos(angle) * zero_line + sin(angle) * cross_line
376 point_list(:, i) = center + radius * temp
379 call this%add_points(point_list)
388 class(
probes_t),
intent(inout) :: this
389 type(json_file),
intent(inout) :: json
390 type(dofmap_t),
intent(in) :: dof
392 real(kind=rp),
dimension(:,:),
allocatable :: point_list
393 character(len=:),
allocatable :: point_zone_name
394 class(point_zone_t),
pointer :: zone
395 integer :: i, idx, lx, nlindex(4)
396 real(kind=rp) :: x, y, z
399 if (pe_rank .ne. 0)
return
401 call json_get(json,
"name", point_zone_name)
402 zone => neko_point_zone_registry%get_point_zone(point_zone_name)
405 allocate(point_list(3, zone%size))
409 idx = zone%mask%get(i)
412 x = dof%x(nlindex(1), nlindex(2), nlindex(3), nlindex(4))
413 y = dof%y(nlindex(1), nlindex(2), nlindex(3), nlindex(4))
414 z = dof%z(nlindex(1), nlindex(2), nlindex(3), nlindex(4))
416 point_list(:, i) = [x, y, z]
419 call this%add_points(point_list)
429 class(
probes_t),
intent(inout) :: this
430 real(kind=rp),
dimension(:,:),
intent(in) :: new_points
432 real(kind=rp),
dimension(:,:),
allocatable :: temp
433 integer :: n_old, n_new
436 n_old = this%n_local_probes
437 n_new =
size(new_points, 2)
440 if (
allocated(this%xyz))
then
441 call move_alloc(this%xyz, temp)
445 allocate(this%xyz(3, n_old + n_new))
446 if (
allocated(temp))
then
447 this%xyz(:, 1:n_old) = temp
449 this%xyz(:, n_old+1:n_old+n_new) = new_points
451 this%n_local_probes = this%n_local_probes + n_new
461 class(
probes_t),
intent(inout) :: this
462 type(dofmap_t),
intent(in) :: dof
463 character(len=:),
allocatable,
intent(inout) :: output_file
464 character(len=1024) :: header_line
465 real(kind=rp),
allocatable :: global_output_coords(:,:)
467 type(matrix_t) :: mat_coords
470 call this%global_interp%init(dof)
473 call this%global_interp%find_points_and_redist(this%xyz, &
477 allocate(this%out_values(this%n_local_probes, this%n_fields))
478 allocate(this%out_values_d(this%n_fields))
479 allocate(this%out_vals_trsp(this%n_fields, this%n_local_probes))
481 if (neko_bcknd_device .eq. 1)
then
482 do i = 1, this%n_fields
483 this%out_values_d(i) = c_null_ptr
484 call device_map(this%out_values(:,i), this%out_values_d(i), &
490 call this%fout%init(trim(output_file))
492 select type (ft => this%fout%file_type)
498 write(header_line,
'(I0,A,I0)') this%n_global_probes,
",", this%n_fields
499 do i = 1, this%n_fields
500 header_line = trim(header_line) //
"," // trim(this%which_fields(i))
502 call this%fout%set_header(header_line)
507 allocate(this%n_local_probes_tot(pe_size))
508 allocate(this%n_local_probes_tot_offset(pe_size))
509 call this%setup_offset()
510 if (pe_rank .eq. 0)
then
511 allocate(global_output_coords(3, this%n_global_probes))
512 call this%mat_out%init(this%n_global_probes, this%n_fields)
513 allocate(this%global_output_values(this%n_fields, &
514 this%n_global_probes))
515 call mat_coords%init(this%n_global_probes,3)
517 call mpi_gatherv(this%xyz, 3*this%n_local_probes, &
518 mpi_double_precision, global_output_coords, &
519 3*this%n_local_probes_tot, &
520 3*this%n_local_probes_tot_offset, &
521 mpi_double_precision, 0, neko_comm, ierr)
522 if (pe_rank .eq. 0)
then
523 call trsp(mat_coords%x, this%n_global_probes, &
524 global_output_coords, 3)
526 call this%fout%write(mat_coords)
529 call neko_error(
"Invalid data. Expected csv_file_t.")
536 class(
probes_t),
intent(inout) :: this
538 if (
allocated(this%xyz))
then
542 if (
allocated(this%out_values))
then
543 deallocate(this%out_values)
546 if (
allocated(this%out_vals_trsp))
then
547 deallocate(this%out_vals_trsp)
550 call this%sampled_fields%free()
552 if (
allocated(this%n_local_probes_tot))
then
553 deallocate(this%n_local_probes_tot)
556 if (
allocated(this%n_local_probes_tot_offset))
then
557 deallocate(this%n_local_probes_tot_offset)
560 if (
allocated(this%global_output_values))
then
561 deallocate(this%global_output_values)
564 call this%global_interp%free()
571 character(len=LOG_SIZE) :: log_buf
575 call neko_log%section(
'Probes')
576 write(log_buf,
'(A,I6)')
"Number of probes: ", this%n_global_probes
577 call neko_log%message(log_buf)
579 call neko_log%message(
"xyz-coordinates:", lvl = neko_log_debug)
580 do i = 1, this%n_local_probes
581 write(log_buf,
'("(",F10.6,",",F10.6,",",F10.6,")")') this%xyz(:,i)
582 call neko_log%message(log_buf, lvl = neko_log_debug)
586 write(log_buf,
'(A,I6)')
"Number of fields: ", this%n_fields
587 call neko_log%message(log_buf)
588 do i = 1, this%n_fields
589 write(log_buf,
'(A,I6,A,A)') &
590 "Field: ", i,
" ", trim(this%which_fields(i))
591 call neko_log%message(log_buf, lvl = neko_log_debug)
593 call neko_log%end_section()
594 call neko_log%newline()
602 character(len=LOG_SIZE) :: log_buf
605 do i = 1, this%n_local_probes
606 write (log_buf, *) pe_rank,
"/", this%global_interp%proc_owner(i), &
607 "/" , this%global_interp%el_owner(i), &
608 "/", this%global_interp%error_code(i)
609 call neko_log%message(log_buf)
610 write(log_buf,
'(A5,"(",F10.6,",",F10.6,",",F10.6,")")') &
611 "rst: ", this%global_interp%rst(:,i)
612 call neko_log%message(log_buf)
620 this%n_local_probes_tot = 0
621 this%n_local_probes_tot_offset = 0
622 this%n_probes_offset = 0
623 call mpi_gather(this%n_local_probes, 1, mpi_integer, &
624 this%n_local_probes_tot, 1, mpi_integer, &
627 call mpi_exscan(this%n_local_probes, this%n_probes_offset, 1, &
628 mpi_integer, mpi_sum, neko_comm, ierr)
629 call mpi_gather(this%n_probes_offset, 1, mpi_integer, &
630 this%n_local_probes_tot_offset, 1, mpi_integer, &
642 class(
probes_t),
intent(inout) :: this
643 type(time_state_t),
intent(in) :: time
647 if (time%t .lt. this%start_time)
return
650 do i = 1, this%n_fields
651 call this%global_interp%evaluate(this%out_values(:,i), &
652 this%sampled_fields%items(i)%ptr%x)
655 if (neko_bcknd_device .eq. 1)
then
656 do i = 1, this%n_fields
657 call device_memcpy(this%out_values(:,i), this%out_values_d(i), &
658 this%n_local_probes, device_to_host, sync = .true.)
662 if (this%output_controller%check(time))
then
665 if (this%seq_io)
then
666 call trsp(this%out_vals_trsp, this%n_fields, &
667 this%out_values, this%n_local_probes)
668 call mpi_gatherv(this%out_vals_trsp, &
669 this%n_fields*this%n_local_probes, &
670 mpi_double_precision, this%global_output_values, &
671 this%n_fields*this%n_local_probes_tot, &
672 this%n_fields*this%n_local_probes_tot_offset, &
673 mpi_double_precision, 0, neko_comm, ierr)
674 if (pe_rank .eq. 0)
then
675 call trsp(this%mat_out%x, this%n_global_probes, &
676 this%global_output_values, this%n_fields)
677 call this%fout%write(this%mat_out, time%t)
680 call neko_error(
'probes sim comp, parallel io need implementation')
684 call this%output_controller%register_execution()
693 class(
probes_t),
intent(inout) :: this
694 character(len=:),
allocatable :: points_file
695 real(kind=rp),
allocatable :: xyz(:,:)
696 integer,
intent(inout) :: n_local_probes, n_global_probes
699 type(file_t) :: file_in
701 call file_in%init(trim(points_file))
703 select type (ft => file_in%file_type)
708 call neko_error(
"Invalid data. Expected csv_file_t.")
712 call file_free(file_in)
722 type(csv_file_t),
intent(inout) :: f
723 real(kind=rp),
allocatable :: xyz(:,:)
724 integer,
intent(inout) :: n_local_probes, n_global_probes
725 type(matrix_t) :: mat_in, mat_in2
728 n_lines = f%count_lines()
731 n_global_probes = n_lines
734 if (pe_rank .eq. 0)
then
735 n_local_probes = n_global_probes
736 allocate(xyz(3, n_local_probes))
737 call mat_in%init(n_global_probes,3)
738 call mat_in2%init(3, n_global_probes)
740 call trsp(xyz, 3, mat_in%x, n_global_probes)
743 allocate(xyz(3, n_local_probes))
__inline__ __device__ void nonlinear_index(const int idx, const int lx, int *index)
Map a Fortran array to a device (allocate and associate)
Copy data between host and device (or device and device)
Retrieves a parameter by name or assigns a provided default value. In the latter case also adds the m...
Retrieves a parameter by name or throws an error.
Defines a simulation case.
integer, public pe_size
MPI size of communicator.
integer, public pe_rank
MPI rank.
type(mpi_comm), public neko_comm
MPI communicator.
File format for .csv files, used for any read/write operations involving floating point data.
Device abstraction, common interface for various accelerators.
integer, parameter, public device_to_host
Defines a mapping of the degrees of freedom.
Defines a registry for storing solution fields.
type(field_registry_t), target, public neko_field_registry
Global field registry.
Module for file I/O operations.
subroutine file_free(this)
File operation destructor.
Implements global_interpolation given a dofmap.
Utilities for retrieving parameters from the case files.
integer, parameter, public neko_log_debug
Debug log level.
type(log_t), public neko_log
Global log stream.
integer, parameter, public log_size
integer, parameter neko_bcknd_device
integer, parameter, public rp
Global precision used in computations.
type(point_zone_registry_t), target, public neko_point_zone_registry
Global point_zone registry.
subroutine read_point_zone(this, json, dof)
Construct a list of points from a point zone.
subroutine read_circle(this, json)
Construct a list of points from a circle.
subroutine add_points(this, new_points)
Append a new list of points to the exsiting list.
subroutine probes_evaluate_and_write(this, time)
Interpolate each probe from its r,s,t coordinates.
subroutine read_line(this, json)
Construct a list of points from a line.
subroutine probes_init_from_components(this, dof, output_file)
Initialize without json things.
subroutine read_probe_locations(this, xyz, n_local_probes, n_global_probes, points_file)
Initialize the physical coordinates from a csv input file.
subroutine read_point(this, json)
Read a list of points from the json file.
subroutine probes_show(this)
Print current probe status, with number of probes and coordinates.
subroutine probes_free(this)
Destructor.
subroutine probes_debug(this)
Show the status of processor/element owner and error code for each point.
subroutine probes_setup_offset(this)
Setup offset for rank 0.
subroutine read_file(this, json)
Read a list of points from a csv file.
subroutine read_xyz_from_csv(xyz, n_local_probes, n_global_probes, f)
Read and initialize the number of probes from a csv input file.
subroutine probes_init_from_json(this, json, case)
Constructor from json.
Simulation components are objects that encapsulate functionality that can be fit to a particular comp...
subroutine compute_(this, time)
Dummy compute function.
subroutine, public trsp(a, lda, b, ldb)
Transpose of a rectangular tensor .
Module with things related to the simulation time.
field_list_t, To be able to group fields together
A wrapper around a polymorphic generic_file_t that handles its init. This is essentially a factory fo...
Implements global interpolation for arbitrary points in the domain.
Base abstract type for point zones.
Base abstract class for simulation components.
A struct that contains all info about the time, expand as needed.