20 SUBROUTINE initpost_nems(NREC,nfile)
22 use vrbls3d, only: t, q, uh, vh, q2, cwm, f_ice, f_rain, f_rimef, cfr, pint,&
23 pint, alpint, pmid, pmidv, zint, zmid, wh, rlwtt, rswtt,&
24 ttnd, tcucn, train, el_pbl, exch_h, omga, qqni, qqnr, qqw, qqi, &
25 qqr, qqs, qqg, ref_10cm, radius_cloud, radius_ice, radius_snow, &
27 use vrbls2d, only: f, pd, fis, pblh, mixht, ustar, z0, ths, qs, twbs, qwbs, prec,&
28 acprec, cuprec,ancprc, lspa, sno, snoavg, psfcavg, t10avg, t10m, akhsavg, akmsavg,&
29 refd_max, w_up_max, w_dn_max, up_heli_max, si, cldefi, th10, q10, pshltr,&
30 tshltr, qshltr, maxtshltr, mintshltr, maxrhshltr, minrhshltr, akhs, akms, albase,&
31 albedo, czen, cfracl, cfracm, islope, cmc, grnflx, pctsno, soiltb, vegfrc,&
32 acfrcv, acfrst, ssroff, bgroff, czmean, mxsnal, radot, sigt4, tg, sr, cfrach,&
33 rlwin, rlwtoa, alwin, alwout, alwtoa, rswin, rswinc, rswout, aswin,aswout,&
34 aswtoa, sfcshx, sfclhx, subshx, snopcx, sfcuvx, potevp, ncfrcv, ncfrst, u10h,&
35 u10, v10h, v10, u10max, v10max, smstav, smstot, sfcevp, ivgtyp, acsnow, acsnom,&
36 sst, thz0, qz0, uz0, vz0, htop, isltyp, sfcexc, hbot, htopd, htops, cuppt, cprate,&
37 hbotd, hbots, prate_max, fprate_max
38 use soil, only: sldpth, sh2o, smc, stc
39 use masks, only: lmv, lmh, htm, vtm, dx, dy, hbm2, gdlat, gdlon, sm, sice
40 use kinds, only: i_llong
42 use params_mod, only: pi, dtr, g, d608, rd,tfrz
43 use lookup_mod, only: thl, plq, ptbl, ttbl, rdq, rdth, rdp, rdthe, pl, qs0, sqs, sthe, the0,&
44 ttblq, rdpq, rdtheq, stheq, the0q
45 use ctlblk_mod
, only: me, mpi_comm_comp, global, icnt, idsp, jsta, ihrst, imin, idat, sdat,&
46 ifhr, ifmin, filename, restrt, imp_physics, isf_surface_physics, icu_physics, jend,&
47 dt, spval, gdsdegr, grib, pdtop, pt, tmaxmin, nsoil, lp1, jend_m, nprec, nphs, avrain,&
48 avcnvc, ardlw, ardsw, asrfc, novegtype, spl, lsm, dtq2, tsrfc, trdlw, trdsw, theat, tclod,&
49 tprec, alsl, lm , im, jm, jsta_2l, jend_2u, ivegsrc, pthresh
50 use gridspec_mod
, only: dyval, dxval, cenlat, cenlon, maptype, gridtype, latstart, latlast, latnw,&
51 latse, lonstart, lonlast, lonnw, lonse, latstartv, latlastv, cenlatv, lonstartv,&
53 use nemsio_module
, only: nemsio_gfile, nemsio_getfilehead, nemsio_close, nemsio_getheadvar
59 type(nemsio_gfile
),
intent(inout) :: nfile
66 character(len=20) :: varname
67 character(len=20) :: vcoordname
69 character startdate*19,sysdepinfo*80,cgar*1
70 character startdate2(19)*4
77 logical,
parameter :: debugprint = .false.
79 logical :: convert_rad_to_deg=.false.
83 INTEGER idate(8),jdate(8)
89 REAL eta1(lm+1), eta2(lm+1)
93 REAL dummy2 ( im, jm )
94 real,
allocatable :: fi(:,:,:)
96 integer ibuf(im,jsta_2l:jend_2u)
97 real buf(im,jsta_2l:jend_2u)
98 character*8,
allocatable:: recname(:)
99 character*16,
allocatable :: reclevtyp(:)
100 integer,
allocatable:: reclev(:)
101 real,
allocatable:: bufy(:)
102 real,
allocatable:: glat1d(:),glon1d(:)
104 integer ii,jj,js,je,jev,iyear,imn,iday,itmp,ioutcount,istatus, &
105 nsrfc,nrdlw,nrdsw,nheat,nclod, &
106 iunit,nrec,i,j,l, iret,nframe,impf,jmpf,nframed2, &
107 igdout,ll,n,im1,jm1,iim1,item
114 if(me==0)
WRITE(6,*)
'INITPOST: ENTER INITPOST'
123 do j = jsta_2l, jend_2u
133 do j = jsta_2l, jend_2u
144 IF (jend_2u==jm)
THEN
156 allocate(recname(nrec),reclevtyp(nrec),reclev(nrec))
158 call nemsio_getfilehead(nfile,iret=iret &
159 ,idate=idate(1:7),nfhour=nfhour,recname=recname &
160 ,reclevtyp=reclevtyp,reclev=reclev,nframe=nframe)
163 print *,
'printing an inventory of NEMS file'
165 print *,
'recname,reclevtyp,reclev=',trim(recname(i)),
' ', &
166 trim(reclevtyp(i)),reclev(i)
171 deallocate(recname,reclevtyp,reclev)
175 print*,
'nframe,impf,jmpf= ',nframe,impf,jmpf
176 allocate(glat1d(impf*jmpf),glon1d(impf*jmpf) )
177 call nemsio_getfilehead(nfile,dx=glat1d &
178 ,dy=glon1d,iret=iret)
179 if(iret/=0)print*,
'did not find dx dy'
185 item = (j-1)*impf + nframe
187 dummy(i,j) = glat1d(item+i)
188 dummy2(i,j) = glon1d(item+i)
193 deallocate(glat1d,glon1d)
202 print*,
'idate before broadcast = ',(idate(i),i=1,7)
204 call mpi_bcast(idate(1),7,mpi_integer,0,mpi_comm_comp,iret)
205 call mpi_bcast(nfhour,1,mpi_integer,0,mpi_comm_comp,iret)
206 call mpi_bcast(nframe,1,mpi_integer,0,mpi_comm_comp,iret)
240 print*,
'impf,jmpf,nframe for reading fields = ',impf,jmpf,nframe
241 print*,
'idate after broadcast = ',(idate(i),i=1,7)
242 print*,
'nfhour = ',nfhour
244 call mpi_scatterv(dummy(1,1),icnt,idsp,mpi_real &
245 ,dx(1,jsta),icnt(me),mpi_real,0,mpi_comm_comp,iret)
246 call mpi_scatterv(dummy2(1,1),icnt,idsp,mpi_real &
247 ,dy(1,jsta),icnt(me),mpi_real,0,mpi_comm_comp,iret)
263 15
format(i4,1x,i2,1x,i2,1x,i2,1x,i2)
265 print*,
'start yr mo day hr min =',iyear,imn,iday,ihrst,imin
266 print*,
'processing yr mo day hr min=' &
267 ,idat(3),idat(1),idat(2),idat(4),idat(5)
288 CALL w3difdat(jdate,idate,0,rinc)
290 ifhr=nint(rinc(2)+rinc(1)*24.)
293 if (me==0)print*,
' in INITPOST ifhr ifmin fileName=',ifhr,ifmin,trim(filename)
314 IF(tstart > 1.0e-2)
THEN
315 ifhr=ifhr+nint(tstart)
319 call w3movdat(rinc,jdate,idate)
324 print*,
'new forecast hours for restrt run= ',ifhr
325 print*,
'new start yr mo day hr min =',sdat(3),sdat(1) &
340 call nemsio_getheadvar(nfile,trim(varname),imp_physics,iret)
342 print*,varname,
" not found in file- go to 16 character "
344 call nemsio_getheadvar(nfile,trim(varname),imp_physics,iret)
346 print*,varname,
" not found in file-Assigned 1000"
352 call mpi_bcast(imp_physics,1,mpi_integer,0,mpi_comm_comp,iret)
353 if(me==0)print*,
'MP_PHYSICS= ',imp_physics
356 if(imp_physics==5 .or. imp_physics==85 .or. imp_physics==95)
then
357 CALL microinit(imp_physics)
360 varname=
'sf_surface_physi'
362 call nemsio_getheadvar(nfile,trim(varname),isf_surface_physics,iret)
364 print*,varname,
" not found in file-Assigned 2 for NOAH LSM as default"
365 isf_surface_physics=2
368 call mpi_bcast(isf_surface_physics,1,mpi_integer,0,mpi_comm_comp,iret)
369 if(me==0) print*,
'SF_SURFACE_PHYSICS= ',isf_surface_physics
374 call nemsio_getheadvar(nfile,trim(varname),ivegsrc,iret)
376 print*,varname,
" not found in file-Assigned 1 for IGBP as default"
380 call mpi_bcast(ivegsrc,1,mpi_integer,0,mpi_comm_comp,iret)
381 if(me==0) print*,
'IVEGSRC= ',ivegsrc
386 else if(ivegsrc==0)
then
389 if(me==0) print*,
'novegtype= ',novegtype
393 call nemsio_getheadvar(nfile,trim(varname),icu_physics,iret)
395 print*,varname,
" not found in file-Assigned 2 for BMJ as default"
399 call mpi_bcast(icu_physics,1,mpi_integer,0,mpi_comm_comp,iret)
400 if(me==0) print*,
'CU_PHYSICS= ',icu_physics
418 if(debugprint)print*,
'sample ',varname,
' = ',dx(im/2,(jsta+jend)/2)
434 if(debugprint)print*,
'sample ',varname,
' = ',dy(im/2,(jsta+jend)/2)
439 call nemsio_getheadvar(nfile,trim(varname),garb,iret)
441 print*,varname,
" not found in file-Assigned missing values"
447 call mpi_bcast(dt,1,mpi_real,0,mpi_comm_comp,iret)
451 call nemsio_getheadvar(nfile,trim(varname),garb,iret)
453 print*,varname,
" not found in file-Assigned missing values"
459 call mpi_bcast(dyval,1,mpi_real,0,mpi_comm_comp,iret)
464 call nemsio_getheadvar(nfile,trim(varname),garb,iret)
466 print*,varname,
" not found in file-Assigned missing values"
472 call mpi_bcast(dxval,1,mpi_real,0,mpi_comm_comp,iret)
475 if(me==0) print*,
'DX, DY, DT=',dxval,dyval,dt
479 call nemsio_getheadvar(nfile,trim(varname),garb,iret)
481 print*,varname,
" not found in file-Assigned missing values"
484 cenlat=nint(garb*gdsdegr)
487 call mpi_bcast(cenlat,1,mpi_integer,0,mpi_comm_comp,iret)
491 call nemsio_getheadvar(nfile,trim(varname),garb,iret)
493 print*,varname,
" not found in file-Assigned missing values"
496 if(grib==
"grib2")
then
497 cenlon=nint((garb+360.)*gdsdegr)
501 call mpi_bcast(cenlon,1,mpi_integer,0,mpi_comm_comp,iret)
551 if(me==0) print*,
'maptype and gridtype= ',maptype,gridtype
558 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
559 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
560 ,l,impf,jmpf,nframe,gdlat)
562 call collect_loc(gdlat,dummy)
565 if(maxval(abs(dummy))<pi)
then
566 if(debugprint)print*,
'convert from radian to degree'
568 convert_rad_to_deg=.true.
574 call mpi_bcast(convert_rad_to_deg,1,mpi_logical,0,mpi_comm_comp,iret)
575 if(convert_rad_to_deg)call mpi_scatterv(dummy(1,1),icnt,idsp,mpi_real &
576 ,gdlat(1,jsta),icnt(me),mpi_real,0,mpi_comm_comp,iret)
577 if(debugprint)print*,
'sample ',varname,
' = ',gdlat(im/2,(jsta+jend)/2)
578 if(debugprint)print*,
'max min lat=',maxval(gdlat),minval(gdlat),
'im=',im, &
579 'jsta_2l=',jsta_2l,
'jend_2u=',jend_2u
581 if(me==0.and.debugprint)print*,
'after collect lat=',dummy(1,1),dummy(im,jm)
585 latstart=nint(dummy(1,1)*gdsdegr)
586 latlast=nint(dummy(im,jm)*gdsdegr)
587 latnw=nint(dummy(1,jm)*gdsdegr)
588 latse=nint(dummy(im,1)*gdsdegr)
596 print*,
'latstart,latlast B bcast= ',latstart,latlast
598 call mpi_bcast(latstart,1,mpi_integer,0,mpi_comm_comp,iret)
599 call mpi_bcast(latlast,1,mpi_integer,0,mpi_comm_comp,iret)
602 if(debugprint)
write(6,*)
'latstart,latlast,me A calling bcast=',latstart,latlast,me
603 if(me==0) print*,
'dyval, cenlat= ',dyval, cenlat
608 f(i,j) = 1.454441e-4*sin(gdlat(i,j)*dtr)
615 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
616 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
617 ,l,impf,jmpf,nframe,gdlon)
618 if(convert_rad_to_deg)gdlon=gdlon*180./pi
625 if(gdlon(1,jsta)>0. .and. gdlon(2,jsta)<0.)
then
627 gdlon(1,j) = gdlon(1,j)-360.0
631 if(debugprint)print*,
'sample ',varname,
' = ',(gdlon(i,(jsta+jend)/2),i=1,im,8)
632 if(debugprint)print*,
'max min lon=',maxval(gdlon),minval(gdlon)
633 call collect_loc(gdlon,dummy)
635 if(grib==
'grib2')
then
636 if(dummy(1,1)<0) dummy(1,1)=dummy(1,1)+360.
637 if(dummy(im,jm)<0) dummy(im,jm)=dummy(im,jm)+360.
639 lonstart=nint(dummy(1,1)*gdsdegr)
640 lonlast=nint(dummy(im,jm)*gdsdegr)
641 lonnw=nint(dummy(1,jm)*gdsdegr)
642 lonse=nint(dummy(im,1)*gdsdegr)
651 call mpi_bcast(lonstart,1,mpi_integer,0,mpi_comm_comp,iret)
652 call mpi_bcast(lonlast,1,mpi_integer,0,mpi_comm_comp,iret)
655 write(6,*)
'lonstart,lonlast A calling bcast=',lonstart,lonlast
656 print*,
'dxval, cenlon= ',dxval, cenlon
658 convert_rad_to_deg=.false.
662 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
663 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
664 ,l,impf,jmpf,nframe,buf)
665 if(debugprint)print*,
'sample ',varname,
' = ',buf(im/2,(jsta+jend)/2)
666 if(debugprint)print*,
'max min vlat=',maxval(buf),minval(buf)
667 call collect_loc(buf,dummy)
669 if(maxval(abs(dummy))<pi)
then
670 dummy(1,1)=dummy(1,1)*180./pi
671 dummy(im,jm)=dummy(im,jm)*180./pi
672 convert_rad_to_deg=.true.
674 latstartv=nint(dummy(1,1)*gdsdegr)
675 latlastv=nint(dummy(im,jm)*gdsdegr)
679 call mpi_bcast(latstartv,1,mpi_integer,0,mpi_comm_comp,iret)
680 call mpi_bcast(latlastv,1,mpi_integer,0,mpi_comm_comp,iret)
683 if(debugprint)
write(6,*)
'latstartv,cenlatv,latlastv,me A calling bcast=', &
684 latstartv,cenlatv,latlastv,me
689 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
690 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
691 ,l,impf,jmpf,nframe,buf)
692 if(debugprint)print*,
'sample ',varname,
' = ',buf(im/2,(jsta+jend)/2)
693 if(debugprint)print*,
'max min vlon=',maxval(buf),minval(buf)
694 call collect_loc(buf,dummy)
696 if(convert_rad_to_deg)
then
697 dummy(1,1)=dummy(1,1)*180./pi
698 dummy(im,jm)=dummy(im,jm)*180./pi
700 if(grib==
'grib2')
then
701 if(dummy(1,1)<0) dummy(1,1)=dummy(1,1)+360.
703 lonstartv=nint(dummy(1,1)*gdsdegr)
704 lonlastv=nint(dummy(im,jm)*gdsdegr)
708 call mpi_bcast(lonstartv,1,mpi_integer,0,mpi_comm_comp,iret)
709 call mpi_bcast(lonlastv,1,mpi_integer,0,mpi_comm_comp,iret)
712 write(6,*)
'lonstartv,cenlonv,lonlastv,me A calling bcast=', &
713 lonstartv,cenlonv,lonlastv,me
718 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
719 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
720 ,l,impf,jmpf,nframe,sm)
721 if(debugprint)print*,
'sample ',varname,
' = ',sm(im/2,(jsta+jend)/2)
726 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
727 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
728 ,l,impf,jmpf,nframe,sice)
729 if(debugprint)print*,
'sample ',varname,
' = ',sice(im/2,(jsta+jend)/2)
733 vcoordname=
'hybrid sig lev'
735 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
736 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
737 ,l,impf,jmpf,nframe,pd)
738 if(debugprint)print*,
'sample ',varname,
' = ',pd(im/2,(jsta+jend)/2)
749 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
750 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
751 ,l,impf,jmpf,nframe,fis)
752 if(debugprint)print*,
'sample ',varname,
' = ',fis(im/2,(jsta+jend)/2)
753 where(fis /= spval)fis=fis*g
756 vcoordname=
'mid layer'
760 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
761 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
762 ,l,impf,jmpf,nframe,t(1,jsta_2l,ll))
763 if(debugprint)print*,
'sample l ',varname,
' = ',ll,t(im/2,(jsta+jend)/2,ll)
768 if(t(i,j,ll)<150.)print*,
'abnormal incoming T ',i,j,ll,t(i,j,ll)
775 if(imp_physics==5 .or. imp_physics==85 .or. imp_physics==95 .or. imp_physics==99)
then
777 vcoordname=
'mid layer'
781 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
782 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
783 ,l,impf,jmpf,nframe,q(1,jsta_2l,ll))
784 if(debugprint)print*,
'sample l ',varname,
' = ',ll,q(im/2,(jsta+jend)/2,ll)
790 vcoordname=
'mid layer'
794 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
795 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
796 ,l,impf,jmpf,nframe,uh(1,jsta_2l,ll))
797 if(debugprint)print*,
'sample l ',varname,
' = ',ll,uh(im/2,(jsta+jend)/2,ll)
801 call exch(buf(1,jsta_2l))
802 if(debugprint)print*,
'sample l u = ',ll,buf(im/2,(jsta+jend)/2)
811 if(iim1<1)iim1=iim1+im
812 if (ii > im) ii = ii - im
813 uh(i,j,ll)=(buf(i,j)+buf(im1,j)+buf(ii,j)+buf(iim1,j))/4.0
815 uh(i,j,ll)=(buf(i,j)+buf(im1,j)+buf(im1,jm1)+buf(i,jm1))/4.0
824 vcoordname=
'mid layer'
828 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
829 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
830 ,l,impf,jmpf,nframe,vh(1,jsta_2l,ll))
831 if(debugprint)print*,
'sample l ',varname,
' = ',ll,vh(im/2,(jsta+jend)/2,ll)
835 call exch(buf(1,jsta_2l))
836 if(debugprint)print*,
'sample l v = ',ll,buf(im/2,(jsta+jend)/2)
845 if(iim1<1)iim1=iim1+im
846 if (ii > im) ii = ii - im
847 vh(i,j,ll)=(buf(i,j)+buf(im1,j)+buf(ii,j)+buf(iim1,j))/4.0
849 vh(i,j,ll)=(buf(i,j)+buf(im1,j)+buf(im1,jm1)+buf(i,jm1))/4.0
859 call nemsio_getheadvar(nfile,trim(varname),eta1,iret)
861 print*,varname,
" not found in file-Assigned missing values"
865 call mpi_bcast(eta1,lm+1,mpi_real,0,mpi_comm_comp,iret)
869 call nemsio_getheadvar(nfile,trim(varname),eta2,iret)
871 print*,varname,
" not found in file-Assigned missing values"
875 call mpi_bcast(eta2,lm+1,mpi_real,0,mpi_comm_comp,iret)
877 open(75,file=
'ETAPROFILE.txt',form=
'formatted', &
880 write(75,1020)l, eta1(lm+2-l), eta2(lm+2-l)
882 1020
format(i3,2e17.10)
887 call nemsio_getheadvar(nfile,trim(varname),pdtop,iret)
889 print*,varname,
" not found in file-Assigned missing values"
893 call mpi_bcast(pdtop,1,mpi_real,0,mpi_comm_comp,iret)
897 call nemsio_getheadvar(nfile,trim(varname),pt,iret)
899 print*,varname,
" not found in file-Assigned missing values"
903 call mpi_bcast(pt,1,mpi_real,0,mpi_comm_comp,iret)
904 if(me==0) print*,
'PT, PDTOP= ',pt,pdtop
909 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
910 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
911 ,l,impf,jmpf,nframe,pblh)
912 if(debugprint)print*,
'sample ',varname,
' = ',pblh(im/2,(jsta+jend)/2)
917 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
918 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
919 ,l,impf,jmpf,nframe,mixht)
920 if(debugprint)print*,
'sample ',varname,
' = ',mixht(im/2,(jsta+jend)/2)
925 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
926 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
927 ,l,impf,jmpf,nframe,ustar)
928 if(debugprint)print*,
'sample ',varname,
' = ',ustar(im/2,(jsta+jend)/2)
933 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
934 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
935 ,l,impf,jmpf,nframe,z0)
936 if(debugprint)print*,
'sample ',varname,
' = ',z0(im/2,(jsta+jend)/2)
941 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
942 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
943 ,l,impf,jmpf,nframe,ths)
944 if(debugprint)print*,
'sample ',varname,
' = ',ths(im/2,(jsta+jend)/2)
949 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
950 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
951 ,l,impf,jmpf,nframe,qs)
952 if(debugprint)print*,
'sample ',varname,
' = ',qs(im/2,(jsta+jend)/2)
957 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
958 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
959 ,l,impf,jmpf,nframe,twbs)
960 if(debugprint)print*,
'sample ',varname,
' = ',twbs(im/2,(jsta+jend)/2)
965 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
966 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
967 ,l,impf,jmpf,nframe,qwbs)
968 if(debugprint)print*,
'sample ',varname,
' = ',qwbs(im/2,(jsta+jend)/2)
973 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
974 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
975 ,l,impf,jmpf,nframe,prec)
976 if(debugprint)print*,
'sample ',varname,
' = ',prec(im/2,(jsta+jend)/2)
981 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
982 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
983 ,l,impf,jmpf,nframe,acprec)
984 if(debugprint)print*,
'sample ',varname,
' = ',acprec(im/2,(jsta+jend)/2)
989 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
990 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
991 ,l,impf,jmpf,nframe,cuprec)
992 if(debugprint)print*,
'sample ',varname,
' = ',cuprec(im/2,(jsta+jend)/2)
997 ancprc(i,j)=acprec(i,j)-cuprec(i,j)
1004 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1005 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1006 ,l,impf,jmpf,nframe,lspa)
1007 if(debugprint)print*,
'sample ',varname,
' = ',lspa(im/2,(jsta+jend)/2)
1012 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1013 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1014 ,l,impf,jmpf,nframe,sno)
1015 if(debugprint)print*,
'sample ',varname,
' = ',sno(im/2,(jsta+jend)/2)
1020 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1021 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1022 ,l,impf,jmpf,nframe,snoavg)
1023 if(debugprint)print*,
'sample ',varname,
' = ',snoavg(im/2,(jsta+jend)/2)
1028 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1029 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1030 ,l,impf,jmpf,nframe,psfcavg)
1031 if(debugprint)print*,
'sample ',varname,
' = ',psfcavg(im/2,(jsta+jend)/2)
1034 vcoordname=
'10 m above gnd'
1036 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1037 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1038 ,l,impf,jmpf,nframe,t10avg)
1039 if(debugprint)print*,
'sample ',varname,
' = ',t10avg(im/2,(jsta+jend)/2)
1042 vcoordname=
'10 m above gnd'
1044 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1045 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1046 ,l,impf,jmpf,nframe,t10m)
1047 if(debugprint)print*,
'sample ',varname,
' = ',t10m(im/2,(jsta+jend)/2)
1052 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1053 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1054 ,l,impf,jmpf,nframe,akhsavg)
1055 if(debugprint)print*,
'sample ',varname,
' = ',akhsavg(im/2,(jsta+jend)/2)
1060 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1061 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1062 ,l,impf,jmpf,nframe,akmsavg)
1063 if(debugprint)print*,
'sample ',varname,
' = ',akmsavg(im/2,(jsta+jend)/2)
1068 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1069 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1070 ,l,impf,jmpf,nframe,refd_max)
1071 if(debugprint)print*,
'sample ',varname,
' = ',refd_max(im/2,(jsta+jend)/2)
1076 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1077 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1078 ,l,impf,jmpf,nframe,w_up_max)
1079 if(debugprint)print*,
'sample ',varname,
' = ',w_up_max(im/2,(jsta+jend)/2)
1084 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1085 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1086 ,l,impf,jmpf,nframe,w_dn_max)
1087 if(debugprint)print*,
'sample ',varname,
' = ',w_dn_max(im/2,(jsta+jend)/2)
1092 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1093 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1094 ,l,impf,jmpf,nframe,up_heli_max)
1095 if(debugprint)print*,
'sample ',varname,
' = ',up_heli_max(im/2,(jsta+jend)/2)
1100 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1101 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1102 ,l,impf,jmpf,nframe,prate_max)
1103 if(debugprint)print*,
'sample ',varname,
' = ',prate_max(im/2,(jsta+jend)/2)
1108 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1109 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1110 ,l,impf,jmpf,nframe,fprate_max)
1111 if(debugprint)print*,
'sample ',varname,
' = ',fprate_max(im/2,(jsta+jend)/2)
1116 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1117 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1118 ,l,impf,jmpf,nframe,si)
1119 if(debugprint)print*,
'sample ',varname,
' = ',si(im/2,(jsta+jend)/2)
1124 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1125 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1126 ,l,impf,jmpf,nframe,cldefi)
1127 if(debugprint)print*,
'sample ',varname,
' = ',cldefi(im/2,(jsta+jend)/2)
1130 vcoordname=
'10 m above gnd'
1132 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1133 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1134 ,l,impf,jmpf,nframe,th10)
1135 if(debugprint)print*,
'sample ',varname,
' = ',th10(im/2,(jsta+jend)/2)
1138 vcoordname=
'10 m above gnd'
1140 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1141 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1142 ,l,impf,jmpf,nframe,q10)
1143 if(debugprint)print*,
'sample ',varname,
' = ',q10(im/2,(jsta+jend)/2)
1148 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1149 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1150 ,l,impf,jmpf,nframe,pshltr)
1151 if(debugprint)print*,
'sample ',varname,
' = ',pshltr(im/2,(jsta+jend)/2), &
1152 'max=',maxval(pshltr(1:im,jsta:jend)),minval(pshltr(1:im,jsta:jend))
1157 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1158 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1159 ,l,impf,jmpf,nframe,tshltr)
1160 if(debugprint)print*,
'sample ',varname,
' = ',tshltr(im/2,(jsta+jend)/2)
1165 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1166 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1167 ,l,impf,jmpf,nframe,qshltr)
1168 if(debugprint)print*,
'sample ',varname,
' = ',qshltr(im/2,(jsta+jend)/2)
1176 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1177 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1178 ,l,impf,jmpf,nframe,maxtshltr)
1179 if(debugprint)print*,
'sample ',varname,
' = ',maxtshltr(im/2,(jsta+jend)/2)
1184 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1185 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1186 ,l,impf,jmpf,nframe,mintshltr)
1187 if(debugprint)print*,
'sample ',varname,
' = ',mintshltr(im/2,(jsta+jend)/2)
1192 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1193 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1194 ,l,impf,jmpf,nframe,maxrhshltr)
1195 if(debugprint)print*,
'sample ',varname,
' = ',maxrhshltr(im/2,(jsta+jend)/2)
1200 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1201 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1202 ,l,impf,jmpf,nframe,minrhshltr)
1203 if(debugprint)print*,
'sample ',varname,
' = ',minrhshltr(im/2,(jsta+jend)/2)
1207 vcoordname=
'mid layer'
1211 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1212 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1213 ,l,impf,jmpf,nframe,q2(1,jsta_2l,ll))
1214 if(debugprint)print*,
'sample l ',varname,
' = ',ll,q2(im/2,(jsta+jend)/2,ll)
1220 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1221 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1222 ,l,impf,jmpf,nframe,akhs)
1223 if(debugprint)print*,
'sample ',varname,
' = ',akhs(im/2,(jsta+jend)/2)
1228 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1229 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1230 ,l,impf,jmpf,nframe,akms)
1231 if(debugprint)print*,
'sample ',varname,
' = ',akms(im/2,(jsta+jend)/2)
1236 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1237 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1238 ,l,impf,jmpf,nframe,albase)
1239 if(debugprint)print*,
'sample ',varname,
' = ',albase(im/2,(jsta+jend)/2)
1244 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1245 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1246 ,l,impf,jmpf,nframe,albedo)
1247 if(debugprint)print*,
'sample ',varname,
' = ',albedo(im/2,(jsta+jend)/2)
1252 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1253 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1254 ,l,impf,jmpf,nframe,czen)
1255 if(debugprint)print*,
'sample ',varname,
' = ',czen(im/2,(jsta+jend)/2)
1260 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1261 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1262 ,l,impf,jmpf,nframe,czmean)
1263 if(debugprint)print*,
'sample ',varname,
' = ',czmean(im/2,(jsta+jend)/2)
1268 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1269 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1270 ,l,impf,jmpf,nframe,mxsnal)
1271 if(debugprint)print*,
'sample ',varname,
' = ',mxsnal(im/2,(jsta+jend)/2)
1276 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1277 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1278 ,l,impf,jmpf,nframe,radot)
1279 if(debugprint)print*,
'sample ',varname,
' = ',radot(im/2,(jsta+jend)/2)
1284 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1285 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1286 ,l,impf,jmpf,nframe,sigt4)
1287 if(debugprint)print*,
'sample ',varname,
' = ',sigt4(im/2,(jsta+jend)/2)
1292 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1293 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1294 ,l,impf,jmpf,nframe,tg)
1295 if(debugprint)print*,
'sample ',varname,
' = ',tg(im/2,(jsta+jend)/2)
1298 if(imp_physics==5 .or. imp_physics==85 .or. imp_physics==95 .or. imp_physics==99)
then
1301 vcoordname=
'mid layer'
1305 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1306 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1307 ,l,impf,jmpf,nframe,cwm(1,jsta_2l,ll))
1308 if(debugprint)print*,
'sample l ',varname,
' = ',ll,cwm(im/2,(jsta+jend)/2,ll)
1312 vcoordname=
'mid layer'
1316 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1317 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1318 ,l,impf,jmpf,nframe,f_ice(1,jsta_2l,ll))
1319 if(debugprint)print*,
'sample l ',varname,
' = ',ll,f_ice(im/2,(jsta+jend)/2,ll)
1320 if(debugprint)print*,
'max min ',varname,
' = ',ll,maxval(f_ice(:,:,ll)),minval(f_ice(:,:,ll))
1324 vcoordname=
'mid layer'
1328 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1329 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1330 ,l,impf,jmpf,nframe,f_rain(1,jsta_2l,ll))
1331 if(debugprint)print*,
'sample l ',varname,
' = ',ll,f_rain(im/2,(jsta+jend)/2,ll)
1332 if(debugprint)print*,
'max min ',varname,
' = ',ll,maxval(f_rain(:,:,ll)),minval(f_rain(:,:,ll))
1335 if(imp_physics /= 99)
then
1337 vcoordname=
'mid layer'
1341 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1342 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1343 ,l,impf,jmpf,nframe,f_rimef(1,jsta_2l,ll))
1344 if(debugprint)print*,
'sample l ',varname,
' = ',ll,f_rimef(im/2,(jsta+jend)/2,ll)
1345 if(debugprint)print*,
'max min ',varname,
' = ',ll,maxval(f_rimef(:,:,ll)),minval(f_rimef(:,:,ll))
1349 if(imp_physics==5)
then
1351 vcoordname=
'mid layer'
1354 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1355 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1356 ,l,impf,jmpf,nframe,ref_10cm(1,jsta_2l,ll))
1357 if(debugprint)print*,
'sample l ',varname,
' = ' &
1358 ,ll,ref_10cm(im/2,(jsta+jend)/2,ll)
1359 if(debugprint)print*,
'max min ',varname,
' = ' &
1360 ,ll,maxval(ref_10cm(:,:,ll)),minval(ref_10cm(:,:,ll))
1365 if(imp_physics==8 .or. imp_physics==9)
then
1367 vcoordname=
'mid layer'
1370 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1371 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1372 ,l,impf,jmpf,nframe,qqni(1,jsta_2l,ll))
1373 if(debugprint)print*,
'sample l ',varname,
' = ' &
1374 ,ll,qqni(im/2,(jsta+jend)/2,ll)
1375 if(debugprint)print*,
'max min ',varname,
' = ' &
1376 ,ll,maxval(qqni(:,:,ll)),minval(qqni(:,:,ll))
1380 vcoordname=
'mid layer'
1383 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1384 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1385 ,l,impf,jmpf,nframe,qqnr(1,jsta_2l,ll))
1386 if(debugprint)print*,
'sample l ',varname,
' = ' &
1387 ,ll,qqnr(im/2,(jsta+jend)/2,ll)
1388 if(debugprint)print*,
'max min ',varname,
' = ' &
1389 ,ll,maxval(qqnr(:,:,ll)),minval(qqnr(:,:,ll))
1395 vcoordname=
'mid layer'
1398 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1399 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1400 ,l,impf,jmpf,nframe,q(1,jsta_2l,ll))
1402 do j=jsta_2l,jend_2u
1404 q(i,j,ll) = max(10e-12,q(i,j,ll))
1405 q(i,j,ll) = q(i,j,ll) / (1.0+q(i,j,ll))
1408 if(debugprint)print*,
'sample l ',varname,
' = ' &
1409 ,ll,q(im/2,(jsta+jend)/2,ll)
1410 if(debugprint)print*,
'max min ',varname,
' = ' &
1411 ,ll,maxval(q(:,:,ll)),minval(q(:,:,ll))
1416 do j=jsta_2l,jend_2u
1428 if(imp_physics/=0)
then
1430 vcoordname=
'mid layer'
1433 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1434 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1435 ,l,impf,jmpf,nframe,qqw(1,jsta_2l,ll))
1436 if(imp_physics==3)
then
1438 do j=jsta_2l,jend_2u
1440 if(t(i,j,ll)<tfrz) qqi(i,j,ll) = qqw(i,j,ll)
1445 do j=jsta_2l,jend_2u
1447 cwm(i,j,ll) = qqw(i,j,ll)
1450 if(debugprint)print*,
'sample l ',varname,
' = ' &
1451 ,ll,qqw(im/2,(jsta+jend)/2,ll)
1452 if(debugprint)print*,
'max min ',varname,
' = ' &
1453 ,ll,maxval(qqw(:,:,ll)),minval(qqw(:,:,ll))
1458 if(imp_physics/=0 .and. imp_physics/=1 .and. imp_physics/=3)
then
1460 vcoordname=
'mid layer'
1463 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1464 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1465 ,l,impf,jmpf,nframe,qqi(1,jsta_2l,ll))
1467 do j=jsta_2l,jend_2u
1469 cwm(i,j,ll) = cwm(i,j,ll) + qqi(i,j,ll)
1472 if(debugprint)print*,
'sample l ',varname,
' = ' &
1473 ,ll,qqi(im/2,(jsta+jend)/2,ll)
1474 if(debugprint)print*,
'max min ',varname,
' = ' &
1475 ,ll,maxval(qqi(:,:,ll)),minval(qqi(:,:,ll))
1479 if(imp_physics/=0)
then
1481 vcoordname=
'mid layer'
1484 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1485 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1486 ,l,impf,jmpf,nframe,qqr(1,jsta_2l,ll))
1487 if(imp_physics==3)
then
1489 do j=jsta_2l,jend_2u
1491 if(t(i,j,ll)<tfrz) qqs(i,j,ll) = qqr(i,j,ll)
1496 do j=jsta_2l,jend_2u
1498 cwm(i,j,ll) = cwm(i,j,ll) + qqr(i,j,ll)
1501 if(debugprint)print*,
'sample l ',varname,
' = ' &
1502 ,ll,qqr(im/2,(jsta+jend)/2,ll)
1503 if(debugprint)print*,
'max min ',varname,
' = ' &
1504 ,ll,maxval(qqr(:,:,ll)),minval(qqr(:,:,ll))
1508 if(imp_physics/=0 .and. imp_physics/=1 .and. imp_physics/=3)
then
1510 vcoordname=
'mid layer'
1513 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1514 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1515 ,l,impf,jmpf,nframe,qqs(1,jsta_2l,ll))
1517 do j=jsta_2l,jend_2u
1519 cwm(i,j,ll) = cwm(i,j,ll) + qqs(i,j,ll)
1522 if(debugprint)print*,
'sample l ',varname,
' = ' &
1523 ,ll,qqs(im/2,(jsta+jend)/2,ll)
1524 if(debugprint)print*,
'max min ',varname,
' = ' &
1525 ,ll,maxval(qqs(:,:,ll)),minval(qqs(:,:,ll))
1529 if(imp_physics==2 .or. imp_physics==6 .or. imp_physics==8)
then
1531 vcoordname=
'mid layer'
1534 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1535 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1536 ,l,impf,jmpf,nframe,qqg(1,jsta_2l,ll))
1538 do j=jsta_2l,jend_2u
1540 cwm(i,j,ll) = cwm(i,j,ll) + qqg(i,j,ll)
1543 if(debugprint)print*,
'sample l ',varname,
' = ' &
1544 ,ll,qqg(im/2,(jsta+jend)/2,ll)
1545 if(debugprint)print*,
'max min ',varname,
' = ' &
1546 ,ll,maxval(qqg(:,:,ll)),minval(qqg(:,:,ll))
1550 if(imp_physics==8)
then
1552 vcoordname=
'mid layer'
1555 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1556 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1557 ,l,impf,jmpf,nframe,ref_10cm(1,jsta_2l,ll))
1558 if(debugprint)print*,
'sample l ',varname,
' = ' &
1559 ,ll,ref_10cm(im/2,(jsta+jend)/2,ll)
1560 if(debugprint)print*,
'max min ',varname,
' = ' &
1561 ,ll,maxval(ref_10cm(:,:,ll)),minval(ref_10cm(:,:,ll))
1565 vcoordname=
'mid layer'
1568 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1569 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1570 ,l,impf,jmpf,nframe,radius_cloud(1,jsta_2l,ll))
1571 if(debugprint)print*,
'sample l ',varname,
' = ' &
1572 ,ll,radius_cloud(im/2,(jsta+jend)/2,ll)
1573 if(debugprint)print*,
'max min ',varname,
' = ' &
1574 ,ll,maxval(radius_cloud(:,:,ll)),minval(radius_cloud(:,:,ll))
1578 vcoordname=
'mid layer'
1581 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1582 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1583 ,l,impf,jmpf,nframe,radius_ice(1,jsta_2l,ll))
1584 if(debugprint)print*,
'sample l ',varname,
' = ' &
1585 ,ll,radius_ice(im/2,(jsta+jend)/2,ll)
1586 if(debugprint)print*,
'max min ',varname,
' = ' &
1587 ,ll,maxval(radius_ice(:,:,ll)),minval(radius_ice(:,:,ll))
1591 vcoordname=
'mid layer'
1594 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1595 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1596 ,l,impf,jmpf,nframe,radius_snow(1,jsta_2l,ll))
1597 if(debugprint)print*,
'sample l ',varname,
' = ' &
1598 ,ll,radius_snow(im/2,(jsta+jend)/2,ll)
1599 if(debugprint)print*,
'max min ',varname,
' = ' &
1600 ,ll,maxval(radius_snow(:,:,ll)),minval(radius_snow(:,:,ll))
1609 vcoordname=
'mid layer'
1613 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1614 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1615 ,l,impf,jmpf,nframe,cfr(1,jsta_2l,ll))
1616 if(debugprint)print*,
'sample l ',varname,
' = ',ll,cfr(im/2,(jsta+jend)/2,ll)
1622 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1623 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1624 ,l,impf,jmpf,nframe,sr)
1625 if(debugprint)print*,
'sample ',varname,
' = ',sr(im/2,(jsta+jend)/2)
1630 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1631 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1632 ,l,impf,jmpf,nframe,cfrach)
1633 if(debugprint)print*,
'sample ',varname,
' = ',cfrach(im/2,(jsta+jend)/2)
1638 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1639 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1640 ,l,impf,jmpf,nframe,cfracl)
1641 if(debugprint)print*,
'sample ',varname,
' = ',cfracl(im/2,(jsta+jend)/2)
1646 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1647 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1648 ,l,impf,jmpf,nframe,cfracm)
1649 if(debugprint)print*,
'sample ',varname,
' = ',cfracm(im/2,(jsta+jend)/2)
1654 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1655 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1656 ,l,impf,jmpf,nframe,islope)
1657 if(debugprint)print*,
'sample ',varname,
' = ',islope(im/2,(jsta+jend)/2)
1666 call nemsio_getheadvar(nfile,trim(varname),sldpth,iret)
1675 call mpi_bcast(sldpth,4,mpi_real,0,mpi_comm_comp,iret)
1676 if(me==0)print*,
'SLDPTH= ',(sldpth(n),n=1,nsoil)
1681 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1682 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1683 ,l,impf,jmpf,nframe,cmc)
1684 if(debugprint)print*,
'sample ',varname,
' = ',cmc(im/2,(jsta+jend)/2)
1689 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1690 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1691 ,l,impf,jmpf,nframe,grnflx)
1692 if(debugprint)print*,
'sample ',varname,
' = ',grnflx(im/2,(jsta+jend)/2)
1697 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1698 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1699 ,l,impf,jmpf,nframe,pctsno)
1700 if(debugprint)print*,
'sample ',varname,
' = ',pctsno(im/2,(jsta+jend)/2)
1705 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1706 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1707 ,l,impf,jmpf,nframe,soiltb)
1708 if(debugprint)print*,
'sample ',varname,
' = ',soiltb(im/2,(jsta+jend)/2)
1712 if(soiltb(i,j)>350.)print*,
'large soiltb='
1720 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1721 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1722 ,l,impf,jmpf,nframe,vegfrc)
1723 if(debugprint)print*,
'sample ',varname,
' = ',vegfrc(im/2,(jsta+jend)/2)
1726 vcoordname=
'soil layer'
1728 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1729 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1730 ,l,impf,jmpf,nframe,sh2o(1,jsta_2l,l))
1731 if(debugprint)print*,
'sample l ',varname,
' = ',l,sh2o(im/2,(jsta+jend)/2,l)
1734 vcoordname=
'soil layer'
1736 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1737 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1738 ,l,impf,jmpf,nframe,sh2o(1,jsta_2l,l))
1739 if(debugprint)print*,
'sample l ',varname,
' = ',l,sh2o(im/2,(jsta+jend)/2,l)
1742 vcoordname=
'soil layer'
1744 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1745 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1746 ,l,impf,jmpf,nframe,sh2o(1,jsta_2l,l))
1747 if(debugprint)print*,
'sample l ',varname,
' = ',l,sh2o(im/2,(jsta+jend)/2,l)
1750 vcoordname=
'soil layer'
1752 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1753 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1754 ,l,impf,jmpf,nframe,sh2o(1,jsta_2l,l))
1755 if(debugprint)print*,
'sample l ',varname,
' = ',l,sh2o(im/2,(jsta+jend)/2,l)
1758 vcoordname=
'soil layer'
1760 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1761 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1762 ,l,impf,jmpf,nframe,smc(1,jsta_2l,l))
1763 if(debugprint)print*,
'sample l ',varname,
' = ',l,smc(im/2,(jsta+jend)/2,l)
1766 vcoordname=
'soil layer'
1768 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1769 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1770 ,l,impf,jmpf,nframe,smc(1,jsta_2l,l))
1771 if(debugprint)print*,
'sample l ',varname,
' = ',l,smc(im/2,(jsta+jend)/2,l)
1774 vcoordname=
'soil layer'
1776 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1777 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1778 ,l,impf,jmpf,nframe,smc(1,jsta_2l,l))
1779 if(debugprint)print*,
'sample l ',varname,
' = ',l,smc(im/2,(jsta+jend)/2,l)
1782 vcoordname=
'soil layer'
1784 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1785 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1786 ,l,impf,jmpf,nframe,smc(1,jsta_2l,l))
1787 if(debugprint)print*,
'sample l ',varname,
' = ',l,smc(im/2,(jsta+jend)/2,l)
1790 vcoordname=
'soil layer'
1792 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1793 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1794 ,l,impf,jmpf,nframe,stc(1,jsta_2l,l))
1795 if(debugprint)print*,
'sample l ',varname,
' = ',l,stc(im/2,(jsta+jend)/2,l)
1798 vcoordname=
'soil layer'
1800 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1801 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1802 ,l,impf,jmpf,nframe,stc(1,jsta_2l,l))
1803 if(debugprint)print*,
'sample l ',varname,
' = ',l,stc(im/2,(jsta+jend)/2,l)
1806 vcoordname=
'soil layer'
1808 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1809 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1810 ,l,impf,jmpf,nframe,stc(1,jsta_2l,l))
1811 if(debugprint)print*,
'sample l ',varname,
' = ',l,stc(im/2,(jsta+jend)/2,l)
1814 vcoordname=
'soil layer'
1816 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1817 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1818 ,l,impf,jmpf,nframe,stc(1,jsta_2l,l))
1819 if(debugprint)print*,
'sample l ',varname,
' = ',l,stc(im/2,(jsta+jend)/2,l)
1826 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1827 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1828 ,l,impf,jmpf,nframe,pint(1,jsta_2l,ll))
1829 if(debugprint)print*,
'sample l ',varname,
' = ',ll,pint(im/2,(jsta+jend)/2,ll)
1833 alpint(i,j,ll)=alog(pint(i,j,ll))
1843 if(pint(i,j,l) /= 0.0)
then
1844 alpint(i,j,l)=alog(pint(i,j,l))
1853 do j = jsta_2l, jend_2u
1855 pmid(i,j,l-1 ) = (pint(i,j,l-1)+ &
1859 if(debugprint)print*,
'sample l, PMID = ',l-1,pmid(im/2,(jsta+jend)/2,l-1)
1862 if(gridtype==
'E')
then
1864 call exch(pmid(1:im,jsta_2l:jend_2u,l))
1866 do i = 1, im-mod(j,2)
1867 IF(j == 1 .AND. i < im)
THEN
1868 pmidv(i,j,l)=0.5*(pmid(i,j,l)+pmid(i+1,j,l))
1869 ELSE IF(j==jm .AND. i<im)
THEN
1870 pmidv(i,j,l)=0.5*(pmid(i,j,l)+pmid(i+1,j,l))
1871 ELSE IF(i == 1 .AND. mod(j,2) == 0)
THEN
1872 pmidv(i,j,l)=0.5*(pmid(i,j-1,l)+pmid(i,j+1,l))
1873 ELSE IF(i == im .AND. mod(j,2) == 0 &
1875 pmidv(i,j,l)=0.5*(pmid(i,j-1,l)+pmid(i,j+1,l))
1876 ELSE IF (mod(j,2) < 1)
THEN
1877 pmidv(i,j,l)=0.25*(pmid(i,j,l)+pmid(i-1,j,l) &
1878 +pmid(i,j+1,l)+pmid(i,j-1,l))
1880 pmidv(i,j,l)=0.25*(pmid(i,j,l)+pmid(i+1,j,l) &
1881 +pmid(i,j+1,l)+pmid(i,j-1,l))
1886 else if(gridtype==
'B')
then
1888 call exch(pmid(1:im,jsta_2l:jend_2u,l))
1891 pmidv(i,j,l)=0.25*(pmid(i,j,l) + pmid(i+1,j,l) &
1892 + pmid(i,j+1,l) + pmid(i+1,j+1,l))
1899 allocate(fi(im,jsta_2l:jend_2u,2))
1902 zint(i,j,lm+1) = fis(i,j)/g
1903 if (debugprint .and. i == im/2 .and. j ==(jsta+jend)/2 )
then
1904 write(6,*)
'G,ZINT: ', g,zint(i,j,lm+1)
1906 fi(i,j,1) = fis(i,j)
1917 fi(i,j,2) = htm(i,j,l)*t(i,j,l)*(q(i,j,l)*d608+1.0)*rd* &
1918 (alpint(i,j,l+1)-alpint(i,j,l))+fi(i,j,1)
1919 zint(i,j,l) = fi(i,j,2)/g
1920 fi(i,j,1) = fi(i,j,2)
1923 if(debugprint)print*,
'L,sample HTM,T,Q,ALPINT(L+1),ALPINT(l)', &
1924 ',ZINT= ',l,htm(ii,jj,l),t(ii,jj,l), &
1925 q(ii,jj,l),alpint(ii,jj,l+1), &
1926 alpint(ii,jj,l),zint(ii,jj,l)
1929 print*,
'finish deriving geopotential in nmm'
1930 write(0,*)
' after ZINT lm=',lm,
' js=',js,
' je=',je,
' im=',im
1931 write(0,*)
' zmid lbounds=',lbound(zmid),
' ubounds=',ubound(zmid)
1932 write(0,*)
' zint lbounds=',lbound(zint),
' ubounds=',ubound(zint)
1933 write(0,*)
' pmid lbounds=',lbound(pmid),
' ubounds=',ubound(pmid)
1934 write(0,*)
' pint lbounds=',lbound(pint),
' ubounds=',ubound(pint)
1949 fact = (log(pmid(i,j,l))-log(pint(i,j,l))) &
1950 / (log(pint(i,j,l+1))-log(pint(i,j,l)))
1951 zmid(i,j,l) = zint(i,j,l) + (zint(i,j,l+1)-zint(i,j,l))*fact
1957 vcoordname=
'mid layer'
1961 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1962 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1963 ,l,impf,jmpf,nframe,wh(1,jsta_2l,ll))
1964 if(debugprint)print*,
'sample l ',varname,
' = ',ll,wh(im/2,(jsta+jend)/2,ll)
1970 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1971 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1972 ,l,impf,jmpf,nframe,acfrcv)
1973 if(debugprint)print*,
'sample ',varname,
' = ',acfrcv(im/2,(jsta+jend)/2)
1978 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1979 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1980 ,l,impf,jmpf,nframe,acfrst)
1981 if(debugprint)print*,
'sample ',varname,
' = ',acfrst(im/2,(jsta+jend)/2)
1987 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1988 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1989 ,l,impf,jmpf,nframe,ssroff)
1990 if(debugprint)print*,
'sample ',varname,
' = ',ssroff(im/2,(jsta+jend)/2)
1996 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
1997 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
1998 ,l,impf,jmpf,nframe,bgroff)
1999 if(debugprint)print*,
'sample ',varname,
' = ',bgroff(im/2,(jsta+jend)/2)
2004 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2005 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2006 ,l,impf,jmpf,nframe,rlwin)
2007 if(debugprint)print*,
'sample ',varname,
' = ',rlwin(im/2,(jsta+jend)/2)
2012 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2013 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2014 ,l,impf,jmpf,nframe,rlwtoa)
2015 if(debugprint)print*,
'sample ',varname,
' = ',rlwtoa(im/2,(jsta+jend)/2)
2020 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2021 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2022 ,l,impf,jmpf,nframe,alwin)
2023 if(debugprint)print*,
'sample ',varname,
' = ',alwin(im/2,(jsta+jend)/2)
2028 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2029 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2030 ,l,impf,jmpf,nframe,alwout)
2031 if(debugprint)print*,
'sample ',varname,
' = ',alwout(im/2,(jsta+jend)/2)
2036 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2037 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2038 ,l,impf,jmpf,nframe,alwtoa)
2039 if(debugprint)print*,
'sample ',varname,
' = ',alwtoa(im/2,(jsta+jend)/2)
2044 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2045 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2046 ,l,impf,jmpf,nframe,rswin)
2047 if(debugprint)print*,
'sample ',varname,
' = ',rswin(im/2,(jsta+jend)/2)
2052 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2053 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2054 ,l,impf,jmpf,nframe,rswinc)
2055 if(debugprint)print*,
'sample ',varname,
' = ',rswinc(im/2,(jsta+jend)/2)
2060 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2061 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2062 ,l,impf,jmpf,nframe,rswout)
2063 if(debugprint)print*,
'sample ',varname,
' = ',rswout(im/2,(jsta+jend)/2)
2068 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2069 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2070 ,l,impf,jmpf,nframe,aswin)
2071 if(debugprint)print*,
'sample ',varname,
' = ',aswin(im/2,(jsta+jend)/2)
2076 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2077 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2078 ,l,impf,jmpf,nframe,aswout)
2079 if(debugprint)print*,
'sample ',varname,
' = ',aswout(im/2,(jsta+jend)/2)
2084 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2085 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2086 ,l,impf,jmpf,nframe,aswtoa)
2087 if(debugprint)print*,
'sample ',varname,
' = ',aswtoa(im/2,(jsta+jend)/2)
2092 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2093 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2094 ,l,impf,jmpf,nframe,sfcshx)
2095 if(debugprint)print*,
'sample ',varname,
' = ',sfcshx(im/2,(jsta+jend)/2)
2100 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2101 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2102 ,l,impf,jmpf,nframe,sfclhx)
2103 if(debugprint)print*,
'sample ',varname,
' = ',sfclhx(im/2,(jsta+jend)/2)
2108 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2109 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2110 ,l,impf,jmpf,nframe,subshx)
2111 if(debugprint)print*,
'sample ',varname,
' = ',subshx(im/2,(jsta+jend)/2)
2116 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2117 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2118 ,l,impf,jmpf,nframe,snopcx)
2119 if(debugprint)print*,
'sample ',varname,
' = ',snopcx(im/2,(jsta+jend)/2)
2124 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2125 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2126 ,l,impf,jmpf,nframe,sfcuvx)
2127 if(debugprint)print*,
'sample ',varname,
' = ',sfcuvx(im/2,(jsta+jend)/2)
2132 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2133 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2134 ,l,impf,jmpf,nframe,potevp)
2135 if(debugprint)print*,
'sample ',varname,
' = ',potevp(im/2,(jsta+jend)/2)
2138 vcoordname=
'mid layer'
2142 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2143 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2144 ,l,impf,jmpf,nframe,rlwtt(1,jsta_2l,ll))
2145 if(debugprint)print*,
'sample l ',varname,
' = ',ll,rlwtt(im/2,(jsta+jend)/2,ll)
2149 vcoordname=
'mid layer'
2153 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2154 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2155 ,l,impf,jmpf,nframe,rswtt(1,jsta_2l,ll))
2156 if(debugprint)print*,
'sample l ',varname,
' = ',ll,rswtt(im/2,(jsta+jend)/2,ll)
2158 where(rlwtt/=spval .and. rswtt/=spval)ttnd=rswtt+rlwtt
2161 vcoordname=
'mid layer'
2165 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2166 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2167 ,l,impf,jmpf,nframe,tcucn(1,jsta_2l,ll))
2168 if(debugprint)print*,
'sample l ',varname,
' = ',ll,tcucn(im/2,(jsta+jend)/2,ll)
2172 vcoordname=
'mid layer'
2176 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2177 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2178 ,l,impf,jmpf,nframe,train(1,jsta_2l,ll))
2179 if(debugprint)print*,
'sample l ',varname,
' = ',ll,train(im/2,(jsta+jend)/2,ll)
2185 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2186 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2187 ,l,impf,jmpf,nframe,ncfrcv)
2188 if(debugprint)print*,
'sample ',varname,
' = ',ncfrcv(im/2,(jsta+jend)/2)
2193 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2194 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2195 ,l,impf,jmpf,nframe,ncfrst)
2196 if(debugprint)print*,
'sample ',varname,
' = ',ncfrst(im/2,(jsta+jend)/2)
2209 call nemsio_getheadvar(nfile,trim(varname),nprec,iret)
2211 print*,varname,
" not found in file-Assigned zero"
2214 call mpi_bcast(nprec,1,mpi_integer,0,mpi_comm_comp,iret)
2215 if(debugprint)print*,
'sample ',varname,
' = ',nprec
2219 call nemsio_getheadvar(nfile,trim(varname),nphs,iret)
2221 print*,varname,
" not found in file-Assigned zero"
2224 call mpi_bcast(nphs,1,mpi_integer,0,mpi_comm_comp,iret)
2225 if(debugprint)print*,
'sample ',varname,
' = ',nphs
2229 call nemsio_getheadvar(nfile,trim(varname),nclod,iret)
2231 print*,varname,
" not found in file-Assigned zero"
2234 call mpi_bcast(nclod,1,mpi_integer,0,mpi_comm_comp,iret)
2235 if(debugprint)print*,
'sample ',varname,
' = ',nclod
2239 call nemsio_getheadvar(nfile,trim(varname),nheat,iret)
2241 print*,varname,
" not found in file-Assigned zero"
2244 call mpi_bcast(nheat,1,mpi_integer,0,mpi_comm_comp,iret)
2245 if(debugprint)print*,
'sample ',varname,
' = ',nheat
2249 call nemsio_getheadvar(nfile,trim(varname),nrdlw,iret)
2251 print*,varname,
" not found in file-Assigned zero"
2254 call mpi_bcast(nrdlw,1,mpi_integer,0,mpi_comm_comp,iret)
2255 if(debugprint)print*,
'sample ',varname,
' = ',nrdlw
2259 call nemsio_getheadvar(nfile,trim(varname),nrdsw,iret)
2261 print*,varname,
" not found in file-Assigned zero"
2264 call mpi_bcast(nrdsw,1,mpi_integer,0,mpi_comm_comp,iret)
2265 if(debugprint)print*,
'sample ',varname,
' = ',nrdsw
2269 call nemsio_getheadvar(nfile,trim(varname),nsrfc,iret)
2271 print*,varname,
" not found in file-Assigned zero"
2274 call mpi_bcast(nsrfc,1,mpi_integer,0,mpi_comm_comp,iret)
2275 if(debugprint)print*,
'sample ',varname,
' = ',nsrfc
2342 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2343 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2344 ,l,impf,jmpf,nframe,buf)
2345 avrain=buf(im/2,(jsta+jend)/2)
2346 if(debugprint)print*,
'sample ',varname,
' = ',avrain
2351 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2352 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2353 ,l,impf,jmpf,nframe,buf)
2354 avcnvc=buf(im/2,(jsta+jend)/2)
2355 if(debugprint)print*,
'sample ',varname,
' = ',avcnvc
2360 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2361 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2362 ,l,impf,jmpf,nframe,buf)
2363 ardlw=buf(im/2,(jsta+jend)/2)
2364 if(debugprint)print*,
'sample ',varname,
' = ',ardlw
2369 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2370 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2371 ,l,impf,jmpf,nframe,buf)
2372 ardsw=buf(im/2,(jsta+jend)/2)
2373 if(debugprint)print*,
'sample ',varname,
' = ',ardsw
2378 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2379 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2380 ,l,impf,jmpf,nframe,buf)
2381 asrfc=buf(im/2,(jsta+jend)/2)
2382 if(debugprint)print*,
'sample ',varname,
' = ',asrfc
2386 vcoordname=
'10 m above gnd'
2388 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2389 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2390 ,l,impf,jmpf,nframe,u10h)
2395 if(debugprint)print*,
'sample ',varname,
' = ',u10(im/2,(jsta+jend)/2)
2398 vcoordname=
'10 m above gnd'
2400 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2401 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2402 ,l,impf,jmpf,nframe,v10h)
2404 if(debugprint)print*,
'sample ',varname,
' = ',v10(im/2,(jsta+jend)/2)
2407 vcoordname=
'10 m above gnd'
2409 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2410 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2411 ,l,impf,jmpf,nframe,u10max)
2412 if(debugprint)print*,
'sample ',varname,
' = ',u10max(im/2,(jsta+jend)/2)
2415 vcoordname=
'10 m above gnd'
2417 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2418 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2419 ,l,impf,jmpf,nframe,v10max)
2420 if(debugprint)print*,
'sample ',varname,
' = ',v10max(im/2,(jsta+jend)/2)
2426 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2427 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2428 ,l,impf,jmpf,nframe,smstav)
2429 if(debugprint)print*,
'sample ',varname,
' = ',smstav(im/2,(jsta+jend)/2)
2430 if(debugprint)print*,
'MAX/MIN ',varname,
' = ' &
2431 ,maxval(smstav),minval(smstav)
2436 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2437 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2438 ,l,impf,jmpf,nframe,smstot)
2439 if(debugprint)print*,
'sample ',varname,
' = ',smstot(im/2,(jsta+jend)/2)
2445 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2446 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2447 ,l,impf,jmpf,nframe,sfcevp)
2456 where(sfcevp /= spval)ivgtyp=nint(sfcevp)
2457 if(debugprint)print*,
'sample ',varname,
' = ',ivgtyp(im/2,(jsta+jend)/2)
2462 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2463 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2464 ,l,impf,jmpf,nframe,sfcevp)
2465 where(sfcevp /= spval)isltyp=nint(sfcevp)
2466 if(debugprint)print*,
'sample ',varname,
' = ',isltyp(im/2,(jsta+jend)/2)
2486 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2487 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2488 ,l,impf,jmpf,nframe,sfcevp)
2489 if(debugprint)print*,
'sample ',varname,
' = ',sfcevp(im/2,(jsta+jend)/2)
2494 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2495 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2496 ,l,impf,jmpf,nframe,sfcexc)
2497 if(debugprint)print*,
'sample ',varname,
' = ',sfcexc(im/2,(jsta+jend)/2)
2498 if(debugprint)print*,
'MAX/MIN ',varname,
' = ' &
2499 ,maxval(sfcexc),minval(sfcexc)
2504 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2505 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2506 ,l,impf,jmpf,nframe,acsnow)
2507 if(debugprint)print*,
'sample ',varname,
' = ',acsnow(im/2,(jsta+jend)/2)
2512 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2513 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2514 ,l,impf,jmpf,nframe,acsnom)
2515 if(debugprint)print*,
'sample ',varname,
' = ',acsnom(im/2,(jsta+jend)/2)
2520 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2521 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2522 ,l,impf,jmpf,nframe,sst)
2523 if(debugprint)print*,
'sample ',varname,
' = ',sst(im/2,(jsta+jend)/2)
2527 vcoordname=
'mid layer'
2531 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2532 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2533 ,l,impf,jmpf,nframe,el_pbl(1,jsta_2l,ll))
2534 if(debugprint)print*,
'sample l ',varname,
' = ',ll,el_pbl(im/2,(jsta+jend)/2,ll)
2538 vcoordname=
'mid layer'
2542 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2543 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2544 ,l,impf,jmpf,nframe,exch_h(1,jsta_2l,ll))
2545 if(debugprint)print*,
'sample l ',varname,
' = ',ll,exch_h(im/2,(jsta+jend)/2,ll)
2551 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2552 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2553 ,l,impf,jmpf,nframe,thz0)
2554 if(debugprint)print*,
'sample ',varname,
' = ',thz0(im/2,(jsta+jend)/2)
2559 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2560 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2561 ,l,impf,jmpf,nframe,qz0)
2562 if(debugprint)print*,
'sample ',varname,
' = ',qz0(im/2,(jsta+jend)/2)
2567 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2568 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2569 ,l,impf,jmpf,nframe,uz0)
2570 if(debugprint)print*,
'sample ',varname,
' = ',uz0(im/2,(jsta+jend)/2)
2575 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2576 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2577 ,l,impf,jmpf,nframe,vz0)
2578 if(debugprint)print*,
'sample ',varname,
' = ',vz0(im/2,(jsta+jend)/2)
2599 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2600 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2601 ,l,impf,jmpf,nframe,htop)
2602 where(htop /= spval)htop=float(lm)-htop+1.0
2604 if(debugprint)print*,
'sample ',varname,
' = ',htop(im/2,(jsta+jend)/2)
2610 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2611 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2612 ,l,impf,jmpf,nframe,hbot)
2613 where(hbot /= spval)hbot=float(lm)-hbot+1.0
2615 if(debugprint)print*,
'sample ',varname,
' = ',hbot(im/2,(jsta+jend)/2)
2620 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2621 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2622 ,l,impf,jmpf,nframe,htopd)
2623 where(htopd /= spval)htopd=float(lm)-htopd+1.0
2625 if(debugprint)print*,
'sample ',varname,
' = ',htopd(im/2,(jsta+jend)/2)
2630 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2631 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2632 ,l,impf,jmpf,nframe,hbotd)
2633 where(hbotd /= spval)hbotd=float(lm)-hbotd+1.0
2635 if(debugprint)print*,
'sample ',varname,
' = ',hbotd(im/2,(jsta+jend)/2)
2640 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2641 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2642 ,l,impf,jmpf,nframe,htops)
2643 where(htops /= spval)htops=float(lm)-htops+1.0
2645 if(debugprint)print*,
'sample ',varname,
' = ',htops(im/2,(jsta+jend)/2)
2650 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2651 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2652 ,l,impf,jmpf,nframe,hbots)
2653 where(hbots /= spval)hbots=float(lm)-hbots+1.0
2655 if(debugprint)print*,
'sample ',varname,
' = ',hbots(im/2,(jsta+jend)/2)
2660 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2661 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2662 ,l,impf,jmpf,nframe,cuppt)
2663 if(debugprint)print*,
'sample ',varname,
' = ',cuppt(im/2,(jsta+jend)/2)
2668 call getnemsandscatter(me,nfile,im,jm,jsta,jsta_2l &
2669 ,jend_2u,mpi_comm_comp,icnt,idsp,spval,varname,vcoordname &
2670 ,l,impf,jmpf,nframe,cprate)
2671 if(debugprint)print*,
'sample ',varname,
' = ',cprate(im/2,(jsta+jend)/2)
2679 IF(abs(t(i,j,l))>1.0e-3 .and. (wh(i,j,1) < spval)) &
2680 omga(i,j,l) = -wh(i,j,l)*pmid(i,j,l)*g &
2681 / (rd*t(i,j,l)*(1.+d608*q(i,j,l)))
2689 CALL table(ptbl,ttbl,pt, &
2690 rdq,rdth,rdp,rdthe,pl,thl,qs0,sqs,sthe,the0)
2692 CALL tableq(ttblq,rdpq,rdtheq,plq,thl,stheq,the0q)
2697 WRITE(6,*)
' SPL (POSTED PRESSURE LEVELS) BELOW: '
2698 WRITE(6,51) (spl(l),l=1,lsm)
2699 50
FORMAT(14(f4.1,1x))
2700 51
FORMAT(8(f8.1,1x))
2711 IF (pthresh > 0.)
THEN
2712 pthresh = 0.01*dtq2/3.6e6
2716 tsrfc=float(nsrfc)/tsph
2717 if(me==0)
write(6,*)
'tsfrc ',tsrfc,nsrfc,tsph
2718 IF(nsrfc==0)tsrfc=float(ifhr)
2719 trdlw=float(nrdlw)/tsph
2720 IF(nrdlw==0)trdlw=float(ifhr)
2721 trdsw=float(nrdsw)/tsph
2722 IF(nrdsw==0)trdsw=float(ifhr)
2723 theat=float(nheat)/tsph
2724 IF(nheat==0)theat=float(ifhr)
2725 tclod=float(nclod)/tsph
2726 IF(nclod==0)tclod=float(ifhr)
2727 tprec=float(nprec)/tsph
2728 IF(nprec==0)tprec=float(ifhr)
2730 if(me==0)print*,
'TSRFC TRDLW TRDSW THEAT TCLOD TPREC= ' &
2731 ,tsrfc, trdlw, trdsw, theat, tclod, tprec
2752 alsl(l) = alog(spl(l))
2757 print*,
'writing out igds'
2761 IF(maptype==203)
THEN
2765 WRITE(igdout)latstart
2766 WRITE(igdout)lonstart
2776 WRITE(igdout)latlast
2777 WRITE(igdout)lonlast
2778 ELSE IF(maptype==205)
THEN
2782 WRITE(igdout)latstart
2783 WRITE(igdout)lonstart
2790 WRITE(igdout)latlast
2791 WRITE(igdout)lonlast
2796 open(111,file=
'copygb_gridnav.txt',form=
'formatted' &
2798 IF(maptype==203)
THEN
2799 write(111,1000) 2*im-1,jm,latstart,lonstart,cenlon, &
2800 nint(dxval*107.),nint(dyval*110.),cenlat,cenlat
2801 ELSE IF(maptype==205)
THEN
2802 if(grib==
"grib2")
then
2803 write(111,1000) im,jm,latstart/1000,lonstart/1000,cenlon/1000, &
2804 nint(dxval*107.)/1000,nint(dyval*110.)/1000, &
2805 cenlat/1000,cenlat/1000, &
2806 latlast/1000,lonlast/1000
2809 1000
format(
'255 3 ',2(i4,x),i6,x,i7,x,
'8 ',i7,x,2(i6,x),
'0 64', &
2813 IF (maptype==205)
THEN
2814 open(112,file=
'latlons_corners.txt',form=
'formatted' &
2816 if(grib==
"grib2")
then
2817 write(112,1001)latstart/1000,(lonstart/1000)-360000, &
2819 lonse/1000,latnw/1000,lonnw/1000,latlast/1000, &
2820 (lonlast/1000)-360000
2822 1001
format(4(i6,x,i7,x))
2829 call nemsio_close(nfile,iret=status)
2831 if(me==0)
write(0,*)
'end of INIT_NEMS'
dvdxdudy() computes dudy, dvdx, uwnd