Changeset 8102
- Timestamp:
- 2017-05-31T11:08:52+02:00 (6 years ago)
- Location:
- branches/2015/nemo_v3_6_STABLE/NEMOGCM
- Files:
-
- 5 edited
Legend:
- Unmodified
- Added
- Removed
-
branches/2015/nemo_v3_6_STABLE/NEMOGCM/CONFIG/SHARED/field_def.xml
r7963 r8102 23 23 <field_group id="grid_T" grid_ref="grid_T_2D" > 24 24 <field id="e3t" long_name="T-cell thickness" standard_name="cell_thickness" unit="m" grid_ref="grid_T_3D"/> 25 <field id="e3t_surf" long_name="T-cell thickness" field_ref="e3t" standard_name="cell_thickness" unit="m" grid_ref="grid_T_surface_extract"/> 25 26 <field id="e3t_0" long_name="Initial T-cell thickness" standard_name="ref_cell_thickness" unit="m" grid_ref="grid_T_3D"/> 26 27 … … 710 711 --> 711 712 712 <field_group id="trendT" grid_ref="grid_T_3D">713 713 <!-- variables available with ln_tra_trd --> 714 <field id="ttrd_xad" long_name="temperature-trend: i-advection" unit="degC/s" /> 714 715 <!-- Asselin trends calculated on odd time steps--> 716 <field_group id="trendT_odd" grid_ref="grid_T_3D"> 717 <field id="ttrd_atf" long_name="temperature-trend: asselin time filter" unit="degree_C/s" /> 718 <field id="strd_atf" long_name="salinity -trend: asselin time filter" unit="0.001/s" /> 719 <!-- Thickness weighted versions: --> 720 <field id="ttrd_atf_e3t" unit="degC/s * m" > ttrd_atf * e3t </field> 721 <field id="strd_atf_e3t" unit="1e-3/s * m" > strd_atf * e3t </field> 722 <!-- OMIP layer-integrated trends --> 723 <field id="ttrd_atf_li" long_name="layer integrated heat-trend: asselin time filter " unit="W/m^2" > ttrd_atf_e3t * 1026.0 * 3991.86795711963 </field> 724 <field id="strd_atf_li" long_name="layer integrated salt -trend: asselin time filter " unit="kg/(m^2 s)" > strd_atf_e3t * 1026.0 * 0.001 </field> 725 </field_group> 726 727 <!-- Other trends calculated on even time steps--> 728 <field_group id="trendT_even" grid_ref="grid_T_3D"> 729 <field id="ttrd_xad" long_name="temperature-trend: i-advection" unit="degC/s" /> 715 730 <field id="strd_xad" long_name="salinity -trend: i-advection" unit="1e-3/s" /> 716 731 <field id="ttrd_yad" long_name="temperature-trend: j-advection" unit="degC/s" /> … … 756 771 <field id="ttrd_qsr" long_name="temperature-trend: solar penetr. heating" unit="degree_C/s" /> 757 772 <field id="ttrd_bbc" long_name="temperature-trend: geothermal heating" unit="degree_C/s" /> 758 <field id="ttrd_atf" long_name="temperature-trend: asselin time filter" unit="degree_C/s" /> 759 <field id="strd_atf" long_name="salinity -trend: asselin time filter" unit="0.001/s" /> 760 <field id="ttrd_tot" long_name="temperature-trend: total model trend" unit="degC/s" /> 761 <field id="strd_tot" long_name="salinity -trend: total model trend" unit="1e-3/s" /> 762 773 763 774 <!-- Thickness weighted versions: --> 764 775 <field id="ttrd_xad_e3t" unit="degC/s * m" > ttrd_xad * e3t </field> … … 779 790 <field id="strd_evd_e3t" unit="1e-3/s * m" > strd_evd * e3t </field> 780 791 792 <field id="strd_evd_e3t" unit="1e-3/s * m" > strd_evd * e3t </field> 793 781 794 <!-- ln_traldf_iso=T only (iso-neutral diffusion) --> 782 795 <field id="ttrd_iso_x_e3t" unit="degC/s * m" > ttrd_iso_x * e3t </field> … … 802 815 <field id="ttrd_qsr_e3t" unit="degC/s * m" > ttrd_qsr * e3t </field> 803 816 <field id="ttrd_bbc_e3t" unit="degC/s * m" > ttrd_bbc * e3t </field> 804 <field id="ttrd_atf_e3t" unit="degC/s * m" > ttrd_atf * e3t </field> 805 <field id="strd_atf_e3t" unit="1e-3/s * m" > strd_atf * e3t </field> 817 818 <!-- OMIP layer-integrated trends --> 819 <field id="ttrd_totad_li" long_name="layer integrated heat-trend : total advection" unit="W/m^2" > ttrd_totad_e3t * 1026.0 * 3991.86795711963 </field> 820 <field id="strd_totad_li" long_name="layer integrated salt -trend : total advection" unit="kg/(m^2 s)" > strd_totad_e3t * 1026.0 * 0.001 </field> 821 <field id="ttrd_evd_li" long_name="layer integrated heat-trend : EVD convection" unit="W/m^2" > ttrd_evd_e3t * 1026.0 * 3991.86795711963 </field> 822 <field id="strd_evd_li" long_name="layer integrated salt -trend : EVD convection" unit="kg/(m^2 s)" > strd_evd_e3t * 1026.0 * 0.001 </field> 823 <field id="ttrd_iso_li" long_name="layer integrated heat-trend : isopycnal diffusion" unit="W/m^2" > ttrd_iso_e3t * 1026.0 * 3991.86795711963 </field> 824 <field id="strd_iso_li" long_name="layer integrated salt -trend : isopycnal diffusion" unit="kg/(m^2 s)" > strd_iso_e3t * 1026.0 * 0.001 </field> 825 <field id="ttrd_zdfp_li" long_name="layer integrated heat-trend : pure vert. diffusion" unit="W/m^2" > ttrd_zdfp_e3t * 1026.0 * 3991.86795711963 </field> 826 <field id="strd_zdfp_li" long_name="layer integrated salt -trend : pure vert. diffusion" unit="kg/(m^2 s)" > strd_zdfp_e3t * 1026.0 * 0.001 </field> 827 <field id="ttrd_qns_li" long_name="layer integrated heat-trend : non-solar flux + runoff" unit="W/m^2" grid_ref="grid_T_2D"> ttrd_qns_e3t * 1026.0 * 3991.86795711963 </field> 828 <field id="ttrd_qsr_li" long_name="layer integrated heat-trend : solar flux" unit="W/m^2" grid_ref="grid_T_3D"> ttrd_qsr_e3t * 1026.0 * 3991.86795711963 </field> 829 <field id="ttrd_bbl_li" long_name="layer integrated heat-trend: bottom boundary layer " unit="W/m^2" > ttrd_bbl_e3t * 1026.0 * 3991.86795711963 </field> 830 <field id="strd_bbl_li" long_name="layer integrated salt -trend: bottom boundary layer " unit="kg/(m^2 s)" > strd_bbl_e3t * 1026.0 * 0.001 </field> 831 <field id="ttrd_evd_li" long_name="layer integrated heat -trend: evd convection " unit="W/m^2" >ttrd_evd_e3t * 1026.0 * 3991.86795711963 </field> 832 <field id="strd_evd_li" long_name="layer integrated salt -trend: evd convection " unit="kg/(m^2 s)" > strd_evd_e3t * 1026.0 * 0.001 </field> 833 </field_group> 834 835 <!-- Total trends calculated every time step--> 836 <field_group id="trendT" grid_ref="grid_T_3D"> 837 <field id="ttrd_tot" long_name="temperature-trend: total model trend" unit="degC/s" /> 838 <field id="strd_tot" long_name="salinity -trend: total model trend" unit="1e-3/s" /> 839 <!-- Thickness weighted versions: --> 806 840 <field id="ttrd_tot_e3t" unit="degC/s * m" > ttrd_tot * e3t </field> 807 841 <field id="strd_tot_e3t" unit="1e-3/s * m" > strd_tot * e3t </field> 808 842 <!-- OMIP layer-integrated total trends --> 843 <field id="ttrd_tot_li" long_name="layer integrated heat-trend: total model trend :" unit="W/m^2" > ttrd_tot_e3t * 1026.0 * 3991.86795711963 </field> 844 <field id="strd_tot_li" long_name="layer integrated salt -trend: total model trend :" unit="kg/(m^2 s)" > strd_tot_e3t * 1026.0 * 0.001 </field> 845 846 <!-- **** these trends have not been apportioned to all/even/odd ts yet **** --> 809 847 <!-- variables available with ln_KE_trd --> 810 848 <field id="ketrd_hpg" long_name="ke-trend: hydrostatic pressure gradient" unit="W/s^3" /> … … 1116 1154 --> 1117 1155 1156 <field_group id="TRD" > 1157 <field field_ref="ttrd_totad_li" name="opottempadvect" /> 1158 <field field_ref="ttrd_iso_li" name="opottemppmdiff" /> 1159 <field field_ref="ttrd_zdfp_li" name="opottempdiff" /> 1160 <field field_ref="ttrd_evd_li" name="opottempevd" /> 1161 <field field_ref="strd_evd_li" name="osaltevd" /> 1162 <field field_ref="ttrd_qns_li" name="opottempqns" /> 1163 <field field_ref="ttrd_qsr_li" name="rsdoabsorb" operation="accumulate" /> 1164 <field field_ref="strd_totad_li" name="osaltadvect" /> 1165 <field field_ref="strd_iso_li" name="osaltpmdiff" /> 1166 <field field_ref="strd_zdfp_li" name="osaltdiff" /> 1167 </field_group> 1168 1118 1169 <field_group id="mooring" > 1119 1170 <field field_ref="toce" name="thetao" long_name="sea_water_potential_temperature" /> -
branches/2015/nemo_v3_6_STABLE/NEMOGCM/NEMO/OPA_SRC/IOM/iom.F90
r7494 r8102 1617 1617 #if ! defined key_xios2 1618 1618 WRITE(cl1,'(i1)') 1 ; CALL iom_set_field_attr('field_definition', freq_op=cl1//'ts', freq_offset='0ts') 1619 WRITE(cl1,'(i1)') 2 ; CALL iom_set_field_attr('trendT_even' , freq_op=cl1//'ts', freq_offset='0ts') 1620 WRITE(cl1,'(i1)') 2 ; CALL iom_set_field_attr('trendT_odd' , freq_op=cl1//'ts', freq_offset='-1ts') 1619 1621 WRITE(cl1,'(i1)') nn_fsbc ; CALL iom_set_field_attr('SBC' , freq_op=cl1//'ts', freq_offset='0ts') 1620 1622 WRITE(cl1,'(i1)') nn_fsbc ; CALL iom_set_field_attr('SBC_scalar' , freq_op=cl1//'ts', freq_offset='0ts') … … 1623 1625 #else 1624 1626 f_op%timestep = 1 ; f_of%timestep = 0 ; CALL iom_set_field_attr('field_definition', freq_op=f_op, freq_offset=f_of) 1627 f_op%timestep = 2 ; f_of%timestep = 0 ; CALL iom_set_field_attr('trendT_even' , freq_op=f_op, freq_offset=f_of) 1628 f_op%timestep = 2 ; f_of%timestep = -1 ; CALL iom_set_field_attr('trendT_odd' , freq_op=f_op, freq_offset=f_of) 1625 1629 f_op%timestep = nn_fsbc ; f_of%timestep = 0 ; CALL iom_set_field_attr('SBC' , freq_op=f_op, freq_offset=f_of) 1626 1630 f_op%timestep = nn_fsbc ; f_of%timestep = 0 ; CALL iom_set_field_attr('SBC_scalar' , freq_op=f_op, freq_offset=f_of) -
branches/2015/nemo_v3_6_STABLE/NEMOGCM/NEMO/OPA_SRC/TRA/tranxt.F90
r7555 r8102 129 129 IF( l_trdtra ) THEN 130 130 CALL wrk_alloc( jpi, jpj, jpk, ztrdt, ztrds ) 131 ztrdt(:,:,j k) = 0._wp132 ztrds(:,:,j k) = 0._wp131 ztrdt(:,:,jpk) = 0._wp 132 ztrds(:,:,jpk) = 0._wp 133 133 IF( ln_traldf_iso ) THEN ! diagnose the "pure" Kz diffusive trend 134 134 CALL trd_tra( kt, 'TRA', jp_tem, jptra_zdfp, ztrdt ) 135 135 CALL trd_tra( kt, 'TRA', jp_sal, jptra_zdfp, ztrds ) 136 136 ENDIF 137 ! total trend for the non-time-filtered variables. 138 DO jk = 1, jpkm1 139 zfact = 1.0 / rdttra(jk) 140 ztrdt(:,:,jk) = ( tsa(:,:,jk,jp_tem) - tsn(:,:,jk,jp_tem) ) * zfact 141 ztrds(:,:,jk) = ( tsa(:,:,jk,jp_sal) - tsn(:,:,jk,jp_sal) ) * zfact 142 END DO 137 ! total trend for the non-time-filtered variables. 138 ! G Nurser 23 Mar 2017. Recalculate trend as Delta(e3t*T)/e3tn; e3tn cancel from tsn terms 139 IF( lk_vvl ) THEN 140 DO jk = 1, jpkm1 141 zfact = 1.0 / rdttra(jk) 142 ztrdt(:,:,jk) = ( tsa(:,:,jk,jp_tem)*fse3t_a(:,:,jk) / fse3t_n(:,:,jk) - tsn(:,:,jk,jp_tem)) * zfact 143 ztrds(:,:,jk) = ( tsa(:,:,jk,jp_sal)*fse3t_a(:,:,jk) / fse3t_n(:,:,jk) - tsn(:,:,jk,jp_sal)) * zfact 144 END DO 145 ELSE 146 DO jk = 1, jpkm1 147 zfact = 1.0 / rdttra(jk) 148 ztrdt(:,:,jk) = ( tsa(:,:,jk,jp_tem) - tsn(:,:,jk,jp_tem) ) * zfact 149 ztrds(:,:,jk) = ( tsa(:,:,jk,jp_sal) - tsn(:,:,jk,jp_sal) ) * zfact 150 END DO 151 END IF 143 152 CALL trd_tra( kt, 'TRA', jp_tem, jptra_tot, ztrdt ) 144 153 CALL trd_tra( kt, 'TRA', jp_sal, jptra_tot, ztrds ) 145 ! Store now fields before applying the Asselin filter 146 ! in order to calculate Asselin filter trend later. 147 ztrdt(:,:,:) = tsn(:,:,:,jp_tem) 148 ztrds(:,:,:) = tsn(:,:,:,jp_sal) 154 IF( .NOT.lk_vvl ) THEN 155 ! Store now fields before applying the Asselin filter 156 ! in order to calculate Asselin filter trend later. 157 ztrdt(:,:,:) = tsn(:,:,:,jp_tem) 158 ztrds(:,:,:) = tsn(:,:,:,jp_sal) 159 END IF 149 160 ENDIF 150 161 … … 155 166 END DO 156 167 END DO 168 IF (l_trdtra.AND.lk_vvl) THEN ! Zero Asselin filter contribution must be explicitly written out since for vvl 169 ! Asselin filter is output by tra_nxt_vvl that is not called on this time step 170 ztrdt(:,:,:) = 0._wp 171 ztrds(:,:,:) = 0._wp 172 CALL trd_tra( kt, 'TRA', jp_tem, jptra_atf, ztrdt ) 173 CALL trd_tra( kt, 'TRA', jp_sal, jptra_atf, ztrds ) 174 END IF 157 175 ELSE ! Leap-Frog + Asselin filter time stepping 158 176 ! … … 164 182 ! 165 183 ! trends computation 166 IF( l_trdtra 184 IF( l_trdtra.AND..NOT.lk_vvl) THEN ! trend of the Asselin filter (tb filtered - tb)/dt 167 185 DO jk = 1, jpkm1 168 186 zfact = 1._wp / r2dtra(jk) … … 172 190 CALL trd_tra( kt, 'TRA', jp_tem, jptra_atf, ztrdt ) 173 191 CALL trd_tra( kt, 'TRA', jp_sal, jptra_atf, ztrds ) 174 CALL wrk_dealloc( jpi, jpj, jpk, ztrdt, ztrds )175 192 END IF 193 IF( l_trdtra) CALL wrk_dealloc( jpi, jpj, jpk, ztrdt, ztrds ) 176 194 ! 177 195 ! ! control print … … 289 307 LOGICAL :: ll_tra_hpg, ll_traqsr, ll_rnf, ll_isf ! local logical 290 308 INTEGER :: ji, jj, jk, jn ! dummy loop indices 291 REAL(wp) :: zfact 1, ztc_a , ztc_n , ztc_b , ztc_f , ztc_d ! local scalar309 REAL(wp) :: zfact, zfact1, ztc_a , ztc_n , ztc_b , ztc_f , ztc_d ! local scalar 292 310 REAL(wp) :: zfact2, ze3t_b, ze3t_n, ze3t_a, ze3t_f, ze3t_d ! - - 311 REAL(wp), POINTER, DIMENSION(:,:,:,:) :: ztrd_atf 293 312 !!---------------------------------------------------------------------- 294 313 ! … … 315 334 ENDIF 316 335 ! 336 IF( l_trdtra ) THEN 337 CALL wrk_alloc( jpi, jpj, jpk, kjpt, ztrd_atf ) 338 ztrd_atf(:,:,:,:) = 0.0_wp 339 ENDIF 317 340 DO jn = 1, kjpt 318 341 DO jk = 1, jpkm1 342 zfact = 1._wp / r2dtra(jk) 319 343 zfact1 = atfp * p2dt(jk) 320 344 zfact2 = zfact1 / rau0 … … 371 395 pta(ji,jj,jk,jn) = ze3t_d * ( ztc_n + rbcp * ztc_d ) ! ta <-- Brown & Campana average 372 396 ENDIF 397 IF( l_trdtra ) THEN 398 ztrd_atf(ji,jj,jk,jn) = (ztc_f - ztc_n) * zfact/ze3t_n 399 ENDIF 373 400 END DO 374 401 END DO … … 377 404 END DO 378 405 ! 406 IF( l_trdtra ) THEN 407 CALL trd_tra( kt, 'TRA', jp_tem, jptra_atf, ztrd_atf(:,:,:,jp_tem) ) 408 CALL trd_tra( kt, 'TRA', jp_sal, jptra_atf, ztrd_atf(:,:,:,jp_sal) ) 409 CALL wrk_dealloc( jpi, jpj, jpk, kjpt, ztrd_atf ) 410 ENDIF 411 379 412 END SUBROUTINE tra_nxt_vvl 380 413 -
branches/2015/nemo_v3_6_STABLE/NEMOGCM/NEMO/OPA_SRC/TRA/trazdf.F90
r5385 r8102 94 94 95 95 IF( l_trdtra ) THEN ! save the vertical diffusive trends for further diagnostics 96 DO jk = 1, jpkm1 97 ztrdt(:,:,jk) = ( ( tsa(:,:,jk,jp_tem) - tsb(:,:,jk,jp_tem) ) / r2dtra(jk) ) - ztrdt(:,:,jk) 98 ztrds(:,:,jk) = ( ( tsa(:,:,jk,jp_sal) - tsb(:,:,jk,jp_sal) ) / r2dtra(jk) ) - ztrds(:,:,jk) 99 END DO 96 ! G Nurser 23 Mar 2017. Recalculate trend as Delta(e3t*T)/e3tn. 97 IF( lk_vvl ) THEN 98 DO jk = 1, jpkm1 99 ztrdt(:,:,jk) = ( ( tsa(:,:,jk,jp_tem)*fse3t_a(:,:,jk) - tsb(:,:,jk,jp_tem)*fse3t_b(:,:,jk) ) & 100 & / (fse3t_n(:,:,jk)*r2dtra(jk)) ) - ztrdt(:,:,jk) 101 ztrds(:,:,jk) = ( ( tsa(:,:,jk,jp_sal)*fse3t_a(:,:,jk) - tsb(:,:,jk,jp_sal)*fse3t_b(:,:,jk) ) & 102 & / (fse3t_n(:,:,jk)*r2dtra(jk)) ) - ztrds(:,:,jk) 103 END DO 104 ELSE 105 DO jk = 1, jpkm1 106 ztrdt(:,:,jk) = ( ( tsa(:,:,jk,jp_tem) - tsb(:,:,jk,jp_tem) ) / r2dtra(jk) ) - ztrdt(:,:,jk) 107 ztrds(:,:,jk) = ( ( tsa(:,:,jk,jp_sal) - tsb(:,:,jk,jp_sal) ) / r2dtra(jk) ) - ztrds(:,:,jk) 108 END DO 109 END IF 100 110 CALL lbc_lnk( ztrdt, 'T', 1. ) 101 111 CALL lbc_lnk( ztrds, 'T', 1. ) -
branches/2015/nemo_v3_6_STABLE/NEMOGCM/NEMO/OPA_SRC/TRD/trdtra.F90
r7555 r8102 301 301 !! ** Purpose : output 3D tracer trends using IOM 302 302 !!---------------------------------------------------------------------- 303 REAL(wp), DIMENSION(:,:,:), INTENT(inout) :: ptrdx ! Temperature or U trend 304 REAL(wp), DIMENSION(:,:,:), INTENT(inout) :: ptrdy ! Salinity or V trend 305 INTEGER , INTENT(in ) :: ktrd ! tracer trend index 306 INTEGER , INTENT(in ) :: kt ! time step 307 !! 308 INTEGER :: ji, jj, jk ! dummy loop indices 309 INTEGER :: ikbu, ikbv ! local integers 310 REAL(wp), POINTER, DIMENSION(:,:) :: z2dx, z2dy ! 2D workspace 311 !!---------------------------------------------------------------------- 312 ! 313 !!gm Rq: mask the trends already masked in trd_tra, but lbc_lnk should probably be added 314 ! 315 SELECT CASE( ktrd ) 316 CASE( jptra_xad ) ; CALL iom_put( "ttrd_xad" , ptrdx ) ! x- horizontal advection 317 CALL iom_put( "strd_xad" , ptrdy ) 318 CASE( jptra_yad ) ; CALL iom_put( "ttrd_yad" , ptrdx ) ! y- horizontal advection 319 CALL iom_put( "strd_yad" , ptrdy ) 320 CASE( jptra_zad ) ; CALL iom_put( "ttrd_zad" , ptrdx ) ! z- vertical advection 321 CALL iom_put( "strd_zad" , ptrdy ) 322 IF( .NOT. lk_vvl ) THEN ! cst volume : adv flux through z=0 surface 323 CALL wrk_alloc( jpi, jpj, z2dx, z2dy ) 324 z2dx(:,:) = wn(:,:,1) * tsn(:,:,1,jp_tem) / fse3t(:,:,1) 325 z2dy(:,:) = wn(:,:,1) * tsn(:,:,1,jp_sal) / fse3t(:,:,1) 326 CALL iom_put( "ttrd_sad", z2dx ) 327 CALL iom_put( "strd_sad", z2dy ) 328 CALL wrk_dealloc( jpi, jpj, z2dx, z2dy ) 329 ENDIF 330 CASE( jptra_totad ) ; CALL iom_put( "ttrd_totad" , ptrdx ) ! total advection 331 CALL iom_put( "strd_totad" , ptrdy ) 332 CASE( jptra_ldf ) ; CALL iom_put( "ttrd_ldf" , ptrdx ) ! lateral diffusion 333 CALL iom_put( "strd_ldf" , ptrdy ) 334 CASE( jptra_zdf ) ; CALL iom_put( "ttrd_zdf" , ptrdx ) ! vertical diffusion (including Kz contribution) 335 CALL iom_put( "strd_zdf" , ptrdy ) 336 CASE( jptra_zdfp ) ; CALL iom_put( "ttrd_zdfp", ptrdx ) ! PURE vertical diffusion (no isoneutral contribution) 337 CALL iom_put( "strd_zdfp", ptrdy ) 338 CASE( jptra_evd ) ; CALL iom_put( "ttrd_evd", ptrdx ) ! EVD trend (convection) 339 CALL iom_put( "strd_evd", ptrdy ) 340 CASE( jptra_dmp ) ; CALL iom_put( "ttrd_dmp" , ptrdx ) ! internal restoring (damping) 341 CALL iom_put( "strd_dmp" , ptrdy ) 342 CASE( jptra_bbl ) ; CALL iom_put( "ttrd_bbl" , ptrdx ) ! bottom boundary layer 343 CALL iom_put( "strd_bbl" , ptrdy ) 344 CASE( jptra_npc ) ; CALL iom_put( "ttrd_npc" , ptrdx ) ! static instability mixing 345 CALL iom_put( "strd_npc" , ptrdy ) 346 CASE( jptra_nsr ) ; CALL iom_put( "ttrd_qns" , ptrdx(:,:,1) ) ! surface forcing + runoff (ln_rnf=T) 347 CALL iom_put( "strd_cdt" , ptrdy(:,:,1) ) ! output as 2D surface fields 348 CASE( jptra_qsr ) ; CALL iom_put( "ttrd_qsr" , ptrdx ) ! penetrative solar radiat. (only on temperature) 349 CASE( jptra_bbc ) ; CALL iom_put( "ttrd_bbc" , ptrdx ) ! geothermal heating (only on temperature) 350 CASE( jptra_atf ) ; CALL iom_put( "ttrd_atf" , ptrdx ) ! asselin time Filter 351 CALL iom_put( "strd_atf" , ptrdy ) 352 CASE( jptra_tot ) ; CALL iom_put( "ttrd_tot" , ptrdx ) ! model total trend 353 CALL iom_put( "strd_tot" , ptrdy ) 354 END SELECT 355 ! 303 REAL(wp), DIMENSION(:,:,:), INTENT(inout) :: ptrdx ! Temperature or U trend 304 REAL(wp), DIMENSION(:,:,:), INTENT(inout) :: ptrdy ! Salinity or V trend 305 INTEGER , INTENT(in ) :: ktrd ! tracer trend index 306 INTEGER , INTENT(in ) :: kt ! time step 307 !! 308 INTEGER :: ji, jj, jk ! dummy loop indices 309 INTEGER :: ikbu, ikbv ! local integers 310 REAL(wp), POINTER, DIMENSION(:,:) :: z2dx, z2dy ! 2D workspace 311 !!---------------------------------------------------------------------- 312 ! 313 !!gm Rq: mask the trends already masked in trd_tra, but lbc_lnk should probably be added 314 ! 315 ! Trends evaluated every time step that could go to the standard T file and can be output every ts into a 1ts file if 1ts output is selected 316 SELECT CASE( ktrd ) 317 ! This total trend is done every time step 318 CASE( jptra_tot ) ; CALL iom_put( "ttrd_tot" , ptrdx ) ! model total trend 319 CALL iom_put( "strd_tot" , ptrdy ) 320 END SELECT 321 322 ! These trends are done every second time step. When 1ts output is selected must go different (2ts) file from standard T-file 323 IF( MOD( kt, 2 ) == 0 ) THEN 324 SELECT CASE( ktrd ) 325 CASE( jptra_xad ) ; CALL iom_put( "ttrd_xad" , ptrdx ) ! x- horizontal advection 326 CALL iom_put( "strd_xad" , ptrdy ) 327 CASE( jptra_yad ) ; CALL iom_put( "ttrd_yad" , ptrdx ) ! y- horizontal advection 328 CALL iom_put( "strd_yad" , ptrdy ) 329 CASE( jptra_zad ) ; CALL iom_put( "ttrd_zad" , ptrdx ) ! z- vertical advection 330 CALL iom_put( "strd_zad" , ptrdy ) 331 IF( .NOT. lk_vvl ) THEN ! cst volume : adv flux through z=0 surface 332 CALL wrk_alloc( jpi, jpj, z2dx, z2dy ) 333 z2dx(:,:) = wn(:,:,1) * tsn(:,:,1,jp_tem) / fse3t(:,:,1) 334 z2dy(:,:) = wn(:,:,1) * tsn(:,:,1,jp_sal) / fse3t(:,:,1) 335 CALL iom_put( "ttrd_sad", z2dx ) 336 CALL iom_put( "strd_sad", z2dy ) 337 CALL wrk_dealloc( jpi, jpj, z2dx, z2dy ) 338 ENDIF 339 CASE( jptra_totad ) ; CALL iom_put( "ttrd_totad" , ptrdx ) ! total advection 340 CALL iom_put( "strd_totad" , ptrdy ) 341 CASE( jptra_ldf ) ; CALL iom_put( "ttrd_ldf" , ptrdx ) ! lateral diffusion 342 CALL iom_put( "strd_ldf" , ptrdy ) 343 CASE( jptra_zdf ) ; CALL iom_put( "ttrd_zdf" , ptrdx ) ! vertical diffusion (including Kz contribution) 344 CALL iom_put( "strd_zdf" , ptrdy ) 345 CASE( jptra_zdfp ) ; CALL iom_put( "ttrd_zdfp", ptrdx ) ! PURE vertical diffusion (no isoneutral contribution) 346 CALL iom_put( "strd_zdfp", ptrdy ) 347 CASE( jptra_evd ) ; CALL iom_put( "ttrd_evd", ptrdx ) ! EVD trend (convection) 348 CALL iom_put( "strd_evd", ptrdy ) 349 CASE( jptra_dmp ) ; CALL iom_put( "ttrd_dmp" , ptrdx ) ! internal restoring (damping) 350 CALL iom_put( "strd_dmp" , ptrdy ) 351 CASE( jptra_bbl ) ; CALL iom_put( "ttrd_bbl" , ptrdx ) ! bottom boundary layer 352 CALL iom_put( "strd_bbl" , ptrdy ) 353 CASE( jptra_npc ) ; CALL iom_put( "ttrd_npc" , ptrdx ) ! static instability mixing 354 CALL iom_put( "strd_npc" , ptrdy ) 355 CASE( jptra_bbc ) ; CALL iom_put( "ttrd_bbc" , ptrdx ) ! geothermal heating (only on temperature) 356 CASE( jptra_nsr ) ; CALL iom_put( "ttrd_qns" , ptrdx(:,:,1) ) ! surface forcing + runoff (ln_rnf=T) 357 CALL iom_put( "strd_cdt" , ptrdy(:,:,1) ) ! output as 2D surface fields 358 CASE( jptra_qsr ) ; CALL iom_put( "ttrd_qsr" , ptrdx ) ! penetrative solar radiat. (only on temperature) 359 END SELECT 360 ! the Asselin filter trend is also every other time step but needs to be lagged one time step 361 ! Even when 1ts output is selected can go to the same (2ts) file as the trends plotted every even time step. 362 ELSE IF( MOD( kt, 2 ) == 1 ) THEN 363 SELECT CASE( ktrd ) 364 CASE( jptra_atf ) ; CALL iom_put( "ttrd_atf" , ptrdx ) ! asselin time Filter 365 CALL iom_put( "strd_atf" , ptrdy ) 366 END SELECT 367 END IF 368 ! 356 369 END SUBROUTINE trd_tra_iom 357 370
Note: See TracChangeset
for help on using the changeset viewer.