diff --git a/.github/workflows/CI.yml b/.github/workflows/CI.yml index 365d1e83a3..e355d914c2 100644 --- a/.github/workflows/CI.yml +++ b/.github/workflows/CI.yml @@ -88,7 +88,16 @@ jobs: LIBACCESSOM2_ROOT: ${{ env.libaccessom2_dir }} run: | env - ./MOM_compile.csh --type ${{ matrix.TYPE }} --platform github --use_netcdf4 + case "${{ matrix.TYPE }}" in + CM2M|ICCM|ESM2M) + debug="" + ;; + *) + debug="--debug" + ;; + esac + echo ./MOM_compile.csh $debug --type ${{ matrix.TYPE }} --platform github --use_netcdf4 + ./MOM_compile.csh $debug --type ${{ matrix.TYPE }} --platform github --use_netcdf4 # ---------- # Test MOM-solo only currently @@ -97,6 +106,7 @@ jobs: uses: actions/checkout@v2 with: repository: mom-ocean/MOM5-examples + ref: master path: MOM5-examples - name: Run bowl1 cold start diff --git a/bin/mkmf.template.github b/bin/mkmf.template.github index 9663aecdd2..a2c589d8bb 100644 --- a/bin/mkmf.template.github +++ b/bin/mkmf.template.github @@ -41,7 +41,11 @@ FPPFLAGS := $(INCLUDE) CFLAGS := -D__IFC -O2 -no-pie $(shell nc-config --cflags) -I/usr/include/openmpi $(INCLUDE) -FFLAGS := -O2 -no-pie -fcray-pointer -fdefault-real-8 -ffree-line-length-none -fno-range-check $(shell nf-config --fflags) +FFLAGS := -O -g -no-pie -fcray-pointer -fdefault-real-8 -ffree-line-length-none -fno-range-check $(shell nf-config --fflags) + +ifdef DEBUG + FFLAGS := $(FFLAGS) -Wuninitialized -Wno-maybe-uninitialized -fcheck=bounds -Werror +endif LDFLAGS += -no-pie $(LIBS) diff --git a/exp/MOM_compile.csh b/exp/MOM_compile.csh index eb3bdc0bb8..420a872fdf 100755 --- a/exp/MOM_compile.csh +++ b/exp/MOM_compile.csh @@ -59,6 +59,8 @@ if ( $help ) then echo echo "--platform followed by the platform name that has a corresponding environ file in the ../bin dir, default is gfortran" echo + echo "--debug make a debugging build" + echo echo "--use_netcdf4 use NetCDF4, the default is NetCDF4. Warning: many of the standard experiments don't work with NetCDF4." echo echo "--no_environ do not source platform specific environment. Allows customising/overriding default environment" diff --git a/src/atmos_fv_dynamics/model/dyn_core.F90 b/src/atmos_fv_dynamics/model/dyn_core.F90 index ee43ba8b0e..396de266cb 100644 --- a/src/atmos_fv_dynamics/model/dyn_core.F90 +++ b/src/atmos_fv_dynamics/model/dyn_core.F90 @@ -13,7 +13,7 @@ module dyn_core #ifdef MARS_GCM use fv_pack, only: p_ref, fv_sponge_damp, fv_sponge_lev -#endif MARS_GCM +#endif use pft_module, only: pft2d @@ -249,7 +249,7 @@ subroutine cd_core(im, jm, km, nq, nx, jfirst, jlast, & allocate( fc(im,jsfc:jnfc) ) #else allocate( fc(jsfc:jnfc) ) -#endif +#endif #ifndef USE_LIMA @@ -322,7 +322,7 @@ subroutine cd_core(im, jm, km, nq, nx, jfirst, jlast, & call get_eta_level(km, p_ref, pfull, phalf, 0.01) #else call get_eta_level(km, 1.E5, pfull, phalf, 0.01) -#endif MARS_GCM +#endif do k=1,km @@ -891,7 +891,7 @@ subroutine geop_d(ptop, pe, delp, pk, wz, hs, pt, im, jm, km, & real dp #ifndef MARS_GCM parameter (dpmin = 0.02) ! unit: pascal -#endif +#endif integer :: ixjs, ixje @@ -1034,7 +1034,7 @@ subroutine geopk(ptop, pe, delp, pk, wz, hs, pt, im, jm, km, & #else ! rjw Note that dpmin was 0.02 in the memphis code parameter (dpmin = 0.1) ! unit: pascal -#endif MARS_GCM +#endif call fv_print_chksums( 'Entering geopk' ) call fv_array_check( LOC(hs) ) diff --git a/src/atmos_fv_dynamics/model/fv_arrays.F90 b/src/atmos_fv_dynamics/model/fv_arrays.F90 index 927e94d743..b823549076 100644 --- a/src/atmos_fv_dynamics/model/fv_arrays.F90 +++ b/src/atmos_fv_dynamics/model/fv_arrays.F90 @@ -87,14 +87,14 @@ module fv_arrays_mod #ifdef MARS_GCM real, allocatable :: delp_dt(:,:,:) real, allocatable :: mars_sfc_budg(:,:,:) -#endif MARS_GCM +#endif !! declarations from fv_pack.F90.1D2D #ifdef MARS_GCM integer, parameter :: NUMPTRS=28 #else integer, parameter :: NUMPTRS=26 -#endif MARS_GCM +#endif integer(POINTER_KIND) :: ptrArray(NUMPTRS) !this array contains addresses to all the variables to be shared !between physics and dynamics. @@ -163,7 +163,7 @@ module fv_arrays_mod ptr_u_srf, ptr_v_srf, ptr_u_dt, ptr_v_dt, ptr_t_dt, ptr_q_dt # ifdef MARS_GCM public :: ptr_delp_dt, ptr_mars_sfc_budg -# endif MARS_GCM +# endif #else !arrays themselves are public @@ -173,9 +173,9 @@ module fv_arrays_mod u_srf, v_srf, u_dt, v_dt, t_dt, q_dt # ifdef MARS_GCM public :: delp_dt, mars_sfc_budg -# endif MARS_GCM +# endif -#endif use_shared_pointers +#endif contains @@ -311,7 +311,7 @@ subroutine fv_arrays_init( nx, ny, nz, nt, shalo, nhalo, ighost, domain ) #ifdef MARS_GCM allocate( delp_dt(isg:ieg, js:je, nz) ) allocate( mars_sfc_budg(isg:ieg, js:je, 5) ) -#endif MARS_GCM +#endif end if isp = isg; iep = ieg jsp = js; jep = je @@ -347,7 +347,7 @@ subroutine fv_arrays_init( nx, ny, nz, nt, shalo, nhalo, ighost, domain ) #ifdef MARS_GCM ptr_delp_dt = LOC(delp_dt) ptr_mars_sfc_budg = LOC(mars_sfc_budg) -#endif MARS_GCM +#endif !the array ptrArray is now filled by equivalence() ptrArray( 1) = ptr_u ptrArray( 2) = ptr_v @@ -378,7 +378,7 @@ subroutine fv_arrays_init( nx, ny, nz, nt, shalo, nhalo, ighost, domain ) #ifdef MARS_GCM ptrArray(27) = ptr_delp_dt ptrArray(28) = ptr_mars_sfc_budg -#endif MARS_GCM +#endif endif call mpp_pset_broadcast_ptr( pset, ptrArray ) ptr_u = ptrArray( 1) @@ -410,7 +410,7 @@ subroutine fv_arrays_init( nx, ny, nz, nt, shalo, nhalo, ighost, domain ) #ifdef MARS_GCM ptr_delp_dt = ptrArray(27) ptr_mars_sfc_budg = ptrArray(28) -#endif MARS_GCM +#endif !isp,... index limits when you divide the computational domain by npex isp = is iep = ie @@ -556,7 +556,7 @@ subroutine fv_print_chksums(caller) delp_dt(isg:ieg,js:je,:) ) call mpp_pset_print_chksum( pset, trim(caller)//' mars_sfc_budg=', & mars_sfc_budg(isg:ieg,js:je,:) ) -#endif MARS_GCM +#endif call mpp_pset_print_stack_chksum(pset, caller) #endif return @@ -599,7 +599,7 @@ subroutine fv_arrays_exit #ifdef MARS_GCM deallocate ( delp_dt ) deallocate ( mars_sfc_budg ) -#endif MARS_GCM +#endif end if diff --git a/src/atmos_fv_dynamics/model/fv_arrays.h b/src/atmos_fv_dynamics/model/fv_arrays.h index 55b8e4c701..a2004887d0 100644 --- a/src/atmos_fv_dynamics/model/fv_arrays.h +++ b/src/atmos_fv_dynamics/model/fv_arrays.h @@ -17,7 +17,7 @@ use fv_arrays_mod, only: is,ie,js,je, isd,ied,jsd,jed, isg,ieg,jsg,jeg # ifdef MARS_GCM use fv_arrays_mod, only: ptr_delp_dt, ptr_mars_sfc_budg -# endif MARS_GCM +# endif #else !get arrays from fv_arrays_mod @@ -28,9 +28,9 @@ # ifdef MARS_GCM use fv_arrays_mod, only: delp_dt, mars_sfc_budg -# endif MARS_GCM +# endif -#endif use_shared_pointers +#endif implicit none diff --git a/src/atmos_fv_dynamics/model/fv_dynamics.F90 b/src/atmos_fv_dynamics/model/fv_dynamics.F90 index cbe58d6376..ae2e7c768a 100644 --- a/src/atmos_fv_dynamics/model/fv_dynamics.F90 +++ b/src/atmos_fv_dynamics/model/fv_dynamics.F90 @@ -446,11 +446,11 @@ subroutine fv_dynamics(im, jm, km, jfirst, jlast, & #if !defined (SW_DYN) call mp_send4d_ns(im, jm, km, 1, jfirst, jlast, 1, km, ng_d, ng_d, pt) -#endif +#endif call mp_send4d_ns(im, jm, km, 1, jfirst, jlast, 1, km, ng_d, ng_d, delpf) #if !defined (SW_DYN) call mp_recv4d_ns(im, jm, km, 1, jfirst, jlast, 1, km, ng_d, ng_d, pt) -#endif +#endif call mp_recv4d_ns(im, jm, km, 1, jfirst, jlast, 1, km, ng_d, ng_d, delpf) call fv_array_sync() #endif diff --git a/src/atmos_fv_dynamics/model/fv_pack.F90 b/src/atmos_fv_dynamics/model/fv_pack.F90 index 207302e326..5c485086e5 100644 --- a/src/atmos_fv_dynamics/model/fv_pack.F90 +++ b/src/atmos_fv_dynamics/model/fv_pack.F90 @@ -186,7 +186,7 @@ module fv_pack tra_step, dyn_step, dry_mass, print_freq, icase, & #ifdef MARS_GCM p_ref, fv_sponge_lev, fv_sponge_damp, & -#endif MARS_GCM +#endif layout, fv_pset_stack #else namelist /fv_core_nml/nlon, mlat, nlev, & @@ -201,7 +201,7 @@ module fv_pack use_tendency, do_ch4_chem, pft_phys, age_tracer, & #ifdef MARS_GCM p_ref, fv_sponge_lev, fv_sponge_damp, & -#endif MARS_GCM +#endif print_freq, icase, layout #endif @@ -422,7 +422,7 @@ subroutine fv_init(ndt) endif !} #endif -#endif +#endif call tm_register_tracers (MODEL_ATMOS, ncnst, nt_prog, pnats, num_family) if(mpp_pe() == mpp_root_pe()) then @@ -592,7 +592,7 @@ subroutine fv_init(ndt) #ifdef MARS_GCM cp_vir = 0.0 -#endif +#endif !-------------------------------------------- ! Set up horizontal grid geometrical factors: @@ -1400,7 +1400,7 @@ subroutine drymadj( im, jm, km, jfirst, jlast, ng, & enddo enddo endif -#endif MARS_GCM +#endif 1000 continue call fv_array_sync() !probably needed before gmean diff --git a/src/atmos_fv_dynamics/model/fv_point.inc b/src/atmos_fv_dynamics/model/fv_point.inc index f4c1fe1ace..019124ff04 100644 --- a/src/atmos_fv_dynamics/model/fv_point.inc +++ b/src/atmos_fv_dynamics/model/fv_point.inc @@ -30,7 +30,7 @@ #ifdef MARS_GCM real :: delp_dt(isg:ieg, js:je, nlev) real :: mars_sfc_budg(isg:ieg, js:je, 5) -#endif MARS_GCM +#endif pointer( p_u, u ) pointer( p_v, v ) pointer( p_delp, delp ) @@ -60,7 +60,7 @@ #ifdef MARS_GCM pointer( p_delp_dt, delp_dt ) pointer( p_mars_sfc_budg, mars_sfc_budg ) -#endif MARS_GCM +#endif !point all the shared pointers p_u = ptr_u p_v = ptr_v @@ -91,6 +91,6 @@ #ifdef MARS_GCM p_delp_dt = ptr_delp_dt p_mars_sfc_budg = ptr_mars_sfc_budg -#endif MARS_GCM +#endif -#endif use_shared_pointers +#endif diff --git a/src/atmos_fv_dynamics/model/update_fv_phys.F90 b/src/atmos_fv_dynamics/model/update_fv_phys.F90 index 8120bd01a4..3757a637bf 100644 --- a/src/atmos_fv_dynamics/model/update_fv_phys.F90 +++ b/src/atmos_fv_dynamics/model/update_fv_phys.F90 @@ -147,7 +147,7 @@ subroutine update_fv_phys ( dt, nq, full_phys, nudge, Time ) enddo endif -#endif +#endif ! Average tendencies for scalars at poles (make it single-valued) ! This is necessary because the the physics/land/ocean use different grid @@ -160,7 +160,7 @@ subroutine update_fv_phys ( dt, nq, full_phys, nudge, Time ) #ifdef MARS_GCM !!!! call polavg( delp_dt(1,beglat,k), nlon, mlat, beglat, endlat) !!!! This is carried out in fv_phys.F90 -#endif MARS_GCM +#endif if ( use_tendency ) then do j=beglat,endlat @@ -234,7 +234,7 @@ subroutine update_fv_phys ( dt, nq, full_phys, nudge, Time ) enddo ! endif enddo -#endif +#endif endif enddo ! -----------------------k-loop------------------ @@ -358,7 +358,7 @@ subroutine update_fv_phys ( dt, nq, full_phys, nudge, Time ) endif call fv_array_sync() u_ghosted = .false. -#endif SPMD +#endif call fv_print_chksums( 'Exiting update_fv_phys' ) end subroutine update_fv_phys diff --git a/src/atmos_fv_dynamics/tools/fv_diagnostics.F90 b/src/atmos_fv_dynamics/tools/fv_diagnostics.F90 index c8e8b9eca3..f43eea2961 100644 --- a/src/atmos_fv_dynamics/tools/fv_diagnostics.F90 +++ b/src/atmos_fv_dynamics/tools/fv_diagnostics.F90 @@ -22,7 +22,7 @@ module fv_diagnostics #ifdef MARS_GCM use fv_pack, only: p_ref use fv_phys_mod, only: mars_mass_budget -#endif MARS_GCM +#endif ! --- tracer manager --- use tracer_manager_mod, only : get_tracer_names, get_number_tracers @@ -91,7 +91,7 @@ subroutine fv_diag_init(axes, Time) trange = (/ 50., 350. /) ! temperature #else trange = (/ 100., 350. /) ! temperature -#endif +#endif arange = (/ 0., 20. /) ! age-of-air slprange = (/800., 1200./) ! sea-level-pressure @@ -104,7 +104,7 @@ subroutine fv_diag_init(axes, Time) call get_eta_level(nlev, p_ref, pfull, phalf, 0.01) #else call get_eta_level(nlev, 1.E5, pfull, phalf, 0.01) -#endif +#endif id_lonb=diag_axis_init('lonb', lonb, 'degrees_E', 'x', 'longitude edges', & set_name=mod_name , Domain2=fv_domain ) @@ -236,7 +236,7 @@ subroutine fv_diag_init(axes, Time) enddo ! for higher tracer number we take the default missing values from FMS do i = nt_phys+1, ncnst -#endif MARS_GCM +#endif call get_tracer_names ( MODEL_ATMOS, i, tname, tlongname, tunits ) id_tracer(i) = register_diag_field ( mod_name, trim(tname), & axes(1:3), Time, trim(tlongname), & @@ -278,7 +278,7 @@ subroutine fv_diag_init(axes, Time) endif endif enddo -#endif +#endif !------- endif !} @@ -475,7 +475,7 @@ subroutine fv_diag( Time, im, jm, km, jfirst, jlast, nq, zvir, dt_atmos, hs_phys call drymadj(im, jm, km, jfirst, jlast, ng_d, .true., kappa, & ptop, ps, delp, pe, pk, peln, pkz, nq, & q, .false.) -#endif MARS_GCM +#endif call pmaxmin('U', ua, qmin, qmax, im*(jlast-jfirst+1), km, 1.) call pmaxmin('V', va, qmin, qmax, im*(jlast-jfirst+1), km, 1.) endif @@ -595,7 +595,7 @@ subroutine fv_diag( Time, im, jm, km, jfirst, jlast, nq, zvir, dt_atmos, hs_phys if(qmin < 50.) call error_mesg('fv_diagnostics:','too cold', FATAL) #else if(qmin < 100.) call error_mesg('fv_diagnostics:','too cold', FATAL) -#endif +#endif endif endif @@ -776,7 +776,7 @@ subroutine fv_diag( Time, im, jm, km, jfirst, jlast, nq, zvir, dt_atmos, hs_phys endif endif enddo -#endif +#endif !------- ! Check tracer mass. Unit: diff --git a/src/atmos_fv_dynamics/tools/fv_restart.F90 b/src/atmos_fv_dynamics/tools/fv_restart.F90 index efdc433ceb..c304d78bde 100644 --- a/src/atmos_fv_dynamics/tools/fv_restart.F90 +++ b/src/atmos_fv_dynamics/tools/fv_restart.F90 @@ -18,7 +18,7 @@ module fv_restart_mod restart_format, use_tendency, cold_start, gid #ifdef MARS_GCM use fv_pack, only: p_ref -#endif MARS_GCM +#endif use tracer_manager_mod, only : tr_get_tracer_names=>get_tracer_names, & get_tracer_names, get_number_tracers, & @@ -356,7 +356,7 @@ subroutine read_fv_rst(im, jm, km, nq, dflnm, days, seconds, oform) do n =1,nqrst call read_data(fms_tracers_restart_file,fv_tr_name(n),q(ids:ide,jds:jde,:,n) , domain = fv_domain) enddo -#endif MARS_GCM +#endif endif ! --------------- Finished reading dynamcics tracers ------------ @@ -383,7 +383,7 @@ subroutine read_fv_rst(im, jm, km, nq, dflnm, days, seconds, oform) if (do_fms_tracer_manager ) then !{ #else if (do_fms_tracer_manager .and. nq > nt_phys) then !{ -#endif MARS_GCM +#endif !Modify the filename if it has an ensemble instance appendix call get_instance_filename(fms_tracers_restart_file,restart_name ) @@ -440,7 +440,7 @@ subroutine read_fv_rst(im, jm, km, nq, dflnm, days, seconds, oform) if(tname == "ice_wat") cycle if(tname == "cld_amt") cycle endif -#endif MARS_GCM +#endif ! this tracer will be added n = n + 1 is_tracer_in_restart_file = .FALSE. @@ -702,7 +702,7 @@ subroutine fv_restart(days, seconds) #ifdef MARS_GCM character (len=128) :: filename, fieldname -#endif MARS_GCM +#endif #include "fv_point.inc" @@ -785,7 +785,7 @@ subroutine fv_restart(days, seconds) phis = 0. endif -#endif MARS_GCM +#endif call set_eta(nlev, ks, ptop, ak, bk) call init_dry_atm(mountain, kappa, grav, rdgas) @@ -883,7 +883,7 @@ subroutine write_fv_rst( dflnm, days, seconds, grav, oform) #else character(len=20) :: fv_tr_name(4) data fv_tr_name / "sphum","liq_wat","ice_wat","cld_amt" / -#endif MARS_GCM +#endif #include "fv_point.inc" @@ -1076,7 +1076,7 @@ subroutine write_fv_rst( dflnm, days, seconds, grav, oform) call get_eta_level(nlev, p_ref, pfull, phalf, 0.01) #else call get_eta_level(nlev, 1.E5, pfull, phalf, 0.01) -#endif MARS_GCM +#endif !Modify the filename if it has an ensemble instance appendix call get_instance_filename(fms_tracers_restart_file,restart_name ) @@ -1152,7 +1152,7 @@ subroutine write_fv_rst( dflnm, days, seconds, grav, oform) call get_eta_level(nlev, p_ref, pfull, phalf, 0.01) #else call get_eta_level(nlev, 1.E5, pfull, phalf, 0.01) -#endif MARS_GCM +#endif ! if(master) write(*,*) "phalf values are ",phalf ! define longitude axis for u and tracer fields call mpp_write_meta(iuic, axis_lon, 'lon', 'degree_E', 'longitude', & diff --git a/src/atmos_fv_dynamics/tools/init_dry_atm.F90 b/src/atmos_fv_dynamics/tools/init_dry_atm.F90 index d68a280c2b..3d1342ef62 100644 --- a/src/atmos_fv_dynamics/tools/init_dry_atm.F90 +++ b/src/atmos_fv_dynamics/tools/init_dry_atm.F90 @@ -8,7 +8,7 @@ subroutine init_dry_atm(mountain, kappa, grav, rg) cosp, sinp, cose, sine, dry_mass, master #ifdef MARS_GCM use fv_pack, only: p_ref -#endif MARS_GCM +#endif use fms_mod, only: file_exist, error_mesg, FATAL @@ -290,7 +290,7 @@ subroutine init_dry_atm(mountain, kappa, grav, rg) call p_var(nlon, mlat, nlev, beglat, endlat, ptop, delp, ps, & pe, peln, pk, pkz, kappa, q, ng_d, ncnst, full_phys) -#endif MARS_GCM +#endif call d2a3d(u(1,beglat-ng_d,nlev), v(1,beglat-ng_d,nlev), u_srf, v_srf, & nlon, mlat, 1, beglat, endlat, ng_d, ng_s, coslon, sinlon) @@ -301,9 +301,9 @@ subroutine init_dry_atm(mountain, kappa, grav, rg) enddo enddo -#endif LIN2004 +#endif -#endif POLVANI +#endif end subroutine init_dry_atm @@ -315,7 +315,7 @@ subroutine hydro_eq(im, jm, km, beglat, endlat, ps, hs, drym, & subroutine hydro_eq(im, jm, km, beglat, endlat, ps, hs, drym, & delp, ak, bk, u, v, pt, ng_d, ng_s, ig, grav, & rg, mountain, master) -#endif MARS_GCM +#endif !============================================================ use fv_arrays_mod, only: fv_array_check, fv_array_sync @@ -334,7 +334,7 @@ subroutine hydro_eq(im, jm, km, beglat, endlat, ps, hs, drym, & logical, intent(in):: master #ifdef MARS_GCM real, intent(in):: pref -#endif MARS_GCM +#endif ! Output real, intent(out):: ps(im,beglat:endlat) @@ -386,7 +386,7 @@ subroutine hydro_eq(im, jm, km, beglat, endlat, ps, hs, drym, & ps(i,j) = mslp*((t0/a0)/(hs(i,j)+t0/a0))**(1./(a0*rg)) enddo enddo -#endif MARS_GCM +#endif psm = gmean(im, jm, beglat, endlat, ps(1,beglat)) dps = drym - psm @@ -441,7 +441,7 @@ subroutine hydro_eq(im, jm, km, beglat, endlat, ps, hs, drym, & pt(i,j,k) = max(min(t0, pt(i,j,k)), t1) enddo enddo -#endif MARS_GCM +#endif enddo @@ -472,7 +472,7 @@ subroutine hydro_eq(im, jm, km, beglat, endlat, ps, hs, drym, & pt(i,j,k) = t1 enddo enddo -#endif MARS +#endif end do endif ! ------- end of no-topography case ------------ diff --git a/src/atmos_fv_dynamics/tools/set_eta.F90 b/src/atmos_fv_dynamics/tools/set_eta.F90 index e73d5f2819..67a43d286d 100644 --- a/src/atmos_fv_dynamics/tools/set_eta.F90 +++ b/src/atmos_fv_dynamics/tools/set_eta.F90 @@ -24,7 +24,7 @@ subroutine set_eta(km, ks, ptop, ak, bk) #else real:: p0=1000.E2 real:: pc=200.E2 -#endif MARS_GCM +#endif real pt, pint, lnpe, dlnp real press(km+1) integer k @@ -85,7 +85,7 @@ subroutine set_eta(km, ks, ptop, ak, bk) 9.6858585131e-01, 9.8274719475e-01, 9.9326941371e-01, & 1.0000000000e+00 / -#endif MARS_GCM +#endif !----------------------------------------------- ! GFDL AM2-L24: modified by SJL at the model top @@ -440,7 +440,7 @@ subroutine set_eta(km, ks, ptop, ak, bk) ak(k) = a36(k) bk(k) = b36(k) enddo -#endif MARS_GCM +#endif case (32) diff --git a/src/atmos_param/cg_drag/cg_drag.F90 b/src/atmos_param/cg_drag/cg_drag.F90 index b81995a035..5626c66e93 100644 --- a/src/atmos_param/cg_drag/cg_drag.F90 +++ b/src/atmos_param/cg_drag/cg_drag.F90 @@ -318,7 +318,7 @@ subroutine cg_drag_init (lonb, latb, pref, Time, axes) call constants_init #ifdef COL_DIAG call column_diagnostics_init -#endif SKIP +#endif !--------------------------------------------------------------------- ! read namelist. !--------------------------------------------------------------------- diff --git a/src/atmos_param/cosp/cosp.F90 b/src/atmos_param/cosp/cosp.F90 index 66e7b040e0..8ac613e3d1 100644 --- a/src/atmos_param/cosp/cosp.F90 +++ b/src/atmos_param/cosp/cosp.F90 @@ -55,13 +55,13 @@ MODULE MOD_COSP SUBROUTINE COSP(overlap,Ncolumns,cfg,vgrid,gbx,sgx,sgradar,sglidar,isccp,misr,modis,rttov,stradar,stlidar,sghydro,cloud_type) #else SUBROUTINE COSP(overlap,Ncolumns,cfg,vgrid,gbx,sgx,sgradar,sglidar,isccp,misr,modis,rttov,stradar,stlidar) -#endif COSP_GFDL +#endif #else #ifdef COSP_GFDL SUBROUTINE COSP(overlap,Ncolumns,cfg,vgrid,gbx,sgx,sgradar,sglidar,isccp,misr,modis,stradar,stlidar, sghydro, cloud_type) #else SUBROUTINE COSP(overlap,Ncolumns,cfg,vgrid,gbx,sgx,sgradar,sglidar,isccp,misr,modis,stradar,stlidar) -#endif COSP_GFDL +#endif #endif ! Arguments integer,intent(in) :: overlap ! overlap type in SCOPS: 1=max, 2=rand, 3=max/rand @@ -326,7 +326,7 @@ SUBROUTINE COSP(overlap,Ncolumns,cfg,vgrid,gbx,sgx,sgradar,sglidar,isccp,misr,mo call construct_cosp_misr(cfg,Ni,misr_it) #ifdef RTTOV call construct_cosp_rttov(Ni,gbx%nchan,rttov_it) -#endif +#endif call construct_cosp_radarstats(cfg,Ni,Ncolumns,vgrid%Nlvgrid,N_HYDRO,stradar_it) call construct_cosp_lidarstats(cfg,Ni,Ncolumns,vgrid%Nlvgrid,N_HYDRO,PARASOL_NREFL,stlidar_it) endif @@ -375,7 +375,7 @@ SUBROUTINE COSP(overlap,Ncolumns,cfg,vgrid,gbx,sgx,sgradar,sglidar,isccp,misr,mo if (cfg%Lmisr_sim) call cosp_misr_cpsection(ix,iy,misr_it,misr) #ifdef RTTOV if (cfg%Lrttov_sim) call cosp_rttov_cpsection(ix,iy,rttov_it,rttov) -#endif +#endif if (cfg%Lradar_sim) call cosp_radarstats_cpsection(ix,iy,stradar_it,stradar) if (cfg%Llidar_sim) call cosp_lidarstats_cpsection(ix,iy,stlidar_it,stlidar) enddo diff --git a/src/atmos_param/cosp/icarus-scops-3.7/icarus.F90 b/src/atmos_param/cosp/icarus-scops-3.7/icarus.F90 index aaba89184a..496c3ad1fd 100644 --- a/src/atmos_param/cosp/icarus-scops-3.7/icarus.F90 +++ b/src/atmos_param/cosp/icarus-scops-3.7/icarus.F90 @@ -1462,16 +1462,17 @@ SUBROUTINE ICARUS( !compute isccp frequencies !reset frequencies - do 38 ilev=1,7 - do 38 ilev2=1,7 - do j=1,npoints ! - if (sunlit(j).eq.1 .or. top_height .eq. 3) then + do ilev=1,7 + do ilev2=1,7 + do j=1,npoints ! + if (sunlit(j).eq.1 .or. top_height .eq. 3) then fq_isccp(j,ilev,ilev2)= 0. - else - fq_isccp(j,ilev,ilev2)= output_missing_value - end if + else + fq_isccp(j,ilev,ilev2)= output_missing_value + end if + enddo enddo -38 continue + enddo !reset variables need for averaging cloud properties do j=1,npoints diff --git a/src/atmos_shared/tracer_driver/stratchem/strat_chem_model.F90 b/src/atmos_shared/tracer_driver/stratchem/strat_chem_model.F90 index e7aa6827a1..7a9052b2bc 100644 --- a/src/atmos_shared/tracer_driver/stratchem/strat_chem_model.F90 +++ b/src/atmos_shared/tracer_driver/stratchem/strat_chem_model.F90 @@ -2125,15 +2125,16 @@ SUBROUTINE ZEN2(ITIME,DT,DRAD,DARG,DELTA,CDX) DGMT = DGMT - 24. IDAY = IDAY + 1. 5 DP = 365.*IYEAR + IDAY + 31.*(IMON-1.) - IF(IMON - 2) 10,10,20 - 10 D1 = (IYEAR - 1.)*0.25 - D2 = (IYEAR - 1.)*1.E-2 + 1. - DF1 = DP + INT(D1) - INT(0.75*INT(D2)) - GOTO 30 - 20 D1 = 4.E-1*IMON + 2.3 - D2 = IYEAR*1.E-2 - DF1 = DP - INT(D1) + INT(25.*D2) - INT(0.75*(INT(D2) + 1.)) - 30 DTY = (DF1 - 693960.)/36525. + if ((IMON - 2) <= 0) then + D1 = (IYEAR - 1.)*0.25 + D2 = (IYEAR - 1.)*1.E-2 + 1. + DF1 = DP + INT(D1) - INT(0.75*INT(D2)) + else + D1 = 4.E-1*IMON + 2.3 + D2 = IYEAR*1.E-2 + DF1 = DP - INT(D1) + INT(25.*D2) - INT(0.75*(INT(D2) + 1.)) + endif + DTY = (DF1 - 693960.)/36525. DTD = 100.*DTY DR = (2.7969668E02 + 3.6000768925E04*DTY + 3.03E-4*DTY*DTY)* & DRAD diff --git a/src/land_lad2/river/river.F90 b/src/land_lad2/river/river.F90 index d65009d192..ac7744f68e 100644 --- a/src/land_lad2/river/river.F90 +++ b/src/land_lad2/river/river.F90 @@ -1544,4 +1544,4 @@ end subroutine river_solo_init end program river_solo -#endif test_river_solo +#endif diff --git a/src/land_lad2/shared/nf_utils/nfc.F90 b/src/land_lad2/shared/nf_utils/nfc.F90 index 9a9ede8239..14150dd44c 100644 --- a/src/land_lad2/shared/nf_utils/nfc.F90 +++ b/src/land_lad2/shared/nf_utils/nfc.F90 @@ -25,10 +25,14 @@ module nfc_mod #define F90_TYPE real(8) #define NF_TYPE double #include "getput_compressed.inc" +#undef F90_TYPE +#undef NF_TYPE #define F90_TYPE integer #define NF_TYPE int #include "getput_compressed.inc" +#undef F90_TYPE +#undef NF_TYPE #undef __INTERFACE_SECTION__ ! ---- module constants ------------------------------------------------------ @@ -205,9 +209,13 @@ function inq_compressed_var_i(ncid, vid, name, xtype, ndims, dimids, dimlens, & #define F90_TYPE real(8) #define NF_TYPE double #include "getput_compressed.inc" +#undef F90_TYPE +#undef NF_TYPE #define F90_TYPE integer #define NF_TYPE int #include "getput_compressed.inc" +#undef F90_TYPE +#undef NF_TYPE end module nfc_mod diff --git a/src/land_lad2/shared/nf_utils/nfu.F90 b/src/land_lad2/shared/nf_utils/nfu.F90 index 297a3cf441..caf142261b 100644 --- a/src/land_lad2/shared/nf_utils/nfu.F90 +++ b/src/land_lad2/shared/nf_utils/nfu.F90 @@ -48,10 +48,14 @@ module nfu_mod #define F90_TYPE integer #define NF_TYPE int #include "getput.inc" +#undef F90_TYPE +#undef NF_TYPE #define F90_TYPE real(8) #define NF_TYPE double #include "getput.inc" +#undef F90_TYPE +#undef NF_TYPE interface nfu_get_valid_range module procedure get_valid_range_i @@ -562,11 +566,14 @@ function nfu_get_dim_bounds(ncid,dimid,edges)result(iret) #define F90_TYPE integer #define NF_TYPE int #include "getput.inc" +#undef F90_TYPE +#undef NF_TYPE #define F90_TYPE real(8) #define NF_TYPE double #include "getput.inc" - +#undef F90_TYPE +#undef NF_TYPE function get_valid_range_n(ncid, varname, v) result (iret) diff --git a/src/land_lad2/vegetation/vegn_cohort_io.F90 b/src/land_lad2/vegetation/vegn_cohort_io.F90 index 7352070054..396858d7dd 100644 --- a/src/land_lad2/vegetation/vegn_cohort_io.F90 +++ b/src/land_lad2/vegetation/vegn_cohort_io.F90 @@ -244,6 +244,11 @@ end subroutine create_cohort_dimension #define READ_0D_FPTR read_cohort_data_r0d_fptr #define WRITE_0D_FPTR write_cohort_data_r0d_fptr #include "vegn_cohort_io.inc" +#undef F90_TYPE +#undef NF_TYPE +#undef NF_FILL_VALUE +#undef READ_0D_FPTR +#undef WRITE_0D_FPTR #define F90_TYPE integer #define NF_TYPE NF_INT @@ -251,5 +256,10 @@ end subroutine create_cohort_dimension #define READ_0D_FPTR read_cohort_data_i0d_fptr #define WRITE_0D_FPTR write_cohort_data_i0d_fptr #include "vegn_cohort_io.inc" +#undef F90_TYPE +#undef NF_TYPE +#undef NF_FILL_VALUE +#undef READ_0D_FPTR +#undef WRITE_0D_FPTR end module cohort_io_mod diff --git a/src/land_lad2/vegetation/vegn_static_override.F90 b/src/land_lad2/vegetation/vegn_static_override.F90 index b1818ef668..8a116c8946 100644 --- a/src/land_lad2/vegetation/vegn_static_override.F90 +++ b/src/land_lad2/vegetation/vegn_static_override.F90 @@ -440,10 +440,14 @@ end subroutine write_static_vegn #define F90_TYPE integer #define READ_REMAP_SUB read_remap_cohort_data_i0d_fptr #include "read_remap_cohort_data.inc" +#undef F90_TYPE +#undef READ_REMAP_SUB #define F90_TYPE real #define READ_REMAP_SUB read_remap_cohort_data_r0d_fptr #include "read_remap_cohort_data.inc" +#undef F90_TYPE +#undef READ_REMAP_SUB ! ============================================================================ ! tile existence detector: returns a logical value indicating wether component diff --git a/src/mom5/ocean_blobs/ocean_blob_dynamic_free.F90 b/src/mom5/ocean_blobs/ocean_blob_dynamic_free.F90 index e2d8cdd2d4..fdb0238dcc 100644 --- a/src/mom5/ocean_blobs/ocean_blob_dynamic_free.F90 +++ b/src/mom5/ocean_blobs/ocean_blob_dynamic_free.F90 @@ -2426,7 +2426,7 @@ subroutine packbuffer(blob,buffer,entrainment,detrainment) stdoutunit = stdout() if (buffer%pe == NULL_PE) then - write (stdoutunit, '(a)'), 'Error: Trying to send blob to a NULL_PE' + write (stdoutunit, '(a)') 'Error: Trying to send blob to a NULL_PE' call mpp_error(FATAL, & '==>Error in ocean_blob_static_bottom_mod (packbuffer): '& //'Trying to send blob to a NULL_PE') diff --git a/src/mom5/ocean_param/gotm-4.0/turbulence/kpp.F90 b/src/mom5/ocean_param/gotm-4.0/turbulence/kpp.F90 index 981e163b3c..7180fa7962 100644 --- a/src/mom5/ocean_param/gotm-4.0/turbulence/kpp.F90 +++ b/src/mom5/ocean_param/gotm-4.0/turbulence/kpp.F90 @@ -936,9 +936,9 @@ subroutine interior(nlev,NN,NNT,NNS,SS) shear2 = SS(i) cff = shear2*shear2/(shear2*shear2+16.0E-10) nu_sx = cff*nu_sx -# else KPP_SHEAR +# else nu_sx=_ZERO_ -# endif KPP_SHEAR +# endif #ifdef KPP_INTERNAL_WAVE ! @@ -955,7 +955,7 @@ subroutine interior(nlev,NN,NNT,NNS,SS) #else iwm = _ZERO_ iws = _ZERO_ -#endif KPP_INTERNAL_WAVE +#endif # ifdef KPP_CONVEC @@ -965,9 +965,9 @@ subroutine interior(nlev,NN,NNT,NNS,SS) cff = min(_ONE_,(bvfcon-cff)/bvfcon) nu_sxc = _ONE_-cff*cff nu_sxc = nu_sxc*nu_sxc*nu_sxc -# else KPP_CONVEC +# else nu_sxc = _ZERO_ -# endif KPP_CONVEC +# endif ! ! Sum contributions due to internal wave breaking, shear instability ! and convective diffusivity due to shear instability. @@ -1030,7 +1030,7 @@ subroutine interior(nlev,NN,NNT,NNS,SS) nuh(i)=nuh(i) + nu_ddt nus(i)=nuh(i) + nu_dds -# endif KPP_DDMIX +# endif enddo ! loop over interior points diff --git a/src/mom5/ocean_param/gotm-4.0/util/ode_solvers.F90 b/src/mom5/ocean_param/gotm-4.0/util/ode_solvers.F90 index 7f9164cae0..fd1fa9f226 100644 --- a/src/mom5/ocean_param/gotm-4.0/util/ode_solvers.F90 +++ b/src/mom5/ocean_param/gotm-4.0/util/ode_solvers.F90 @@ -1070,7 +1070,7 @@ subroutine right_hand_side(first,numc,nlev,cc,rhs) first=.false. do ci=1,nlev - call findp_bisection(numc, cc(:,ci), derivative(:,ci), dt, 1.d-9, pi) + call findp_bisection(numc, cc(:,ci), derivative(:,ci), dt, 1.e-9, pi) cc(:,ci) = cc(:,ci) + dt*derivative(:,ci)*pi end do @@ -1152,7 +1152,7 @@ subroutine right_hand_side(first,numc,nlev,cc,rhs) first=.false. do ci=1,nlev - call findp_bisection(numc, cc(:,ci), rhs(:,ci), dt, 1.d-9, pi) + call findp_bisection(numc, cc(:,ci), rhs(:,ci), dt, 1.e-9, pi) cc_med(:,ci) = cc(:,ci) + dt*rhs(:,ci)*pi end do @@ -1166,7 +1166,7 @@ subroutine right_hand_side(first,numc,nlev,cc,rhs) if (rhs(i,ci) .lt. 0.) rhs(:,ci) = rhs(:,ci) * cc(i,ci)/cc_med(i,ci) end do - call findp_bisection(numc, cc(:,ci), rhs(:,ci), dt, 1.d-9, pi) + call findp_bisection(numc, cc(:,ci), rhs(:,ci), dt, 1.e-9, pi) cc(:,ci) = cc(:,ci) + dt*rhs(:,ci)*pi end do ! ci (z-levels) diff --git a/src/mom5/ocean_param/vertical/ocean_vert_chen.F90 b/src/mom5/ocean_param/vertical/ocean_vert_chen.F90 index fbe0ee328c..e8a2e31c75 100644 --- a/src/mom5/ocean_param/vertical/ocean_vert_chen.F90 +++ b/src/mom5/ocean_param/vertical/ocean_vert_chen.F90 @@ -314,7 +314,7 @@ subroutine ocean_vert_chen_init (Grid, Domain, Time, Time_steps, T_prog, hor_gri riu(:,:,:) = 0.0 rit(:,:,:) = 0.0 -#ifdef defined(ACCESS_CM) +#if defined(ACCESS_CM) kbl(:,:) = 1 hbl(:,:) = 5.0 #endif @@ -324,7 +324,7 @@ subroutine ocean_vert_chen_init (Grid, Domain, Time, Time_steps, T_prog, hor_gri domain=Dom%domain2d) if(file_exist('INPUT/kraus.res.nc')) then call restore_state(Che_restart) -#ifdef defined(ACCESS_CM) +#if defined(ACCESS_CM) call mpp_update_domains(kbl,Dom%domain2d) call mpp_update_domains(hbl,Dom%domain2d) #endif @@ -332,7 +332,7 @@ subroutine ocean_vert_chen_init (Grid, Domain, Time, Time_steps, T_prog, hor_gri write(stdoutunit,*) 'From ocean_vert_chen: reading hbl from kraus.res.nc' call write_timestamp(Time%model_time) call write_chksum_2d('hbl', hbl(COMP)*Grd%tmask(COMP,1)) -#ifdef defined(ACCESS_CM) +#if defined(ACCESS_CM) write(stdoutunit,*) 'From ocean_vert_chen: reading kbl from kraus.res.nc' call write_timestamp(Time%model_time) call write_chksum_2d('kbl', kbl(COMP)*Grd%tmask(COMP,1)) @@ -716,7 +716,7 @@ subroutine kraus_turner(Time, Velocity, T_prog, Dens, swflx, pme, mixmask) do i=isc,iec kbl_m1=max(1,kbl(i,j)-1) shallow=max(hbl(i,j),Grd%zt(1))-Grd%zt(kbl_m1) -#ifdef defined(ACCESS_CM) +#if defined(ACCESS_CM) !dhb599: try to avoid "floating invalid" here: mixmask(i,j,kbl(i,j))=shallow/(Grd%zt(kbl(i,j))-Grd%zt(kbl_m1)+ 1.0e-10) #else diff --git a/src/shared/axis_utils/axis_utils.F90 b/src/shared/axis_utils/axis_utils.F90 index 0a2fade440..f0ffaae3e1 100644 --- a/src/shared/axis_utils/axis_utils.F90 +++ b/src/shared/axis_utils/axis_utils.F90 @@ -876,7 +876,7 @@ program test end program test -#endif /* test_axis_utils */ +#endif diff --git a/src/shared/exchange/test_xgrid.F90 b/src/shared/exchange/test_xgrid.F90 index 91025f3bc6..439fed7b3f 100644 --- a/src/shared/exchange/test_xgrid.F90 +++ b/src/shared/exchange/test_xgrid.F90 @@ -980,4 +980,4 @@ end program xgrid_test module null_test_xgrid end module -#endif /* test_mpp */ +#endif diff --git a/src/shared/memutils/memutils.F90 b/src/shared/memutils/memutils.F90 index f858f9955d..139f066236 100644 --- a/src/shared/memutils/memutils.F90 +++ b/src/shared/memutils/memutils.F90 @@ -241,7 +241,7 @@ integer function hplen( hpalloc, hplargest, hpshrink, hpgrow, hpfirs if( present(hplast ) )hplast = IHPSTAT(14) !Last word address return end function hplen -#endif /* _CRAY */ +#endif #ifdef _CRAYT90 integer function stklen( stkhiwm, stknumber, stktotal, stkmost, stkgrew, stkgtimes ) @@ -259,7 +259,7 @@ integer function stklen( stkhiwm, stknumber, stktotal, stkmost, stkgr if( present(stkgtimes) )stkgtimes = istat(7) !#times stack grew return end function stklen -#endif /* _CRAYT90 */ +#endif !cache utilities: need to write version for other argument types function get_l1_cache_line(a) diff --git a/src/shared/mpp/include/mpp_io_write.inc b/src/shared/mpp/include/mpp_io_write.inc index 1596f4fc9f..3564e8579b 100644 --- a/src/shared/mpp/include/mpp_io_write.inc +++ b/src/shared/mpp/include/mpp_io_write.inc @@ -1032,7 +1032,7 @@ else call mpp_error( FATAL, 'WRITE_ATTRIBUTE_NETCDF: one of rval, ival, cval must be present.' ) end if -#endif /* use_netCDF */ +#endif return end subroutine write_attribute_netcdf diff --git a/src/shared/mpp/include/mpp_update_domains2D.h b/src/shared/mpp/include/mpp_update_domains2D.h index 4df50b37aa..c9d4bf8f70 100644 --- a/src/shared/mpp/include/mpp_update_domains2D.h +++ b/src/shared/mpp/include/mpp_update_domains2D.h @@ -620,4 +620,4 @@ return end subroutine MPP_UPDATE_DOMAINS_5D_V_ -#endif /* VECTOR_FIELD_ */ +#endif diff --git a/src/shared/mpp/include/mpp_update_domains2D_ad.h b/src/shared/mpp/include/mpp_update_domains2D_ad.h index 84968e5723..45d416efcb 100644 --- a/src/shared/mpp/include/mpp_update_domains2D_ad.h +++ b/src/shared/mpp/include/mpp_update_domains2D_ad.h @@ -417,4 +417,4 @@ whalo, ehalo, shalo, nhalo, name, tile_count ) return end subroutine MPP_UPDATE_DOMAINS_AD_5D_V_ -#endif /* VECTOR_FIELD_ */ +#endif diff --git a/src/shared/mpp/mpp.F90 b/src/shared/mpp/mpp.F90 index 67153749f4..2a2a4e89f4 100644 --- a/src/shared/mpp/mpp.F90 +++ b/src/shared/mpp/mpp.F90 @@ -1297,7 +1297,7 @@ module mpp_mod !(t3e: fixed on 3.3 I believe) integer, parameter :: MPI_INTEGER8=MPI_INTEGER #endif -#endif /* use_libMPI */ +#endif #ifdef use_MPI_SMA #include integer :: pSync(SHMEM_BARRIER_SYNC_SIZE) diff --git a/src/shared/mpp/mpp_parameter.F90 b/src/shared/mpp/mpp_parameter.F90 index e4f6bec1d9..43d8dd642a 100644 --- a/src/shared/mpp/mpp_parameter.F90 +++ b/src/shared/mpp/mpp_parameter.F90 @@ -117,7 +117,7 @@ module mpp_parameter_mod ! combination with the flag parameter defined above to create a unique identifier for ! each Domain+flags combination. Therefore, the value of any flag must not exceed DOMAIN_ID_BASE. ! integer(LONG_KIND), parameter :: DOMAIN_ID_BASE=INT( 2**(4*LONG_KIND),KIND=LONG_KIND ) - integer(LONG_KIND), parameter :: DOMAIN_ID_BASE=Z'0000000100000000' ! Workaround for 64bit init problem + integer(LONG_KIND), parameter :: DOMAIN_ID_BASE=INT(Z'0000000100000000', kind=LONG_KIND) ! Workaround for 64bit init problem integer, parameter :: NON_BITWISE_EXACT_SUM=0 integer, parameter :: BITWISE_EXACT_SUM=1 integer, parameter :: BITWISE_EFP_SUM=2 diff --git a/src/shared/mpp/test_mpp.F90 b/src/shared/mpp/test_mpp.F90 index 195b1c3676..5e7ec9e5f4 100644 --- a/src/shared/mpp/test_mpp.F90 +++ b/src/shared/mpp/test_mpp.F90 @@ -543,4 +543,4 @@ end program test module null_mpp_test end module -#endif /* test_mpp */ +#endif diff --git a/src/shared/mpp/threadloc.c b/src/shared/mpp/threadloc.c index 173b52cb39..26caa6d9bb 100644 --- a/src/shared/mpp/threadloc.c +++ b/src/shared/mpp/threadloc.c @@ -68,7 +68,7 @@ int find_nodenum(int mynodedev) { int mld_id_() { /* dummy routine for portability */ return 0; } -#endif /* sgi */ +#endif #ifdef test_threadloc void main(int argc, char **argv) { diff --git a/src/tools/mppncscatter/common.h b/src/tools/mppncscatter/common.h index b62ebe4393..56970b640b 100755 --- a/src/tools/mppncscatter/common.h +++ b/src/tools/mppncscatter/common.h @@ -49,4 +49,4 @@ extern int errno; #define MPPNCSCATTER_VERSION "0.3.2" -#endif /* !COMMON_H */ +#endif diff --git a/src/tools/mppncscatter/mppncscatter.h b/src/tools/mppncscatter/mppncscatter.h index d4b2f4c8fd..7c0808f601 100755 --- a/src/tools/mppncscatter/mppncscatter.h +++ b/src/tools/mppncscatter/mppncscatter.h @@ -46,4 +46,4 @@ void scatter_dims(int nc, int ndims, int nvars, ScatterDim* scatterdims[], mnsop /*-------------------------------------------------------------------*/ -#endif /* MPPNCSCATTER_H */ \ No newline at end of file +#endif \ No newline at end of file diff --git a/src/tools/mppncscatter/opt.h b/src/tools/mppncscatter/opt.h index 5572a2041b..f3e7cb5cdd 100755 --- a/src/tools/mppncscatter/opt.h +++ b/src/tools/mppncscatter/opt.h @@ -76,5 +76,5 @@ static struct option const long_options[] = {0, 0, 0, 0} }; -#endif /* MPPNCSCATTER_OPT_H */ +#endif diff --git a/src/tools/mppncscatter/scatterdim.h b/src/tools/mppncscatter/scatterdim.h index 34971a3ff4..935517f25a 100755 --- a/src/tools/mppncscatter/scatterdim.h +++ b/src/tools/mppncscatter/scatterdim.h @@ -21,4 +21,4 @@ void ScatterDim_free(ScatterDim* p); ScatterDim* ScatterDim_new(int id, size_t len, const char * name, scatter_t scatter_type, int ndiv); -#endif /* SCATTERDIM_H */ \ No newline at end of file +#endif \ No newline at end of file diff --git a/src/tools/mppncscatter/strlist.h b/src/tools/mppncscatter/strlist.h index 7d01b82f59..2c65fa9238 100755 --- a/src/tools/mppncscatter/strlist.h +++ b/src/tools/mppncscatter/strlist.h @@ -55,4 +55,4 @@ int copystrlist(char** listsrc, char** listdst, int nsrc, int ndst); /* Get number of strings in list (and not number of available slots), which don't have to occupy every array position contiguously. */ int getnumstrlist(char** list, int nlist); -#endif /* !STRLIST_H */ +#endif diff --git a/src/tools/mppncscatter/util.h b/src/tools/mppncscatter/util.h index 9cd7ec5382..0559c2abc8 100755 --- a/src/tools/mppncscatter/util.h +++ b/src/tools/mppncscatter/util.h @@ -8,4 +8,4 @@ #define MAX(A,B) ( ((A) > (B)) ? (A) : (B) ) #define ODD(X) ((X) % 2) -#endif /* MPPNCSCATTER_UTIL_H */ \ No newline at end of file +#endif \ No newline at end of file