OOPS
qg_error_covariance_mod.F90
Go to the documentation of this file.
1 ! (C) Copyright 2009-2016 ECMWF.
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 ! In applying this licence, ECMWF does not waive the privileges and immunities
6 ! granted to it by virtue of its status as an intergovernmental organisation nor
7 ! does it submit to any jurisdiction.
8 
10 
11 use fckit_configuration_module, only: fckit_configuration
12 use fckit_log_module, only: fckit_log
13 use fft_mod
14 use iso_c_binding
15 use kinds
16 !$ use omp_lib
19 use qg_fields_mod
20 use qg_geom_mod
21 use random_mod
22 
23 implicit none
24 
25 private
30 ! ------------------------------------------------------------------------------
32  integer :: nx !< Number of points in the zonal direction
33  integer :: ny !< Number of points in the meridional direction
34  integer :: nz !< Number of vertical levels
35  real(kind_real) :: sigma !< Standard deviation
36  real(kind_real),allocatable :: sqrt_zonal(:) !< Spectral weights for the spectral of the zonal correlation matrix
37  real(kind_real),allocatable :: sqrt_merid(:,:) !< Square-root of the meridional correlation matrix
38  real(kind_real),allocatable :: sqrt_vert(:,:) !< Square-root of the meridional correlation matrix
39  real(kind_real),allocatable :: norm(:,:) !< Normalization factor
41 
42 real(kind_real),parameter :: eps_ad = 1.0e-10 !< Epsilon value for adjoint tests
43 
44 #define LISTED_TYPE qg_error_covariance_config
45 
46 !> Linked list interface - defines registry_t type
47 #include "oops/util/linkedList_i.f"
48 
49 !> Global registry
50 type(registry_t) :: qg_error_covariance_registry
51 ! ------------------------------------------------------------------------------
52 contains
53 ! ------------------------------------------------------------------------------
54 ! Public
55 ! ------------------------------------------------------------------------------
56 !> Linked list implementation
57 #include "oops/util/linkedList_c.f"
58 ! ------------------------------------------------------------------------------
59 !> Setup error covariance matrix
60 subroutine qg_error_covariance_setup(self,f_conf,geom)
61 
62 implicit none
63 
64 ! Passed variables
65 type(qg_error_covariance_config),intent(inout) :: self !< Error covariance configuration
66 type(fckit_configuration),intent(in) :: f_conf !< FCKIT configuration
67 type(qg_geom),intent(in) :: geom !< Geometry
68 
69 ! Local variables
70 integer :: ix,iy,jy,ky,iz,jz,kz,info
71 real(kind_real) :: horizontal_length_scale,vertical_length_scale
72 real(kind_real) :: distx,condition_number,threshold
73 real(kind_real),allocatable :: struct_fn(:),workx(:)
74 real(kind_real),allocatable :: evalsy(:),worky(:),evectsy(:,:),revalsy(:)
75 real(kind_real),allocatable :: evalsz(:),workz(:),evectsz(:,:),revalsz(:)
76 real(kind_real),allocatable :: norm(:,:)
77 character(len=160) :: record
78 type(qg_fields) :: fld_in,fld_out
79 type(oops_variables) :: vars
80 
81 ! Get parameters
82 call f_conf%get_or_die("standard_deviation",self%sigma)
83 call f_conf%get_or_die("horizontal_length_scale",horizontal_length_scale)
84 call f_conf%get_or_die("vertical_length_scale",vertical_length_scale)
85 call f_conf%get_or_die("maximum_condition_number",condition_number)
86 
87 ! Check nx
88 if (mod(geom%nx,2)/=0) then
89  write(record,*) 'qg_error_covariance_setup: number of zonal gridpoints nx=',geom%nx
90  call fckit_log%error(record)
91  call abor1_ftn('qg_error_covariance_setup: odd number of zonal grid points')
92 endif
93 
94 ! Copy grid size
95 self%nx = geom%nx
96 self%ny = geom%ny
97 self%nz = geom%nz
98 
99 ! Allocation
100 allocate(self%sqrt_merid(geom%ny,geom%ny))
101 allocate(self%sqrt_vert(geom%nz,geom%nz))
102 allocate(self%norm(geom%ny,geom%nz))
103 allocate(struct_fn(geom%nx))
104 allocate(workx(geom%nx+2))
105 allocate(self%sqrt_zonal(0:geom%nx/2))
106 allocate(evectsy(geom%ny,geom%ny))
107 allocate(evalsy(geom%ny))
108 allocate(worky((geom%ny+3)*geom%ny))
109 allocate(revalsy(geom%ny))
110 allocate(evectsz(geom%nz,geom%nz))
111 allocate(evalsz(geom%nz))
112 allocate(workz((geom%nz+3)*geom%nz))
113 allocate(revalsz(geom%nz))
114 allocate(norm(geom%ny,geom%nz))
115 
116 ! Calculate spectral weights for zonal correlations:
117 ! First we construct the structure function in grid space and FFT it
118 do ix=1,geom%nx
119  distx = geom%x(ix)-geom%x(1)
120  if (distx>0.5*domain_zonal) distx = domain_zonal-distx
121  struct_fn(ix) = exp(-0.5*(distx/horizontal_length_scale)**2)
122 enddo
123 call fft_fwd(geom%nx,struct_fn,workx)
124 workx = workx/real(geom%nx,kind_real)
125 
126 ! We are after sqrt(B) or sqrt(Q),so square-root the coefficents.
127 ! The factor N ensures we get the struture function back if we apply
128 ! B or Q to a unit delta function.
129 threshold = 0.0
130 do ix=0,geom%nx/2
131  threshold = max(threshold,workx(1+2*ix))
132 enddo
133 threshold = threshold/condition_number
134 do ix=0,geom%nx/2
135  self%sqrt_zonal(ix) = sqrt(max(threshold,real(geom%nx,kind_real)*workx(1+2*ix)))
136 enddo
137 
138 ! Generate the lower triangle of the meridional correlation matrix
139 do jy=1,geom%ny
140  do iy=jy,geom%ny
141  evectsy(iy,jy) = exp(-0.5*((geom%y(iy)-geom%y(jy))/horizontal_length_scale)**2)
142  evectsy(jy,iy) = evectsy(iy,jy)
143  enddo
144 enddo
145 
146 ! Calculate the eigen-decomposition
147 call dsyev('V','L',geom%ny,evectsy,geom%ny,evalsy,worky,size(worky),info)
148 if (info/=0) then
149  write(record,*) 'qg_error_covariance_setup: dsyev returns info=',info
150  call fckit_log%error(record)
151  call abor1_ftn ('qg_error_covariance_setup: dsyev failed to sqrt matrix')
152 endif
153 
154 ! Calculate the lower triangle of the symmetric square-root
155 threshold = maxval(evalsy)/condition_number
156 do iy=1,geom%ny
157  evalsy(iy) = sqrt(max(threshold,evalsy(iy)))
158  revalsy(iy) = 1.0/evalsy(iy)
159 enddo
160 do jy=1,geom%ny
161  do iy=jy,geom%ny
162  self%sqrt_merid(iy,jy) = 0.0
163  do ky=1,geom%ny
164  self%sqrt_merid(iy,jy) = self%sqrt_merid(iy,jy)+evectsy(iy,ky)*evectsy(jy,ky)*evalsy(ky)
165  enddo
166  enddo
167 enddo
168 
169 ! Generate the lower triangle of the vertical correlation matrix
170 do jz=1,geom%nz
171  do iz=jz,geom%nz
172  evectsz(iz,jz) = exp(-0.5*((geom%z(iz)-geom%z(jz))/vertical_length_scale)**2)
173  evectsz(jz,iz) = evectsz(iz,jz)
174  enddo
175 enddo
176 
177 ! Calculate the eigen-decomposition
178 call dsyev('V','L',geom%nz,evectsz,geom%nz,evalsz,workz,size(workz),info)
179 if (info/=0) then
180  write(record,*) 'qg_error_covariance_setup: dsyev returns info=',info
181  call fckit_log%error(record)
182  call abor1_ftn ('qg_error_covariance_setup: dsyev failed to sqrt matrix')
183 endif
184 
185 ! Calculate the lower triangle of the symmetric square-root
186 threshold = maxval(evalsz)/condition_number
187 do iz=1,geom%nz
188  evalsz(iz) = sqrt(max(threshold,evalsz(iz)))
189  revalsz(iz) = 1.0/evalsz(iz)
190 enddo
191 do jz=1,geom%nz
192  do iz=jz,geom%nz
193  self%sqrt_vert(iz,jz) = 0.0
194  do kz=1,geom%nz
195  self%sqrt_vert(iz,jz) = self%sqrt_vert(iz,jz)+evectsz(iz,kz)*evectsz(jz,kz)*evalsz(kz)
196  enddo
197  enddo
198 enddo
199 
200 ! Compute normalization factor
201 vars = oops_variables()
202 call vars%push_back('x')
203 call qg_fields_create(fld_in,geom,vars,.false.)
204 call qg_fields_create(fld_out,geom,vars,.false.)
205 self%norm = 1.0
206 do iz=1,geom%nz
207  do iy=1,geom%ny
208  call qg_fields_zero(fld_in)
209  fld_in%x(1,iy,iz) = 1.0
210  call qg_error_covariance_mult(self,fld_in,fld_out)
211  norm(iy,iz) = 1.0/sqrt(fld_out%x(1,iy,iz))
212  end do
213 end do
214 self%norm = norm*self%sigma
215 
216 ! Release memory
217 deallocate(struct_fn)
218 deallocate(workx)
219 deallocate(worky)
220 deallocate(revalsy)
221 deallocate(evectsy)
222 deallocate(evalsy)
223 deallocate(workz)
224 deallocate(revalsz)
225 deallocate(evectsz)
226 deallocate(evalsz)
227 call vars%destruct()
228 call qg_fields_delete(fld_in)
229 call qg_fields_delete(fld_out)
230 
231 end subroutine qg_error_covariance_setup
232 ! ------------------------------------------------------------------------------
233 !> Delete error covariance matrix
235 
236 implicit none
237 
238 ! Passed variables
239 type(qg_error_covariance_config),intent(inout) :: self !< Error covariance configuration
240 
241 ! Release memory
242 deallocate(self%sqrt_zonal)
243 deallocate(self%sqrt_merid)
244 deallocate(self%sqrt_vert)
245 deallocate(self%norm)
246 
247 end subroutine qg_error_covariance_delete
248 ! ------------------------------------------------------------------------------
249 !> Multiply by error covariance matrix
250 subroutine qg_error_covariance_mult(self,fld_in,fld_out)
251 
252 implicit none
253 
254 ! Passed variables
255 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
256 type(qg_fields),intent(in) :: fld_in !< Input field
257 type(qg_fields),intent(inout) :: fld_out !< Output field
258 
259 ! Local variables
260 type(qg_fields) :: fld_tmp
261 
262 ! Initialization
263 call qg_fields_create_from_other(fld_tmp,fld_in,fld_in%geom)
264 call qg_fields_copy(fld_tmp,fld_in)
265 
266 ! Apply covariance matrix
267 call qg_error_covariance_sqrt_mult_ad(self,fld_tmp,fld_out)
268 call qg_fields_copy(fld_tmp,fld_out)
269 call qg_error_covariance_sqrt_mult(self,fld_tmp,fld_out)
270 
271 end subroutine qg_error_covariance_mult
272 ! ------------------------------------------------------------------------------
273 !> Randomize error covariance
274 subroutine qg_error_covariance_randomize(self,fld_out)
275 
276 implicit none
277 
278 ! Passed variables
279 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
280 type(qg_fields),intent(inout) :: fld_out !< Output field
281 
282 ! Local variables
283 type(qg_fields) :: fld_tmp
284 
285 ! Initialize temporary field
286 call qg_fields_create_from_other(fld_tmp,fld_out,fld_out%geom)
287 call qg_fields_random(fld_tmp,'x')
288 
289 ! Apply square-root of the covariance matrix
290 call qg_error_covariance_sqrt_mult(self,fld_tmp,fld_out)
291 
292 end subroutine qg_error_covariance_randomize
293 ! ------------------------------------------------------------------------------
294 ! Private
295 ! ------------------------------------------------------------------------------
296 !> Multiply by error covariance matrix square-root, zonal part
298 
299 implicit none
300 
301 ! Passed variables
302 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
303 real(kind_real),intent(inout) :: fld(self%nx,self%ny,self%nz) !< Field
304 
305 ! Local variables
306 integer :: iy,iz,m,iri
307 real(kind_real) :: zfour(self%nx+2)
308 
309 do iz=1,self%nz
310  do iy=1,self%ny
311  call fft_fwd(self%nx,fld(:,iy,iz),zfour)
312  !$omp parallel do schedule(static) private(m,iri)
313  do m=0,self%nx/2
314  do iri=1,2
315  zfour(2*m+iri) = zfour(2*m+iri)*self%sqrt_zonal(m)
316  enddo
317  enddo
318  !$omp end parallel do
319  call fft_inv(self%nx,zfour,fld(:,iy,iz))
320  enddo
321 enddo
322 
324 ! ------------------------------------------------------------------------------
325 !> Multiply by error covariance matrix square-root - meridional part
327 
328 implicit none
329 
330 ! Passed variables
331 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
332 real(kind_real),intent(inout) :: fld(self%nx,self%ny,self%nz) !< Field
333 
334 ! Local variables
335 integer :: ix,iz
336 real(kind_real),allocatable :: arr_in(:),arr_out(:)
337 
338 !$omp parallel do schedule(static) private(iz,ix) firstprivate(arr_in,arr_out)
339 do iz=1,self%nz
340  do ix=1,self%nx
341  ! Allocation
342  allocate(arr_in(self%ny))
343  allocate(arr_out(self%ny))
344 
345  ! Initialize
346  arr_in = fld(ix,:,iz)
347 
348  ! Apply transform
349  call dsymv('L',self%ny,1.0_kind_real,self%sqrt_merid,self%ny,arr_in,1,0.0_kind_real,arr_out,1)
350 
351  ! Copy
352  fld(ix,:,iz) = arr_out
353 
354  ! Release memory
355  deallocate(arr_in)
356  deallocate(arr_out)
357  enddo
358 enddo
359 !$omp end parallel do
360 
362 ! ------------------------------------------------------------------------------
363 !> Multiply by error covariance matrix square-root - vertical part
365 
366 implicit none
367 
368 ! Passed variables
369 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
370 real(kind_real),intent(inout) :: fld(self%nx,self%ny,self%nz) !< Field
371 
372 ! Local variables
373 integer :: ix,iy
374 real(kind_real),allocatable :: arr_in(:),arr_out(:)
375 
376 !$omp parallel do schedule(static) private(iy,ix) firstprivate(arr_in,arr_out)
377 do iy=1,self%ny
378  do ix=1,self%nx
379  ! Allocation
380  allocate(arr_in(self%nz))
381  allocate(arr_out(self%nz))
382 
383  ! Initialize
384  arr_in = fld(ix,iy,:)
385 
386  ! Apply transform
387  call dsymv('L',self%nz,1.0_kind_real,self%sqrt_vert,self%nz,arr_in,1,0.0_kind_real,arr_out,1)
388 
389  ! Copy
390  fld(ix,iy,:) = arr_out
391 
392  ! Release memory
393  deallocate(arr_in)
394  deallocate(arr_out)
395  enddo
396 enddo
397 !$omp end parallel do
398 
400 ! ------------------------------------------------------------------------------
401 !> Multiply by error covariance matrix square-root
402 subroutine qg_error_covariance_sqrt_mult(self,fld_in,fld_out)
403 
404 implicit none
405 
406 ! Passed variables
407 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
408 type(qg_fields),intent(in) :: fld_in !< Input field
409 type(qg_fields),intent(inout) :: fld_out !< Output field
410 
411 ! Local variables
412 integer :: ix
413 
414 ! Check input/output
415 if (.not.allocated(fld_in%x)) call abor1_ftn("qg_error_covariance_sqrt_mult: x required as input")
416 if (.not.allocated(fld_out%x)) call abor1_ftn("qg_error_covariance_sqrt_mult: x required as output")
417 
418 ! Copy field
419 call qg_fields_copy(fld_out,fld_in)
420 
421 ! Multiply by symmetric square-root of vertical correlation matrix
422 call qg_error_covariance_sqrt_mult_vertical(self,fld_out%x)
423 
424 ! Multiply by square-root of meridional correlation matrix
425 call qg_error_covariance_sqrt_mult_meridional(self,fld_out%x)
426 
427 ! Multiply by square-root of zonal correlation matrix
428 call qg_error_covariance_sqrt_mult_zonal(self,fld_out%x)
429 
430 ! Multiply by normalization factor
431 !$omp parallel do schedule(static) private(ix)
432 do ix=1,fld_out%geom%nx
433  fld_out%x(ix,:,:) = fld_out%x(ix,:,:)*self%norm
434 end do
435 !$omp end parallel do
436 
437 ! Multiply by standard deviation
438 fld_out%x = fld_out%x*self%sigma
439 
440 end subroutine qg_error_covariance_sqrt_mult
441 ! ------------------------------------------------------------------------------
442 !> Multiply by error covariance matrix square-root - adjoint
443 subroutine qg_error_covariance_sqrt_mult_ad(self,fld_in,fld_out)
444 
445 implicit none
446 
447 ! Passed variables
448 type(qg_error_covariance_config),intent(in) :: self !< Error covariance configuration
449 type(qg_fields),intent(in) :: fld_in !< Input field
450 type(qg_fields),intent(inout) :: fld_out !< Output field
451 
452 ! Local variables
453 integer :: ix
454 
455 ! Check input/output
456 if (.not.allocated(fld_in%x)) call abor1_ftn("qg_error_covariance_sqrt_mult: x required as input")
457 if (.not.allocated(fld_out%x)) call abor1_ftn("qg_error_covariance_sqrt_mult: x required as output")
458 
459 ! Copy field
460 call qg_fields_copy(fld_out,fld_in)
461 
462 ! Multiply by standard deviation
463 fld_out%x = fld_out%x*self%sigma
464 
465 ! Multiply by normalization factor
466 !$omp parallel do schedule(static) private(ix)
467 do ix=1,fld_out%geom%nx
468  fld_out%x(ix,:,:) = fld_out%x(ix,:,:)*self%norm
469 end do
470 !$omp end parallel do
471 
472 ! Multiply by square-root of zonal correlation matrix
473 call qg_error_covariance_sqrt_mult_zonal(self,fld_out%x)
474 
475 ! Multiply by square-root of meridional correlation matrix
476 call qg_error_covariance_sqrt_mult_meridional(self,fld_out%x)
477 
478 ! Multiply by symmetric square-root of vertical correlation matrix
479 call qg_error_covariance_sqrt_mult_vertical(self,fld_out%x)
480 
482 ! ------------------------------------------------------------------------------
483 end module qg_error_covariance_mod
Fortran module for Eigen FFTs.
Definition: fft_mod.F90:7
subroutine, public fft_inv(kk, pf, pg)
Definition: fft_mod.F90:66
subroutine, public fft_fwd(kk, pg, pf)
Definition: fft_mod.F90:49
Fortran interface to Variables.
real(kind_real), parameter, public domain_zonal
Model domain in zonal direction (m)
type(registry_t), public qg_error_covariance_registry
Linked list interface - defines registry_t type.
subroutine qg_error_covariance_sqrt_mult_vertical(self, fld)
Multiply by error covariance matrix square-root - vertical part.
subroutine qg_error_covariance_sqrt_mult_ad(self, fld_in, fld_out)
Multiply by error covariance matrix square-root - adjoint.
subroutine, public qg_error_covariance_setup(self, f_conf, geom)
Linked list implementation.
subroutine qg_error_covariance_sqrt_mult_zonal(self, fld)
Multiply by error covariance matrix square-root, zonal part.
subroutine, public qg_error_covariance_delete(self)
Delete error covariance matrix.
subroutine, public qg_error_covariance_randomize(self, fld_out)
Randomize error covariance.
subroutine qg_error_covariance_sqrt_mult(self, fld_in, fld_out)
Multiply by error covariance matrix square-root.
real(kind_real), parameter eps_ad
Epsilon value for adjoint tests.
subroutine qg_error_covariance_sqrt_mult_meridional(self, fld)
Multiply by error covariance matrix square-root - meridional part.
subroutine, public qg_error_covariance_mult(self, fld_in, fld_out)
Multiply by error covariance matrix.
subroutine, public qg_fields_zero(self)
Set fields to zero.
subroutine, public qg_fields_delete(self)
Delete fields.
subroutine, public qg_fields_create(self, geom, vars, lbc)
Linked list implementation.
subroutine, public qg_fields_copy(self, other)
Copy fields.
subroutine, public qg_fields_random(self, var)
Generate random fields.
subroutine, public qg_fields_create_from_other(self, other, geom)
Create fields from another one.