MODULE limwri !!====================================================================== !! *** MODULE limwri *** !! Ice diagnostics : write ice output files !!====================================================================== #if defined key_lim3 !!---------------------------------------------------------------------- !! 'key_lim3' LIM3 sea-ice model !!---------------------------------------------------------------------- !! lim_wri : write of the diagnostics variables in ouput file !! lim_wri_state : write for initial state or/and abandon !!---------------------------------------------------------------------- USE ioipsl USE dianam ! build name of file (routine) USE phycst USE dom_oce USE sbc_oce ! Surface boundary condition: ocean fields USE sbc_ice ! Surface boundary condition: ice fields USE ice USE dom_ice USE limvar USE in_out_manager USE lbclnk USE lib_mpp ! MPP library USE wrk_nemo ! work arrays USE iom USE timing ! Timing USE lib_fortran ! Fortran utilities IMPLICIT NONE PRIVATE PUBLIC lim_wri ! routine called by lim_step.F90 PUBLIC lim_wri_state ! called by dia_wri_state !!---------------------------------------------------------------------- !! NEMO/LIM3 4.0 , UCL - NEMO Consortium (2011) !! $Id$ !! Software governed by the CeCILL licence (NEMOGCM/NEMO_CeCILL.txt) !!---------------------------------------------------------------------- CONTAINS SUBROUTINE lim_wri( kindic ) !!------------------------------------------------------------------- !! This routine computes the average of some variables and write it !! on the ouput files. !! ATTENTION cette routine n'est valable que si le pas de temps est !! egale a une fraction entiere de 1 jours. !! Diff 1-D 3-D : suppress common also included in etat !! suppress cmoymo 11-18 !! modif : 03/06/98 !!------------------------------------------------------------------- INTEGER, INTENT(in) :: kindic ! if kindic < 0 there has been an error somewhere ! INTEGER :: ii, ji, jj, jk, jl ! dummy loop indices REAL(wp) :: z2da, z2db, ztmp, zrho1, zrho2 REAL(wp), POINTER, DIMENSION(:,:,:) :: zswi2 REAL(wp), POINTER, DIMENSION(:,:) :: z2d, zswi ! 2D workspace REAL(wp), POINTER, DIMENSION(:,:) :: zfb ! ice freeboard REAL(wp), POINTER, DIMENSION(:,:) :: zamask, zamask15 ! 15% concentration mask ! Global ice diagnostics (SIMIP) REAL(wp) :: zdiag_area_nh, & ! area, extent, volume & zdiag_extt_nh, & & zdiag_area_sh, & & zdiag_extt_sh, & & zdiag_volu_nh, & & zdiag_volu_sh ! Strait / passage fluxes (SIMIP) REAL(wp), DIMENSION(4) :: & ! Strait fluxes for output & zdiag_area_strait , & ! 1=Fram Strait, 2=CAA, 3= Barents, 4 = Bering & zdiag_mice_strait , & & zdiag_msno_strait REAL(wp) :: zfarea_u, zfmice_u, zfmsno_u, zfarea_v, zfmice_v, zfmsno_v ! dummy fluxes REAL(wp), DIMENSION(11) :: & & zui, zuj, zvi, zvj ! strait addresses INTEGER :: Nu, Nv, & ! passage size i_strait ! strait number INTEGER, DIMENSION(4) :: ji0, ji1, jj0, jj1 !!------------------------------------------------------------------- IF( nn_timing == 1 ) CALL timing_start('limwri') CALL wrk_alloc( jpi, jpj, jpl, zswi2 ) CALL wrk_alloc( jpi, jpj , z2d, zswi ) CALL wrk_alloc( jpi, jpj , zfb, zamask, zamask15 ) !----------------------------- ! Mean category values !----------------------------- ! brine volume CALL lim_var_bv ! tresholds for outputs DO jj = 1, jpj DO ji = 1, jpi zswi(ji,jj) = MAX( 0._wp , SIGN( 1._wp , at_i(ji,jj) - epsi06 ) ) ! 1 if ice, 0 if no ice END DO END DO DO jj = 1, jpj DO ji = 1, jpi zamask(ji,jj) = MAX( 0._wp , SIGN( 1._wp , at_i(ji,jj) - 0.05 ) ) ! 1 if 5% ice, 0 if less - required to mask thickness and snow depth zamask15(ji,jj) = MAX( 0._wp , SIGN( 1._wp , at_i(ji,jj) - 0.15 ) ) ! 1 if 15% ice, 0 if less END DO END DO DO jl = 1, jpl DO jj = 1, jpj DO ji = 1, jpi zswi2(ji,jj,jl) = MAX( 0._wp , SIGN( 1._wp , a_i(ji,jj,jl) - epsi06 ) ) END DO END DO END DO ! ! fluxes ! pfrld is the lead fraction at the previous time step (actually between TRP and THD) IF( iom_use('qsr_oce') ) CALL iom_put( "qsr_oce" , qsr_oce(:,:) * pfrld(:,:) ) ! solar flux at ocean surface IF( iom_use('qns_oce') ) CALL iom_put( "qns_oce" , qns_oce(:,:) * pfrld(:,:) + qemp_oce(:,:) ) ! non-solar flux at ocean surface IF( iom_use('qsr_ice') ) CALL iom_put( "qsr_ice" , SUM( qsr_ice(:,:,:) * a_i_b(:,:,:), dim=3 ) ) ! solar flux at ice surface IF( iom_use('qns_ice') ) CALL iom_put( "qns_ice" , SUM( qns_ice(:,:,:) * a_i_b(:,:,:), dim=3 ) + qemp_ice(:,:) ) ! non-solar flux at ice surface IF( iom_use('qtr_ice') ) CALL iom_put( "qtr_ice" , SUM( ftr_ice(:,:,:) * a_i_b(:,:,:), dim=3 ) ) ! solar flux transmitted thru ice IF( iom_use('qt_oce' ) ) CALL iom_put( "qt_oce" , ( qsr_oce(:,:) + qns_oce(:,:) ) * pfrld(:,:) + qemp_oce(:,:) ) IF( iom_use('qt_ice' ) ) CALL iom_put( "qt_ice" , SUM( ( qns_ice(:,:,:) + qsr_ice(:,:,:) ) & & * a_i_b(:,:,:),dim=3 ) + qemp_ice(:,:) ) IF( iom_use('qemp_oce') ) CALL iom_put( "qemp_oce" , qemp_oce(:,:) ) IF( iom_use('qemp_ice') ) CALL iom_put( "qemp_ice" , qemp_ice(:,:) ) IF( iom_use('emp_oce' ) ) CALL iom_put( "emp_oce" , emp_oce(:,:) ) !emp over ocean (taking into account the snow blown away from the ice) IF( iom_use('emp_ice' ) ) CALL iom_put( "emp_ice" , emp_ice(:,:) ) !emp over ice (taking into account the snow blown away from the ice) ! velocity IF ( iom_use( "uice_ipa" ) .OR. iom_use( "vice_ipa" ) .OR. iom_use( "icevel" ) ) THEN DO jj = 2 , jpjm1 DO ji = 2 , jpim1 z2da = ( u_ice(ji,jj) * umask(ji,jj,1) + u_ice(ji-1,jj) * umask(ji-1,jj,1) ) * 0.5_wp z2db = ( v_ice(ji,jj) * vmask(ji,jj,1) + v_ice(ji,jj-1) * vmask(ji,jj-1,1) ) * 0.5_wp z2d(ji,jj) = SQRT( z2da * z2da + z2db * z2db ) END DO END DO CALL lbc_lnk( z2d, 'T', 1. ) CALL iom_put( "uice_ipa" , u_ice ) ! ice velocity u component CALL iom_put( "vice_ipa" , v_ice ) ! ice velocity v component CALL iom_put( "icevel" , z2d ) ! ice velocity module ENDIF ! IF ( iom_use( "miceage" ) ) CALL iom_put( "miceage" , om_i * zswi * zamask15 ) ! mean ice age IF ( iom_use( "micet" ) ) CALL iom_put( "micet" , ( tm_i - rt0 ) * zswi ) ! ice mean temperature IF ( iom_use( "icest" ) ) CALL iom_put( "icest" , ( tm_su - rt0 ) * zswi ) ! ice surface temperature IF ( iom_use( "icecolf" ) ) CALL iom_put( "icecolf" , hicol ) ! frazil ice collection thickness ! CALL iom_put( "isst" , sst_m ) ! sea surface temperature CALL iom_put( "isss" , sss_m ) ! sea surface salinity CALL iom_put( "iceconc" , at_i * zswi ) ! ice concentration CALL iom_put( "icevolu" , vt_i * zswi ) ! ice volume = mean ice thickness over the cell CALL iom_put( "icehc" , et_i * zswi ) ! ice total heat content CALL iom_put( "isnowhc" , et_s * zswi ) ! snow total heat content CALL iom_put( "ibrinv" , bvm_i * zswi * 100. ) ! brine volume CALL iom_put( "utau_ice" , utau_ice*zswi ) ! wind stress over ice along i-axis at I-point CALL iom_put( "vtau_ice" , vtau_ice*zswi ) ! wind stress over ice along j-axis at I-point CALL iom_put( "snowpre" , sprecip * 86400. ) ! snow precipitation CALL iom_put( "micesalt" , smt_i * zswi ) ! mean ice salinity CALL iom_put( "icestr" , strength * zswi ) ! ice strength CALL iom_put( "idive" , divu_i ) ! divergence CALL iom_put( "ishear" , shear_i ) ! shear CALL iom_put( "snowvol" , vt_s * zswi ) ! snow volume CALL iom_put( "icetrp" , diag_trp_vi * rday ) ! ice volume transport CALL iom_put( "snwtrp" , diag_trp_vs * rday ) ! snw volume transport CALL iom_put( "saltrp" , diag_trp_smv * rday * rhoic ) ! salt content transport CALL iom_put( "deitrp" , diag_trp_ei ) ! advected ice enthalpy (W/m2) CALL iom_put( "destrp" , diag_trp_es ) ! advected snw enthalpy (W/m2) CALL iom_put( "sfxbog" , sfx_bog * rday ) ! salt flux from bottom growth CALL iom_put( "sfxbom" , sfx_bom * rday ) ! salt flux from bottom melting CALL iom_put( "sfxsum" , sfx_sum * rday ) ! salt flux from surface melting CALL iom_put( "sfxsni" , sfx_sni * rday ) ! salt flux from snow ice formation CALL iom_put( "sfxopw" , sfx_opw * rday ) ! salt flux from open water formation CALL iom_put( "sfxdyn" , sfx_dyn * rday ) ! salt flux from ridging rafting CALL iom_put( "sfxres" , sfx_res * rday ) ! salt flux from limupdate (resultant) CALL iom_put( "sfxbri" , sfx_bri * rday ) ! salt flux from brines CALL iom_put( "sfxsub" , sfx_sub * rday ) ! salt flux from sublimation CALL iom_put( "sfx" , sfx * rday ) ! total salt flux ztmp = rday / rhoic CALL iom_put( "vfxres" , wfx_res * ztmp ) ! daily prod./melting due to limupdate CALL iom_put( "vfxopw" , wfx_opw * ztmp ) ! daily lateral thermodynamic ice production CALL iom_put( "vfxsni" , wfx_sni * ztmp ) ! daily snowice ice production CALL iom_put( "vfxbog" , wfx_bog * ztmp ) ! daily bottom thermodynamic ice production CALL iom_put( "vfxdyn" , wfx_dyn * ztmp ) ! daily dynamic ice production (rid/raft) CALL iom_put( "vfxsum" , wfx_sum * ztmp ) ! surface melt CALL iom_put( "vfxbom" , wfx_bom * ztmp ) ! bottom melt CALL iom_put( "vfxice" , wfx_ice * ztmp ) ! total ice growth/melt IF ( iom_use( "vfxthin" ) ) THEN ! ice production for open water + thin ice (<20cm) => comparable to observations WHERE( htm_i(:,:) < 0.2 .AND. htm_i(:,:) > 0. ) ; z2d = wfx_bog ELSEWHERE ; z2d = 0._wp END WHERE CALL iom_put( "vfxthin", ( wfx_opw + z2d ) * ztmp ) ENDIF ztmp = rday / rhosn CALL iom_put( "vfxspr" , wfx_spr * ztmp ) ! precip (snow) CALL iom_put( "vfxsnw" , wfx_snw * ztmp ) ! total snw growth/melt CALL iom_put( "vfxsub" , wfx_sub * ztmp ) ! sublimation (snow/ice) CALL iom_put( "vfxsub_err" , wfx_err_sub * ztmp ) ! "excess" of sublimation sent to ocean CALL iom_put( "afxtot" , afx_tot ) ! concentration tendency (total) CALL iom_put( "afxdyn" , afx_dyn ) ! concentration tendency (dynamics) CALL iom_put( "afxthd" , afx_thd ) ! concentration tendency (thermo) CALL iom_put ('hfxthd' , hfx_thd(:,:) ) ! CALL iom_put ('hfxdyn' , hfx_dyn(:,:) ) ! CALL iom_put ('hfxres' , hfx_res(:,:) ) ! CALL iom_put ('hfxout' , hfx_out(:,:) ) ! CALL iom_put ('hfxin' , hfx_in(:,:) ) ! CALL iom_put ('hfxsnw' , hfx_snw(:,:) ) ! CALL iom_put ('hfxsub' , hfx_sub(:,:) ) ! CALL iom_put ('hfxerr' , hfx_err(:,:) ) ! CALL iom_put ('hfxerr_rem' , hfx_err_rem(:,:) ) ! CALL iom_put ('hfxsum' , hfx_sum(:,:) ) ! CALL iom_put ('hfxbom' , hfx_bom(:,:) ) ! CALL iom_put ('hfxbog' , hfx_bog(:,:) ) ! CALL iom_put ('hfxdif' , hfx_dif(:,:) ) ! CALL iom_put ('hfxopw' , hfx_opw(:,:) ) ! CALL iom_put ('hfxtur' , fhtur(:,:) * SUM( a_i_b(:,:,:), dim=3 ) ) ! turbulent heat flux at ice base CALL iom_put ('hfxdhc' , diag_heat(:,:) ) ! Heat content variation in snow and ice CALL iom_put ('hfxspr' , hfx_spr(:,:) ) ! Heat content of snow precip !---------------------------------- ! Output category-dependent fields !---------------------------------- IF ( iom_use( "iceconc_cat" ) ) CALL iom_put( "iceconc_cat" , a_i * zswi2 ) ! area for categories IF ( iom_use( "icethic_cat" ) ) CALL iom_put( "icethic_cat" , ht_i * zswi2 ) ! thickness for categories IF ( iom_use( "snowthic_cat" ) ) CALL iom_put( "snowthic_cat" , ht_s * zswi2 ) ! snow depth for categories IF ( iom_use( "salinity_cat" ) ) CALL iom_put( "salinity_cat" , sm_i * zswi2 ) ! salinity for categories ! ice temperature IF ( iom_use( "icetemp_cat" ) ) CALL iom_put( "icetemp_cat", ( SUM( t_i(:,:,:,:), dim=3 ) * r1_nlay_i - rt0 ) * zswi2 ) ! snow temperature IF ( iom_use( "snwtemp_cat" ) ) CALL iom_put( "snwtemp_cat", ( SUM( t_s(:,:,:,:), dim=3 ) * r1_nlay_s - rt0 ) * zswi2 ) ! ice age IF ( iom_use( "iceage_cat" ) ) CALL iom_put( "iceage_cat" , o_i * zswi2 ) ! brine volume IF ( iom_use( "brinevol_cat" ) ) CALL iom_put( "brinevol_cat", bv_i * 100. * zswi2 ) !-------------------------------- ! Add-ons for SIMIP !-------------------------------- zrho1 = ( rau0 - rhoic ) / rau0; zrho2 = rhosn / rau0 IF ( iom_use( "icethic" ) ) CALL iom_put( "icethic" , htm_i * zamask ) ! Ice thickness IF ( iom_use( "icepres" ) ) CALL iom_put( "icepres" , zswi ) ! Ice presence (1 or 0) IF ( iom_use( "snowthic" ) ) CALL iom_put( "snowthic" , htm_s * zamask ) ! Snow thickness IF ( iom_use( "icemass" ) ) CALL iom_put( "icemass" , rhoic * vt_i(:,:) * zswi ) ! Ice mass per cell area IF ( iom_use( "snomass" ) ) CALL iom_put( "snomass" , rhosn * vt_s(:,:) * zswi ) ! Snow mass per cell area IF ( iom_use( "icesnt" ) ) CALL iom_put( "icesnt" , ( tm_si - rt0 ) * zswi ) ! Snow-ice interface temperature IF ( iom_use( "icebot" ) ) CALL iom_put( "icebot" , ( t_bo - rt0 ) * zswi ) ! Ice bottom temperature IF ( iom_use( "icesmass" ) ) CALL iom_put( "icesmass" , SUM( smv_i, DIM = 3 ) * rhoic * 1.0e-3 * zswi ) ! Mass of salt in sea ice per cell area IF ( iom_use( "icefb" ) ) THEN zfb(:,:) = ( zrho1 * htm_i(:,:) - zrho2 * htm_s(:,:) ) * zswi(:,:) WHERE( zfb < 0._wp ) ; zfb = 0._wp ; END WHERE CALL iom_put( "icefb" , zfb ) ! Ice freeboard ENDIF IF ( iom_use( "dmithd" ) ) CALL iom_put( "dmithd" , - wfx_bog - wfx_bom - wfx_sum & ! Sea-ice mass change from thermodynamics & - wfx_sni - wfx_opw - wfx_res ) IF ( iom_use( "dmidyn" ) ) CALL iom_put( "dmidyn" , diag_dmi_dyn ) ! Sea-ice mass change from dynamics IF ( iom_use( "dmiopw" ) ) CALL iom_put( "dmiopw" , - wfx_opw ) ! Sea-ice mass change through growth in open water IF ( iom_use( "dmibog" ) ) CALL iom_put( "dmibog" , - wfx_bog ) ! Sea-ice mass change through basal growth IF ( iom_use( "dmisni" ) ) CALL iom_put( "dmisni" , - wfx_sni ) ! Sea-ice mass change through snow-to-ice conversion IF ( iom_use( "dmisum" ) ) CALL iom_put( "dmisum" , - wfx_sum ) ! Sea-ice mass change through surface melting IF ( iom_use( "dmibom" ) ) CALL iom_put( "dmibom" , - wfx_bom ) ! Sea-ice mass change through bottom melting IF ( iom_use( "dmtsub" ) ) CALL iom_put( "dmtsub" , - wfx_sub ) ! Sea-ice mass change through evaporation and sublimation IF ( iom_use( "dmssub" ) ) CALL iom_put( "dmssub" , - wfx_snw_sub ) ! Snow mass change through sublimation IF ( iom_use( "dmisub" ) ) CALL iom_put( "dmisub" , - wfx_ice_sub ) ! Sea-ice mass change through sublimation IF ( iom_use( "dmsspr" ) ) CALL iom_put( "dmsspr" , - wfx_spr ) ! Snow mass change through snow fall IF ( iom_use( "dmsssi" ) ) CALL iom_put( "dmsssi" , wfx_sni*rhosn/rhoic ) ! Snow mass change through snow-to-ice conversion IF ( iom_use( "dmsmel" ) ) CALL iom_put( "dmsmel" , - wfx_snw_sum ) ! Snow mass change through melt IF ( iom_use( "dmsdyn" ) ) CALL iom_put( "dmsdyn" , diag_dms_dyn ) ! Snow mass change through dynamics IF ( iom_use( "hfxconbo" ) ) CALL iom_put( "hfxconbo" , diag_fc_bo ) ! Bottom conduction flux IF ( iom_use( "hfxconsu" ) ) CALL iom_put( "hfxconsu" , diag_fc_su ) ! Surface conduction flux IF ( iom_use( "wfxtot" ) ) CALL iom_put( "wfxtot" , wfx_ice ) ! Total freshwater flux from sea ice IF ( iom_use( "wfxsum" ) ) CALL iom_put( "wfxsum" , wfx_sum ) ! Freshwater flux from sea-ice surface IF ( iom_use( "dmtxdyn" ) ) CALL iom_put( "dmtxdyn" , diag_dmtx_dyn ) ! X-component of sea-ice mass transport IF ( iom_use( "dmtydyn" ) ) CALL iom_put( "dmtydyn" , diag_dmty_dyn ) ! Y-component of sea-ice mass transport IF ( iom_use( "utau_oi" ) ) CALL iom_put( "utau_oi" , diag_utau_oi*zswi ) ! X-component of ocean stress on sea ice IF ( iom_use( "vtau_oi" ) ) CALL iom_put( "vtau_oi" , diag_vtau_oi*zswi ) ! Y-component of ocean stress on sea ice IF ( iom_use( "dssh_dx" ) ) CALL iom_put( "dssh_dx" , diag_dssh_dx*zswi ) ! Sea-surface tilt term in force balance (x-component) IF ( iom_use( "dssh_dy" ) ) CALL iom_put( "dssh_dy" , diag_dssh_dy*zswi ) ! Sea-surface tilt term in force balance (y-component) IF ( iom_use( "corstrx" ) ) CALL iom_put( "corstrx" , diag_corstrx*zswi ) ! Coriolis force term in force balance (x-component) IF ( iom_use( "corstry" ) ) CALL iom_put( "corstry" , diag_corstry*zswi ) ! Coriolis force term in force balance (y-component) IF ( iom_use( "intstrx" ) ) CALL iom_put( "intstrx" , diag_intstrx*zswi ) ! Internal force term in force balance (x-component) IF ( iom_use( "intstry" ) ) CALL iom_put( "intstry" , diag_intstry*zswi ) ! Internal force term in force balance (y-component) IF ( iom_use( "normstr" ) ) CALL iom_put( "normstr" , diag_sig1 *zswi ) ! Normal stress IF ( iom_use( "sheastr" ) ) CALL iom_put( "sheastr" , diag_sig2 *zswi ) ! Shear stress !-------------------------------- ! Global ice diagnostics (SIMIP) !-------------------------------- IF ( iom_use( "NH_icearea" ) .OR. iom_use( "NH_icevolu" ) .OR. iom_use( "NH_iceextt" ) ) THEN ! NH integrated diagnostics WHERE( fcor > 0._wp ); zswi(:,:) = 1.0e-12 ELSEWHERE ; zswi(:,:) = 0. END WHERE zdiag_area_nh = glob_sum( at_i(:,:) * zswi(:,:) * e12t(:,:) ) zdiag_volu_nh = glob_sum( vt_i(:,:) * zswi(:,:) * e12t(:,:) ) WHERE( fcor > 0._wp .AND. at_i > 0.15 ); zswi(:,:) = 1.0e-12 ELSEWHERE ; zswi(:,:) = 0. END WHERE zdiag_extt_nh = glob_sum( zswi(:,:) * e12t(:,:) ) IF ( iom_use( "NH_icearea" ) ) CALL iom_put( "NH_icearea" , zdiag_area_nh ) IF ( iom_use( "NH_icevolu" ) ) CALL iom_put( "NH_icevolu" , zdiag_volu_nh ) IF ( iom_use( "NH_iceextt" ) ) CALL iom_put( "NH_iceextt" , zdiag_extt_nh ) ENDIF IF ( iom_use( "SH_icearea" ) .OR. iom_use( "SH_icevolu" ) .OR. iom_use( "SH_iceextt" ) ) THEN ! SH integrated diagnostics WHERE( fcor < 0._wp ); zswi(:,:) = 1.0e-12; ELSEWHERE ; zswi(:,:) = 0. END WHERE zdiag_area_sh = glob_sum( at_i(:,:) * zswi(:,:) * e12t(:,:) ) zdiag_volu_sh = glob_sum( vt_i(:,:) * zswi(:,:) * e12t(:,:) ) WHERE( fcor < 0._wp .AND. at_i > 0.15 ); zswi(:,:) = 1.0e-12 ELSEWHERE ; zswi(:,:) = 0. END WHERE zdiag_extt_sh = glob_sum( zswi(:,:) * e12t(:,:) ) IF ( iom_use( "SH_icearea" ) ) CALL iom_put( "SH_icearea", zdiag_area_sh ) IF ( iom_use( "SH_icevolu" ) ) CALL iom_put( "SH_icevolu", zdiag_volu_sh ) IF ( iom_use( "SH_iceextt" ) ) CALL iom_put( "SH_iceextt", zdiag_extt_sh ) ENDIF !-------------------------------- ! Fluxes through straits (SIMIP) !-------------------------------- ! ! Valid only for ORCA-like grids ! ! 4 Arctic passages are considered (Fram, CAA, Barents, Bering; see Notz et al (GMD 2016) for definitions) ! ! Fram and Bering straits are easy because they follow parallels ! Barents and Canadian Arctic Archipelago are less easy because they do not, which is why they look so awful. ! IF ( iom_use( "strait_arfl" ) .OR. iom_use( "strait_mifl" ) .OR. iom_use( "strait_msfl" ) .AND. cp_cfg == "orca" ) THEN zdiag_area_strait(:) = 0._wp ; zdiag_mice_strait(:) = 0._wp ; zdiag_msno_strait(:) = 0._wp !------------------------------ ! === Fram & Bering Straits === !------------------------------ SELECT CASE ( jp_cfg ) CASE ( 2 ) ! --- ORCA2 ! Fram Strait (i_strait = 1) ji0(1) = 133 ; ji1(1) = 136 jj0(1) = 136 ! Bering Strait (i_strait = 4) ji0(4) = 55 ; ji1(4) = 56 jj0(4) = 122 CASE ( 1 ) ! --- eORCA1 ! Fram Strait ji0(1) = 268 ; ji1(1) = 277 jj0(1) = 311 ! Bering Strait ji0(4) = 113 ; jj1(4) = 115 jj0(4) = 285 END SELECT DO i_strait = 1, 4, 3 DO ji = mi0( ji0(i_strait) ), mi1(ji1 (i_strait) ) jj = mj0( jj0(i_strait) ) zdiag_area_strait(i_strait) = zdiag_area_strait(i_strait) & ! --- ice area flux --- & + at_i(ji,jj-1) * e12t(ji,jj-1) * MAX( v_ice(ji,jj-1), 0.0 ) & ! northwards (positive) flow & + at_i(ji,jj ) * e12t(ji,jj) * MIN( v_ice(ji,jj-1), 0.0 ) ! southwards (negative) flow zdiag_mice_strait(i_strait) = zdiag_mice_strait(i_strait) + rhoic * & ! --- ice mass flux --- & ( vt_i(ji,jj-1) * e12t(ji,jj-1) * MAX( v_ice(ji,jj-1), 0.0 ) & & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( v_ice(ji,jj-1), 0.0 ) ) zdiag_msno_strait(i_strait) = zdiag_msno_strait(i_strait) + rhosn * & ! --- snow mass flux --- & ( vt_s(ji,jj-1) * e12t(ji,jj-1) * MAX( v_ice(ji,jj-1), 0.0 ) & & + vt_s(ji,jj ) * e12t(ji,jj) * MIN( v_ice(ji,jj-1), 0.0 ) ) END DO END DO !--------------------- ! === Barents opening !--------------------- SELECT CASE ( jp_cfg ) CASE ( 1 ) ! 'eORCA1' Nu = 11 ! U-Flow zui(1:Nu) = (/ 282,283,284,285,286,286,287,288,289,290,292/) zuj(1:Nu) = (/ 308,307,306,305,304,303,302,301,300,299,298/) Nv = 9 ! V-Flow zvi(1:Nv) = (/ 282,283,284,285,286,287,288,289,290/) zvj(1:Nv) = (/ 308,307,306,305,303,302,301,300,299/) CASE ( 2 ) ! 'ORCA2' Nu = 5 ! U-Flow zui(1:Nu) = (/ 141,142,142,143,144 /) zuj(1:Nu) = (/ 134,133,132,131,130 /) Nv = 4 ! V-Flow zvi(1:Nv) = (/ 140,141,142,143 /) zvj(1:Nv) = (/ 135,134,132,131 /) END SELECT ! Barents U-flow zfarea_u = 0._wp ; zfmice_u = 0._wp ; zfmsno_u = 0._wp DO ii = 1, Nu ji = mi0(zui(ii)) jj = mj0(zuj(ii)) zfarea_u = zfarea_u & ! --- ice area zonal flux --- & + at_i(ji-1,jj) * e12t(ji-1,jj) * MAX( u_ice(ji-1,jj), 0.0 ) & ! --- northward & + at_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji-1,jj), 0.0 ) ! --- southward zfmice_u = zfmice_u + rhoic * & ! --- ice mass zonal flux --- & ( vt_i(ji-1,jj) * e12t(ji-1,jj) * MAX( u_ice(ji-1,jj), 0.0 ) & & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji-1,jj), 0.0 ) ) zfmsno_u = zfmsno_u + rhosn * & ! --- snow mass zonal flux --- & ( vt_s(ji-1,jj) * e12t(ji-1,jj) * MAX( u_ice(ji-1,jj), 0.0 ) & & + vt_s(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji-1,jj), 0.0 ) ) END DO ! Barents V-flow zfarea_v = 0._wp ; zfmice_v = 0._wp ; zfmsno_v = 0._wp DO ii = 1, Nv ji = mi0(zvi(ii)) jj = mj0(zvj(ii)) zfarea_v = zfarea_v & ! --- ice area meridian flux --- & + at_i(ji,jj-1) * e12t(ji,jj-1) * MAX( u_ice(ji,jj-1), 0.0 ) & ! --- eastward & + at_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji,jj-1), 0.0 ) ! --- westward zfmice_v = zfmice_v + rhoic * & ! --- ice mass meridian flux --- & ( vt_i(ji,jj-1) * e12t(ji,jj-1) * MAX( u_ice(ji,jj-1), 0.0 ) & ! & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji,jj-1), 0.0 ) ) ! zfmsno_v = zfmsno_v + rhosn * & ! --- snow mass meridian flux --- & ( vt_i(ji,jj-1) * e12t(ji,jj-1) * MAX( u_ice(ji,jj-1), 0.0 ) & ! & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji,jj-1), 0.0 ) ) ! END DO ! Sum Barents U-/V- contributions zdiag_area_strait(3) = zfarea_u + zfarea_v zdiag_mice_strait(3) = zfmice_u + zfmice_v zdiag_msno_strait(3) = zfmsno_u + zfmsno_v !--------------------- ! === CAA throughflow !--------------------- SELECT CASE ( jp_cfg ) CASE ( 1 ) ! eORCA1 ! V-flow through Nares Strait Nv = 4 zvi(1:Nv) = (/ 254,255,256,257 /) zvj(1:Nv) = (/ 317,317,317,317 /) ! U-flow through Queen Elisabeth Islands and McClure straits Nu = 8 zui(1:Nu) = (/ 231,231,231, 132,132,132,132,132 /) zuj(1:Nu) = (/ 328,329,330, 318,319,320,321,322 /) zfarea_u = 0._wp ; zfmice_u = 0._wp ; zfmsno_u = 0._wp DO ii = 1, Nu ji = mi0(zui(ii)) jj = mj0(zuj(ii)) zfarea_u = zfarea_u & ! --- ice area zonal flux --- & + at_i(ji-1,jj) * e12t(ji-1,jj) * MAX( u_ice(ji-1,jj), 0.0 ) & ! --- eastward & + at_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji-1,jj), 0.0 ) ! --- westward zfmice_u = zfmice_u + rhoic * & ! --- ice mass zonal flux --- & ( vt_i(ji-1,jj) * e12t(ji-1,jj) * MAX( u_ice(ji-1,jj), 0.0 ) & & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji-1,jj), 0.0 ) ) zfmsno_u = zfmsno_u + rhosn * & ! --- snow mass zonal flux --- & ( vt_s(ji-1,jj) * e12t(ji-1,jj) * MAX( u_ice(ji-1,jj), 0.0 ) & & + vt_s(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji-1,jj), 0.0 ) ) END DO CASE ( 2 ) ! ORCA2 ! V-flow through Nares Strait Nv = 2 zvi(1:Nv) = (/ 117,118 /) zvj(1:Nv) = (/ 145,145 /) ! U-flow through Queen Elisabeth Islands and McClure straits (not resolved in ORCA2) zfarea_u = 0._wp ; zfmice_u = 0._wp ; zfmsno_u = 0._wp END SELECT ! V-flow through Nares Strait zfarea_v = 0._wp ; zfmice_v = 0._wp ; zfmsno_v = 0._wp DO ii = 1, Nv ji = mi0(zvi(ii)) jj = mj0(zvj(ii)) zfarea_v = zfarea_v & ! --- ice area meridian flux --- & + at_i(ji,jj-1) * e12t(ji,jj-1) * MAX( u_ice(ji,jj-1), 0.0 ) & ! --- eastward & + at_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji,jj-1), 0.0 ) ! --- westward zfmice_v = zfmice_v + rhoic * & ! --- ice mass meridian flux --- & ( vt_i(ji,jj-1) * e12t(ji,jj-1) * MAX( u_ice(ji,jj-1), 0.0 ) & ! & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji,jj-1), 0.0 ) ) ! zfmsno_v = zfmsno_v + rhosn * & ! --- snow mass meridian flux --- & ( vt_i(ji,jj-1) * e12t(ji,jj-1) * MAX( u_ice(ji,jj-1), 0.0 ) & ! & + vt_i(ji,jj ) * e12t(ji,jj) * MIN( u_ice(ji,jj-1), 0.0 ) ) ! END DO ! Sum U/V contributions zdiag_area_strait(2) = zfarea_u + zfarea_v zdiag_mice_strait(2) = zfmice_u + zfmice_v zdiag_msno_strait(2) = zfmsno_u + zfmsno_v ! === Ncdf output IF ( iom_use("strait_arfl") ) CALL iom_put( "strait_arfl", zdiag_area_strait ) IF ( iom_use("strait_mifl") ) CALL iom_put( "strait_mifl", zdiag_mice_strait ) IF ( iom_use("strait_msfl") ) CALL iom_put( "strait_msfl", zdiag_msno_strait ) WRITE(numout,*) " area flx ", zdiag_area_strait(:) WRITE(numout,*) " mice flx ", zdiag_mice_strait(:) WRITE(numout,*) " msno flx ", zdiag_msno_strait(:) ENDIF ! ! Create an output files (output.lim.abort.nc) if S < 0 or u > 20 m/s ! IF( kindic < 0 ) CALL lim_wri_state( 'output.abort' ) ! not yet implemented CALL wrk_dealloc( jpi, jpj, jpl, zswi2 ) CALL wrk_dealloc( jpi, jpj , z2d, zswi ) CALL wrk_dealloc( jpi, jpj , zfb, zamask, zamask15 ) IF( nn_timing == 1 ) CALL timing_stop('limwri') END SUBROUTINE lim_wri SUBROUTINE lim_wri_state( kt, kid, kh_i ) !!--------------------------------------------------------------------- !! *** ROUTINE lim_wri_state *** !! !! ** Purpose : create a NetCDF file named cdfile_name which contains !! the instantaneous ice state and forcing fields for ice model !! Used to find errors in the initial state or save the last !! ocean state in case of abnormal end of a simulation !! !! History : !! 4.0 ! 2013-06 (C. Rousset) !!---------------------------------------------------------------------- INTEGER, INTENT( in ) :: kt ! ocean time-step index) INTEGER, INTENT( in ) :: kid , kh_i INTEGER :: nz_i, jl REAL(wp), DIMENSION(jpl) :: jcat !!---------------------------------------------------------------------- DO jl = 1, jpl jcat(jl) = REAL(jl) ENDDO CALL histvert( kid, "ncatice", "Ice Categories","", jpl, jcat, nz_i, "up") CALL histdef( kid, "sithic", "Ice thickness" , "m" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "siconc", "Ice concentration" , "%" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sitemp", "Ice temperature" , "C" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sivelu", "i-Ice speed " , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sivelv", "j-Ice speed " , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sistru", "i-Wind stress over ice " , "Pa" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sistrv", "j-Wind stress over ice " , "Pa" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sisflx", "Solar flux over ocean" , "w/m2" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sinflx", "Non-solar flux over ocean" , "w/m2" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "isnowpre", "Snow precipitation" , "kg/m2/s", & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sisali", "Ice salinity" , "PSU" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sivolu", "Ice volume" , "m" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sidive", "Ice divergence" , "10-8s-1", & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxbog", "Ice bottom production" , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxdyn", "Ice dynamic production" , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxopw", "Ice open water prod" , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxsni", "Snow ice production " , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxres", "Ice prod from limupdate" , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxbom", "Ice bottom melt" , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "vfxsum", "Ice surface melt" , "m/s" , & & jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sithicat", "Ice thickness" , "m" , & & jpi, jpj, kh_i, jpl, 1, jpl, nz_i, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "siconcat", "Ice concentration" , "%" , & & jpi, jpj, kh_i, jpl, 1, jpl, nz_i, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sisalcat", "Ice salinity" , "" , & & jpi, jpj, kh_i, jpl, 1, jpl, nz_i, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sitemcat", "Ice temperature" , "C" , & & jpi, jpj, kh_i, jpl, 1, jpl, nz_i, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "snthicat", "Snw thickness" , "m" , & & jpi, jpj, kh_i, jpl, 1, jpl, nz_i, 32, "inst(x)", rdt, rdt ) CALL histdef( kid, "sntemcat", "Snw temperature" , "C" , & & jpi, jpj, kh_i, jpl, 1, jpl, nz_i, 32, "inst(x)", rdt, rdt ) CALL histend( kid, snc4set ) ! end of the file definition CALL histwrite( kid, "sithic", kt, htm_i , jpi*jpj, (/1/) ) CALL histwrite( kid, "siconc", kt, at_i , jpi*jpj, (/1/) ) CALL histwrite( kid, "sitemp", kt, tm_i - rt0 , jpi*jpj, (/1/) ) CALL histwrite( kid, "sivelu", kt, u_ice , jpi*jpj, (/1/) ) CALL histwrite( kid, "sivelv", kt, v_ice , jpi*jpj, (/1/) ) CALL histwrite( kid, "sistru", kt, utau_ice , jpi*jpj, (/1/) ) CALL histwrite( kid, "sistrv", kt, vtau_ice , jpi*jpj, (/1/) ) CALL histwrite( kid, "sisflx", kt, qsr , jpi*jpj, (/1/) ) CALL histwrite( kid, "sinflx", kt, qns , jpi*jpj, (/1/) ) CALL histwrite( kid, "isnowpre", kt, sprecip , jpi*jpj, (/1/) ) CALL histwrite( kid, "sisali", kt, smt_i , jpi*jpj, (/1/) ) CALL histwrite( kid, "sivolu", kt, vt_i , jpi*jpj, (/1/) ) CALL histwrite( kid, "sidive", kt, divu_i*1.0e8 , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxbog", kt, wfx_bog , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxdyn", kt, wfx_dyn , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxopw", kt, wfx_opw , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxsni", kt, wfx_sni , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxres", kt, wfx_res , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxbom", kt, wfx_bom , jpi*jpj, (/1/) ) CALL histwrite( kid, "vfxsum", kt, wfx_sum , jpi*jpj, (/1/) ) CALL histwrite( kid, "sithicat", kt, ht_i , jpi*jpj*jpl, (/1/) ) CALL histwrite( kid, "siconcat", kt, a_i , jpi*jpj*jpl, (/1/) ) CALL histwrite( kid, "sisalcat", kt, sm_i , jpi*jpj*jpl, (/1/) ) CALL histwrite( kid, "sitemcat", kt, tm_i - rt0 , jpi*jpj*jpl, (/1/) ) CALL histwrite( kid, "snthicat", kt, ht_s , jpi*jpj*jpl, (/1/) ) CALL histwrite( kid, "sntemcat", kt, tm_su - rt0 , jpi*jpj*jpl, (/1/) ) ! Close the file ! ----------------- !CALL histclo( kid ) END SUBROUTINE lim_wri_state #else !!---------------------------------------------------------------------- !! Default option : Empty module NO LIM sea-ice model !!---------------------------------------------------------------------- CONTAINS SUBROUTINE lim_wri ! Empty routine END SUBROUTINE lim_wri #endif !!====================================================================== END MODULE limwri