MPAS-JEDI
mpasjedi_getvalues_mod.F90
Go to the documentation of this file.
1 ! (C) Copyright 2020 UCAR
2 !
3 ! This software is licensed under the terms of the Apache Licence Version 2.0
4 ! which can be obtained at http://www.apache.org/licenses/LICENSE-2.0.
5 
7 
8 use iso_c_binding
9 
10 ! fckit
11 use fckit_mpi_module, only: fckit_mpi_sum
12 use fckit_configuration_module, only: fckit_configuration
13 
14 ! oops
15 use datetime_mod, only: datetime
16 use kinds, only: kind_real
17 use unstructured_interpolation_mod
18 
19 ! saber
20 use interpolatorbump_mod, only: bump_interpolator
21 
22 ! ufo
23 use ufo_locations_mod
24 use ufo_geovals_mod, only: ufo_geovals
25 use ufo_vars_mod
26 
27 !MPAS-Model
28 use mpas_constants
29 use mpas_derived_types
30 use mpas_field_routines
31 use mpas_kind_types, only: strkind
32 use mpas_pool_routines
33 use mpas_dmpar, only: mpas_dmpar_exch_halo_field
35 
36 
37 !mpas-jedi
39 use mpas_geom_mod
40 !use mpas_fields_mod
43 use mpas4da_mod
44 
45 ! --------------------------------------------------------------------------------------------------
46 
47 implicit none
48 private
52 
53 type, abstract :: mpasjedi_getvalues_base
54  private
55  logical, public :: use_bump_interp
56  type(bump_interpolator), public :: bumpinterp
57  type(unstrc_interp), public :: unsinterp
58  contains
59  procedure :: initialize_uns_interp
60  procedure, public :: fill_geovals
61  generic, public :: set_trajectory => fill_geovals
65 
67  private
68  contains
69  procedure, public :: create
70  procedure, public :: delete
71 end type mpasjedi_getvalues
72 
73 #define LISTED_TYPE mpasjedi_getvalues
74 
75 !> Linked list interface - defines registry_t type
76 #include <oops/util/linkedList_i.f>
77 
78 !> Global registry
79 type(registry_t) :: mpas_getvalues_registry
80 
81 ! --------------------------------------------------------------------------------------------------
82 
83 character (len=1024) :: message
84 
85 contains
86 
87 ! --------------------------------------------------------------------------------------------------
88 !> Linked list implementation
89 #include <oops/util/linkedList_c.f>
90 
91 ! ------------------------------------------------------------------------------
92 
93 ! -----------------------------------------------------------------------------
94 !> \brief GetValues base class 'create' logic
95 !!
96 !! \details **getvalues_base_create** This subroutine populates the getvalues_base
97 !! class members. This subroutine is called from the 'create' subroutines of all
98 !! derived classes. (i.e. getvalues and lineargetvalues)
99 subroutine getvalues_base_create(self, geom, locs, f_conf)
100  implicit none
101  class(mpasjedi_getvalues_base), intent(inout) :: self !< getvalues_base self
102  type(mpas_geom), intent(in) :: geom !< geometry (mpas mesh)
103  type(ufo_locations), intent(in) :: locs !< ufo geovals (obs) locations
104  type(fckit_configuration), intent(in) :: f_conf !< configuration
105 
106  real(kind=kind_real), allocatable :: lons(:), lats(:)
107  integer :: nlocs
108  character (len=:), allocatable :: interp_type
109 
110  nlocs = locs%nlocs()
111  allocate(lons(nlocs), lats(nlocs))
112  call locs%get_lons(lons)
113  call locs%get_lats(lats)
114 
115  if (f_conf%get("interpolation type", interp_type)) then
116  select case (interp_type)
117  case ('bump')
118  self%use_bump_interp = .true.
119  case ('unstructured')
120  self%use_bump_interp = .false.
121  case default
122  write(message,*) '--> getvalues_base_create: interpolation type: ',interp_type,' not implemented'
123  call abor1_ftn(message)
124  end select
125  else
126  self%use_bump_interp = .true. ! BUMP is default interpolation
127  end if
128 
129  if (self%use_bump_interp) then
130  call self%bumpinterp%init(geom%f_comm, afunctionspace_in=geom%afunctionspace, lon_out=lons, lat_out=lats, &
131  & nl=geom%nVertLevels)
132  else
133  call initialize_uns_interp(self, geom, lats, lons)
134  endif
135 
136  if (allocated(interp_type)) deallocate(interp_type)
137  deallocate(lons, lats)
138 
139 end subroutine getvalues_base_create
140 
141 ! --------------------------------------------------------------------------------------------------
142 
143 !> \brief GetValues class 'create' logic
144 !!
145 !! \details **create** This subroutine contstructs an mpasjedi_getvalues object
146 !! class instance.
147 subroutine create(self, geom, locs, f_conf)
148  implicit none
149  class(mpasjedi_getvalues), intent(inout) :: self !< getvalues self
150  type(mpas_geom), intent(in) :: geom !< geometry (mpas mesh)
151  type(ufo_locations), intent(in) :: locs !< ufo geovals (obs) locations
152  type(fckit_configuration), intent(in) :: f_conf !< configuration
153  call getvalues_base_create(self, geom, locs, f_conf)
154 end subroutine create
155 
156 ! --------------------------------------------------------------------------------------------------
157 
158 !> \brief GetValues base class 'delete' logic
159 !!
160 !! \details **getvalues_base_delete** This subroutine deletes (frees memory) for
161 !! the getvalues_base class members. This subroutine is called from the 'delete'
162 !! subroutines of all derived classes. (i.e. getvalues and lineargetvalues)
163 subroutine getvalues_base_delete(self)
164  class(mpasjedi_getvalues_base), intent(inout) :: self !< getvalues_base self
165  if (self%use_bump_interp) then
166  call self%bumpinterp%delete()
167  else
168  call self%unsinterp%delete()
169  endif
170 end subroutine getvalues_base_delete
171 
172 ! --------------------------------------------------------------------------------------------------
173 
174 !> \brief GetValues class 'delete' logic
175 !!
176 !! \details **delete** This subroutine deletes (frees memory) for an mpasjedi_getvalues object
177 !! class instance.
178 subroutine delete(self)
179  class(mpasjedi_getvalues), intent(inout) :: self !< getvalues self
180  call getvalues_base_delete(self)
181 end subroutine delete
182 
183 ! --------------------------------------------------------------------------------------------------
184 
185 !> \brief Interpolates from geovar mpas_fields to populate ufo_geovals
186 !!
187 !! \details **fill_geovals** This subroutine populates the variables in a
188 !! ufo_geovals object by interpolating the state variables in an mpas_fields object.
189 !! This is the non-linear subroutine used in both GetValues and LinearGetValues classes
190 subroutine fill_geovals(self, geom, state, t1, t2, locs, gom)
191  implicit none
192  class(mpasjedi_getvalues_base), intent(inout) :: self !< getvalues_base self
193  type(mpas_geom), intent(in) :: geom !< geometry (mpas mesh)
194  type(mpas_fields), intent(in) :: state !< state containing geovars
195  type(datetime), intent(in) :: t1 !< time window begin
196  type(datetime), intent(in) :: t2 !< time window end
197  type(ufo_locations), intent(in) :: locs !< observation locations
198  type(ufo_geovals), intent(inout) :: gom !< geovals
199 
200  logical(c_bool), allocatable :: time_mask(:)
201  integer :: jvar, jlev, ilev, jloc, ndims
202  integer :: ncells, maxlevels, nlevels, nlocs, nlocsg
203  integer, allocatable ::obs_field_int(:,:)
204  real(kind=kind_real), allocatable :: mod_field(:,:), obs_field(:,:)
205 
206  character(len=MAXVARLEN) :: geovar
207 
208  type(mpas_pool_iterator_type) :: poolitr
209  real(kind=kind_real), pointer :: ptrr1(:)
210  real(kind=kind_real), pointer :: ptrr2(:,:)
211  integer, pointer :: ptri1(:)
212  integer, pointer :: ptri2(:,:)
213 
214  ! Get grid dimensions and checks
215  ! ------------------------------
216  ncells = geom % nCellsSolve
217  nlocs = locs % nlocs() ! # of location for entire window
218 
219  ! If no observations can early exit
220  ! ---------------------------------
221  call geom%f_comm%allreduce(nlocs,nlocsg,fckit_mpi_sum())
222  if (nlocsg == 0) then
223  return
224  endif
225 
226  ! Get mask for locations in this time window
227  ! ------------------------------------------
228  allocate(time_mask(nlocs))
229  call locs%get_timemask(t1, t2, time_mask)
230 
231  ! Interpolate state to obs locations using pre-calculated weights
232  ! ----------------------------------------------------------------
233  maxlevels = geom%nVertLevelsP1
234  allocate(mod_field(ncells,maxlevels))
235  allocate(obs_field(nlocs,maxlevels))
236  allocate(obs_field_int(nlocs,1))
237 
238  call mpas_pool_begin_iteration(state%subFields)
239  do while ( mpas_pool_get_next_member(state%subFields, poolitr) )
240  if (poolitr % memberType == mpas_pool_field) then
241 
242  geovar = trim(poolitr % memberName)
243  ndims = poolitr % nDims
244 
245  jvar = ufo_vars_getindex(gom%variables, geovar)
246  if ( jvar < 1 ) cycle
247 
248  if (poolitr % dataType == mpas_pool_real) then
249  nlevels = gom%geovals(jvar)%nval
250 
251  if (ndims == 1) then
252  call state%get(geovar, ptrr1)
253  mod_field(:,1) = ptrr1(1:ncells)
254  else if (ndims == 2) then
255  call state%get(geovar, ptrr2)
256  mod_field(:,1:nlevels) = transpose(ptrr2(1:nlevels,1:ncells))
257  else
258  write(message,*) '--> fill_geovals: nDims == ',ndims,' not handled for reals'
259  call abor1_ftn(message)
260  endif
261 
262  !TODO: make a generic self%apply that encapsulates all this logic and looping:
263  ! call self%apply(mod_field(:,1:nlevels), obs_field(:,1:nlevels), nlevels, nCells, nlocs)
264 
265  if (self%use_bump_interp) then
266  call self%bumpinterp%apply(mod_field(1:ncells,1:nlevels), &
267  obs_field(:,1:nlevels), &
268  trans_in=.false.)
269  else
270  do jlev = 1, nlevels
271  call self%unsinterp%apply(mod_field(:,jlev), &
272  obs_field(:,jlev))
273  end do
274  endif
275  do jloc = 1, nlocs
276  if (time_mask(jloc)) then
277  do jlev = 1, nlevels
278  !BJJ-tmp vertical flip, top-to-bottom for CRTM geoval
279  ilev = nlevels - jlev + 1
280  gom%geovals(jvar)%vals(ilev,jloc) = obs_field(jloc,jlev)
281  end do
282  endif
283  end do
284  else if (poolitr % dataType == mpas_pool_integer) then
285  if (ndims == 1) then
286  call state%get(geovar, ptri1)
287  mod_field(:,1) = real(ptri1(1:ncells), kind_real)
288  else
289  write(message,*) '--> fill_geovals: nDims == ',ndims,' not handled for integers'
290  call abor1_ftn(message)
291  endif
292 
293  jvar = ufo_vars_getindex(gom%variables, poolitr % memberName)
294  if (self%use_bump_interp) then
295  call self%integer_interpolation_bump(ncells, nlocs, &
296  ptri1, obs_field_int, gom, jvar, time_mask)
297  else
298  call self%integer_interpolation_unstructured(ncells, nlocs, &
299  ptri1, mod_field(:,1), gom, jvar, time_mask)
300  endif
301  end if
302 
303  endif
304  end do !- end of pool iteration
305  deallocate(mod_field)
306  deallocate(obs_field)
307  deallocate(obs_field_int)
308  deallocate(time_mask)
309 
310 end subroutine fill_geovals
311 
312 ! --------------------------------------------------------------------------------------------------
313 
314 !> \brief Initializes an unstructured interpolation type
315 !!
316 !! \details **initialize_uns_interp** This subroutine calls unsinterp%create,
317 !! which calculates the barycentric weights used to interpolate data between the
318 !! mpas mesh locations (grid) and the observation locations.
319 subroutine initialize_uns_interp(self, grid, lats_obs, lons_obs)
320 
321  implicit none
322  class(mpasjedi_getvalues_base), intent(inout) :: self !< self
323  type(mpas_geom), intent(in) :: grid !< mpas mesh data
324  real(kind=kind_real), allocatable, intent(in) :: lats_obs(:) !< latitudes of obs
325  real(kind=kind_real), allocatable, intent(in) :: lons_obs(:) !< longitudes of obs
326 
327  integer :: nn, ngrid_in
328  character(len=8) :: wtype = 'barycent'
329  real(kind=kind_real), allocatable :: lats_in(:), lons_in(:)
330 
331  ! Get the Solution dimensions
332  ! ---------------------------
333  ngrid_in = grid%nCellsSolve
334 
335  !Calculate interpolation weight
336  !------------------------------------------
337  allocate( lats_in(ngrid_in) )
338  allocate( lons_in(ngrid_in) )
339  lats_in(:) = grid%latCell( 1:ngrid_in ) * mpas_jedi_rad2deg_kr !- to Degrees
340  lons_in(:) = grid%lonCell( 1:ngrid_in ) * mpas_jedi_rad2deg_kr !- to Degrees
341 
342  ! Initialize unsinterp
343  ! ---------------
344  nn = 3 ! number of nearest neigbors
345  call self%unsinterp%create(grid%f_comm, nn, wtype, &
346  ngrid_in, lats_in, lons_in, &
347  size(lats_obs), lats_obs, lons_obs)
348 
349  ! Release memory
350  ! --------------
351  deallocate(lats_in)
352  deallocate(lons_in)
353 
354 end subroutine initialize_uns_interp
355 
356 ! ------------------------------------------------------------------------------
357 
358 !> \brief Performs interpolation of integer fields using BUMP
359 !!
360 !! \details **integer_interpolation_bump** This subroutine performs the interpolation
361 !! of integer-valued fields (i.e. types) using BUMP
362 subroutine integer_interpolation_bump(self, ngrid, nlocs, &
363  data_in, obs_field_int, gom, jvar, time_mask)
364  implicit none
365 
366  class(mpasjedi_getvalues_base), intent(inout) :: self !< self
367  integer, intent(in) :: ngrid !< number of cells in model mesh
368  integer, intent(in) :: nlocs !< number of locations for obs
369  integer, dimension(:), intent(in) :: data_in !< data to interpolate
370  integer, allocatable, intent(inout) :: obs_field_int(:,:) !< output array of interpolated data
371  type(ufo_geovals), intent(inout) :: gom !< output geoVaLs
372  integer, intent(in) :: jvar !< gom % geovals index
373  logical(c_bool), intent(in) :: time_mask(nlocs) !< mask for time window
374 
375  integer :: jloc
376 
377  ! This code assumes time_mask already allocated to size nlocs and poplulated earlier.
378 
379  ! by default, bumpinterp%apply uses nearest neighbor interpolation for integer types
380  call self%bumpinterp%apply(data_in(1:ngrid), obs_field_int)
381  do jloc = 1, nlocs
382  if (time_mask(jloc)) then
383 ! JJG: apply was here, but moved outside loop as it should only get called once
384 ! call self%bumpinterp%apply(data_in(1:ngrid), obs_field_int)
385  gom%geovals(jvar)%vals(1,jloc) = real(obs_field_int(jloc,1), kind_real)
386  endif
387  enddo
388 
389 end subroutine integer_interpolation_bump
390 
391 ! ------------------------------------------------------------------------------
392 
393 !> \brief Performs interpolation of integer fields using unstructured interpolation
394 !!
395 !! \details **integer_interpolation_unstructured** This subroutine performs the interpolation
396 !! of integer-valued fields (i.e. types) using unstructured interpolation
397 subroutine integer_interpolation_unstructured(self, ngrid, nlocs, &
398  data_in, work_field, gom, jvar, time_mask)
399  implicit none
400 
401  class(mpasjedi_getvalues_base), intent(inout) :: self !< self
402  integer, intent(in) :: ngrid !< number of cells in model mesh
403  integer, intent(in) :: nlocs !< number of locations for obs
404  integer, dimension(:), intent(in) :: data_in !< data to interpolate
405  real(kind=kind_real), intent(inout) :: work_field(ngrid) !< (ngrid,1) array
406  type(ufo_geovals), intent(inout) :: gom !< output geoVaLs
407  integer, intent(in) :: jvar !< gom % geovals index
408  logical(c_bool), intent(in) :: time_mask(nlocs) !< mask for time window
409 
410  integer :: jloc
411  real(kind=kind_real), dimension(nlocs) :: interpolated_data
412 
413  ! This code assumes time_mask already allocated to size nlocs and poplulated earlier.
414  ! Also, that work_field already allocated to size (ngrid, 1)
415 
416  work_field = real(data_in(1:ngrid), kind_real)
417  call unsinterp_integer_apply(self%unsinterp, work_field, interpolated_data)
418  do jloc = 1, nlocs
419  if (time_mask(jloc)) then
420  gom%geovals(jvar)%vals(1,jloc) = interpolated_data(jloc)
421  endif
422  enddo
423 
425 
426 end module mpasjedi_getvalues_mod
real(kind=kind_real), parameter mpas_jedi_rad2deg_kr
subroutine integer_interpolation_bump(self, ngrid, nlocs, data_in, obs_field_int, gom, jvar, time_mask)
Performs interpolation of integer fields using BUMP.
subroutine integer_interpolation_unstructured(self, ngrid, nlocs, data_in, work_field, gom, jvar, time_mask)
Performs interpolation of integer fields using unstructured interpolation.
subroutine create(self, geom, locs, f_conf)
GetValues class 'create' logic.
subroutine, public getvalues_base_create(self, geom, locs, f_conf)
Linked list implementation.
type(registry_t), public mpas_getvalues_registry
Linked list interface - defines registry_t type.
subroutine, public fill_geovals(self, geom, state, t1, t2, locs, gom)
Interpolates from geovar mpas_fields to populate ufo_geovals.
subroutine, public getvalues_base_delete(self)
GetValues base class 'delete' logic.
subroutine delete(self)
GetValues class 'delete' logic.
subroutine initialize_uns_interp(self, grid, lats_obs, lons_obs)
Initializes an unstructured interpolation type.
subroutine, public unsinterp_integer_apply(unsinterp, field_in, field_out)
Fortran derived type to hold MPAS field.
Fortran derived type to hold geometry definition.