/[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.41 by heimbach, Tue May 27 22:43:44 2003 UTC revision 1.96 by adcroft, Tue Nov 5 19:15:12 2002 UTC
# Line 3  $Header$ Line 3  $Header$
3      Notes on tags used in MITgcmUV      Notes on tags used in MITgcmUV
4      ==============================      ==============================
5    
6  o Patrick's adjoint-model storage directives for pkg/seaice  o introduced flag for controllin non-hydrostatic metric terms
7  o merged with checkpoint50g_post (pkg/seaice and verification/lab_sea)  o removed gravitySign from PARM04
8    - added SEAICE_MULTILEVEL for 8-category sea-ice thermodynamics  o switched to g77/ifc from pgf77 in aim experiments
9    - LSR sea-ice dynamic solver moved to SouthWest B-grid location and  
10      made the default because of faster convergence than ADI  checkpoint46l_post
11  o Modifications for adjoint of SEAICE_ALLOW_DYNAMICS  o made convective adjustment work with pressure coordinates:
12    - extended state in checkpoint_lev...   - changed the direction of k-loop in convective_adjustment.F for the
13    - in lsr.F, replaced GO TO by fixed loop index (also avoid DO WHILE)     case of pressure coordinates (OCEANICP,ATMOSPHERIC buoyancyRelation)
14    - YEAH: in lsr.F, (first) successful use of CADJ LOOP = ITERATION   - adjusted the reference pressure k-index in convective_adjustment.F
15    - avoid stoing in S/R budget for now   - adjusted the convection condition in convect.F (in analogy to
16    - in dynsolver.F, avoid NPSEUDO loop for adjoint     calc_ivdc.F)
17    - new comlev1_lsr in the_main_loop   - convective_adjustment no longer computes anything on the halos
18     - removed the warnings about negative salinity from find_rho.F and
19  ecco_c50_e31     find_alpha.F; instead the new routine look_for_neg_salinity, called
20  o exf totally restructured     at the beginning of find_rho, find_alpha, and find_beta, does a
21    - replaced all exf_set_ routines by one generic exf_set_gen.F     check of the entire slice, if CPP-option
22      and made sure it's still differentiable     CHECK_SALINITY_FOR_NEGATIVE_VALUES is defined
23    - split exf_getffields.F into new exf_bulkformulae.F  checkpoint46l_pre
24    - exf_inscal_/exf_outscal_ suffixes consistent with field names  
25  o New cost function: Tini-Tfin to do model spinup optimization.  checkpoint46k_post
26  o Started new verification exp for Tini-Tfin optimization.  o fixed the verification/global_ocean.90x40x15 experiment:
27     - new bathymetry (the world according to A., JMC, and M.)
28  ecco_c50_e30   - new initial fields and forcing fields (*.bin files)
29  o corrected CPP option mismatch in exf_Bulk... functions for case   - new POLY3.COEFFS (for the next release one should switch to a full
30    #define ALLOW_ATM_WIND && #undef ALLOW_ATM_TEMP     equation of state: JMD95P or MDJWF)
31  o Merging from release1_p13 and from icebear5   - fixed several errors and redundancies in the data file
32    - bug fix for pkg/seaice dynamic solver   - experiment uses looped cells
33    - Added SEAICE_initialHEFF to pkg/seaice   - added matlab directory with diagnostic scripts for plotting of output
34    - Additional options for pkg/cost/cost_ice.F  
35    - Updates to verification/natl_box_adjoint  o S/R aim_initialise.F replace S/R aim_init from file aim_do_inphys.F:
36    - pkg/ctrl/ctrl_init.F   - read AIM physics parameters from a file (data.aimphys)
37      Fix for determination of startrec and endrec.   - set defaults values = F.Molteni paper (Clim.Dyn., 2002)
38    - pkg/cal/cal_toseconds.F  
39      Fix for negative intervals shorter than 1 day.  checkpoint46j_post
40    o split calc_exact_eta in 2 S/R : integr_continuity & update_etaH
41  ecco_c50_e29  o move wVel computation at the end of the time step, in S/R integr_continuity
42  Bug fix for merging between c50 and KPP.  o create specific S/R to exchange T,S before DYNAMICS (for stagger time step)
43  ikey was passed from thermodynamics to kpp_calc via  o update timeave pkg for wVel diagnostic.
44  common block rather than being recomputed in kpp_calc,  checkpoint46j_pre
45  in contradiction with new key itdkey.  
46  New key ikppkey created, and tamc.h headers updated.  checkpoint46i_post
47    o Clean up AIM package (and keep the results unchanged):
48  ecco_c50_e28    include CPP_OPTION and use IMPLICT NONE in all routines ;
49  o major merge:    declare all the variables _RL ; use _d 0 for all numerical constants.
50    ecco-branch merged with checkpoint50    use ifdef ALLOW_AIM everywhere. And now AIM can be used with g77 !
51    gmredi now available, grdchk, DIVA up-to-date for MPI  
52    However, two outstanding problems:  checkpoint46h_post
53    - kpp adjoint is broken, needs fixing!  o cleaned up the use of rhoNil and rhoConst.
54    - a few minor modif's in handling of CPP option    - rhoNil should only appear in the LINEAR equation of state, everywhere
55      ALLOW_TANGENTLINEAR_RUN in conjunction with      else rhoNil is replaced by rhoConst, e.g. find_rho computes rho-rhoConst
56      ALLOW_ECCO_OPTIMIZATION are necessary to enable      and the dynamical equations are all divided by rhoConst
57      TLM runs with ECCO setup  o introduced new parameter rhoConstFresh, a reference density of fresh
58      water, to remove the fresh water flux's dependence on rhoNil. The default
59  ecco_c44_e27    value is 999.8 kg/m^3
60  o exf:  o cleanup up external_forcing.F and external_forcing_surf.F
61    - Enable initialisation of forcing fields to constant    - can now be used by both OCEANIC and OCEANICP
62      (runtime) values.  checkpoint46h_pre
63    - in exf_getffields.F  
64      Reduce i-/j-loop to interior domain, discarding overlaps.   Added code to convert surface volume flux (fresh water) into
65      That also fixes wrong TAF-key computations for key_1, key_2   a mass flux when using P coordinates in the ocean (OCEANICP).
66      with bulf formulae.   Note: It assumes you have set rho0=rhoConst=density of fresh water.
67    - exf_init.F modify #ifdef for exf_init_evap  
68    - exf_getffieldrec.F, ctrl_getrec.F  checkpoint46g_post
69      The following INT-usages are not safe:  o Include a new diagnostic variable phiHydLow for the ocean model
70        fldsecs  = int(fldsecs/fldperiod)*fldperiod    - in z-coordinates, it is the bottom pressure anomaly
71        fldcount = int(fldsecs/fldperiod) + 1    - in p-coordinates, it is the sea surface elevation
72      and were modified.    - in both cases, these variable have global drift, reflecting the mass
73    - added repeatPeriod (from MAIN branch)      drift in z-coordinates and the volume drift in p-coordinates
74  o grdchk: updated and merged    - included time averaging for phiHydLow, be aware of the drift!
75    - has both ADM and TLM checks  o depth-dependent computation of Bo_surf for pressure coordinates
76    - works for single- and multi-proc.    in the ocean (buoyancyRelation='OCEANICP')
77    - output cleaned    - requires a new routine (FIND_RHO_SCALAR) to compute density with only
78    - worked successfully for parallel DIVA      Theta, Salinity, and Pressure in the parameter list. This routine is
79    Needed one update in EEPARAMS.h and updates in ctrl package      presently contained in find_rho.F. This routine does not give the
80    More modif's may be necessary for ECCO code to support TLM.      correct density for 'POLY3', which would be a z-dependent reference
81  o autodiff: checkpoint_lev...      density.
82    - updated storing for bulk formulae (some arrays were missing)  o cleaned up find_rho
83    - added state for seaice package    - removed obsolete 'eqn' from the parameter list.
84    - synchronized with main branch  o added two new verification experiments: gop and goz
85  o DIVA:    (4x4 degree global ocean, 15 layers in pressure and height coordinates)
86    Modif.s in  checkpoint46g_pre
87    - cost_init.F  
88    - cost_averagesfields.F  checkpoint46f_post
89    - ecco_the_main_loop.F  o Enable tangent linear (forward mode) gradient checks:
90    - ecco_the_model_main.F    - extended active file handling to g_... files
91    and added cost_final_restore.F cost_final_store.F    - added TANGENT_SIMULATION to theSimulationMode
92    o With these changes, it is possible to fully separate    - extended grdchk package accordingly
93      the first forward run to compute the cost function (mdthe_main_loop)  o added tangent linear setup in verification/carbon/code_ftl
94      and adjoint runs over individual DIVA intervals (adthe_main_loop)  o added adjoint setup in verification/front_relax/code_ad
95      into separate model executions.  
96      This enables better tuning of DIVA to given queue sizes.  checkpoint46e_post
97    o Loss of cost function value in consecutive DIVA runs is  o Added new equation of state -> MDJWF
98      fixed by storing to 'costfinal' file.    - EOS of McDougall et al., 2002, JAOT, submitted
99    o Appropriate call of ctrl_unpack/_pack,grdchk_main at    - caveat: the equation of state is only valid for a smaller (more
100      beginning/end of adjoint integration is accounted for.      realistic?) range of values than JMD95P/Z and UNESCO
101    The current changes apply to TAF-1.4.26.    - added masks to the calculation of pressure in store_pressure
102    TAF has one remaining bug, requiring one manual change    - added more check values for density in check_eos (ini_eos.F), some of
103    (see MITgcm manual).      the old check values are out of the range of the MDJWF-eos, so don't
104  o bug fix plus modif for ubar, vbar in cost_averagesfields      expect perfect matches for those
105  o cal: synchronized between MAIN and ecco-branch  checkpoint46e_pre
106    
107  icebear4  checkpoint46d_post
108  o Added cost_ice for sea-ice volume sensitivity experiment.  o fixed store_pressure to work with both buoyancy relation = 'OCEANIC' and
109  o ecco_the_model_main.F: SEAICE_WRITE_PICKUP must precede WRITE_CHECKPOINT    'OCEANICP', also initialised field pressure correctly in ini_eos in the
110  o Reduced derivative singularities in pkg/seaice.    case of pressure coordinates. eosType='JMD95Z' in
111  o Updated verification/natl_box_adjoint    combination with buoyancyRelation='OCEANICP' now causes an error.
112    o Changed p = pressure(i,j,k,bi,bj)  to  p = pressure(i,j,kRef,bi,bj)
113  icebear3    in find_alpha/beta.
114  o Removed spurious iikey and idkey  checkpoint46d_pre
115  o pkg/exf  
116    - bug fix in treatment of downward radiation  o Changed p = pressure(i,j,k,bi,bj)  to  p = pressure(i,j,kRef,bi,bj)
117  o pkg/seaice    so that JMD95Z and JMD95P give approptiate static stability in find_rho.
118    - added initial sea-ice thickness parameter SEAICE_initialHEFF  
119  o updated verification/natl_box_adjoint  checkpoint46c_post
120    o Changes necessary for ocean in p-coordinates
121  icebear2   -  Added new buoyancy relation = 'OCEANICP'
122  o Added missing /* */ to CPP comments in pkg/seaice, pkg/exf,   -  Added new parameters = gravitySign (this used to be contained inside
123    kpp_transport_t.F,and ecco_the_main_loop.F      the factor dRdZ which I added when we first switched to R coordinates).
124  o adjoint-friendly modifications to pkg/seaice   X GM/Redi is not compatible (yet)
125  o added verification/lab_sea as per release1_p12_pre   X bottom drag and no-slip need to be debugged.
126    checkpoint46c_pre
127  ecco_c44_e26  
128  o Merging pkg/exf and pkg/seaice from cvs tag ecco_ice2  checkpoint46b_post
129  o exf: Modifications to correctly handle evap field for adjoint  o Added new equation of state -> JMD95Z and JMD95P
130  o grdchk:    - EOS of Jackett and McDougall, 1995, JAOT
131    Added code to perform gradient checks for bulk formulae/atmos. state    - moved all EOS parameters into EOS.h
132    (atemp, aqh, uwind, vwind).    - new routines ini_eos.F, store_pressure.F
133    NOTE:  o Added UNESCO EOS, but not recommended because it requires
134    This package is out of synch with c48 package.    in-situ temperature (see JMD95)
135    The latter also has the tangent linear gradient checks.  o Modified formatting for knudsen2.f in utils/knudsen2 and added
136    Need to be merged.    unesco.f to be used with POLY3
137  o verification/natl_box_adjoint:  checkpoint46b_pre
138    * added new setup: code_bulk/, input_bulk, results_bulk  
139      (Experiment 2, described in README)  checkpoint46a_post
140      uses bulk formulae and atmos. state as control instead of  o Added (atmospheric) pressure loading
141      air-sea fluxes.    - new field in FFIELDS.h, etc...
142      Performs gradient checks for first 4 elements of atemp control.    - new cpp flag ATMOSPHERIC_LOADING
143    * changed standard verification to perform  o Changed hFacC to _hFacC in calc_phi_hyd.F
144      gradient checks on first 4 elements on hflux control.  o Added SHORTWAVE_HEATING to some files for consistency
145    * gmredi switched off (will come after merge with c48).  checkpoint46a_pre
146    
147  ecco_c44_e25  checkpoint46
148  o Merging some GM changes from main trunk (c47) to ecco-branch.  further merges from release1_p5
149  o Updating verif. natl_box_adjoint with GMRedi.  o new ctrl package
150  o Adding setup with explicit differentiaton of pressure solver.    - adopted from ECCO environment to enable optimization
151  o Bug fix: missing OBCS_OPTIONS.h for sponge layer code.    - added Eliassen Palm fluxes to controls
152  o (Re-?) Commiting old bug fixes in kpp to ecco-branch  o added Eliassen Palm flux controls to gradient check package
153    (kpp_calc.F, kpp_routines.F)  o cost package
154  o exf:    - Compatible with new ctrl package
155    updated external forcing package    - added Eliassen Palm cost hooks
156    - cleaned old exfa stuff    - modif's of existing cost functions
157    - bug fixes  o Adjoint-related bug fixes in kpp:
158      (missing OBCS_OPTIONS.h in two routines)    - kpp_calc: sore of kpphbl avoids recomputation/call to S/R kppmix
159    - enable easy to use "no forcing".    - kpp_routines: store of Rib avoids partial recomputation bug of TAF.
160    - added exf I/O for atmospheric loading  o autodiff package
161    - added exf I/O for runoff data    - flow directives:
162    - transfered scaling between exf <-> MITgcm to exf namelist      + new for S/R do_the_model_io
163        + enhanced for S/R checkpoint
164  ecco_c44_e24      + new gmredi.flow
165      - Introduced CPP option ALLOW_AUTODIFF_MONITOR to
166        disable adcommon.h/g_common.h by default.
167      - fixed problem for adjoint of global_max
168    o modified verification/carbon/
169    o New setup for adjoint of global_ocean
170    o added hooks for Eliassen Palm fluxes (dynamics.F, ini_fields.F)
171    o cleaned TAF keys iikey, idkey (dynamics.F, thermodynamics.F)
172    o incorporated hooks for sponge layer code (external_forcing.F)
173    
174    checkpoint45d_post
175    o import 2 fixes from release1_p5 (CG2D.h & packages_readparms.F)
176    o use recip_dx*,recip_dy* instead of /dx*,/dy* in orlanski_E,W,N,S
177      (affects plume_on_slope "cg2d" output)
178    o add new parameter deltaTfreesurf for free-surface time stepping
179    o exchange gT,gS when using staggerTimeStep & GM & Oly<4
180    o NONLIN_FRSURF: rescale gNm1 to get a better conservation with A-B
181    o change phiMin in exp1 (to agree with documentation)
182    o add new flags:
183     - T,S forcing inside/outside Adams-Bashforth
184     - turn off temp,salt advection and/or forcing
185     - for each tracer, define internal flag for multiDimAdvection & A-B
186    o monitor: change definition of KE to check conservation of Energy
187    
188    checkpoint45c_post
189    o Removed f90 comments ("!")
190    o Modified initialisations to enable exf package for MITgcm
191      (without invoking ECCO_PACKAGE).
192  o modifications to gradient check package (Martin Losch)  o modifications to gradient check package (Martin Losch)
193    - enable centered differences    - enable centered differences
194    - modified format of standard output    - modified format of standard output
195  o bug fix for nwettile contents  
196    so far assumed global sum  in first entry (1,1,k),  checkpoint45b_post
197    needed for global control vector  o cleaned exchange calls in cg2d
198    -> introduced new variable nwet[c/w/s]global(nr)  o Included CPP option ALLOW_AUTODIFF_MONITOR in forward_step
199  o shifts of calls to cal/exf package to be accessible  o included CPP option SINGLE_LAYER_MODE in thermodynamics
200    in MITgcm stand-alone    to configure barotropic setup (Martin Losch)
201  o shifted packages_init_variables before convective_adjustment_ini  o moved some initialisations within bi,bj loop in dynamics
202    (corresponding update of TAF tape initialisation).    (TAF flow dependency)
203  o removed auxiliary field in impldiff  o in initialise_varia, moved call packages_init_variables
204    (caused numerical differences for GMRedi cases)    before convective_adjustment_init
205  o updated obcs control part (G. Gebbie)    (corresponding adjustment of TAF tape initialisation).
206  o removed some f90 comments ("!")  o in calc_diffusivity/calc_viscosity extended domain to full overlap.
207  o Bug fixes and updates in cost package  
208   * cost_final: correct multiplier mult_tauv, mult_sflux  checkpoint45a_post
209   * cost_hyd: added call cost_ssh  o compute Rho over the whole domain (extend iMin,jMin indices)
210   * cost_init_barfiles.F: replaced arrays by tmpfld's  o specific exchange for X-slice domain (case Ny=1)
211   * cost_readtopexmean.F: ersmask -> tpmeanmask  o argument futureIter of S/R obcs_calc missing in exp4 & internal_wave /code
212   * cost_weights.F: corrected wtheta[2], wsalt[2]  o solve_for_pressure : set cg2d_x to zero where OBCS are applied
213  o cleaned exchanges in cg2d.F  
214    checkpoint44h_post = checkpoint45
215  ecco_c44_e23  o Fix to restore differentiability:
216  merged patches between release1_p1 and release1_p2:    place at which packages_init_variables is called in
217  o fixed array boundary problem for adjoint    initialise_varia is crucial for reverse control flow.
218    (related to partial recomputation within subroutine  o modifications in GMRedi to enable stable adjoint
219    related to dynamics -> calc_viscosity -> mom_...    (corresponding modif's in thermodynamics, dynamics)
220  o fixed recomputation in thermodynamics  o added missing hook for sponge layer code in external_forcing
221  o prepare (but not complete) recomputation problem in impldiff  o modified test cost functions
222  o fixed problem for adjoint of global_max  o storing in gad_advection (plus removal of write(0,*)!
223  o switched off sponge layer code in external_forcing  o missing headers TR1.h added in convective_adjustment routines
224  Bug fix in ctrl_mask_set_yz (spotted by G. Gebbie)  o errorMessageUnit set non-equal zero in eeboot
225      (conflict on some platforms, e.g. IBM SP3)
226  ecco_c44_e22  o modified carbon verif.
227  o Finally, the merges with the Scripps cost function terms:  
228    Various additions, modifications, quality checks.  checkpoint44h_pre
229  o Plus: Included switch ALLOW_AUTODIFF_MONITOR to handle  o vertical grid option: allow to put the Interface at the middle between
230    monitoring of adjoint state.    2 cell-centers ; replace delZ in pkg/kpp by drF.
231  o Plus: removed comm_stats, ini_communication_patterns from diff. list  o GM Advective form: Tracers are advected using the residual transport (=
232    (no more need to "keep" MPI headers for adjoint generation)    Euler+GM-bolus); set param GM_AdvSeparate=T to return to previous form.
233  o Plus: exf changes:  
234    o added run-off routine  checkpoint44g_post
235    o additional storing needed for ustress,vstess  o fix surface correction term in multiDimAdvection (affects plume_on_slope
236      because of state-dependent quality check    results) ; ifdef missing in thermodynamics.F
237    o added missing initialisations  
238  o Plus: genmake with MAKEDEPEND variable was still missing in ecco-branch  checkpoint44f_pre,checkpoint44f_post
239  NB: - verification/natl_box_adjoint/ 240 steps run  o added PTRACERS package
240        * looks ok under Linux (twain.lcs.mit.edu)    This allows an arbitrary number of passive tracers to be integrated
241        * looks ok on MIT SUN's (fjord.mit.edu)    forward simultaneously with the dynamicaly model.
242        * NaN in reverse mode on Scripps SUN's at iter=214    + Implemented so far:
243        * NaN in reverse mode on IBM SP3 (BlueHorizon) at iter=204      - basic forward algorithm (time-stepping, advection, diffusion, convection)
244      - 1 year forward int. global 2x2 deg. produces similar cost functions      - I/O and checkpointing
245        * all cost terms of new code are slightly smaller (0.5 to 3%).      - GM/Redi  *but*  using the GM/Redi coefficient of Salt
246      + Not implemented so far:
247  ecco_c44_e21      - KPP
248  o reversed order of ctrl/cost initialisation      - OBCS
249  o gmredi_slope_psi.F: Inconsistent types in MIN/MAX expressions    + No specific example supplied (yet) but global_ocean.90x40x15 has the
250  o modified to enable ctrl field swapping      necessary data.ptracer file. Simply use -enable=ptracers and uncomment
251  o bug fix for global sum of ncvarlength in ctrl_init      line in data.pkg.
252  o no more call to ctrl_unpack from ctrl_init    + This package is disabled by default since it increases storage.
253  o no more write of ctrl vector in ctrl_pack  
254    however, init. of control vector from ctrl_unpack  
255  o various bug fixes & consistent nobcs handling in  o testscript: added -cleanup option
256    ctrl_pack/unpack routines (by G. Gebbie)  o Shap_filt: a) new shap_filt S/R to use no-slip BC with S2 filter
257  o optim package: Added obcs control part for lsopt I/O               b) enable to filter 2D fields.
258    (by G. Gebbie)  
259  o missing call to obcs_diags  checkpoint44e_pre,post
260  o moved calls in packages_init_fixed to packages_readparms  o re-wrote convective adjustment to use pre-calculated weights
261    because some quantities are needed earlier.    Affects: model/src/convective_adjustment.F, convective_adjustment_ini.F
262      Adds:    model/src/convective_weights.F, convectively_mixtracer.F
263  ecco_c44_e20    Original calls to convect() still in place.
264  o before major merges from the Scripps setup  
265    here are two small updates:  chkpt44d_pre,post
266    - field swapping for surface flux controls enabled  o added missing EXCLUDE_MONITOR flags
267      (remains t.b.d. for atmos. state plus obcs)  o changed "e" to "_d" in gmredi_slope_limit, gmredi_slope_psi
268    - bug fix in active_file.F for xz-/yz- routines    (incompatible typ in MIN/MAX expressions caused problems
269    - added missing xz-/yz- routines to active_file_ad.F    on IBM SP3)
270    o in genmake added variable MAKEDEPEND
271  ecco_c44_e19    plus resetting for case SunOS
272  o merged necessary patches:  o added timer_stats.c routine for IBM SP3
273    - AD-related changes for GMRedi  o removed variables in dynamics
274    - fixes i KPP (delZ -> drF)  !!! I forgot to create tag chkpt44d_pre !!!
275    - hook to OBCS songe layer code in external_forcing  !!! But chkpt44d_pre = chkpt44c_post    !!!
276    - errorMessageUnit non-zero in eeboot.F  
277    - included GMREDI, EXACT_CONSERV to natl_box_adjoint verif.  o real fresh water flux implemented with non-linear free-surface.
278    
279  ecco_c44_e18  chkpt44c_pre,post
280  o sponge layer code for obcs was missing  o few fix (mask in shap_s2, EmPmR in external_field_load,
281    - added hook in external_forcing.F    USE_NATURAL_BCS in solve_for_P);
282    - added storing for TAF  o add arguments myIter & myTime to S/R obcs_calc & solve_for_P
283  o new routine cost_init_barfiles to initialise  
284    adjoint fields adtbar, adsbar, adpsbar  checkpoint44b_pre/_post
285    (needed in conjunction with corrected ladinit for active I/O)  o merge of relevant stuff from the ecco-branch:
 o cleaned up and corrected order in packages_readparms, ecco_readparms  
 o corrected and simplified weights for obcs controls  
   - weight fields simplified  
   - bug fix in ctrl_pack  
   - no more write of control vector in ctrl_pack  
 o i/j index bug fixes in cost_ssh_mean  
   
 ecco_c44_e17  
 o bug fixes in cost package  
   * wrong identifier for active I/O of monthly mean psbar  
     (cost_averagesfields, cost_ssh) xx_psbar_dummy  
   * cleaned all identifier for active I/O of monthly fields  
   * wrong ladinit in various cost routines  
 o merge with interval (chkpt44c_post - chkpt44d_post)  
   * added missing EXCLUDE_MONITOR flags  
   * changed "e" to "_d" in gmredi_slope_limit, gmredi_slope_psi  
     (incompatible typ in MIN/MAX expressions caused problems  
     on IBM SP3)  
   * in genmake added variable MAKEDEPEND  
     plus resetting for case SunOS  
     added timer_stats.c routine for IBM SP3  
   * removed variables in dynamics  
   
 ecco_c44_e16  
 o new ECCO checkpoint, the first since ecco_c43_e15  
   which is branched from MITgcm.  
   All changes were merged in between (see ecco-branch-mod? tags).  
 o last changes:  
   * assuming path for TAF and TAMC are known (e.g. in $path)  
   * genmake:  
     - added tools/xmakedepend to circumvene shortcoming of  
       SUN's makedepend (size too small)  
     - invoking ../tools/xmakedepend instead of makedepend  
     - changed compiler flags for case SunOS  
   
 ecco-branch-mod5  
 o mod's to reproduce open boundary run  
 o enable field swapping for OB's and climatology  
 o update store directives for OB control  
 o added option ALLOW_OBCS_PRESCRIBE  
 o call of getobcs now out of obcs_calc (param. list modified)  
   
 ecco-branch-mod4  
 o this is the second part of changes necessary to reconcile  
   the natl_box_adjoint verification (with and without grdchk).  
   >>>!!! CHANGES BETWEEN THE TAGS ecco-branch-mod3 !!!<<<  
   >>>!!!                      AND ecco-branch-mod4 !!!<<<  
   >>>!!! SHOULD BE MERGED INTO THE MAIN TRUNK      !!!<<<  
286    - genmake: removed $S64 overwrite for case SunOS    - genmake: removed $S64 overwrite for case SunOS
287    - pkg/exf: update and corrections for field swapping and obcs    - pkg/exf: update and corrections for field swapping and obcs
288    - pkg/ecco: parameter lists for the_model_main, the_main_loop    - pkg/ecco: parameter lists for the_model_main, the_main_loop
# Line 311  o this is the second part of changes nec Line 290  o this is the second part of changes nec
290    - pkg/autodiff: added flow directives for obcs, mdsio_gl_slice    - pkg/autodiff: added flow directives for obcs, mdsio_gl_slice
291                    updated checkpointing_lev... lists for obcs                    updated checkpointing_lev... lists for obcs
292    - model/src: minor changes in forward_step, plot_field    - model/src: minor changes in forward_step, plot_field
293                   added directive for divided adjoint in the_main_loop
294    - pkg/mdsio: added mdsio_gl_slice    - pkg/mdsio: added mdsio_gl_slice
295    
296  ecco-branch-mod3  o check parameters & config (chkpt44a_pre,post)
297  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  
298    
299  checkpoint44  checkpoint44
 o apply Shapiro filter on T&S before calc_PhiHyd (stagger time stepping)  
300  o fix bug in mom_vi_del2uv  o fix bug in mom_vi_del2uv
301    o select when filters are applied ; add options to zonal_filter (data.zonfilt)
302    o gmredi: fix Pb in the adiabatic form ; add options (.e.g. Bolus advection)
303    o update AIM experiments (NCEP input files)
304    o improve and extend diagnostics (Monitor, TimeAve with NonLin-FrSurf)
305  o added some stuff for AD  o added some stuff for AD
306    
 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.  
   
307  checkpoint43  checkpoint43
308  o added two new advection tests  o added two new advection tests
309  o added global 4x4 degree ocean test  o added global 4x4 degree ocean test

Legend:
Removed from v.1.53.4.41  
changed lines
  Added in v.1.96

  ViewVC Help
Powered by ViewVC 1.1.22