From b4672ab0c3b5685a8e1116b670bbfad82f133642 Mon Sep 17 00:00:00 2001 From: XiaqiongZhou-NOAA <48254930+XiaqiongZhou-NOAA@users.noreply.github.com> Date: Wed, 10 Jun 2020 12:12:10 -0400 Subject: [PATCH 1/6] Merge GFDL FV3 dynamic core new (201912) version (#65) * Change 'mytile' to 'mygrid' corresponding to the change in atmos_cubed_sphere --- CMakeLists.txt | 2 +- atmos_cubed_sphere | 2 +- atmos_model.F90 | 10 +++++----- ccpp/physics | 2 +- 4 files changed, 8 insertions(+), 8 deletions(-) diff --git a/CMakeLists.txt b/CMakeLists.txt index 639030cfc..0af2ea9a7 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -65,7 +65,7 @@ target_link_libraries(fv3core PRIVATE fms) target_link_libraries(fv3core PRIVATE gfsphysics) target_link_libraries(fv3core PRIVATE ipd) -target_include_directories(fv3core PRIVATE ${ESMF_MOD}) +target_include_directories(fv3core PRIVATE atmos_cubed_sphere ${ESMF_MOD}) # end of fv3core diff --git a/atmos_cubed_sphere b/atmos_cubed_sphere index 66c8df235..3ff1ed2ad 160000 --- a/atmos_cubed_sphere +++ b/atmos_cubed_sphere @@ -1 +1 @@ -Subproject commit 66c8df23500bde286907a26cb3feab987dd2dba5 +Subproject commit 3ff1ed2adb10bbe892c9d9d010bb5b11c66ce425 diff --git a/atmos_model.F90 b/atmos_model.F90 index c024ea295..b4e39f171 100644 --- a/atmos_model.F90 +++ b/atmos_model.F90 @@ -78,7 +78,7 @@ module atmos_model_mod use atmosphere_mod, only: atmosphere_scalar_field_halo use atmosphere_mod, only: atmosphere_get_bottom_layer use atmosphere_mod, only: set_atmosphere_pelist -use atmosphere_mod, only: Atm, mytile +use atmosphere_mod, only: Atm, mygrid use block_control_mod, only: block_control_type, define_blocks_packed use DYCORE_typedefs, only: DYCORE_data_type, DYCORE_diag_type #ifdef CCPP @@ -604,8 +604,8 @@ subroutine atmos_model_init (Atmos, Time_init, Time, Time_step) Init_parm%area => Atmos%area Init_parm%tracer_names => tracer_names #ifdef CCPP - Init_parm%restart = Atm(mytile)%flagstruct%warm_start - Init_parm%hydrostatic = Atm(mytile)%flagstruct%hydrostatic + Init_parm%restart = Atm(mygrid)%flagstruct%warm_start + Init_parm%hydrostatic = Atm(mygrid)%flagstruct%hydrostatic #endif #ifdef INTERNAL_FILE_NML @@ -677,7 +677,7 @@ subroutine atmos_model_init (Atmos, Time_init, Time, Time_step) endif endif - Atm(mytile)%flagstruct%do_skeb = IPD_Control%do_skeb + Atm(mygrid)%flagstruct%do_skeb = IPD_Control%do_skeb ! initialize the IAU module call iau_initialize (IPD_Control,IAU_data,Init_parm) @@ -698,7 +698,7 @@ subroutine atmos_model_init (Atmos, Time_init, Time, Time_step) call FV3GFS_diag_register (IPD_Diag, Time, Atm_block, IPD_Control, Atmos%lon, Atmos%lat, Atmos%axes) call IPD_initialize_rst (IPD_Control, IPD_Data, IPD_Diag, IPD_Restart, Init_parm) #ifdef CCPP - call FV3GFS_restart_read (IPD_Data, IPD_Restart, Atm_block, IPD_Control, Atmos%domain, Atm(mytile)%flagstruct%warm_start) + call FV3GFS_restart_read (IPD_Data, IPD_Restart, Atm_block, IPD_Control, Atmos%domain, Atm(mygrid)%flagstruct%warm_start) #else call FV3GFS_restart_read (IPD_Data, IPD_Restart, Atm_block, IPD_Control, Atmos%domain) #endif diff --git a/ccpp/physics b/ccpp/physics index 6a6dd2c7b..693d0016c 160000 --- a/ccpp/physics +++ b/ccpp/physics @@ -1 +1 @@ -Subproject commit 6a6dd2c7beaeb8d5dd848341d4becf52f05fe0e2 +Subproject commit 693d0016c1552a3660b82f61ab7d17ade414d023 From 02ce4ad4812bd91356e8a975567e83a346ddb18d Mon Sep 17 00:00:00 2001 From: Jun Wang <37633869+junwang-noaa@users.noreply.github.com> Date: Fri, 12 Jun 2020 14:04:34 -0400 Subject: [PATCH 2/6] GFS.v16.0.4 physics update (#128) * physics update from GFS.v16.0.4 * GFS.v16.0.4 physics udpate * remove whitespaces in sfc_diff.f * keep z0 unchanged in coupled mode in sfc_diff.f * fix IPD run * point to NCAR ccpp-physics branch Co-authored-by: Jun Wang --- ccpp/physics | 2 +- gfsphysics/GFS_layer/GFS_physics_driver.F90 | 4 +- gfsphysics/physics/radsw_datatb.f | 2 +- gfsphysics/physics/samfdeepcnv.f | 6 +-- gfsphysics/physics/satmedmfvdifq.f | 43 +++++++++++++++++---- gfsphysics/physics/sfc_diff.f | 28 +++++--------- io/FV3GFS_io.F90 | 2 + 7 files changed, 52 insertions(+), 35 deletions(-) diff --git a/ccpp/physics b/ccpp/physics index 693d0016c..571ff99bd 160000 --- a/ccpp/physics +++ b/ccpp/physics @@ -1 +1 @@ -Subproject commit 693d0016c1552a3660b82f61ab7d17ade414d023 +Subproject commit 571ff99bdadb418ef978c1ed329023548c3a26ae diff --git a/gfsphysics/GFS_layer/GFS_physics_driver.F90 b/gfsphysics/GFS_layer/GFS_physics_driver.F90 index 962aaee54..9a4e54cbd 100644 --- a/gfsphysics/GFS_layer/GFS_physics_driver.F90 +++ b/gfsphysics/GFS_layer/GFS_physics_driver.F90 @@ -2387,7 +2387,7 @@ subroutine GFS_physics_driver & call satmedmfvdifq(ix, im, levs, nvdiff, ntcw, ntiw, ntke, & dvdt, dudt, dtdt, dqdt, & Statein%ugrs, Statein%vgrs, Statein%tgrs, Statein%qgrs, & - Radtend%htrsw, Radtend%htrlw, xmu, garea, & + Radtend%htrsw, Radtend%htrlw, xmu, garea, islmsk, snowd3, & Statein%prsik(1,1), rb, Sfcprop%zorl, Diag%u10m, Diag%v10m, & Sfcprop%ffmm, Sfcprop%ffhh, Sfcprop%tsfc, hflxq, evapq, & stress, wind, kpbl, Statein%prsi, del, Statein%prsl, & @@ -2640,7 +2640,7 @@ subroutine GFS_physics_driver & call satmedmfvdifq(ix, im, levs, nvdiff, ntcw, ntiwx, ntkev, & dvdt, dudt, dtdt, dvdftra, & Statein%ugrs, Statein%vgrs, Statein%tgrs, vdftra, & - Radtend%htrsw, Radtend%htrlw, xmu, garea, & + Radtend%htrsw, Radtend%htrlw, xmu, garea, islmsk, snowd3, & Statein%prsik(1,1), rb, Sfcprop%zorl, Diag%u10m, Diag%v10m, & Sfcprop%ffmm, Sfcprop%ffhh, Sfcprop%tsfc, hflxq, evapq, & stress, wind, kpbl, Statein%prsi, del, Statein%prsl, & diff --git a/gfsphysics/physics/radsw_datatb.f b/gfsphysics/physics/radsw_datatb.f index ba57d075f..9188d889f 100644 --- a/gfsphysics/physics/radsw_datatb.f +++ b/gfsphysics/physics/radsw_datatb.f @@ -2552,7 +2552,7 @@ module module_radsw_sflux ! !> band index (3rd index in array sfluxref described below) integer, dimension(nblow:nbhgh), public :: ibx - data layreffr/ 18,30, 6, 3, 3, 8, 2, 6, 1, 2, 0,32,58,49 / + data layreffr/ 18,30, 6, 3, 3, 8, 2, 6, 1, 2, 0,32,42,49 / data ix1 / 1, 1, 1, 1, 0, 1, 1, 0, 1, 0, 0, 0, 3, 0 / data ix2 / 5, 2, 5, 2, 0, 2, 6, 0, 6, 0, 0, 0, 6, 0 / data ibx / 1, 1, 1, 2, 2, 3, 4, 3, 5, 4, 5, 6, 2, 7 / diff --git a/gfsphysics/physics/samfdeepcnv.f b/gfsphysics/physics/samfdeepcnv.f index 7de9a4c90..25a17d5f4 100644 --- a/gfsphysics/physics/samfdeepcnv.f +++ b/gfsphysics/physics/samfdeepcnv.f @@ -217,7 +217,7 @@ subroutine samfdeepcnv(im,ix,km,delt,itc,ntc,ntk,ntr,delp, parameter(clamd=0.03,tkemx=0.65,tkemn=0.05) parameter(dtke=tkemx-tkemn) parameter(dbeta=0.1) - parameter(cthk=200.,dthk=25.) + parameter(cthk=150.,dthk=25.) parameter(cinpcrmx=180.,cinpcrmn=120.) ! parameter(cinacrmx=-120.,cinacrmn=-120.) parameter(cinacrmx=-120.,cinacrmn=-80.) @@ -1191,9 +1191,7 @@ subroutine samfdeepcnv(im,ix,km,delt,itc,ntc,ntk,ntr,delp, ! k = kbcon(i) dp = 1000. * del(i,k) - xmbmax(i) = dp / (2. * g * dt2) -! -! xmbmax(i) = dp / (g * dt2) + xmbmax(i) = dp / (g * dt2) ! ! mbdt(i) = 0.1 * dp / g ! diff --git a/gfsphysics/physics/satmedmfvdifq.f b/gfsphysics/physics/satmedmfvdifq.f index 478e909f0..77ac36b97 100644 --- a/gfsphysics/physics/satmedmfvdifq.f +++ b/gfsphysics/physics/satmedmfvdifq.f @@ -19,7 +19,8 @@ ! !---------------------------------------------------------------------- subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, - & dv,du,tdt,rtg,u1,v1,t1,q1,swh,hlw,xmu,garea, +!wz & dv,du,tdt,rtg,u1,v1,t1,q1,swh,hlw,xmu,garea, + & dv,du,tdt,rtg,u1,v1,t1,q1,swh,hlw,xmu,garea,islimsk,snwdph, & psk,rbsoil,zorl,u10m,v10m,fm,fh, & tsea,heat,evap,stress,spd1,kpbl, & prsi,del,prsl,prslk,phii,phil,delt, @@ -38,6 +39,10 @@ subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, !---------------------------------------------------------------------- integer ix, im, km, ntrac, ntcw, ntiw, ntke integer kpbl(im), kinver(im) +! +!wz + integer islimsk(im) + real(kind=kind_phys), dimension(im,3), intent(in) :: snwdph ! real(kind=kind_phys) delt, xkzm_m, xkzm_h, xkzm_s, dspfac, & bl_upfr, bl_dnfr @@ -156,6 +161,8 @@ subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, & zlup, zldn, bsum, & tem, tem1, tem2, & ptem, ptem0, ptem1, ptem2 +!wz + real(kind=kind_phys) xkzm_mp, xkzm_hp ! real(kind=kind_phys) ck0, ck1, ch0, ch1, ce0, rchck ! @@ -173,7 +180,7 @@ subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, parameter(gamcrt=3.,gamcrq=0.,sfcfrac=0.1) parameter(vk=0.4,rimin=-100.) parameter(rbcr=0.25,zolcru=-0.02,tdzmin=1.e-3) - parameter(rlmn=30.,rlmn1=5.,rlmn2=15.) + parameter(rlmn=30.,rlmn1=5.,rlmn2=10.) parameter(rlmx=300.,elmx=300.) parameter(prmin=0.25,prmax=4.0) parameter(pr0=1.0,prtke=1.0,prscu=0.67) @@ -183,7 +190,7 @@ subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, parameter(aphi5=5.,aphi16=16.) parameter(elmfac=1.0,elefac=1.0,cql=100.) parameter(dw2min=1.e-4,dkmax=1000.,xkgdx=5000.) - parameter(qlcr=3.5e-5,zstblmax=2500.,xkzinv=0.15) + parameter(qlcr=3.5e-5,zstblmax=2500.,xkzinv=0.1) parameter(h1=0.33333333) parameter(ck0=0.4,ck1=0.15,ch0=0.4,ch1=0.15) parameter(ce0=0.4) @@ -254,17 +261,37 @@ subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, ! xkzm_hx = 0.01 + (xkzm_h - 0.01)/(xkgdx-5.) * (gdx-5.) ! xkzm_mx = 0.01 + (xkzm_h - 0.01)/(xkgdx-5.) * (gdx-5.) ! +!wz do i=1,im + xkzm_mp = xkzm_m + xkzm_hp = xkzm_h +! + if( islimsk(i) == 1 .and. snwdph(i,1) > 10.0 ) then ! over land + if (rbsoil(i) > 0. .and. rbsoil(i) <= 0.25) then + xkzm_mp = xkzm_m * (1.0 - rbsoil(i)/0.25)**2 + + & 0.1 * (1.0 - (1.0-rbsoil(i)/0.25)**2) + xkzm_hp = xkzm_h * (1.0 - rbsoil(i)/0.25)**2 + + & 0.1 * (1.0 - (1.0-rbsoil(i)/0.25)**2) + else if (rbsoil(i) > 0.25) then + xkzm_mp = 0.1 + xkzm_hp = 0.1 + endif + endif +!# kx1(i) = 1 tx1(i) = 1.0 / prsi(i,1) tx2(i) = tx1(i) if(gdx(i) >= xkgdx) then - xkzm_hx(i) = xkzm_h - xkzm_mx(i) = xkzm_m +!wz xkzm_hx(i) = xkzm_h +!wz xkzm_mx(i) = xkzm_m + xkzm_hx(i) = xkzm_hp + xkzm_mx(i) = xkzm_mp else tem = 1. / (xkgdx - 5.) - tem1 = (xkzm_h - 0.01) * tem - tem2 = (xkzm_m - 0.01) * tem +!wz tem1 = (xkzm_h - 0.01) * tem +!wz tem2 = (xkzm_m - 0.01) * tem + tem1 = (xkzm_hp - 0.01) * tem + tem2 = (xkzm_mp - 0.01) * tem ptem = gdx(i) - 5. xkzm_hx(i) = 0.01 + tem1 * ptem xkzm_mx(i) = 0.01 + tem2 * ptem @@ -699,7 +726,7 @@ subroutine satmedmfvdifq(ix,im,km,ntrac,ntcw,ntiw,ntke, ! tem1 = (tvx(i,k+1)-tvx(i,k)) * rdzt(i,k) ! if(tem1 > 1.e-5) then tem1 = tvx(i,k+1)-tvx(i,k) - if(tem1 > 0.) then + if(tem1 > 0. .and. islimsk(i) /= 1 ) then xkzo(i,k) = min(xkzo(i,k), xkzinv) xkzmo(i,k) = min(xkzmo(i,k), xkzinv) rlmnz(i,k) = min(rlmnz(i,k), rlmn2) diff --git a/gfsphysics/physics/sfc_diff.f b/gfsphysics/physics/sfc_diff.f index 5874c01c1..22bfe4289 100644 --- a/gfsphysics/physics/sfc_diff.f +++ b/gfsphysics/physics/sfc_diff.f @@ -139,17 +139,12 @@ subroutine sfc_diff(im,ps,t1,q1,z1, wind, !intent(in) z0max = max(z0max, 1.0e-6) ! czilc = 10.0 ** (- (0.40/0.07) * z0) ! fei's canopy height dependance of czil -! czilc = 0.8 - -! tem1 = 1.0 - sigmaf(i) -! ztmax = z0max*exp( - tem1*tem1 -! & * czilc*ca*sqrt(ustar(i,1)*(0.01/1.5e-05))) -! - czilc = 10.0 ** (- 4. * z0max) ! Trier et al. (2011, WAF) - ztmax = z0max * exp( - czilc * ca - & * 258.2 * sqrt(ustar(i,1)*z0max) ) - + czilc = 0.8 + tem1 = 1.0 - sigmaf(i) + ztmax = z0max*exp( - tem1*tem1 + & * czilc*ca*sqrt(ustar(i,1)*(0.01/1.5e-05))) + ! mg, sfc-perts: add surface perturbations to ztmax/z0max ratio over land if (ztpert(i) /= 0.0) then ztmax = ztmax * (10.**ztpert(i)) @@ -183,16 +178,11 @@ subroutine sfc_diff(im,ps,t1,q1,z1, wind, !intent(in) ! czilc = 10.0 ** (- (0.40/0.07) * z0) ! fei's canopy height ! dependance of czil -! czilc = 0.8 + czilc = 0.8 -! tem1 = 1.0 - sigmaf(i) -! ztmax = z0max*exp( - tem1*tem1 -! & * czilc*ca*sqrt(ustar(i,2)*(0.01/1.5e-05))) -! - czilc = 10.0 ** (- 4. * z0max) ! Trier et al. (2011, WAF) - ztmax = z0max * exp( - czilc * ca - & * 258.2 * sqrt(ustar(i,2)*z0max) ) -! + tem1 = 1.0 - sigmaf(i) + ztmax = z0max*exp( - tem1*tem1 + & * czilc*ca*sqrt(ustar(i,2)*(0.01/1.5e-05))) ztmax = max(ztmax, 1.0e-6) ! call stability diff --git a/io/FV3GFS_io.F90 b/io/FV3GFS_io.F90 index 33ff21080..97269f1a5 100644 --- a/io/FV3GFS_io.F90 +++ b/io/FV3GFS_io.F90 @@ -1176,6 +1176,7 @@ subroutine sfc_prop_restart_read (Sfcprop, Atm_block, Model, fv_domain) endif endif +#ifdef CCPP if (nint(sfc_var3ice(1,1,1)) == -9999) then if (Model%me == Model%master ) call mpp_error(NOTE, 'gfs_driver::surface_props_input - computing tiice') do nb = 1, Atm_block%nblks @@ -1186,6 +1187,7 @@ subroutine sfc_prop_restart_read (Sfcprop, Atm_block, Model, fv_domain) enddo endif +#endif !#endif if(Model%frac_grid) then ! 3-way composite From ea71b79011ddbc1e022e203b7e15d6d1c90d314f Mon Sep 17 00:00:00 2001 From: Dom Heinzeller Date: Mon, 22 Jun 2020 07:35:54 -0600 Subject: [PATCH 3/6] Update for GFDL_atmos_cubed_sphere (dycore GNU bugfix) (#131) --- atmos_cubed_sphere | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atmos_cubed_sphere b/atmos_cubed_sphere index 3ff1ed2ad..205cc7622 160000 --- a/atmos_cubed_sphere +++ b/atmos_cubed_sphere @@ -1 +1 @@ -Subproject commit 3ff1ed2adb10bbe892c9d9d010bb5b11c66ce425 +Subproject commit 205cc762231f6b558c9bc2253debf41aab6cd89b From 6c217fcbebf026a91fb178cf98a11a27cf5fe19f Mon Sep 17 00:00:00 2001 From: Dom Heinzeller Date: Mon, 29 Jun 2020 09:36:50 -0600 Subject: [PATCH 4/6] Bugfix for regional runs when dycore is compiled in double precision (#133) * Update .gitmodules and submodule pointer for fv3atm for code review and testing * Revert change to .gitmodules and update submodule pointer for GFDL_atmos_cubed_sphere --- atmos_cubed_sphere | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/atmos_cubed_sphere b/atmos_cubed_sphere index 205cc7622..61a6c1d77 160000 --- a/atmos_cubed_sphere +++ b/atmos_cubed_sphere @@ -1 +1 @@ -Subproject commit 205cc762231f6b558c9bc2253debf41aab6cd89b +Subproject commit 61a6c1d776871791a75d7145c7de3b573769241d From c19e7ef9d8ecdacd57d315906da70d95f97c24fb Mon Sep 17 00:00:00 2001 From: Dom Heinzeller Date: Mon, 29 Jun 2020 14:17:38 -0600 Subject: [PATCH 5/6] Update .gitmodules and submodule pointers for GFDL_atmos_cubed_sphere and ccpp-physics --- .gitmodules | 12 ++++++++---- atmos_cubed_sphere | 2 +- ccpp/physics | 2 +- 3 files changed, 10 insertions(+), 6 deletions(-) diff --git a/.gitmodules b/.gitmodules index 2fdeca40a..1e1a6ebd0 100644 --- a/.gitmodules +++ b/.gitmodules @@ -1,12 +1,16 @@ [submodule "atmos_cubed_sphere"] path = atmos_cubed_sphere - url = https://github.com/NCAR/GFDL_atmos_cubed_sphere - branch = dtc/develop + #url = https://github.com/NCAR/GFDL_atmos_cubed_sphere + #branch = dtc/develop + url = https://github.com/climbfuji/GFDL_atmos_cubed_sphere + branch = update_dtc_develop_from_emc_and_delz_diag_bugfix [submodule "ccpp/framework"] path = ccpp/framework url = https://github.com/NCAR/ccpp-framework branch = dtc/develop [submodule "ccpp/physics"] path = ccpp/physics - url = https://github.com/NCAR/ccpp-physics - branch = dtc/develop + #url = https://github.com/NCAR/ccpp-physics + #branch = dtc/develop + url = https://github.com/climbfuji/ccpp-physics + branch = update_dtc_develop_from_master_20200629 diff --git a/atmos_cubed_sphere b/atmos_cubed_sphere index b3bd04f2d..cfd9f44d0 160000 --- a/atmos_cubed_sphere +++ b/atmos_cubed_sphere @@ -1 +1 @@ -Subproject commit b3bd04f2d80f2adbb92016cce48f64addb05c0f7 +Subproject commit cfd9f44d06f644e441b9a62d0982ba8dc43905fc diff --git a/ccpp/physics b/ccpp/physics index 19998f0a6..ba6287003 160000 --- a/ccpp/physics +++ b/ccpp/physics @@ -1 +1 @@ -Subproject commit 19998f0a6aa3d5e265ae0bd080a7cddf9f07a3c1 +Subproject commit ba628700394a7f63ccd4d7007adbddc1e8d7770c From c0976ce2a2e8e34e1b6c77a653ec9085f7608434 Mon Sep 17 00:00:00 2001 From: Dom Heinzeller Date: Tue, 30 Jun 2020 10:35:01 -0600 Subject: [PATCH 6/6] Revert change to .gitmodules and update submodule pointer for GFDL_atmos_cubed_sphere and ccpp-physics --- .gitmodules | 12 ++++-------- atmos_cubed_sphere | 2 +- ccpp/physics | 2 +- 3 files changed, 6 insertions(+), 10 deletions(-) diff --git a/.gitmodules b/.gitmodules index 1e1a6ebd0..2fdeca40a 100644 --- a/.gitmodules +++ b/.gitmodules @@ -1,16 +1,12 @@ [submodule "atmos_cubed_sphere"] path = atmos_cubed_sphere - #url = https://github.com/NCAR/GFDL_atmos_cubed_sphere - #branch = dtc/develop - url = https://github.com/climbfuji/GFDL_atmos_cubed_sphere - branch = update_dtc_develop_from_emc_and_delz_diag_bugfix + url = https://github.com/NCAR/GFDL_atmos_cubed_sphere + branch = dtc/develop [submodule "ccpp/framework"] path = ccpp/framework url = https://github.com/NCAR/ccpp-framework branch = dtc/develop [submodule "ccpp/physics"] path = ccpp/physics - #url = https://github.com/NCAR/ccpp-physics - #branch = dtc/develop - url = https://github.com/climbfuji/ccpp-physics - branch = update_dtc_develop_from_master_20200629 + url = https://github.com/NCAR/ccpp-physics + branch = dtc/develop diff --git a/atmos_cubed_sphere b/atmos_cubed_sphere index cfd9f44d0..447b9e573 160000 --- a/atmos_cubed_sphere +++ b/atmos_cubed_sphere @@ -1 +1 @@ -Subproject commit cfd9f44d06f644e441b9a62d0982ba8dc43905fc +Subproject commit 447b9e573d6d6ab877185f2905f27e579107a2b9 diff --git a/ccpp/physics b/ccpp/physics index ba6287003..1b9ef1221 160000 --- a/ccpp/physics +++ b/ccpp/physics @@ -1 +1 @@ -Subproject commit ba628700394a7f63ccd4d7007adbddc1e8d7770c +Subproject commit 1b9ef122121321acae8a64832cd0c986f8cdcd39