/[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.1466 by jmc, Mon Jun 27 22:45:33 2011 UTC revision 1.1537 by mlosch, Tue Nov 29 10:56:03 2011 UTC
# Line 4  $Name$ Line 4  $Name$
4      Notes on tags used in MITgcmUV      Notes on tags used in MITgcmUV
5      ==============================      ==============================
6    
7    o pkg/obcs/obcs_calc_stevens.F:
8      - fix a bug in code for northern and southern boundaries.
9    o pkg/seaice/seaice_init_varia.F
10      - undo resetting UVM=0 that has slipped in unnoticed in r1.49 and
11        caused zero ice-velocities for the B-grid code
12    o pkg/seaice/seaice_init_fixed.F
13      - fix a bug in the initialisation of the second metric terms
14        k2AtC and k2AtZ: k2AtC was set to the value of k2AtZ and k2AtZ was 0.
15      - this affects all seaice configurations with useCurviLinearGrid = .true.
16        and SEAICEuseDynamics = .true. (default) and SEAICEuseMetricTerms
17        = .true. (default)
18      - the only verification experiment affected is global_ocean.cs32x15:
19        icedyn, seaice, and seaice_dynmix (AD)
20    o pkg/thsice/thsice_diagnostics_state.F
21      - only for TARGET_NEC_SX: initialise all of tmpFld, so that overlap does
22        not contain garbage that can lead to surprises in diagstats_calc.F
23    o model/src:
24      - move bi,bj loops inside INTEGR_CONTINUITY ;
25      - call INTEGR_CONTINUITY directly from forward_step.F
26        (previously called from momentum_correction_step.F)
27      - call UPDATE_ETAH from integr_continuity.F and update initialise_varia.F,
28        forward_step.F and pkg/ecco/the_main_loop.F
29    o model/src/do_oceanic_phys.F:
30      - reset addMass to zero only if useICEFRONT ;
31      - separated k-loop for rhoInSitu calculation ;
32      - add 2 diagnostics for wVel*delta^k(Rho) at constant pressure (= WdRHO_P)
33        and at constant T,S (= WdRHOdP);
34      NOTE: change diagnostics WRHOMASS : this is now simply the Vertical transport
35        of In-Situ Density (Anomaly) (=wVel*rho^bar-k) (previously was Vertical
36        transport of locally-referenced potential density);
37        to recover old diag: (WRHOMASS)_old = (WRHOMASS)_new -1/2 * (WdRHOdP)
38    o gluemnc:
39      - replace ncrcat with ncks when adding variables to *.glob.nc
40      - change the way variables without record dimensions are handled so that
41        files that have variables with and without record variables can be glued:
42        add a record dimension with a new unique name to be able to differentiate
43        between variable with and without a-prior record dimensions. Remove
44        this record dimension before adding the variable to the *.glob.nc file.
45        This procedure automatically works also for grid.*.nc files that do not
46        have any record dimension.
47    o verification/cpl_aim+ocn:
48      - generate new reference output on baudelaire (gfortran, mpich2) (previously
49        from old aces-grid cluster, ao + ifort) and update 'run_cpl_test' script.
50    o pkg/obcs/obcs_calc_stevens.F:
51      - add code for northern and southern boundaries.
52      - reorder some loops to save some operations and so that drFBar can be scalar
53    o model/src:
54      - re-arrange extrapolation calculation in Adams-Bashforth S/R (affects machine
55        truncation) and add diagnostics for Adams-Bashforth tendency increment.
56      - update test-exp. AD output:
57        1D_ocean_ice_column, bottom_ctrl_5x5, lab_sea.noseaicedyn, obcs_ctrl;
58      and FWD output: exp4 (x3), fizhi-cs-32x32x40, fizhi-cs-aqualev20,
59        front_relax (x3), global_ocean.90x40x15 (x2), global_ocean.cs32x15 (x5),
60        global_ocean_ebm, ideal_2D_oce, internal_wave, isomip (x3), lab_sea (x4),
61        matrix_example, MLAdjust (x5), natl_box (x2), tutorial_advection_in_gyre,
62        tutorial_global_oce_in_p, tutorial_global_oce_latlon and
63        tutorial_plume_on_slope.
64    o pkg/diagnostics/diagstats_calc.F: add special code for TARGET_NEC_SX
65      that vectorises. This code uses 3 extra 2D fields, F90 array assignments
66      and F90 intrinsic routines SUM, MINVAL, MAXVAL, but since TARGET_NEC_SX
67      does not even come with an F77 compiler anymore, this should not be
68      a limitation
69    
70    checkpoint63e (2011/11/06)
71    o pkg/seaice adjoint of LSR:
72      - substantially rework STORE dirs.
73      - add new flag SEAICE_LSR_ADJOINT_ITER and parameter SOLV_MAX_FIXED
74        this flag will do SOLV_MAX_ITERS but only store SOLV_MAX_FIXED fields
75        and only perform SOLV_MAX_FIXED adjoint iters.
76        If flag SEAICE_LSR_ADJOINT_ITER is undef-ined, the store in the iteration
77        always goes to same record, meaning that the last forward field will be
78        the one used in the adjoint - an approximation.
79      - now produces non-zero LSR-related gradients, and acceptable gradients for
80        An's zonal (x-z) test case (to be checked in)
81      - lab_sea: produces acceptable gradients for lab_sea with forward/backward LSR
82        (but these are screwed up by the thermodynamics in the first place);
83        reduce from 4 to 3 timesteps to avoid t.d. issue as temporary solution;
84        output_adm.txt also reflects changes to seaice_lsr
85      - global_ocean.cs32x15:
86        * the "default" input_ad.seaice has been re-defined to always exclude dynamics
87          (output_adm.seaice.txt was updated)
88        * new input_ad.seaice_dynmix tests a forward LSR / backward free-drift
89          (output_adm.seaice_dynmix.txt)
90    o test-exp. exp4+stevens:
91      - switch off pTracers and nonHydrostatic (restart problems with NH); update output
92    o pkg/seaice (lsr solver):
93      - put coriolis term into FORCEX,Y (as in seaice_evp.F; previously in rhsU,V only);
94        update output (change truncation) of FWD test exp lab_sea & global_ocean.cs32x15
95      - fix SEAICEuseFREEDRIFT for new OBCS version (ndef OBCS_UVICE_OLD)
96      - new parameter "LSR_mixIniGuess" allows (if=2,4) to mix free-drift solution
97        into initial guess for linearised solver; use weight ~ (1/err)^2,4.
98      - compute (with new S/R) and print initial (+ free-driff sol. if available)
99        and final residual of linearised system.
100    o pkg/pp81: add diagnostics for vertical eddy viscosity and diffusivity
101      (requires new subroutines pp81_init_fixed.F/pp81_diagnostics_init.F)
102    o pkg/obcs: Stevens BCs (still only for east and west)
103      - fix Stevens BCs by using intermediate velocities of previous
104        time step as "baroclinic" contribution rather velocity of one grid cell
105        inside the boundaries; more consistent but makes the entire treatment
106        more complicated, requires new pickup files and two new S/Rs:
107        obcs_copy_uv_n and obcs_save_uv_n
108        keep old version with flag OBCS_STEVENS_USE_INTERIOR_VELOCITY
109        (undefined by default)
110      - silently move computation of some grid factors into separate loops to
111        save some recomputations
112      - add a hack for non-linear free surface
113      - add a verification experiment to exp4 that tests this code
114    o make gluemnc/xplodemnc work with (moron) non-GNU shell tools
115    
116    checkpoint63d (2011/10/25)
117    o pkg/obcs + seaice-dynamics:
118      - new implementation calls OBCS_APPLY_UVICE (in seaice_dynsolver.F) before
119        solving for uIce,vIce and prevent SEAICE_LSR or SEAICE_EVP to modify OB
120        values (consistent with an implicit method).
121      - add option OBCS_UVICE_OLD (in OBCS_OPTIONS.h, defined by default) to
122        return to older implementation (same results as before); note that none of
123        the "experimental" OBCS_SEAICE options are implemented in the new version.
124      - switch test exp. seaice_obcs to use new version (update output).
125    o pkg/seaice:
126      - add few stop (B-grid & CS-exch, B-grid & obcs, AUTODIFF & SEAICE_maskRHS)
127      - add parenthesis in Water-Ice drag calculations (evp & lsr);
128      - in seaice_lsr.F, simplify and fix AA3 setting in case sNx or sNy=1;
129        and fix case SEAICE_waterDrag=0 (but unstable if no or little seaice)
130      - update output of test exp lab_sea that uses evp or lsr (fwd+ad)
131        and global_ocean.cs32x15 (icedyn & seaice fwd+ad).
132    o pkg/layers:
133      - Include potential density as new coordinate (Thanks to David Munday)
134    o pkg/dic:
135      - Remove subroutine CALC_PCO2_APPROX_CO3 from carbon_chem.F and add
136        carbonate computation/output to CALC_PCO2_APPROX
137    o pkg/generic_advdiff
138      - make TAF generate code that vectorizes:
139        gad_dst3fl_adv_*.F, gad_u3c4_impl_r.F
140    o model/src:
141      - improve vectorization also for adjoint code of
142        solve_tridiagonal and solve_pentadiagonal. As this requires up to
143        5 new 3D-fields, this code is only turned on for the combination of
144        ALLOW_AUTODIFF_TAMC and TARGET_NEC_SX. Also remove error message
145        for singular matrix check (only for TARGET_NEC_SX).
146      - remove hard-wiring of CPP-flag ALLOW_SOLVERS_KLOOPINSIDE to
147        ALLOW_AUTODIFF. This flag now needs to be set outside of
148        solve_tri/pentadiagonal.F
149    o pkg/exf:
150      - fix previous modif in exf_readparms.F (revision 1.66: treatment of
151        optional namelist EXF_NML_OBCS).
152      - add many debug-print (to trace down where pkg/cal error msg comes from)
153    o pkg/mom_vecinv/mom_vi_hdissip.F
154      - rearrange loops so that vectorization is improved and in particular
155        the adjoint routine vectorizes. The code is a little longer now, but I
156        think easier to read.
157        Note: CPP-flag MOM_VI_ORIGINAL_VISCA4 is not tested.
158    o pkg/seaice:
159      - allow to specify initial seaice velocity from files (uIceFile,vIceFile)
160    o pkg/exch2:
161      - alternative code (without tile x tile matrix) for cumulated (global) sum;
162        used as default; keep using matrix version in adjustment.cs-32x32x1.
163    o tools/build_options:
164      - after merging some MPI and/or multi-threads specific optfiles so that
165        the modified default optfile support both built (using genmake2 -mpi
166        for the MPI built, using genmake2 -omp for OpenMP built),
167        move now obsolete optfiles to tools/build_options/unsupported/
168       (add copy of email sent to support list in doc/optfiles_changes.txt)
169    
170    checkpoint63c (2011/09/28)
171    o pkg/ebm:
172      - fix ebm_zonalmean.F for several procs in Ydir (nPy > 1); update output of
173        test exp. global_ocean_ebm (affects machine truncation, 12 digits for cg2d)
174    o pkg/seaice (SItracer pickup)
175    * Simple code for pickup of SItracer fields (#define ALLOW_SITRACER)
176      To be done:
177      - thorough testing of missing fields in S/R seaice_read_pickup
178      - thorough matching between generic tracers and specific fields used
179        (e.g. volume-weighted age, area-weighted age, salinity, ...)
180    o pkg/grdchk:
181      - all procs calculate and print finite-difference gradient (for testreport)
182      - change description output used by testreport;
183      - AD testing: also compare and report Finite-difference gradient;
184        => update all output_adm*.txt
185    o test exp. global_ocean_ebm:
186      - switch back useRealFreshWaterFlux (no problem anymore with run-off);
187        and turn on exactConserve; update (fwd) output.
188    o pkg/seaice (LSR):
189      - print to STDOUT number of solver iterations at SEAICE_monFreq interval.
190      - modify solver to deal cleanly with u/v switch at face edges (CS-grid):
191        * identical results with non-CS topology (but save up to half of EXCH calls)
192        * no much changes in cs-32 verification tests since no ice at face edges
193         (differences due to convergence criteria, since nb of iterations changed)
194        * expect some differences on lat-lon-cap grid.
195        update FWD results of global_ocean.cs32x15 test exp. (icedyn & seaice)
196    o pkg/exch2:
197      - add new CPP option to disable Cumul-Sum matrix (to save storage when using
198        many tiles); until alternative coding is added, just add a stop.
199    o pkg/kpp:
200      - move ptracer/salt correction to KPP diffusivity from calc_3d_diffusivity.F
201        to S/R KPP_CALC_DIFF_PTR (+ add tracer-index to argument list).
202    o optfiles:
203      - merged few MPI specific (*+mpi*) and multi-threads specific (*+mth) optfiles
204        into corresponding standard one, which now support different build:
205        (when using "genmake2 -mpi" for MPI built, "genmake2 -omp" for OpenMP built)
206      - add "darwin_amd64_gfortran" optfile (initially from Constantinos, tested by Gael)
207    o pkg/obcs (seaice):
208      - add missing EXCH for uIce,vIce after applying OBCS;
209      - remove S/R EXF_SWAPFFIELDS_X/Y , disable S/R EXF_SET_OBCS_X/Y by adding
210        argument = number of levels to S/R EXF_SWAPFFIELDS_XZ/YZ and S/R
211        EXF_SET_OBCS_XZ/YZ ; update obcs_exf_load.F;
212      - fix EXF_SET_OBCS_XZ/YZ for multi-threaded (assuming loaded arrays are shared)
213      - verification exp. seaice_obcs: split domain in 2 tiles ; add SIZE.h_mpi
214        and eedata.mth for MPI and mutlti-threaded testing.
215    o pkg/flt:
216      - make FLT EXCH working with multi-threads (and MPI + multi-threads);
217      - use buffer for floats IO (trajectories & profiles); size set in FLT_SIZE.h;
218      - fix pickup and trajectories + profiles output with multi-threads;
219      - add parameter to select group of fields to write along trajectory and
220        profile (default unchanged);
221      - only call PORT_RAND* function when flt_noise <> 0;
222      - add multi-threaded test for verification exp. flt_example.
223    o eesupp/src:
224      - fix S/R ALL_PROC_DIE for MPI+multi-threads.
225      - USE_OMP_THREADING: check that number of threads (from eedata) matches
226        actual number (from env.var. setting).
227    o pkg/ebm:
228      - fix multi-threading in ebm_area_t.F ; clean-up EBM.h header file.
229      - add multi-threaded test for verification exp. global_ocean_ebm
230    
231    checkpoint63b (2011/08/29)
232    o pkg/ebm:
233      - fix sign of runoff;
234      - update directly forcing fields (Qnet,EmPmR) to use standard
235        external_forcing_surf.F (remove ebm_forcing_surf.F);
236      - avoid loading forcing fields a 2nd time (1rst time from ini_forcing.F);
237      - set either tauThetaClimRelax (in data) or tauThetaZonRelax (in data.ebm)
238        and apply relaxation towards corresponding SST field (2-D map or ZonAver).
239      - update global_ocean_ebm parameters file data and update output (fwd+ad).
240    o verification/matrix_example:
241      - split domain in 8 tiles (2x4); add SIZE.h_mpi and eedata.mth for
242        MPI and mutlti-threaded testing.
243    o pkg/matrix:
244      - change name of S/R MATRIX_INIT to S/R MATRIX_INIT_VARIA ;
245      - fix for multi-tiles (add bi,bj indices to exp/impMatrixCounter);
246      - fix for multi-threaded (remove DATA statement);
247      - use standard DIFFERENT_MULTIPLE function;
248      - add MATRIX_OPTIONS.h
249    o verification/matrix_example:
250       To allow to split the domain in several tiles, change the domain size
251        from 31x31 to 32x32 by adding 1 row (on Southern side) + 1 column (on
252        Western side) of land points.
253    o (*_)write_pickup:
254      - fix few bugs in mypackage_read/write_pickup.F
255      - in MDS_WR_METAFILES calls, replace "myTime" by a local copy into
256        array of length 1 (was caught by compiler syntax-check).
257    o pkg/diagnostics (velocity potential solver):
258      - fix initialisation of main diagonal matrix (for overlap values)
259    o tools/build_options:
260      - towards single optfile for MPI and non-MPI built: merge few +mpi optfile
261        into previously non MPI one (linux_am64 pgf77,open64,pathf90,ifort11)
262      - linux_amd64_gfortran: merge +mpi_generic version into standard optfile:
263        * move IEEE flags to DEVEL section; take IEEE flags from +mpi_generic ;
264        * FAST case: for now, keep -O3 with ini_masks_etc.F in NOOPTFILES list;
265        and use "-devel" testreport option for standard testing on baudelaire.
266    o pkg/grdchk:
267      - Assume that all gradient-check position are within the same tile
268        corresponding to global indices (iGloTile,jGloTile) and that
269        positions (i,j indices or nbeg) are local to this tile;
270      - set tile local-indices and proc. number according to tile global-indices;
271      - remove grdchkwhichproc from namelist (retired param);
272      - send adjoint gradient to all procs so that all procs print it to STDOUT;
273      - switch on MPI test for global_ocean.90x40x15 AD test experiment.
274    o adding package bbl (Bottom Boundary Layer)
275      description in MITgcm/pkg/bbl/bbl_description.tex
276      example/test experiment in MITgcm_contrib/bbl
277    o adjoint verifications
278      - changed 5 experiments to multi-tiles
279        * global_ocean.90x40x15
280        * obcs_ctrl
281        * offline_exf_seaice
282        * tutorial_dic_adjoffline
283        * tutorial_tracer_adjsens
284        changed reference output for those that crossed tile boundaries
285        (changed choices of gradient check positions)
286      - with same tiling, switch on MPI test for the last 4 (add SIZE.h_mpi)
287      - temporary bug fix in grdchk_loc.F for obcs
288    o genmake2 & testreport
289      - add target "obj" (just for OBJFILES files) to Makefile;
290      - add option to specify FEXTRAFLAGS on command line.
291    o pkg/mypackage:
292      - remove bi,bj arguments from argument list of S/R MYPACKAGE_CALC_RHS
293    
294    checkpoint63a (2011/08/02)
295    o pkg/diagnostics (velocity potential):
296      - fix velocity-potential calculation when using OBCS: balance net inflow
297        at each level (new S/R OBCS_DIAG_BALANCE).
298      - fix some of the problems with OBCS in stream-function calculation.
299    o pkg/exf/exf_readparms.F
300      - make treatment of optional namelists (EXF_NML_04, EXF_NML_SGRUNOFF,
301        EXF_NML_OBCS) more consistent, so that you need not have these lists
302        in data.exf when they are not used.
303    o optim/optim_readdata.F:
304      - add some output about obcs variables that might help debugging
305      - add a check about nvarlength
306    o pkg/ctrl: once again, fix computation of endrec in s/r ctrl_init_rec
307    o pkg/diagnostics (velocity potential):
308      - fix mask for OBCS (still problems in stream-function with OBCS);
309      - add specific parameter (default = main code CG2D params) for solver;
310      - in case of poor convergence, use solution corresponding to lowest residual.
311    o pkg/seaice/seaice_growth.F: small changes that permit vectorizable
312      adjoint code. In general statements like tmpscal=fld(i,j) are problematic
313      and should be avoided where possible.
314    o model/src (rStar):
315      - include r* effect on reference-state (PhiRef) in totPhiHyd
316        (so that it's really the potential anomaly at the cell center);
317        affect solution only if z* with full pressure in EOS.
318      - test-exp global_ocean.90x40x15: reduce viscA4 (was not stable) and
319        update output (because of z* in totPhiHyd and viscA4 changes);
320      - keep the previous diagnostics as "PHIHYDcR" (closer to potential anomaly
321        @ constant r) until interpolation at constant r is implemented.
322    o pkg/diagnostics
323      - fix RCENTER diagnostics in case cell center is not at interface middle
324    o add code for TEOS-10 (www.teos-10.org, McDougall et al. 2011). Use
325      this eos with eosType = 'TEOS10', in data (PARM01). This eos implies
326      that THETA and SALT are "conservative temperature" and "absolute
327      salinity"
328    o pkg/ctrl
329      - fix computation of endrec in s/r ctrl_init_rec
330      - ctrl_pack/unpack_*: remove unused variables and some obsolete code
331    o pkg/seaice/seaice_growth.F
332      - fix recomputation with FENTY_AREA_EXPANSION_CONTRACTION code,
333        remove then obsolete STORE directives
334      - fix STORE directives for tice and tices, so that only the
335        appropriate part of the fields are stored (and not the entire
336        field); update global_ocean.cs32x15.seaice AD output.
337      - cosmetic changes: adjust CPP flags and indentation for better
338        legibilty
339    o pkg/autodiff: add mnc-output of adBottomDragFld (code contributed by
340      Chris Wilson)
341    o pkg/gmredi:
342       Add Sub-Meso Eddies parameterisation from Baylor (for now, disabled with TAF),
343       and test it in verification exp. "front_relax.bvp" (update output.bvp.txt)
344    
345    checkpoint63  (2011/07/11)
346    o pkg/exch2:
347     - rename+move: nTiles in W2_EXCH2_PARAMS.h --> exch2_nTiles in W2_EXCH2_TOPOLOGY.h
348     - exch2 version of Cumul-Sum routine: S/R W2_SET_MAP_CUMSUM set up the
349       (2*nTiles)x(nTiles) Cumul-Sum matrix and Master Proc collects all tiles X,Y
350       increments, calculates Cumul-Sum @ tile origin and sends results to each tile.
351    o pkg/diagnostics:
352     - deal with pairs of post-processed diags which are computed together; in
353       particular, re-order list of diags within 1 file to save 2nd computation.
354     - add S/R to compute velocity stream-function (called after velocity-potential
355       calculation) from divergence free transport -> new diagnostics "PsiVEL".
356     - add parameter to select grid-point location where PsiVEL == 0.
357    o eesupp/src:
358       new S/R to calculate cumulated sum on tiled array, corner grid-cell location
359       (specific S/R needed with exch2 topology - for now, just print an error msg)
360    o pkg/shelfice
361     - Implement friction velocity-dependent transfer coefficients following
362       Holland and Jenkins, JPO, 1999
363       Original code by M. Losch with small modifs.
364       Enable with CPP option SHI_ALLOW_GAMMAFRICT
365       and runtime flag SHELFICEuseGammaFrict
366    o verification lab_sea & global_ocean.cs32x15:
367     - use tools/xmakedepend (instead of cyrus_makedepend, in genmake_local):
368       does not miss some dependencies (but is slower) and also works with many files
369       (default makedepend limitation for AD built).
370     - use cyrus_makedepend in adjustment.128x64x1 (so that it still tested).
371  o pkg/diagnostics:  o pkg/diagnostics:
372   - add run-time parameter "useMissingValue" (def=False) to fill land-point   - add run-time parameter "useMissingValue" (def=False) to fill land-point
373      (i.e., where mask=0) with MissingValue ; used only in MNC output file.      (i.e., where mask=0) with MissingValue ; used only in MNC output file.
# Line 12  o pkg/diagnostics: Line 376  o pkg/diagnostics:
376     of counter-diagnostics (where fraction-weight is zero). This applies both to     of counter-diagnostics (where fraction-weight is zero). This applies both to
377     MNC and MDS output files.     MNC and MDS output files.
378  o pkg/seaice/seaice_growth.F:  o pkg/seaice/seaice_growth.F:
379      - add 'a priori' cap of latent heat flux based on actual mass considerations
380        when SEAICE_ADD_SUBLIMATION_TO_FWBUDGET is used in conjunction with the
381        non-legacy seaice_solve4temp.
382      - add diagnostic of the residual sublimation freshwater flux (the freshwater
383        flux taken from the ocean if the total actual latent heat fluxes exceed
384        the maximum)
385    - remove the CPP switch around the *_FWbySublim unit change and move diagnostic    - remove the CPP switch around the *_FWbySublim unit change and move diagnostic
386     fill for SIatmQnt, SIfwSubl, SIatmFW to the end of seaice_growth.F.     fill for SIatmQnt, SIfwSubl, SIatmFW to the end of seaice_growth.F.
387    - add diagnostic of the actual sublimation freshwater flux (that is 0. ifndef    - add diagnostic of the actual sublimation freshwater flux (that is 0. ifndef

Legend:
Removed from v.1.1466  
changed lines
  Added in v.1.1537

  ViewVC Help
Powered by ViewVC 1.1.22