New URL for NEMO forge!   http://forge.nemo-ocean.eu

Since March 2022 along with NEMO 4.2 release, the code development moved to a self-hosted GitLab.
This present forge is now archived and remained online for history.
limwri.F90 in trunk/NEMOGCM/NEMO/LIM_SRC_3 – NEMO

source: trunk/NEMOGCM/NEMO/LIM_SRC_3/limwri.F90 @ 4765

Last change on this file since 4765 was 4765, checked in by rblod, 10 years ago

Compilation issue, see ticket #1379

  • Property svn:keywords set to Id
File size: 19.2 KB
RevLine 
[825]1MODULE limwri
2   !!======================================================================
3   !!                     ***  MODULE  limwri  ***
4   !!         Ice diagnostics :  write ice output files
5   !!======================================================================
[888]6#if defined key_lim3
[825]7   !!----------------------------------------------------------------------
[2528]8   !!   'key_lim3'                                      LIM3 sea-ice model
[825]9   !!----------------------------------------------------------------------
10   !!   lim_wri      : write of the diagnostics variables in ouput file
[4161]11   !!   lim_wri_state : write for initial state or/and abandon
[825]12   !!----------------------------------------------------------------------
13   USE ioipsl
[888]14   USE dianam          ! build name of file (routine)
[825]15   USE phycst
16   USE dom_oce
[888]17   USE sbc_oce         ! Surface boundary condition: ocean fields
18   USE sbc_ice         ! Surface boundary condition: ice fields
[825]19   USE dom_ice
20   USE ice
[2715]21   USE limvar
22   USE in_out_manager
[825]23   USE lbclnk
[2715]24   USE lib_mpp         ! MPP library
[3294]25   USE wrk_nemo        ! work arrays
[825]26   USE par_ice
[4161]27   USE iom
28   USE timing          ! Timing
29   USE lib_fortran     ! Fortran utilities
[825]30
31   IMPLICIT NONE
32   PRIVATE
33
34   PUBLIC lim_wri        ! routine called by lim_step.F90
[4161]35   PUBLIC lim_wri_state  ! called by dia_wri_state
[825]36
[4333]37   REAL(wp)  ::   epsi06 = 1.e-6_wp
[2528]38   !!----------------------------------------------------------------------
[4161]39   !! NEMO/LIM3 4.0 , UCL - NEMO Consortium (2011)
[2528]40   !! $Id$
[2715]41   !! Software governed by the CeCILL licence     (NEMOGCM/NEMO_CeCILL.txt)
[2528]42   !!----------------------------------------------------------------------
43CONTAINS
[825]44
45#if defined key_dimgout
46# include "limwri_dimg.h90"
47#else
48
49   SUBROUTINE lim_wri( kindic )
50      !!-------------------------------------------------------------------
51      !!  This routine computes the average of some variables and write it
52      !!  on the ouput files.
53      !!  ATTENTION cette routine n'est valable que si le pas de temps est
54      !!  egale a une fraction entiere de 1 jours.
55      !!  Diff 1-D 3-D : suppress common also included in etat
56      !!                 suppress cmoymo 11-18
57      !!  modif : 03/06/98
58      !!-------------------------------------------------------------------
[2715]59      INTEGER, INTENT(in) ::   kindic   ! if kindic < 0 there has been an error somewhere
60      !
[4688]61      INTEGER ::  ji, jj, jk, jl  ! dummy loop indices
62      REAL(wp) ::  zinda, zindb, z1_365
63      REAL(wp), POINTER, DIMENSION(:,:,:) ::   zoi, zei
64      REAL(wp), POINTER, DIMENSION(:,:)   :: z2d, z2da, z2db, zind    ! 2D workspace
[2715]65      !!-------------------------------------------------------------------
[825]66
[4161]67      IF( nn_timing == 1 )  CALL timing_start('limwri')
68
[4688]69      CALL wrk_alloc( jpi, jpj, jpl, zoi, zei )
70      CALL wrk_alloc( jpi, jpj     , z2d, z2da, z2db, zind )
[2777]71
[4688]72      !-----------------------------
73      ! Mean category values
74      !-----------------------------
[825]75
[4688]76      CALL lim_var_icetm      ! mean sea ice temperature
[921]77
[4688]78      CALL lim_var_bv         ! brine volume
[825]79
[4688]80      DO jj = 1, jpj          ! presence indicator of ice
81         DO ji = 1, jpi
82            zind(ji,jj)  = MAX( 0._wp , SIGN( 1._wp , at_i(ji,jj) - epsi06 ) )
83         END DO
84      END DO
85      !
86      !
87      !                                             
88      IF ( iom_use( "icethic_cea" ) ) THEN                       ! mean ice thickness
89         DO jj = 1, jpj 
90            DO ji = 1, jpi
91               z2d(ji,jj)  = vt_i(ji,jj) / MAX( at_i(ji,jj), epsi06 ) * zind(ji,jj)
92            END DO
93         END DO
94         CALL iom_put( "icethic_cea"  , z2d              )
95      ENDIF
[921]96
[4688]97      IF ( iom_use( "snowthic_cea" ) ) THEN                      ! snow thickness = mean snow thickness over the cell
98         DO jj = 1, jpj                                           
99            DO ji = 1, jpi
100               z2d(ji,jj)  = vt_s(ji,jj) / MAX( at_i(ji,jj), epsi06 ) * zind(ji,jj)
101            END DO
102         END DO
103         CALL iom_put( "snowthic_cea" , z2d              )       
104      ENDIF
105      !
106      IF ( iom_use( "uice_ipa" ) .OR. iom_use( "vice_ipa" ) .OR. iom_use( "icevel" ) ) THEN
107         DO jj = 2 , jpjm1
108            DO ji = 2 , jpim1
109               z2da(ji,jj)  = (  u_ice(ji,jj) * tmu(ji,jj) + u_ice(ji-1,jj) * tmu(ji-1,jj) ) * 0.5_wp
110               z2db(ji,jj)  = (  v_ice(ji,jj) * tmv(ji,jj) + v_ice(ji,jj-1) * tmv(ji,jj-1) ) * 0.5_wp
111           END DO
112         END DO
113         CALL lbc_lnk( z2da, 'T', -1. )
114         CALL lbc_lnk( z2db, 'T', -1. )
115         CALL iom_put( "uice_ipa"     , z2da                )       ! ice velocity u component
116         CALL iom_put( "vice_ipa"     , z2db                )       ! ice velocity v component
117         DO jj = 1, jpj                                 
118            DO ji = 1, jpi
119               z2d(ji,jj)  = SQRT( z2da(ji,jj) * z2da(ji,jj) + z2db(ji,jj) * z2db(ji,jj) ) 
120            END DO
121         END DO
122         CALL iom_put( "icevel"       , z2d                 )       ! ice velocity module
123      ENDIF
124      !
125      IF ( iom_use( "miceage" ) ) THEN
126         z2d(:,:) = 0.e0
127         DO jl = 1, jpl
128            DO jj = 1, jpj
129               DO ji = 1, jpi
130                  z2d(ji,jj) = z2d(ji,jj) + zind(ji,jj) * oa_i(ji,jj,jl)
131               END DO
132            END DO
133         END DO
134         z1_365 = 1._wp / 365._wp
135         CALL iom_put( "miceage"     , z2d * z1_365         )        ! mean ice age
136      ENDIF
[825]137
[4688]138      IF ( iom_use( "micet" ) ) THEN
139         DO jj = 1, jpj
140            DO ji = 1, jpi
141               z2d(ji,jj) = ( tm_i(ji,jj) - rtt ) * zind(ji,jj)
142            END DO
143         END DO
144         CALL iom_put( "micet"       , z2d                  )        ! mean ice temperature
145      ENDIF
146      !
147      IF ( iom_use( "icest" ) ) THEN
148         z2d(:,:) = 0.e0
[825]149         DO jl = 1, jpl
[4688]150            DO jj = 1, jpj
151               DO ji = 1, jpi
152                  z2d(ji,jj) = z2d(ji,jj) + zind(ji,jj) * ( t_su(ji,jj,jl) - rtt ) * a_i(ji,jj,jl) / MAX( at_i(ji,jj) , epsi06 )
153               END DO
154            END DO
[825]155         END DO
[4688]156         CALL iom_put( "icest"       , z2d                 )        ! ice surface temperature
[825]157      ENDIF
158
[4688]159      IF ( iom_use( "icecolf" ) ) THEN
[825]160         DO jj = 1, jpj
161            DO ji = 1, jpi
[4688]162               zindb  = MAX( 0._wp , SIGN( 1._wp , at_i(ji,jj) ) )
163               z2d(ji,jj) = hicol(ji,jj) * zindb
[825]164            END DO
165         END DO
[4688]166         CALL iom_put( "icecolf"     , z2d                 )        ! frazil ice collection thickness
167      ENDIF
[825]168
[4688]169      CALL iom_put( "isst"        , sst_m               )        ! sea surface temperature
170      CALL iom_put( "isss"        , sss_m               )        ! sea surface salinity
171      CALL iom_put( "iceconc"     , at_i                )        ! ice concentration
172      CALL iom_put( "icevolu"     , vt_i                )        ! ice volume = mean ice thickness over the cell
173      CALL iom_put( "icehc"       , et_i                )        ! ice total heat content
174      CALL iom_put( "isnowhc"     , et_s                )        ! snow total heat content
175      CALL iom_put( "ibrinv"      , bv_i * 100._wp      )        ! brine volume
176      CALL iom_put( "utau_ice"    , utau_ice            )        ! wind stress over ice along i-axis at I-point
177      CALL iom_put( "vtau_ice"    , vtau_ice            )        ! wind stress over ice along j-axis at I-point
178      CALL iom_put( "snowpre"     , sprecip             )        ! snow precipitation
179      CALL iom_put( "micesalt"    , smt_i               )        ! mean ice salinity
[4161]180
[4688]181      CALL iom_put( "icestr"      , strength * 0.001    )        ! ice strength
182      CALL iom_put( "idive"       , divu_i * 1.0e8      )        ! divergence
183      CALL iom_put( "ishear"      , shear_i * 1.0e8     )        ! shear
184      CALL iom_put( "snowvol"     , vt_s                )        ! snow volume
185     
186      CALL iom_put( "icetrp"      , diag_trp_vi * rday  )        ! ice volume transport
187      CALL iom_put( "snwtrp"      , diag_trp_vs * rday  )        ! snw volume transport
188      CALL iom_put( "deitrp"      , diag_trp_ei         )        ! advected ice enthalpy (W/m2)
189      CALL iom_put( "destrp"      , diag_trp_es         )        ! advected snw enthalpy (W/m2)
[921]190
[4688]191      CALL iom_put( "sfxbog"      , sfx_bog * rday      )        ! salt flux from brines
192      CALL iom_put( "sfxbom"      , sfx_bom * rday      )        ! salt flux from brines
193      CALL iom_put( "sfxsum"      , sfx_sum * rday      )        ! salt flux from brines
194      CALL iom_put( "sfxsni"      , sfx_sni * rday      )        ! salt flux from brines
195      CALL iom_put( "sfxopw"      , sfx_opw * rday      )        ! salt flux from brines
196      CALL iom_put( "sfxdyn"      , sfx_dyn * rday      )        ! salt flux from ridging rafting
197      CALL iom_put( "sfxres"      , sfx_res * rday      )        ! salt flux from limupdate (resultant)
198      CALL iom_put( "sfxbri"      , sfx_bri * rday      )        ! salt flux from brines
199      CALL iom_put( "sfx"         , sfx     * rday      )        ! total salt flux
[825]200
[4688]201      CALL iom_put( "vfxres"     , wfx_res * rday / rhoic  )        ! daily prod./melting due to limupdate
202      CALL iom_put( "vfxopw"     , wfx_opw * rday / rhoic  )        ! daily lateral thermodynamic ice production
203      CALL iom_put( "vfxsni"     , wfx_sni * rday / rhoic  )        ! daily snowice ice production
204      CALL iom_put( "vfxbog"     , wfx_bog * rday / rhoic  )       ! daily bottom thermodynamic ice production
205      CALL iom_put( "vfxdyn"     , wfx_dyn * rday / rhoic  )       ! daily dynamic ice production (rid/raft)
206      CALL iom_put( "vfxsum"     , wfx_sum * rday / rhoic  )        ! surface melt
207      CALL iom_put( "vfxbom"     , wfx_bom * rday / rhoic  )        ! bottom melt
208      CALL iom_put( "vfxice"     , wfx_ice * rday / rhoic  )        ! total ice growth/melt
209      CALL iom_put( "vfxsnw"     , wfx_snw * rday / rhoic  )        ! total snw growth/melt
210      CALL iom_put( "vfxsub"     , wfx_sub * rday / rhoic  )        ! sublimation (snow)
211      CALL iom_put( "vfxspr"     , wfx_spr * rday / rhoic  )        ! precip (snow)
[825]212
[4688]213      CALL iom_put ('hfxthd', hfx_thd(:,:) )   
214      CALL iom_put ('hfxdyn', hfx_dyn(:,:) )   
215      CALL iom_put ('hfxres', hfx_res(:,:) )   
216      CALL iom_put ('hfxout', hfx_out(:,:) )   
217      CALL iom_put ('hfxin' , hfx_in(:,:) )   
218      CALL iom_put ('hfxsnw', hfx_snw(:,:) )   
219      CALL iom_put ('hfxsub', hfx_sub(:,:) )   
220      CALL iom_put ('hfxerr', hfx_err(:,:) )   
221      CALL iom_put ('hfxerr_rem', hfx_err_rem(:,:) )   
222     
223      CALL iom_put ('hfxsum', hfx_sum(:,:) )   
224      CALL iom_put ('hfxbom', hfx_bom(:,:) )   
225      CALL iom_put ('hfxbog', hfx_bog(:,:) )   
226      CALL iom_put ('hfxdif', hfx_dif(:,:) )   
227      CALL iom_put ('hfxopw', hfx_opw(:,:) )   
228      CALL iom_put ('hfxtur', fhtur(:,:) * at_i(:,:) )   ! turbulent heat flux at ice base
229      CALL iom_put ('hfxdhc', diag_heat_dhc(:,:) )          ! Heat content variation in snow and ice
230      CALL iom_put ('hfxspr', hfx_spr(:,:) )          ! Heat content of snow precip
231     
232      !--------------------------------
233      ! Output values for each category
234      !--------------------------------
235      CALL iom_put( "iceconc_cat"      , a_i         )        ! area for categories
236      CALL iom_put( "icethic_cat"      , ht_i        )        ! thickness for categories
237      CALL iom_put( "snowthic_cat"     , ht_s        )        ! snow depth for categories
238      CALL iom_put( "salinity_cat"     , sm_i        )        ! salinity for categories
[825]239
[4688]240      ! Compute ice age
241      IF ( iom_use( "iceage_cat" ) ) THEN
[921]242         DO jl = 1, jpl 
[825]243            DO jj = 1, jpj
244               DO ji = 1, jpi
[4688]245                  zinda = MAX( 0._wp , SIGN( 1._wp , a_i(ji,jj,jl) - epsi06 ) )
[4161]246                  zoi(ji,jj,jl) = oa_i(ji,jj,jl)  / MAX( a_i(ji,jj,jl) , epsi06 ) * zinda
[825]247               END DO
248            END DO
249         END DO
[4688]250         CALL iom_put( "iceage_cat"     , zoi         )        ! ice age for categories
251      ENDIF
[825]252
[4688]253      ! Compute brine volume
254      IF ( iom_use( "brinevol_cat" ) ) THEN
[2715]255         zei(:,:,:) = 0._wp
[921]256         DO jl = 1, jpl 
257            DO jk = 1, nlay_i
258               DO jj = 1, jpj
259                  DO ji = 1, jpi
[4688]260                     zinda = MAX( 0._wp , SIGN( 1._wp , a_i(ji,jj,jl) - epsi06 ) )
[921]261                     zei(ji,jj,jl) = zei(ji,jj,jl) + 100.0* &
[4161]262                        ( - tmut * s_i(ji,jj,jk,jl) / MIN( ( t_i(ji,jj,jk,jl) - rtt ), - epsi06 ) ) * &
[921]263                        zinda / nlay_i
264                  END DO
265               END DO
266            END DO
267         END DO
[4688]268         CALL iom_put( "brinevol_cat"     , zei         )        ! brine volume for categories
[825]269      ENDIF
270
[4688]271      !     !  Create an output files (output.lim.abort.nc) if S < 0 or u > 20 m/s
272      !     IF( kindic < 0 )   CALL lim_wri_state( 'output.abort' )
273      !     not yet implemented
274     
275      CALL wrk_dealloc( jpi, jpj, jpl, zoi, zei )
276      CALL wrk_dealloc( jpi, jpj     , z2d, zind, z2da, z2db )
[4161]277
278      IF( nn_timing == 1 )  CALL timing_stop('limwri')
[2777]279     
[825]280   END SUBROUTINE lim_wri
281#endif
282
[4161]283 
284   SUBROUTINE lim_wri_state( kt, kid, kh_i )
285      !!---------------------------------------------------------------------
286      !!                 ***  ROUTINE lim_wri_state  ***
287      !!       
288      !! ** Purpose :   create a NetCDF file named cdfile_name which contains
289      !!      the instantaneous ice state and forcing fields for ice model
290      !!        Used to find errors in the initial state or save the last
291      !!      ocean state in case of abnormal end of a simulation
292      !!
293      !! History :
294      !!   4.1  !  2013-06  (C. Rousset)
295      !!----------------------------------------------------------------------
296      INTEGER, INTENT( in ) ::   kt               ! ocean time-step index)
297      INTEGER, INTENT( in ) ::   kid , kh_i       
298      !!----------------------------------------------------------------------
[825]299
[4765]300      CALL histdef( kid, "iicethic", "Ice thickness"           , "m"      ,   &
301      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
302      CALL histdef( kid, "iiceconc", "Ice concentration"       , "%"      ,   &
303      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
304      CALL histdef( kid, "iicetemp", "Ice temperature"         , "C"      ,   &
305      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
306      CALL histdef( kid, "iicevelu", "i-Ice speed (I-point)"   , "m/s"    ,   &
307      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
308      CALL histdef( kid, "iicevelv", "j-Ice speed (I-point)"   , "m/s"    ,   &
309      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
310      CALL histdef( kid, "iicestru", "i-Wind stress over ice (I-pt)", "Pa",   &
311      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
312      CALL histdef( kid, "iicestrv", "j-Wind stress over ice (I-pt)", "Pa",   &
313      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
314      CALL histdef( kid, "iicesflx", "Solar flux over ocean"     , "w/m2" ,   &
315      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
316      CALL histdef( kid, "iicenflx", "Non-solar flux over ocean" , "w/m2" ,   &
317      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
318      CALL histdef( kid, "isnowpre", "Snow precipitation"      , "kg/m2/s",   &
319      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
320      CALL histdef( kid, "iicesali", "Ice salinity"            , "PSU"    ,   &
321      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
322      CALL histdef( kid, "iicevolu", "Ice volume"              , "m"      ,   &
323      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
324      CALL histdef( kid, "iicedive", "Ice divergence"          , "10-8s-1",   &
325      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt ) 
326      CALL histdef( kid, "iicebopr", "Ice bottom production"   , "m/s"    ,   &
327      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
328      CALL histdef( kid, "iicedypr", "Ice dynamic production"  , "m/s"    ,   &
329      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
330      CALL histdef( kid, "iicelapr", "Ice open water prod"     , "m/s"    ,   &
331      &       jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
332      CALL histdef( kid, "iicesipr", "Snow ice production "    , "m/s"    ,   &
333      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
334      CALL histdef( kid, "iicerepr", "Ice prod from limupdate" , "m/s"    ,   &
335      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
336      CALL histdef( kid, "iicebome", "Ice bottom melt"         , "m/s"    ,   &
337      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
338      CALL histdef( kid, "iicesume", "Ice surface melt"        , "m/s"    ,   &
339      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
340      CALL histdef( kid, "iisfxdyn", "Salt flux from dynmics"  , ""       ,   &
341      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
342      CALL histdef( kid, "iisfxres", "Salt flux from limupdate", ""       ,   &
343      &      jpi, jpj, kh_i, 1, 1, 1, -99, 32, "inst(x)", rdt, rdt )
[4161]344
345      CALL histend( kid, snc4set )   ! end of the file definition
346
347      CALL histwrite( kid, "iicethic", kt, icethi        , jpi*jpj, (/1/) )   
348      CALL histwrite( kid, "iiceconc", kt, at_i          , jpi*jpj, (/1/) )
349      CALL histwrite( kid, "iicetemp", kt, tm_i - rtt    , jpi*jpj, (/1/) )
350      CALL histwrite( kid, "iicevelu", kt, u_ice          , jpi*jpj, (/1/) )
351      CALL histwrite( kid, "iicevelv", kt, v_ice          , jpi*jpj, (/1/) )
352      CALL histwrite( kid, "iicestru", kt, utau_ice       , jpi*jpj, (/1/) )
353      CALL histwrite( kid, "iicestrv", kt, vtau_ice       , jpi*jpj, (/1/) )
354      CALL histwrite( kid, "iicesflx", kt, qsr , jpi*jpj, (/1/) )
355      CALL histwrite( kid, "iicenflx", kt, qns , jpi*jpj, (/1/) )
356      CALL histwrite( kid, "isnowpre", kt, sprecip        , jpi*jpj, (/1/) )
357      CALL histwrite( kid, "iicesali", kt, smt_i          , jpi*jpj, (/1/) )
358      CALL histwrite( kid, "iicevolu", kt, vt_i           , jpi*jpj, (/1/) )
359      CALL histwrite( kid, "iicedive", kt, divu_i*1.0e8   , jpi*jpj, (/1/) )
360
[4688]361      CALL histwrite( kid, "iicebopr", kt, wfx_bog        , jpi*jpj, (/1/) )
362      CALL histwrite( kid, "iicedypr", kt, wfx_dyn        , jpi*jpj, (/1/) )
363      CALL histwrite( kid, "iicelapr", kt, wfx_opw        , jpi*jpj, (/1/) )
364      CALL histwrite( kid, "iicesipr", kt, wfx_sni        , jpi*jpj, (/1/) )
365      CALL histwrite( kid, "iicerepr", kt, wfx_res        , jpi*jpj, (/1/) )
366      CALL histwrite( kid, "iicebome", kt, wfx_bom        , jpi*jpj, (/1/) )
367      CALL histwrite( kid, "iicesume", kt, wfx_sum        , jpi*jpj, (/1/) )
368      CALL histwrite( kid, "iisfxdyn", kt, sfx_dyn        , jpi*jpj, (/1/) )
[4333]369      CALL histwrite( kid, "iisfxres", kt, sfx_res        , jpi*jpj, (/1/) )
370
[4688]371      ! Close the file
372      ! -----------------
373      !CALL histclo( kid )
[4161]374
375    END SUBROUTINE lim_wri_state
376
[825]377#else
378   !!----------------------------------------------------------------------
379   !!   Default option :         Empty module          NO LIM sea-ice model
380   !!----------------------------------------------------------------------
381CONTAINS
382   SUBROUTINE lim_wri          ! Empty routine
383   END SUBROUTINE lim_wri
384#endif
385
386   !!======================================================================
387END MODULE limwri
Note: See TracBrowser for help on using the repository browser.