/[MITgcm]/MITgcm/doc/tag-index
ViewVC logotype

Diff of /MITgcm/doc/tag-index

Parent Directory Parent Directory | Revision Log Revision Log | View Revision Graph Revision Graph | View Patch Patch

revision 1.53.4.10 by heimbach, Tue Mar 26 08:28:14 2002 UTC revision 1.120 by jmc, Fri Jan 17 14:21:21 2003 UTC
# Line 2  $Header$ Line 2  $Header$
2    
3      Notes on tags used in MITgcmUV      Notes on tags used in MITgcmUV
4      ==============================      ==============================
5    o add new exp. (ideal_2D_oce) to test "exotic" parameters and options.
6    
7  ecco_c44_e20  checkpoint47i_post
8  o before major merges from the Scripps setup  o GM_EXCLUDE_() replace GM_TAPER_(): by default, all the code is compiled.
9    here are two small updates:  o add GM_Small_Number & GM_slopeSqCutoff as run-time parameters (data.gmredi)
10    - field swapping for surface flux controls enabled    default values = 1.D-12 & 1.D+48 (=> give same results as checkpoint47f_post)
11      (remains t.b.d. for atmos. state plus obcs)  o cg2dTargetResWunit: define tolerance using deltaTmom (and not deltaTfreesurf)
12    - bug fix in active_file.F for xz-/yz- routines  o gmredi: fix few bugs.
13    - added missing xz-/yz- routines to active_file_ad.F  
14    checkpoint47h_post (duplicate tag for PH's c48 tag, in order to move c48)
15  ecco_c44_e19  This will be a good checkpoint to plug into the ecco-branch.
16  o merged necessary patches:  o few modif.'s to get latest version adjointed
17    - AD-related changes for GMRedi    (mainly kick out code in ini_linear_phisurf)
18    - fixes i KPP (delZ -> drF)  o modif's to run adjoint with exactConserv
19    - hook to OBCS songe layer code in external_forcing  o case GM_BOLUS_ADVEC should be cleaned
20    - errorMessageUnit non-zero in eeboot.F    S/R gmredi_slope_psi should be cleaned
21    - included GMREDI, EXACT_CONSERV to natl_box_adjoint verif.  o verification/carbon now has exactConserv=.TRUE.
22    
23  ecco_c44_e18  checkpoint47g_post
24  o sponge layer code for obcs was missing  o time-average AIM output: becomes independent from statvars time-average
25    - added hook in external_forcing.F    (can be used with #undef ALLOW_TIMEAVE) ; add new variables (e.g., RH)
26    - added storing for TAF  o After TAF bug fix:
27  o new routine cost_init_barfiles to initialise    Tested adjoint of gmredi package.
28    adjoint fields adtbar, adsbar, adpsbar    Tests were done with checkpoint47 rather than with latest
29    (needed in conjunction with corrected ladinit for active I/O)    checkpoint47f_post since the latter is broken for the adjoint
30  o cleaned up and corrected order in packages_readparms, ecco_readparms    verification/carbon/ contains both ADM and TLM gradient checks.
31  o corrected and simplified weights for obcs controls  Here they are, before they get changed/lost/stolen.
32    - weight fields simplified  Mostly modif.'s to fix numerical sensitivities.
33    - bug fix in ctrl_pack  Gradient checks OK for
34    - no more write of control vector in ctrl_pack  - GM_taper_scheme:
35  o i/j index bug fixes in cost_ssh_mean    * clipping
36      * ac02
37  ecco_c44_e17    * linear
38  o bug fixes in cost package    * glw91
39    * wrong identifier for active I/O of monthly mean psbar    * dm95
40      (cost_averagesfields, cost_ssh) xx_psbar_dummy    * ldd97
41    * cleaned all identifier for active I/O of monthly fields  - GMREDI_OPTIONS:
42    * wrong ladinit in various cost routines    * GM_VISBECK_VARIABLE_K
43  o merge with interval (chkpt44c_post - chkpt44d_post)    * GM_NON_UNITY_DIAGONAL
44    * added missing EXCLUDE_MONITOR flags    * GM_EXTRA_DIAGONAL
45    * changed "e" to "_d" in gmredi_slope_limit, gmredi_slope_psi    * GM_BOLUS_ADVEC
46      (incompatible typ in MIN/MAX expressions caused problems  in conjunction with data.gmredi parameters to be checked in
47      on IBM SP3)  in a few minutes under verification/carbon/code/
48    * in genmake added variable MAKEDEPEND  
49      plus resetting for case SunOS  checkpoint47f_post
50      added timer_stats.c routine for IBM SP3  Merging from release1_p10:
51    * removed variables in dynamics  o modifications for using pkg/exf with pkg/seaice
52      - pkg/seaice CPP options SEAICE_EXTERNAL_FORCING
53  ecco_c44_e16      and SEAICE_EXTERNAL_FLUXES
54  o new ECCO checkpoint, the first since ecco_c43_e15    - pkg/exf CPP options EXF_READ_EVAP and
55    which is branched from MITgcm.      EXF_NO_BULK_COMPUTATIONS
56    All changes were merged in between (see ecco-branch-mod? tags).    - usage examples are Experiments 8 and 9 in
57  o last changes:      verification/lab_sea/README
58    * assuming path for TAF and TAMC are known (e.g. in $path)    - verification/lab_sea default experiment now uses
59    * genmake:      pkg/gmredi, pkg/kpp, pkg/seaice, and pkg/exf
60      - added tools/xmakedepend to circumvene shortcoming of  
61        SUN's makedepend (size too small)  checkpoint47e_post
62      - invoking ../tools/xmakedepend instead of makedepend  o created a tag prior to creating a branch
63      - changed compiler flags for case SunOS  
64    checkpoint47d_post
65  ecco-branch-mod5  o fixed bug in the oceanic pressure coordinates code: vertical viscosity
66  o mod's to reproduce open boundary run    at the bottom boundary had an erroneous half slip boundary condition
67  o enable field swapping for OB's and climatology  o added bottom drag and no slip boundary condition capabilities to
68  o update store directives for OB control    oceanic pressure coordinates code
69  o added option ALLOW_OBCS_PRESCRIBE  o added new verification experiment global_ocean_pressure, this experiment is
70  o call of getobcs now out of obcs_calc (param. list modified)    also described in the tutorial section of the manual
71    checkpoint47d_pre
72  ecco-branch-mod4  
73  o this is the second part of changes necessary to reconcile  checkpoint47c_post
74    the natl_box_adjoint verification (with and without grdchk).  o Added a verification experiment for a global cubed-sphere ocean run
75    >>>!!! CHANGES BETWEEN THE TAGS ecco-branch-mod3 !!!<<<    -  verification/global_ocean.cubed32x32x30
76    >>>!!!                      AND ecco-branch-mod4 !!!<<<    -  uses pkg/therm_seaice and pkg/bulk_forcing
77    >>>!!! SHOULD BE MERGED INTO THE MAIN TRUNK      !!!<<<  
78    o allow to run AIM physics with SPEEDY input files (from Franco Molteni)
79    o allow a more accurate definition of Ro_Surf (selectFindRoSurf=1)
80      when using P-coordinate; only implemented for atmospheric config.
81    o OCEANICP & realFreshWater: include P-E direct effect on wVel ;
82      NOTES: requires option NONLIN_FRSURF to be "#define".
83    o update advect_xz/results/output.txt (left from checkpoint44g_post)
84    
85    checkpoint47b_post
86    Merging from release1_p9:
87    o pkg/seaice
88      - removed GOTO's and added taf directives
89      - double precision constants to reduce the g77 (Linux)
90        to F77 (SGI) differences reported in release1_p8
91    o tools/genmake
92      - added SGI options
93    o verification/testscript
94      - updated to that of checkpoint47a_post
95    o verification/global_ocean.90x40x15/input/eedata
96      - modified for SGI f77 compatibility
97    o verification/lab_sea
98      - added description of sea-ice model
99      - added missing matlab routines
100      - added test of thermodynamics parallelization
101    
102    checkpoint47a_post
103    o new pkg: aim_v23
104     = F. Molteni atmos.physics (SPEEDY, ver23) adapted to MITgcm.
105       for now, keep the same surface forcing as before.
106     - Part-Cell implemented into AIM; check that Heat & Water are conserved
107     - aim.5l_cs: use new aim pkg (run 10yr & get better results than before)
108     - aim.5l_LatLon & aim.5l_Equatorial_Channel are still using old aim pkg
109    o add diagnostic of surface correction term in monitor output
110    
111    o bulk_force and therm_seaice
112    - Two packages:  bulk_force (Bulk forcing)
113      and therm_seaice (thermodynamic_seaice) - adopted from LANL CICE.v2.0.2
114    - Earlier integration from Stephaine Dutkiewicz
115      and Patrick Heimbach.
116    - Two ifdef statements for compile time,
117       ALLOW_THERM_SEAICE and ALLOW_BULK_FORCE
118    
119    checkpoint47
120    differentiable version of checkpoint46n_post
121    o bug fix in quasihydrostaticterms
122    o * "clean" adjoint code (in terms of extensive recomputations)
123        can now be obtained for all GMREDI options (i.e. for
124        - GM_VISBECK_VARIABLE_K
125        - GM_NON_UNITY_DIAGONAL
126        - GM_EXTRA_DIAGONAL
127        - GM_BOLUS_ADVEC )
128      * However, wrong gradient check problem remains unsolved.
129      * New CPP options have been introduced for different
130        tapering schemes
131    o external_fields_load now part of differentiation list
132    o pressure needs multiple storing;
133      would be nice to have store_pressure at beginning or
134      end of forward_step, e.g. by having phiHyd global (5-dim.)
135      (NB: pressure is needed for certain cases in find_rho,
136      which is also invoked through convective_adjustment).
137    o recomputations in find_rho for cases
138     'JMD95'/'UNESCO' or 'MDJWF' are OK.
139    o #define ATMOSPHERIC_LOADING should be differentiable
140    o ini_forcing shifted to begining of initialise_varia
141    o Incorporating QNVS line search routines into MITgcm
142      (this is separate code, and therefore not under pkg)
143      lsopt/, optim/
144    o Updated verification/carbon/
145      - #define GM_VISBECK_VARIABLE_K
146      - GM_taper_scheme    = 'ldd97'    
147    
148    checkpoint46n_post
149    Merging from release1_p8:
150    o verification/natl_box:
151      updating new external_fields_load routine
152    o New package: pkg/seaice
153      Sea ice model by D. Menemenlis (JPL) and Jinlun Zhang (Seattle).
154      The sea-ice code is based on Hibler (1979-1980).
155      Two sea-ice dynamic solvers, ADI and LSR, are included.
156      In addition to computing prognostic sea-ice variables and diagnosing
157      the forcing/external data fields that drive the ocean model,
158      SEAICE_MODEL also sets theta to the freezing point under sea-ice.
159      The implied surface heat flux is then stored in variable
160      surfaceTendencyTice, which is needed by KPP package (kpp_calc.F and
161      kpp_transport_t.F) to diagnose surface buoyancy fluxes and for the
162      non-local transport term.  Because this call precedes model
163      thermodynamics, temperature under sea-ice may not be "exactly" at
164      the freezing point by the time theta is dumped or time-averaged.
165      N.B.: fairly large differences in accuracy occur across
166            different platforms/compilers; comparison between
167            g77 (Linux) and F77 (SGI Origin 2000/MIPSpro)
168            generated output gives:
169       T           S           U           V
170      C D M    c        m  s        m  s        m  s        m  s
171      n p a R  g  m  m  e  .  m  m  e  .  m  m  e  .  m  m  e  .
172      f n k u  2  i  a  a  d  i  a  a  d  i  a  a  d  i  a  a  d
173      g d e n  d  n  x  n  .  n  x  n  .  n  x  n  .  n  x  n  .
174    
175      Y Y Y Y  5  5  7  7  7  8 10  9  6  6  6  6  7  5  7  5  7 FAIL  lab_sea
176    o GAD:
177      - generated new common blocks to account for call of
178        same gad routines with differing traceridentities
179        (needed to modify tracerIdentity indices in GAD.h)
180      - generated separate common blocks for case useCubedSphereExchange
181        (Department of Futurology)
182      - parameter lists to gmredi_?transport: added tracerIdentity
183      - added new key indices to tamc.h
184    o external_fields_load:
185      - added this routine to TAF list
186      - needed to make some common blocks global and additional storing
187        along the same lines as exf package (checkpoint_lev?_directives.h)
188    o exf:
189      updated external forcing package
190      - bug fixes carried over from ecco-branch
191        (missing OBCS_OPTIONS.h in two routines)
192      - enable easy to use "no forcing".
193      - added exf I/O for atmospheric loading
194      - added exf I/O for runoff data
195      - transfered scaling between exf <-> MITgcm to exf namelist
196    o Adding new verification experiment global_with_exf.
197      This verification experiment is almost identical to the
198      global_ocean.90x40x15 experiment, except that it uses
199      the exf (and cal) package instead of the
200      external_fields_load routine (cf README file).
201    
202    checkpoint46m_post
203    o modified testscript to return -- when there are no lines of "%MON" output
204    o added new flag "quasiHydrostatic" for QH mode
205      and new routine quasihydrostaticterms()
206    o added 2*Omega*Cos(phi)*W to u equations (non-hydrostatic Coriolis term)
207      New routine: mom_u_coriolis_nh()
208    o fixed sign of non-hydrostatic metric terms in u and v equations.
209      Depend on correct sign of gravitySign.
210    o added work.pc* to .cvsignore in aim directories using ifc
211    o introduced flag for controllin non-hydrostatic metric terms
212    o removed gravitySign from PARM04
213    o switched to g77/ifc from pgf77 in aim experiments
214    
215    checkpoint46l_post
216    o made convective adjustment work with pressure coordinates:
217     - changed the direction of k-loop in convective_adjustment.F for the
218       case of pressure coordinates (OCEANICP,ATMOSPHERIC buoyancyRelation)
219     - adjusted the reference pressure k-index in convective_adjustment.F
220     - adjusted the convection condition in convect.F (in analogy to
221       calc_ivdc.F)
222     - convective_adjustment no longer computes anything on the halos
223     - removed the warnings about negative salinity from find_rho.F and
224       find_alpha.F; instead the new routine look_for_neg_salinity, called
225       at the beginning of find_rho, find_alpha, and find_beta, does a
226       check of the entire slice, if CPP-option
227       CHECK_SALINITY_FOR_NEGATIVE_VALUES is defined
228    checkpoint46l_pre
229    
230    checkpoint46k_post
231    o fixed the verification/global_ocean.90x40x15 experiment:
232     - new bathymetry (the world according to A., JMC, and M.)
233     - new initial fields and forcing fields (*.bin files)
234     - new POLY3.COEFFS (for the next release one should switch to a full
235       equation of state: JMD95P or MDJWF)
236     - fixed several errors and redundancies in the data file
237     - experiment uses looped cells
238     - added matlab directory with diagnostic scripts for plotting of output
239    
240    o S/R aim_initialise.F replace S/R aim_init from file aim_do_inphys.F:
241     - read AIM physics parameters from a file (data.aimphys)
242     - set defaults values = F.Molteni paper (Clim.Dyn., 2002)
243    
244    checkpoint46j_post
245    o split calc_exact_eta in 2 S/R : integr_continuity & update_etaH
246    o move wVel computation at the end of the time step, in S/R integr_continuity
247    o create specific S/R to exchange T,S before DYNAMICS (for stagger time step)
248    o update timeave pkg for wVel diagnostic.
249    checkpoint46j_pre
250    
251    checkpoint46i_post
252    o Clean up AIM package (and keep the results unchanged):
253      include CPP_OPTION and use IMPLICT NONE in all routines ;
254      declare all the variables _RL ; use _d 0 for all numerical constants.
255      use ifdef ALLOW_AIM everywhere. And now AIM can be used with g77 !
256    
257    checkpoint46h_post
258    o cleaned up the use of rhoNil and rhoConst.
259      - rhoNil should only appear in the LINEAR equation of state, everywhere
260        else rhoNil is replaced by rhoConst, e.g. find_rho computes rho-rhoConst
261        and the dynamical equations are all divided by rhoConst
262    o introduced new parameter rhoConstFresh, a reference density of fresh
263      water, to remove the fresh water flux's dependence on rhoNil. The default
264      value is 999.8 kg/m^3
265    o cleanup up external_forcing.F and external_forcing_surf.F
266      - can now be used by both OCEANIC and OCEANICP
267    checkpoint46h_pre
268    
269     Added code to convert surface volume flux (fresh water) into
270     a mass flux when using P coordinates in the ocean (OCEANICP).
271     Note: It assumes you have set rho0=rhoConst=density of fresh water.
272    
273    checkpoint46g_post
274    o Include a new diagnostic variable phiHydLow for the ocean model
275      - in z-coordinates, it is the bottom pressure anomaly
276      - in p-coordinates, it is the sea surface elevation
277      - in both cases, these variable have global drift, reflecting the mass
278        drift in z-coordinates and the volume drift in p-coordinates
279      - included time averaging for phiHydLow, be aware of the drift!
280    o depth-dependent computation of Bo_surf for pressure coordinates
281      in the ocean (buoyancyRelation='OCEANICP')
282      - requires a new routine (FIND_RHO_SCALAR) to compute density with only
283        Theta, Salinity, and Pressure in the parameter list. This routine is
284        presently contained in find_rho.F. This routine does not give the
285        correct density for 'POLY3', which would be a z-dependent reference
286        density.
287    o cleaned up find_rho
288      - removed obsolete 'eqn' from the parameter list.
289    o added two new verification experiments: gop and goz
290      (4x4 degree global ocean, 15 layers in pressure and height coordinates)
291    checkpoint46g_pre
292    
293    checkpoint46f_post
294    o Enable tangent linear (forward mode) gradient checks:
295      - extended active file handling to g_... files
296      - added TANGENT_SIMULATION to theSimulationMode
297      - extended grdchk package accordingly
298    o added tangent linear setup in verification/carbon/code_ftl
299    o added adjoint setup in verification/front_relax/code_ad
300    
301    checkpoint46e_post
302    o Added new equation of state -> MDJWF
303      - EOS of McDougall et al., 2002, JAOT, submitted
304      - caveat: the equation of state is only valid for a smaller (more
305        realistic?) range of values than JMD95P/Z and UNESCO
306      - added masks to the calculation of pressure in store_pressure
307      - added more check values for density in check_eos (ini_eos.F), some of
308        the old check values are out of the range of the MDJWF-eos, so don't
309        expect perfect matches for those
310    checkpoint46e_pre
311    
312    checkpoint46d_post
313    o fixed store_pressure to work with both buoyancy relation = 'OCEANIC' and
314      'OCEANICP', also initialised field pressure correctly in ini_eos in the
315      case of pressure coordinates. eosType='JMD95Z' in
316      combination with buoyancyRelation='OCEANICP' now causes an error.
317    o Changed p = pressure(i,j,k,bi,bj)  to  p = pressure(i,j,kRef,bi,bj)
318      in find_alpha/beta.
319    checkpoint46d_pre
320    
321    o Changed p = pressure(i,j,k,bi,bj)  to  p = pressure(i,j,kRef,bi,bj)
322      so that JMD95Z and JMD95P give approptiate static stability in find_rho.
323    
324    checkpoint46c_post
325    o Changes necessary for ocean in p-coordinates
326     -  Added new buoyancy relation = 'OCEANICP'
327     -  Added new parameters = gravitySign (this used to be contained inside
328        the factor dRdZ which I added when we first switched to R coordinates).
329     X GM/Redi is not compatible (yet)
330     X bottom drag and no-slip need to be debugged.
331    checkpoint46c_pre
332    
333    checkpoint46b_post
334    o Added new equation of state -> JMD95Z and JMD95P
335      - EOS of Jackett and McDougall, 1995, JAOT
336      - moved all EOS parameters into EOS.h
337      - new routines ini_eos.F, store_pressure.F
338    o Added UNESCO EOS, but not recommended because it requires
339      in-situ temperature (see JMD95)
340    o Modified formatting for knudsen2.f in utils/knudsen2 and added
341      unesco.f to be used with POLY3
342    checkpoint46b_pre
343    
344    checkpoint46a_post
345    o Added (atmospheric) pressure loading
346      - new field in FFIELDS.h, etc...
347      - new cpp flag ATMOSPHERIC_LOADING
348    o Changed hFacC to _hFacC in calc_phi_hyd.F
349    o Added SHORTWAVE_HEATING to some files for consistency
350    checkpoint46a_pre
351    
352    checkpoint46
353    further merges from release1_p5
354    o new ctrl package
355      - adopted from ECCO environment to enable optimization
356      - added Eliassen Palm fluxes to controls
357    o added Eliassen Palm flux controls to gradient check package
358    o cost package
359      - Compatible with new ctrl package
360      - added Eliassen Palm cost hooks
361      - modif's of existing cost functions
362    o Adjoint-related bug fixes in kpp:
363      - kpp_calc: sore of kpphbl avoids recomputation/call to S/R kppmix
364      - kpp_routines: store of Rib avoids partial recomputation bug of TAF.
365    o autodiff package
366      - flow directives:
367        + new for S/R do_the_model_io
368        + enhanced for S/R checkpoint
369        + new gmredi.flow
370      - Introduced CPP option ALLOW_AUTODIFF_MONITOR to
371        disable adcommon.h/g_common.h by default.
372      - fixed problem for adjoint of global_max
373    o modified verification/carbon/
374    o New setup for adjoint of global_ocean
375    o added hooks for Eliassen Palm fluxes (dynamics.F, ini_fields.F)
376    o cleaned TAF keys iikey, idkey (dynamics.F, thermodynamics.F)
377    o incorporated hooks for sponge layer code (external_forcing.F)
378    
379    checkpoint45d_post
380    o import 2 fixes from release1_p5 (CG2D.h & packages_readparms.F)
381    o use recip_dx*,recip_dy* instead of /dx*,/dy* in orlanski_E,W,N,S
382      (affects plume_on_slope "cg2d" output)
383    o add new parameter deltaTfreesurf for free-surface time stepping
384    o exchange gT,gS when using staggerTimeStep & GM & Oly<4
385    o NONLIN_FRSURF: rescale gNm1 to get a better conservation with A-B
386    o change phiMin in exp1 (to agree with documentation)
387    o add new flags:
388     - T,S forcing inside/outside Adams-Bashforth
389     - turn off temp,salt advection and/or forcing
390     - for each tracer, define internal flag for multiDimAdvection & A-B
391    o monitor: change definition of KE to check conservation of Energy
392    
393    checkpoint45c_post
394    o Removed f90 comments ("!")
395    o Modified initialisations to enable exf package for MITgcm
396      (without invoking ECCO_PACKAGE).
397    o modifications to gradient check package (Martin Losch)
398      - enable centered differences
399      - modified format of standard output
400    
401    checkpoint45b_post
402    o cleaned exchange calls in cg2d
403    o Included CPP option ALLOW_AUTODIFF_MONITOR in forward_step
404    o included CPP option SINGLE_LAYER_MODE in thermodynamics
405      to configure barotropic setup (Martin Losch)
406    o moved some initialisations within bi,bj loop in dynamics
407      (TAF flow dependency)
408    o in initialise_varia, moved call packages_init_variables
409      before convective_adjustment_init
410      (corresponding adjustment of TAF tape initialisation).
411    o in calc_diffusivity/calc_viscosity extended domain to full overlap.
412    
413    checkpoint45a_post
414    o compute Rho over the whole domain (extend iMin,jMin indices)
415    o specific exchange for X-slice domain (case Ny=1)
416    o argument futureIter of S/R obcs_calc missing in exp4 & internal_wave /code
417    o solve_for_pressure : set cg2d_x to zero where OBCS are applied
418    
419    checkpoint44h_post = checkpoint45
420    o Fix to restore differentiability:
421      place at which packages_init_variables is called in
422      initialise_varia is crucial for reverse control flow.
423    o modifications in GMRedi to enable stable adjoint
424      (corresponding modif's in thermodynamics, dynamics)
425    o added missing hook for sponge layer code in external_forcing
426    o modified test cost functions
427    o storing in gad_advection (plus removal of write(0,*)!
428    o missing headers TR1.h added in convective_adjustment routines
429    o errorMessageUnit set non-equal zero in eeboot
430      (conflict on some platforms, e.g. IBM SP3)
431    o modified carbon verif.
432    
433    checkpoint44h_pre
434    o vertical grid option: allow to put the Interface at the middle between
435      2 cell-centers ; replace delZ in pkg/kpp by drF.
436    o GM Advective form: Tracers are advected using the residual transport (=
437      Euler+GM-bolus); set param GM_AdvSeparate=T to return to previous form.
438    
439    checkpoint44g_post
440    o fix surface correction term in multiDimAdvection (affects plume_on_slope
441      results) ; ifdef missing in thermodynamics.F
442    
443    checkpoint44f_pre,checkpoint44f_post
444    o added PTRACERS package
445      This allows an arbitrary number of passive tracers to be integrated
446      forward simultaneously with the dynamicaly model.
447      + Implemented so far:
448        - basic forward algorithm (time-stepping, advection, diffusion, convection)
449        - I/O and checkpointing
450        - GM/Redi  *but*  using the GM/Redi coefficient of Salt
451      + Not implemented so far:
452        - KPP
453        - OBCS
454      + No specific example supplied (yet) but global_ocean.90x40x15 has the
455        necessary data.ptracer file. Simply use -enable=ptracers and uncomment
456        line in data.pkg.
457      + This package is disabled by default since it increases storage.
458    
459    
460    o testscript: added -cleanup option
461    o Shap_filt: a) new shap_filt S/R to use no-slip BC with S2 filter
462                 b) enable to filter 2D fields.
463    
464    checkpoint44e_pre,post
465    o re-wrote convective adjustment to use pre-calculated weights
466      Affects: model/src/convective_adjustment.F, convective_adjustment_ini.F
467      Adds:    model/src/convective_weights.F, convectively_mixtracer.F
468      Original calls to convect() still in place.
469    
470    chkpt44d_pre,post
471    o added missing EXCLUDE_MONITOR flags
472    o changed "e" to "_d" in gmredi_slope_limit, gmredi_slope_psi
473      (incompatible typ in MIN/MAX expressions caused problems
474      on IBM SP3)
475    o in genmake added variable MAKEDEPEND
476      plus resetting for case SunOS
477    o added timer_stats.c routine for IBM SP3
478    o removed variables in dynamics
479    !!! I forgot to create tag chkpt44d_pre !!!
480    !!! But chkpt44d_pre = chkpt44c_post    !!!
481    
482    o real fresh water flux implemented with non-linear free-surface.
483    
484    chkpt44c_pre,post
485    o few fix (mask in shap_s2, EmPmR in external_field_load,
486      USE_NATURAL_BCS in solve_for_P);
487    o add arguments myIter & myTime to S/R obcs_calc & solve_for_P
488    
489    checkpoint44b_pre/_post
490    o merge of relevant stuff from the ecco-branch:
491    - genmake: removed $S64 overwrite for case SunOS    - genmake: removed $S64 overwrite for case SunOS
492    - pkg/exf: update and corrections for field swapping and obcs    - pkg/exf: update and corrections for field swapping and obcs
493    - pkg/ecco: parameter lists for the_model_main, the_main_loop    - pkg/ecco: parameter lists for the_model_main, the_main_loop
# Line 81  o this is the second part of changes nec Line 495  o this is the second part of changes nec
495    - pkg/autodiff: added flow directives for obcs, mdsio_gl_slice    - pkg/autodiff: added flow directives for obcs, mdsio_gl_slice
496                    updated checkpointing_lev... lists for obcs                    updated checkpointing_lev... lists for obcs
497    - model/src: minor changes in forward_step, plot_field    - model/src: minor changes in forward_step, plot_field
498                   added directive for divided adjoint in the_main_loop
499    - pkg/mdsio: added mdsio_gl_slice    - pkg/mdsio: added mdsio_gl_slice
500    
501  ecco-branch-mod3  o check parameters & config (chkpt44a_pre,post)
502  o this is the first part of changes necessary to reconcile  o OBC and NonLin_FrSurf.
   natl_box_adjoint verification (with and without grdchk).  
   This set of changes is relevant for ECCO only.  
   The next set/tag of changes (ecco-branch-mod4)  
   should be merged into the main trunk.  
   - update some options  
   - parameter lists of ecco_the_model_main and ecco_the_main_loop  
     differed from those of the MITgcm counterparts.  
   
 ecco-branch-mod2  
 o update ecco-branch-mod1 to checkpoint44  
 o exclude from updates:  
   - verification/  
   - adjoint/  
   - pkg/cost  
   - pkg/ctrl  
   - pkg/ecco  
   - pkg/obcs  
   - model/src/the_model_main.F  
   - model/src/the_main_loop.F  
503    
504  checkpoint44  checkpoint44
 o apply Shapiro filter on T&S before calc_PhiHyd (stagger time stepping)  
505  o fix bug in mom_vi_del2uv  o fix bug in mom_vi_del2uv
506    o select when filters are applied ; add options to zonal_filter (data.zonfilt)
507    o gmredi: fix Pb in the adiabatic form ; add options (.e.g. Bolus advection)
508    o update AIM experiments (NCEP input files)
509    o improve and extend diagnostics (Monitor, TimeAve with NonLin-FrSurf)
510  o added some stuff for AD  o added some stuff for AD
511    
 ecco-branch-mod1  
 o based on c43  
 o replaced packages cost, ctrl, ecco, obcs  
 o removed MITgcm verif.'s, added ECCO verif.'s  
 o added lsopt, optim for line search optimization.  
   
512  checkpoint43  checkpoint43
513  o added two new advection tests  o added two new advection tests
514  o added global 4x4 degree ocean test  o added global 4x4 degree ocean test

Legend:
Removed from v.1.53.4.10  
changed lines
  Added in v.1.120

  ViewVC Help
Powered by ViewVC 1.1.22