From aa74f04318277c689f14cd86a8299daa22237ad0 Mon Sep 17 00:00:00 2001 From: dumoda01 Date: Thu, 24 Feb 2011 17:37:41 +0000 Subject: [PATCH] Suppression du repertoire exp --- exp/airsea.nml | 98 -------- exp/bio.nml | 56 ----- exp/bio_fasham.nml | 91 -------- exp/gotmmean.nml | 50 ---- exp/gotmrun.nml | 138 ----------- exp/gotmturb.nml | 304 ------------------------ exp/kpp.nml | 40 ---- exp/obs.nml | 564 --------------------------------------------- 8 files changed, 1341 deletions(-) delete mode 100644 exp/airsea.nml delete mode 100644 exp/bio.nml delete mode 100644 exp/bio_fasham.nml delete mode 100644 exp/gotmmean.nml delete mode 100644 exp/gotmrun.nml delete mode 100644 exp/gotmturb.nml delete mode 100644 exp/kpp.nml delete mode 100644 exp/obs.nml diff --git a/exp/airsea.nml b/exp/airsea.nml deleted file mode 100644 index 2252ffa..0000000 --- a/exp/airsea.nml +++ /dev/null @@ -1,98 +0,0 @@ -!$Id: airsea.proto,v 1.1.1.1 2003/03/11 13:38:58 kbk Exp $ -!------------------------------------------------------------------------------- -! -!------------------------------------------------------------------------------- -! air-sea interaction (heat, momentum and freshwater fluxes and solar radiation) -! -! calc_fluxes -> surface fluxes calculated by means of bulk formulae -! (.true./.false.). Solar radiation is calculated from -! time, latitude, longitude and clouds. If (.true.), -! meteo_file must be given and wet_mode must be specified. -! If (.false.), surface fluxes and solar radiation are -! prescribed. -! -! meteo_file -> file with meteo data (for calc_fluxes=.true.) with -! - date (yyyy-mm-dd hh:mm:ss) -! - x-comp. of wind (10 m) in m/s -! - y-comp. of wind (10 m) in m/s -! - air pressure ( 2 m) in hectopascal -! - dry air temp. ( 2 m) in Celsius -! - relative humidity in % or wet bulb temperature in C -! or dew point temperature in C (depending on wet_mode) -! - cloud cover in 1/10 -! -! wet_mode -> decides what is given in 7. column in meteo_file -! 1: relative humidity -! 2: wet bulb temperature -! 3: dew point temperature -! -! heat_method -> method to provide short wave radiation (swr) and -! surface heat flux (qh) -! (only for calc_fluxes=.false.) -! 0: heat flux not prescribed -! 1: constant "const_swr" and "const_qh" given (see below) -! 2: swr and qh are read from heatflux_file - -! const_swr -> constant value of incoming short wave radiation in W/m^2 -! (always positive) -! -! const_qh -> constant value of surface heat flux in W/m^2 -! (negative for heat loss) -! -! heatflux_file -> file with qin and qout given in W/m^2 -! (negative for net outgoing) -! -! momentum_method -> method how momentum fluxes are given -! (only for calc_fluxes=.false.) -! 0: momentum flux not prescribed -! 1: constant surface momentum fluxes given -! 2: surface momentum fluxes given from file momentumflux_file -! -! const_tx -> x-component of surface momentum flux in N/m^2 -! const_ty -> y-component of surface momentum flux in N/m^2 -! -! momentumflux_file-> file with tx and ty given in N/m^2 -! -! p_e_method -> method how fresh water fluxes (P-E) are given -! 0: P-E not used -! 1: constant value for P-E (in m/s) used -! (P-E = precipitation-evaporation) -! 2: values for P-E read from file -! -! const_p_e -> constant value for P-E in m/s (positive for P>E) -! -! p_e_flux_file -> file with value for P-E (positive for P>E) -! used if p_e_method=2 -! -! sst_method -> method how sea surface temperature (SST) is given -! 0: no independent SST observation is read from file -! 2: independent SST observation is read from file, -! only for output -! -! sst_file -> file with independent SST observation -! -! sss_method -> method how sea surface salinity (SSS) is given -! 0: no independent SSS observation is read from file -! 2: independent SSS observation is read from file, -! only for output -!------------------------------------------------------------------------------- - &airsea - calc_fluxes= .false. - meteo_file= 'meteo.dat' - wet_mode= 1 - heat_method= 2 - const_swr= 100.0 - const_heat= -100.0 - heatflux_file= 'narr_daily_heatflux_ice.dat' - momentum_method= 2 - const_tx= 0.1 - const_ty= 0.0 - momentumflux_file='narr_hourly_momentumflux.dat' - p_e_method= 0 - const_p_e= 0. - p_e_flux_file= 'p_e.dat' - sst_method= 0 - sst_file= 'sst.dat' - sss_method= 0 - sss_file= 'sss.dat' - / diff --git a/exp/bio.nml b/exp/bio.nml deleted file mode 100644 index 1485ae2..0000000 --- a/exp/bio.nml +++ /dev/null @@ -1,56 +0,0 @@ -!$Id$ -!------------------------------------------------------------------------------- -! Basic settings for biogeochemical model -! -! bio_calc -> calculation of the bio model 'bio_model' (.true./.false.) -! bio_model -> choice of the bio model: -! 1: NPZD (4 variables) -! 2: IOW-ERGOM (9 variables) -! 3: Suspended matter only (1 variable) -! 4: Fasham et al. 1990 (7 variables) -! -! bio_eulerian -> state variables are Eulerian (.true./.false.) -! -! cnpar -> Cranck-Nicolson parameter for vertical diffusion -! -! w_adv_discr -> advection scheme for vertical motion -! 1: first order upstream -! 2: not coded yet -! 3: third-order polynomial -! 4: TVD with Superbee limiter -! 5: TVD with MUSCL limiter -! 6: TVD with ULTIMATE QUICKEST -! -! ode_method -> ODE scheme for source and sink dynamics -! 1: first-order explicit (not positive) -! 2: second order explicit Runge-Kutta (not positive) -! 3: fourth-order explicit Runge-Kutta (not positive) -! 4: Patankar (first order, not conservative) -! 5: Patankar-RK (second order, not conservative) -! 6: Patankar-RK (does not work, not conservative) -! 7: Modified Patankar (1. order, conservat., posit.) -! 8: Modified Patankar-RK (2. order, conservat., posit.) -! 9: Modified Patankar-RK (does not work, conservat., posit.) -! 10: Ext. Modified Patankar (1. order, conservat., posit.) -! 11: Ext. Modified Patankar-RK (2. order, conservat., posit.) -! -! split_factor -> number of biogeochemical time steps per physical time step -! -! bioshade_feedback -> feedback of bio-turbidity to temp. eq. (.true./.false.) -! -! bio_lagrange_mean -> averaging Lagrangian conc. on output (.true./.false.) -! -! bio_npar -> total number of Lagrangian particles -!------------------------------------------------------------------------------- -&bio_nml - bio_calc= .true. - bio_model= 4 - bio_eulerian= .true. - cnpar= 1.0 - w_adv_discr= 6 - ode_method= 8 - split_factor= 1 - bioshade_feedback= .true. - bio_lagrange_mean= .false. - bio_npar= 1000 - / diff --git a/exp/bio_fasham.nml b/exp/bio_fasham.nml deleted file mode 100644 index 108dca7..0000000 --- a/exp/bio_fasham.nml +++ /dev/null @@ -1,91 +0,0 @@ -#$Id$ -!------------------------------------------------------------------------------- -! Fasham et al. biological model with modifications by Kuehn and Radach -! -! numc= number of compartments for geobiochemical model -! -! p_initial= initial phytoplankton concentration [mmol n/m3] -! z_initial= initial zooplakton concentration [mmol n/m3] -! b_initial= initial bacteria concentration [mmol n/m3] -! d_initial= initial detritus concentration [mmol n/m3] -! n_initial= initial nitrate concentration [mmol n/m3] -! a_initial= initial ammonium concentration [mmol n/m3] -! l_initial= initial LDON concentration [mmol n/m3] -! p0 = minimum phytoplankton concentration [mmol n/m3] -! z0 = minimum zooplakton concentration [mmol n/m3] -! b0 = minimum bacteria concentration [mmol n/m3] -! vp = maximum phytoplankton uptake rate [1/day] -! alpha = slope of the PI-curvea [m2/(W day)] -! k1 = half saturation constant nitrate uptake [mmol n/m3] -! k2 = half saturation constant ammonium uptake [mmol n/m3] -! mu1 = phytoplankton mortality rate [1/day] -! k5 = half saturation constant phytoplankton mortality [mmol n/m3] -! gamma = exudation fraction [-] -! w_p = phytoplankton settling velocity [m/day] -! gmax = maximum ingestion rate [1/day] -! k3 = half saturation constant ingestion [mmol n/m3] -! beta = grazing efficiency [-] -! mu2 = maximum zooplankton loss rate [1/day] -! k6 = half saturation zooplankton loss [mmol n/m3] -! delta = fractional zooplankton loss to LDON [-] -! epsi = fractional zooplankton loss to ammonium [-] -! r1 = grazing preference phytoplankton [-] -! r2 = grazing preference bacteria [-] -! r3 = grazing preference detritus [-] -! vb = maximum bacterial uptake rate [1/day] -! k4 = half saturation bacterial uptake [mmol n/m3] -! mu3 = bacteria excretion rate [1/day] -! eta = uptake ratio ammonium:LDON [-] -! mu4 = detritus breakdown rate [1/day] -! w_d = detritus settling velocity [m/day] -! kc = attenuation constant for the self shading effect [m**2/mmol N] -! I_min = minimum photosynthetically active radiation (PAR) [W/m**2] -! I_opt = optimal photosynthetically active radiation (PAR) [W/m**2] !CHG1 -! inib = inhibition slope of the PI-curve (positive) [m2/(W day)] !CHG1 -! theta = phytoplancton buoyancy parameter [m3 day/(mmol N)] !CHG2 -!------------------------------------------------------------------------------- - &bio_fasham_nml - numc= 7 - p_initial= 0.012 - z_initial= 0.012 - b_initial= 0.001 - d_initial= 0.01 - n_initial= 12.0 - a_initial= 0.1 - l_initial= 0.1 - p0= 0.0001 - z0= 0.0001 - b0= 0.0001 - vp= 0.3 - alpha= 0.04 - inib= 0.06 - I_opt= 20.0 - k1= 1.0 - k2= 0.8 - mu1= 0.05 - k5= 0.2 - gamma= 0.05 - w_p= -0.38 - theta= 0.0 - w_pmin= -0.06 - w_pmax= -0.38 - gmax= 1.0 - k3= 1.0 - beta= 0.625 - mu2= 0.3 - k6= 0.2 - delta= 0.1 - epsi= 0.70 - r1= 0.55 - r2= 0.4 - r3= 0.05 - vb= 0.24 - k4= 0.5 - mu3= 0.03 - eta= 0.0 - mu4= 0.02 - w_d= -5.0 - kc= 0.03 - aa= 0.70 - g2= 14.0 - / diff --git a/exp/gotmmean.nml b/exp/gotmmean.nml deleted file mode 100644 index 73b91d4..0000000 --- a/exp/gotmmean.nml +++ /dev/null @@ -1,50 +0,0 @@ -!$Id: gotmmean.proto,v 1.1.1.1 2003/03/11 13:38:58 kbk Exp $ -!------------------------------------------------------------------------------- -! The namelists 'meanflow' is read in meanflow.F90. -!------------------------------------------------------------------------------- - -!------------------------------------------------------------------------------- -! Specify variables related to the 1D meanflow model. -! -! h0b= bottom roughness - Note: z0b=0.03*h0b+0.1*nu/ustar [m] -! z0s_min= minimum value of z0s, default value if charnock=.false. [m] -! charnock= .true.: adaptation of Charnok 1955 formula used -! .false.: constant surface roughness length z0s_min used -! charnock_val= emp. constant in Charnok 1955 formula (default = 1400.) -! ddu= grid zooming (surface), 0: no zooming; > 3 strong zooming -! ddl= grid zooming (bottom), 0: no zooming; > 3 strong zooming -! grid_method= 0: zooming of grid with ddl, ddu >= 0 -! 1: sigma grid (relative depth fractions) read from file -! 2: cartesian grid (fixed layer height in m) read from file -! -! grid_file= file for sigma or cartesian grid. the first line gives the -! number of layers, the following lines give fractions or -! layer heights in m from the surface down to the bottom. -! gravity= gravitational acceleration [m/s^2] -! rho_0= Reference density [kg/m^3]. -! cp= Specific heat of sea water [J/kg/K]. -! avmolu= molecular viscosity for momentum [m^2/s]. -! avmolt= molecular diffusity for temperature [m^2/s]. -! avmols= molecular diffusity for salinity [m^2/s]. -! MaxItz0b= max # of iterations for z0b as function of u_taub. -! no_shear= .true.: shear production term P is set to zero -! avmoln= molecular diffusivity for nitrate [m^2/s]. !DD -!------------------------------------------------------------------------------- - &meanflow - h0b= 0.05 - z0s_min= 0.02 - charnock= .false. - charnock_val= 1400. - ddu= 1. - ddl= 0. - grid_method= 0 - grid_file= 'grid.dat' - gravity= 9.81 - rho_0= 1027. - cp= 3985. - avmolu= 1.3e-6 - avmolt= 1.4e-7 - avmols= 1.1e-9 - MaxItz0b= 1 - no_shear= .false. - / diff --git a/exp/gotmrun.nml b/exp/gotmrun.nml deleted file mode 100644 index d39b646..0000000 --- a/exp/gotmrun.nml +++ /dev/null @@ -1,138 +0,0 @@ -!$Id: gotmrun.proto,v 1.1.1.1 2003/03/11 13:38:58 kbk Exp $ -!------------------------------------------------------------------------------- -! -!------------------------------------------------------------------------------- -! general model setup -! -! title -> title of simulation -! nlev -> number of levels -! dt -> time step in seconds -! cnpar -> parameter for "explicitness" of numerical scheme -! (between 0.0 and 1.0) -! buoy_method -> method to compute mean buoyancy -! 1: from equation of state -! (i.e. from potential temperature and salinity) -! 2: from prognostic equation -! -!------------------------------------------------------------------------------- - &model_setup - title= "Arctic SCM" - nlev= 80 - dt= 300. - cnpar= 1.0 - buoy_method= 2 - / - -!------------------------------------------------------------------------------- -! geographic location -! -! name -> name of the station -! latitude -> latitude in degree (north is positive) -! longitude -> longitude in degree (east is positive) -! depth -> water depth in meters -! -!------------------------------------------------------------------------------- - &station - name= "Amundsen Gulf" - latitude= 71.5 - longitude= -127.0 - depth= 200.0 - / - -!------------------------------------------------------------------------------- -! duration of run -! -! timefmt -> method to specify start and duration of model run -! 1: duration computed from number of time steps, MaxN -! (bogus start date used) -! 2: duration computed from given start and stop dates -! (number of time steps MaxN computed) -! 3: duration computed from number of time steps, MaxN -! (start date as specified, stop date computed) -! -! MaxN -> nominal number of time steps (see "timefmt") -! start -> nominal start date: YYYY/MM/DD HH:MM:SS (see "timefmt") -! stop -> nominal stop date: YYYY/MM/DD HH:MM:SS (see "timefmt") -! -!------------------------------------------------------------------------------- - &time - timefmt= 2 - MaxN= 1200 - start= '2004-01-01 00:00:00' - stop= '2004-12-31 00:00:00' - / - -!------------------------------------------------------------------------------- -! format for output and filename(s). -! -! out_fmt -> format for GOTM output -! 1: ASCII -! 2: NetCDF -! 3: GrADS -! -! out_dir -> path to output directory (set permissions) -! out_fn -> output string used to generate output file names -! nsave -> save results every 'nsave' timesteps -! diagnostics -> diagnostics are written to output (if .true.) -! -! mld_method -> how to diagnose mixed layer depth -! 1: mixed layer depth computed from TKE threshold -! 2: mixed layer depth from Ri threshold -! diff_k -> TKE threshold [m^2/s^2] for mixed layer depth -! ri_crit -> Ri threshold for mixed layer depth -! -! rad_corr -> correct surface buoyancy flux for solar radiation -! for output (if true) -! -!------------------------------------------------------------------------------- - &output - out_fmt= 2 - out_dir= "." - out_fn= "amdgulf" - nsave= 36 - diagnostics= .false. - mld_method= 2 - diff_k= 1.e-5 - Ri_crit= 0.5 - rad_corr= .true. - / - -!------------------------------------------------------------------------------- -! Specify variables related to the equation of state. -! -! eq_state_mode -> choice for empirical formula for equation of state -! 1: UNESCO equation of state by Fofonoff and Millard (1983) -! 2: equation of state according Jackett et al. (2005) -! -! eq_state_method -> method to compute density and buoyancy from salinity, -! potential temperature and pressure -! 1: full equation of state (i.e. with the LOCAL -! pressure). This implies that T is NOT treated as -! the potential temperature but rather as the in-situ -! temperature! -! 2: equation of state with pressure evaluated at the surface. -! This implies that T is treated as the potential -! temperature and thus rho as the potential density. -! 3: linearized equation of state at T0,S0,p0 -! (again, use p0=p_surf to work with potential -! temperature and density.) -! 4: linear equation of state with T0,S0,dtr0,dsr0 -! -! For the precise definition of the following quantities, see -! GOTM documentation: -! -! T0 -> reference temperature (deg C) for linear equation of state -! S0 -> reference salinity (psu) for linear equation of state -! p0 -> reference pressure (bar) for linear equation of state -! dtr0 -> thermal expansion coefficient for linear equation of state -! dsr0 -> saline expansion coefficient for linear equation of state -!------------------------------------------------------------------------------- - &eqstate - eq_state_mode = 2 - eq_state_method= 2 - T0= 10. - S0= 35. - p0= 0. - dtr0= -0.17 - dsr0= 0.78 - / diff --git a/exp/gotmturb.nml b/exp/gotmturb.nml deleted file mode 100644 index 6a1da8c..0000000 --- a/exp/gotmturb.nml +++ /dev/null @@ -1,304 +0,0 @@ -!$Id: gotmturb.proto,v 1.1.1.1 2003/03/11 13:38:58 kbk Exp $ -!------------------------------------------------------------------------------- - -!------------------------------------------------------------------------------- -! What type of equations are solved in the turbulence model? -! -! turb_method -> type of turbulence closure -! -! 0: convective adjustment -! 1: analytical eddy visc. and diff. profiles, not coded yet -! 2: turbulence Model calculating TKE and length scale -! (specify stability function below) -! 3: second-order model (see "scnd" namelist below) -! 99: KPP model (requires "kpp.inp" with specifications) -! -! -! tke_method -> type of equation for TKE -! -! 1: algebraic equation -! 2: dynamic equation (k-epsilon style) -! 3: dynamic equation (Mellor-Yamada style) -! -! -! len_scale_method -> type of model for dissipative length scale -! -! 1: parabolic shape -! 2: triangle shape -! 3: Xing and Davies [1995] -! 4: Robert and Ouellet [1987] -! 5: Blackadar (two boundaries) [1962] -! 6: Bougeault and Andre [1986] -! 7: Eifler and Schrimpf (ISPRAMIX) [1992] -! 8: dynamic dissipation rate equation -! 9: dynamic Mellor-Yamada q^2l-equation -! 10: generic length scale (GLS) -! -! -! stab_method -> type of stability function -! -! 1: constant stability functions -! 2: Munk and Anderson [1954] -! 3: Schumann and Gerz [1995] -! 4: Eifler and Schrimpf [1992] -! -!------------------------------------------------------------------------------- - &turbulence - turb_method= 99 - tke_method= 2 - len_scale_method=8 - stab_method= 3 - / - -!------------------------------------------------------------------------------- -! What boundary conditions are used? -! -! k_ubc, k_lbc -> upper and lower boundary conditions -! for k-equation -! 0: prescribed BC -! 1: flux BC -! -! psi_ubc, psi_lbc -> upper and lower boundary conditions -! for the length-scale equation (e.g. -! epsilon, kl, omega, GLS) -! 0: prescribed BC -! 1: flux BC -! -! -! ubc_type -> type of upper boundary layer -! 0: viscous sublayer (not yet impl.) -! 1: logarithmic law of the wall -! 2: tke-injection (breaking waves) -! -! lbc_type -> type of lower boundary layer -! 0: viscous sublayer (not yet impl.) -! 1: logarithmic law of the wall -! -!------------------------------------------------------------------------------- - &bc - k_ubc= 1 - k_lbc= 1 - psi_ubc= 1 - psi_lbc= 1 - ubc_type= 1 - lbc_type= 1 - / - -!------------------------------------------------------------------------------- -! What turbulence parameters have been described? -! -! cm0_fix -> value of cm0 for turb_method=2 -! Prandtl0_fix -> value of the turbulent Prandtl-number for stab_method=1-4 -! cw -> constant of the wave-breaking model -! (Craig & Banner (1994) use cw=100) -! compute_kappa -> compute von Karman constant from model parameters -! kappa -> the desired von Karman constant (if compute_kappa=.true.) -! compute_c3 -> compute c3 (E3 for Mellor-Yamada) for given Ri_st -! Ri_st -> the desired steady-state Richardson number (if compute_c3=.true.) -! length_lim -> apply length scale limitation (see Galperin et al. 1988) -! galp -> coef. for length scale limitation -! const_num -> minimum eddy diffusivity (only with turb_method=0) -! const_nuh -> minimum heat diffusivity (only with turb_method=0) -! k_min -> minimun TKE -! eps_min -> minimum dissipation rate -! kb_min -> minimun buoyancy variance -! epsb_min -> minimum buoyancy variance destruction rate -! -!------------------------------------------------------------------------------- - &turb_param - cm0_fix= 0.5477 - Prandtl0_fix= 0.74 - cw= 100. - compute_kappa= .true. - kappa= 0.4 - compute_c3= .true. - ri_st= 0.25 - length_lim= .false. - galp= 0.53 - const_num= 5.e-4 - const_nuh= 5.e-4 - k_min= 1.e-10 - eps_min= 1.e-12 - kb_min= 1.e-10 - epsb_min= 1.e-14 - / - -!------------------------------------------------------------------------------- -! The generic model (Umlauf & Burchard, J. Mar. Res., 2003) -! -! This part is active only, when len_scale_method=10 has been set. -! -! compute_param -> compute the model parameters: -! if this is .false., you have to set all -! model parameters (m,n,cpsi1,...) explicitly -! if this is .true., all model parameters -! set by you (except m) will be ignored and -! re-computed from kappa, d, alpha, etc. -! (see Umlauf&Burchard 2002) -! -! m: -> exponent for k -! n: -> exponent for l -! p: -> exponent for cm0 -! -! Examples: -! -! k-epsilon (Rodi 1987) : m=3/2, n=-1, p=3 -! k-omega (Umlauf et al. 2003) : m=1/2, n=-1, p=-1 -! -! cpsi1 -> emp. coef. in psi equation -! cpsi2 -> emp. coef. in psi equation -! cpsi3minus -> cpsi3 for stable stratification -! cpsi3plus -> cpsi3 for unstable stratification -! sig_kpsi -> Schmidt number for TKE diffusivity -! sig_psi -> Schmidt number for psi diffusivity -! -!------------------------------------------------------------------------------- - &generic - compute_param= .false. - gen_m= 1.0 - gen_n= -0.67 - gen_p= 3.0 - cpsi1= 1. - cpsi2= 1.22 - cpsi3minus= 0.05 - cpsi3plus = 1.0 - sig_kpsi= 0.8 - sig_psi= 1.07 - gen_d= -1.2 - gen_alpha= -2.0 - gen_l= 0.2 - / - -!------------------------------------------------------------------------------- -! The k-epsilon model (Rodi 1987) -! -! This part is active only, when len_scale_method=8 has been set. -! -! ce1 -> emp. coef. in diss. eq. -! ce2 -> emp. coef. in diss. eq. -! ce3minus -> ce3 for stable stratification, overwritten if compute_c3=.true. -! ce3plus -> ce3 for unstable stratification (Rodi 1987: ce3plus=1.0) -! sig_k -> Schmidt number for TKE diffusivity -! sig_e -> Schmidt number for diss. diffusivity -! sig_peps -> if .true. -> the wave breaking parameterisation suggested -! by Burchard (JPO 31, 2001, 3133-3145) will be used. -!------------------------------------------------------------------------------- - &keps - ce1= 1.44 - ce2= 1.92 - ce3minus= -0.4 - ce3plus= 1.0 - sig_k= 1. - sig_e= 1.3 - sig_peps= .false. - / - -!------------------------------------------------------------------------------- -! The Mellor-Yamada model (Mellor & Yamada 1982) -! -! This part is active only, when len_scale_method=9 has been set! -! -! e1 -> coef. in MY q**2 l equation -! e2 -> coef. in MY q**2 l equation -! e3 -> coef. in MY q**2 l equation, overwritten if compute_c3=.true. -! sq -> turbulent diffusivities of q**2 (= 2k) -! sl -> turbulent diffusivities of q**2 l -! my_length -> prescribed barotropic lengthscale in q**2 l equation of MY -! 1: parabolic -! 2: triangular -! 3: lin. from surface -! new_constr -> stabilisation of Mellor-Yamada stability functions -! according to Burchard & Deleersnijder (2001) -! (if .true.) -! -!------------------------------------------------------------------------------- - &my - e1= 1.8 - e2= 1.33 - e3= 1.8 - sq= 0.2 - sl= 0.2 - my_length= 3 - new_constr= .false. - / - -!------------------------------------------------------------------------------- -! The second-order model -! -! scnd_method -> type of second-order model -! 1: EASM with quasi-equilibrium -! 2: EASM with weak equilibrium, buoy.-variance algebraic -! 3: EASM with weak equilibrium, buoy.-variance from PDE -! -! kb_method -> type of equation for buoyancy variance -! -! 1: algebraic equation for buoyancy variance -! 2: PDE for buoyancy variance -! -! -! epsb_method -> type of equation for variance destruction -! -! 1: algebraic equation for variance destruction -! 2: PDE for variance destruction -! -! -! scnd_coeff -> coefficients of second-order model -! -! 0: read the coefficients from this file -! 1: coefficients of Gibson and Launder (1978) -! 2: coefficients of Mellor and Yamada (1982) -! 3: coefficients of Kantha and Clayson (1994) -! 4: coefficients of Luyten et al. (1996) -! 5: coefficients of Canuto et al. (2001) (version A) -! 6: coefficients of Canuto et al. (2001) (version B) -! 7: coefficients of Cheng et al. (2002) -! -!------------------------------------------------------------------------------- - &scnd - scnd_method= 1 - kb_method= 1 - epsb_method= 1 - scnd_coeff= 7 - cc1= 3.6 - cc2= 0.8 - cc3= 1.2 - cc4= 1.2 - cc5= 0.0 - cc6= 0.3 - ct1= 3.28 - ct2= 0.4 - ct3= 0.4 - ct4= 0.0 - ct5= 0.4 - ctt= 0.8 - / - -!------------------------------------------------------------------------------- -! The internal wave model -! -! iw_model -> method to compute internal wave mixing -! 0: no internal waves mixing parameterisation -! 1: Mellor 1989 internal wave mixing -! 2: Large et al. 1994 internal wave mixing -! -! alpha -> coeff. for Mellor IWmodel (0: no IW, 0.7 Mellor 1989) -! -! The following six empirical parameters are used for the -! Large et al. 1994 shear instability and internal wave breaking -! parameterisations (iw_model = 2, all viscosities are in m**2/s): -! -! klimiw -> critcal value of TKE -! rich_cr -> critical Richardson number for shear instability -! numshear -> background diffusivity for shear instability -! numiw -> background viscosity for internal wave breaking -! nuhiw -> background diffusivity for internal wave breaking -!------------------------------------------------------------------------------- - &iw - iw_model= 0 - alpha= 0.7 - klimiw= 1e-6 - rich_cr= 0.7 - numshear= 5.e-3 - numiw= 1.e-4 - nuhiw= 1.e-5 - / diff --git a/exp/kpp.nml b/exp/kpp.nml deleted file mode 100644 index 6439eaf..0000000 --- a/exp/kpp.nml +++ /dev/null @@ -1,40 +0,0 @@ -!$Id$ -!------------------------------------------------------------------------------- -! -!------------------------------------------------------------------------------- -! specifications for the KPP turbulence model -! -! Set "turb_method=99" in gotmturb.inp and check for the correct pre-processor -! macros in cppdefs.h. -! These are (see documentation at www.gotm.net): -! -! NONLOCAL for inclusion of non-local fluxes -! KPP_SHEAR for shear instability interior mixing -! KPP_INTERNAL_WAVE for internal waves interior mixing -! KPP_CONVEC for convective interior mixing -! KPP_DDMIX for double-diffusion interior mixing -! KPP_TWOPOINT_REF for two grid points to compute reference values -! KPP_IP_FC for scheme to interpolate MLD -! KPP_CLIP_GS for clipping of shape function G(sigma) -! KPP_SALINITY for computation of salinity diffusivity -! -! These pre-processor macros have been introduced for higher efficiency -! of the code. -! -! The main flags for the KPP algorithm can be set in this file. -! They are: -! -! kpp_sbl -> .true. for active surface boundary layer module -! kpp_bbl -> .true. for active bottom boundary layer module -! kpp_internal -> .true. for active interior mixing -! clip_mld -> .true. for clipping of MLD at MO or Ekman scale -! Ric -> critical value of bulk Richardson number -! -!------------------------------------------------------------------------------- - &kpp - kpp_sbl= .true. - kpp_bbl= .true. - kpp_interior= .true. - clip_mld= .false. - Ric= 0.3 - / diff --git a/exp/obs.nml b/exp/obs.nml deleted file mode 100644 index 3489711..0000000 --- a/exp/obs.nml +++ /dev/null @@ -1,564 +0,0 @@ -!$Id: obs.proto,v 1.1.1.1 2003/03/11 13:38:58 kbk Exp $ -!------------------------------------------------------------------------------- -! -!------------------------------------------------------------------------------- -! observed or prescribed salinity profiles -! -! s_prof_method -> method to create initial or observed salinity profiles -! 0: no initial values, S-equation is not solved -! 1: use analytically prescribed initial profile -! 2: read profiles at different dates from "s_prof_file" -! and interpolate to GOTM timestep -! -! s_analyt_method -> method to create analytically precribed inital profile -! 1: set profile to constant value s_1 -! 2: set "two layer" stratification (see user's guide) -! 3: set profile with constant N^2 (see user's guide) -! This option can only be used toghether with -! t_analyt_method=1 (constant temperature). -! -! z_s1 -> upper layer thickness if s_analyt_method=2 -! -! s_1 -> constant salinity if s_analyt_method=1 -! upper layer salinity if s_analyt_method=2 -! surface salinity if s_analyt_method=3 -! -! z_s2 -> depth of top of lower layer if s_analyt_method=2 -! -! s_2 -> lower layer salinity if s_analyt_method=2 -! -! s_obs_NN -> constant value N^2 corresponding to salinity profile -! if s_analyt_method=3 - -! s_prof_file -> filename of file with salinity profiles -! if s_prof_method=2 -! -! The computed profiles can be relaxed towards observed or prescribed -! profiles with a certain relaxation time. If you do not want relaxation, -! set the relaxation times to 1.e15 (something large). It is possible to choose -! different relaxation times in a surface and bottom layer. -! -! SRelaxTauM -> relaxation time for bulk of the flow -! SRelaxTauB -> relaxation time for bottom layer -! SRelaxTauS -> relaxation time for surface layer -! SRelaxBott -> height of bottom relaxation layer -! (set to 0. if not used) -! SRelaxSurf -> height of surface relaxation layer -! (set to 0. if not used) -! -!------------------------------------------------------------------------------- - &sprofile - s_prof_method= 2 - s_analyt_method= 2 - z_s1= 25. - s_1= 31. - z_s2= 35. - s_2= 32. - s_obs_NN= 2.56e-4 - s_prof_file= 'franklin_sprof_ctd.dat' - SRelaxTauM= 1209600. - SRelaxTauB= 1209600. - SRelaxTauS= 1209600. - SRelaxBott= 0. - SRelaxSurf= 0. - / - -!------------------------------------------------------------------------------- -! observed or prescribed nitrate profiles -! -! n_prof_method -> method to create initial or observed nitrate profiles -! 0: no initial values, N-equation is not solved -! 1: use analytically prescribed initial profile -! 2: read profiles at different dates from "n_prof_file" -! and interpolate to GOTM timestep -! -! n_analyt_method -> method to create analytically precribed inital profile -! 1: set profile to constant value n_1 -! 2: set "two layer" stratification (see user's guide) -! -! z_n1 -> upper layer thickness if n_analyt_method=2 -! -! n_1 -> constant nitrate if n_analyt_method=1 -! upper layer nitrate if n_analyt_method=2 -! -! z_n2 -> depth of top of lower layer if n_analyt_method=2 -! -! n_2 -> lower layer salinity if n_analyt_method=2 -! - -! n_prof_file -> filename of file with nitrate profiles -! if n_prof_method=2 -! -! The computed profiles can be relaxed towards observed or prescribed -! profiles with a certain relaxation time. If you do not want relaxation, -! set the relaxation times to 1.e15 (something large). It is possible to choose -! different relaxation times in a surface and bottom layer. -! -! NRelaxTauM -> relaxation time for bulk of the flow -! NRelaxTauB -> relaxation time for bottom layer -! NRelaxTauS -> relaxation time for surface layer -! NRelaxBott -> height of bottom relaxation layer -! (set to 0. if not used) -! NRelaxSurf -> height of surface relaxation layer -! (set to 0. if not used) -! -!------------------------------------------------------------------------------- - &nprofile - n_prof_method= 1 - n_analyt_method= 2 - z_n1= 35. - n_1= 3.0 - z_n2= 70. - n_2= 15.0 - n_prof_file= 'nprof_ctd.dat' - NRelaxTauM= 1.e15 - NRelaxTauB= 1.e15 - NRelaxTauS= 1.e15 - NRelaxBott= 0. - NRelaxSurf= 0. - / - -!------------------------------------------------------------------------------- -! observed or prescribed potential temperature profiles -! -! a_prof_method -> method to create initial or observed ammonium profiles -! 0: no initial values, A-equation is not solved -! 1: use analytically prescribed initial profile -! 2: read profiles at different dates from "a_prof_file" -! and interpolate to GOTM timestep -! -! a_analyt_method -> method to create analytically precribed inital profile -! 1: set profile to constant value a_1 -! 2: set "two layer" stratification (see user's guide) -! 3: set profile with constant N^2 (see user's guide) -! This option can only be used toghether with -! a_analyt_method=1 (constant ammonium). -! -! z_a1 -> upper layer thickness if a_analyt_method=2 -! -! a_1 -> constant ammonium if a_analyt_method=1 -! upper layer ammonium if a_analyt_method=2 -! surface ammonium if a_analyt_method=3 -! -! z_a2 -> depth of top of lower layer if a_analyt_method=2 -! -! a_2 -> lower layer temperature if a_analyt_method=2 -! -! a_obs_NN -> constant value N^2 corresponding to ammonium profile -! if a_analyt_method=3 - -! a_prof_file -> filename of file with ammonium profiles -! if a_prof_method=2 -! -! Computed profiles are relaxed towards observed or prescribed -! profiles with a the same relaxation coefficients as for nitrate. -! If you do not want relaxation, set the relaxation times to 1.e15 (something large). -! It is possible to choose different relaxation times in a surface and bottom layer. -! -!------------------------------------------------------------------------------- - &aprofile - a_prof_method= 1 - a_analyt_method= 1 - z_a1= 25. - a_1= 0.0 - z_a2= 35. - a_2= 0.0 - a_prof_file= 'aprof.dat' - / - -!------------------------------------------------------------------------------- -! observed or prescribed potential temperature profiles -! -! t_prof_method -> method to create initial or observed temperature profiles -! 0: no initial values, T-equation is not solved -! 1: use analytically prescribed initial profile -! 2: read profiles at different dates from "t_prof_file" -! and interpolate to GOTM timestep -! -! t_analyt_method -> method to create analytically precribed inital profile -! 1: set profile to constant value s_1 -! 2: set "two layer" stratification (see user's guide) -! 3: set profile with constant N^2 (see user's guide) -! This option can only be used toghether with -! s_analyt_method=1 (constant salinity). -! -! z_t1 -> upper layer thickness if t_analyt_method=2 -! -! t_1 -> constant temperature if t_analyt_method=1 -! upper layer temperature if t_analyt_method=2 -! surface temperature if t_analyt_method=3 -! -! z_t2 -> depth of top of lower layer if t_analyt_method=2 -! -! t_2 -> lower layer temperature if t_analyt_method=2 -! -! t_obs_NN -> constant value N^2 corresponding to temperature profile -! if t_analyt_method=3 - -! t_prof_file -> filename of file with temperature profiles -! if t_prof_method=2 -! -! The computed profiles can be relaxed towards observed or prescribed -! profiles with a certain relaxation time. If you do not want relaxation, -! set the relaxation times to 1.e15 (something large). It is possible to choose -! different relaxation times in a surface and bottom layer. -! -! TRelaxTauM -> relaxation time for bulk of the flow -! TRelaxTauB -> relaxation time for bottom layer -! TRelaxTauS -> relaxation time for surface layer -! TRelaxBott -> height of bottom relaxation layer -! (set to 0. if not used) -! TRelaxSurf -> height of surface relaxation layer -! (set to 0. if not used) -! -!------------------------------------------------------------------------------- - &tprofile - t_prof_method= 2 - t_analyt_method= 2 - z_t1= 25. - t_1= -1.0 - z_t2= 35. - t_2= 0.0 - t_obs_NN= 2.56e-4 - t_prof_file= 'franklin_tprof_ctd.dat' - TRelaxTauM= 1209600. - TRelaxTauB= 1209600. - TRelaxTauS= 1209600. - TRelaxBott= 0. - TRelaxSurf= 0. - / - -!------------------------------------------------------------------------------- -! external pressure gradients -! -! ext_press_method -> method to compute external pressure gradient from data -! 0: constant external pressure gradient -! 1: external pressure gradient from tidal constituents -! 2: external pressure gradient from data -! found in "ext_press_file". -! The data supplied from 0-2 are interpreted differently -! depending on the value of "ext_press_mode" ! -! -! -! ext_press_mode -> how to interprete ANY prescribed data for -! the computation of the external pressure gradient -! 0: interprete all data as surface elevation gradients -! 1: interprete all data as current meter measurements -! at a given height "PressHeight" -! (see documentation) -! 2: interprete all data as vertically averaged current speeds -! (see documentation) -! -! ext_press_file -> filename of input file for ext_press_method=2. -! The data in the file are interpreted according to the -! value of "ext_press_mode". -! -! PressConstU -> constant pressure gradient data for x-direction for -! ext_press_method=0. The value is interpreted according to -! the value of "ext_press_mode". -! -! PressConstV -> constant pressure gradient data for y-direction for -! ext_press_method=0. The value is interpreted according to -! the value of "ext_press_mode". -! -! PressHeight -> height above bottom for current meter observations -! (only used for ext_press_mode=1) -! -! The following data specify the tidal constituents for ext_press_method=1. The -! tidal amplitudes are interpreted according to the value of "ext_press_mode". -! -! PeriodM -> period of 1. harmonic (eg. M2-tide) -! AmpMu -> u amplitude of 1. harmonic -! AmpMv -> v amplitude of 1. harmonic -! PhaseMu -> u phase of 1. harmonic -! PhaseMv -> v phase of 1. harmonic -! PeriodS -> period of 2. harmonic (eg. S2-tide) -! AmpSu -> v amplitude of 2. harmonic -! AmpSv -> v amplitude of 2. harmonic -! PhaseSu -> v phase of 2. harmonic -! PhaseSv -> v phase of 2. harmonic -! -!------------------------------------------------------------------------------- - &ext_pressure - ext_press_method=0 - ext_press_mode= 0 - ext_press_file= 'pressure.dat' - PressConstU= 0.0 - PressConstV= 0.0 - PressHeight= 0.0 - PeriodM= 0.0 - AmpMu= 0.0 - AmpMv= 0.0 - PhaseMu= 0.0 - PhaseMv= 0.0 - PeriodS= 0.0 - AmpSu= 0.0 - AmpSv= 0.0 - PhaseSu= 0.0 - PhaseSv= 0.0 - / - -!------------------------------------------------------------------------------- -! internal pressure gradients -! -! -! int_press_method -> method to compute internal pressure gradient from data -! 0: no internal pressure gradient -! 1: vertically and temporally constant internal pressure -! gradient computed from fixed horizontal salinity and -! temperature gradients -! 2: vertically and temporally variable int. pressure gradient -! computed from data in file "int_press_file" -! -! int_press_file -> file with profiles of dsdx,dsdy,dtdx,dtdy -! (only read for int_press_method=2) -! -! const_dsdx -> x-gradient of S [psu/m] for int_press_method=1 -! const_dsdy -> y-gradient of S [psu/m] for int_press_method=1 -! const_dndx -> x-gradient of NIT [mmol N/m] for int_press_method=1 -! const_dndy -> y-gradient of NIT [mmol N/m] for int_press_method=1 -! const_dtdx -> x-gradient of T [K/m] for int_press_method=1 -! const_dtdy -> y-gradient of T [K/m] for int_press_method=1 -! -! For all values of "int_press_method", it can be specified if -! the given temperature and salinity gradients should also be taken into -! account in the lateral advection terms of temperature and salinity. -! -! s_adv -> advection of salinity (.true./.false.) -! n_adv -> advection of nitrate (.true./.false.) -! t_adv -> advection of temperature (.true./.false.) -! -!------------------------------------------------------------------------------- - &int_pressure - int_press_method=0 - int_press_file= 'intern_press.dat' - const_dsdx= 0.0 - const_dsdy= 0.0 - const_dtdx= 0.0 - const_dtdy= 0.0 - const_dndx= 0.0 - const_dndy= 0.0 - n_adv= .false. - s_adv= .true. - t_adv= .true. - / - -!------------------------------------------------------------------------------- -! Light extinction - Jerlov type or from file -! -! extinct_method -> which method used to compute the extinction coefficient -! 0: from file -! 1: Jerlov type I -! 2: Jerlov type 1 (upper 50 m) -! 3: Jerlov type IA -! 4: Jerlov type IB -! 5: Jerlov type II -! 6: Jerlov type III -! 7: Adolf Stips, Lago Maggiore -! 8: Dany Dumont, Amundsen Gulf -! -! extinct_file -> name of file used if extinct_method=0 -! -!------------------------------------------------------------------------------- - &extinct - extinct_method= 5 - extinct_file= 'extinction.dat' - / - -!------------------------------------------------------------------------------- -! vertical advection -! -! It is possible to specify a vertical advection velocity. All fields (except -! the turbulence quantities) are then vertically advected with this velocity, -! for example to mimic the effect of horizontal divergence leading to vertical -! velocities. The profiles of vertical velocity are determined by two values, -! the height of maximum absolute value of vertical velocity, w_height, and the -! vertical velocity at this height, w_adv. From w_height, the vertical velocity -! is linearly decreasing towards the surface and the bottom, where is value -! is zero. -! -! w_adv_method -> method to specify the vertical advection velocity -! 0: zero vertical advection velocity -! 1: temporally constant vertical advection velocity profile -! 2: temporally varying vertical advection velocity profile -! with "w_adv" and "w_height" both read in from file -! "w_adv_file") -! -! w_adv_height0 -> constant height of maximum absolute value of vertical -! advection velocity -! -! w_adv0 -> constant vertical advection velocity for -! w_adv_method=1 - -! w_adv_file -> filename for file with "w_height" and "w_adv" -! (for w_adv_method=2) -! -! w_adv_discr -> method to discretize the vertical advection term -! 1: first order upstream -! 2: second-order polynomial (P2) -! 3: third-order polynomial (P3) -! 4: TVD with Superbee limiter -! 5: TVD with MUSCL limiter -! 6: TVD with ULTIMATE QUICKEST -! -!------------------------------------------------------------------------------- - &w_advspec - w_adv_method= 0 - w_adv_height0= 0. - w_adv0= 0. - w_adv_file= 'w_adv.dat' - w_adv_discr= 6 - / - -!------------------------------------------------------------------------------- -! sea surface elevations -! -! Varying sea surface elevations can be specified, where the depth of the water -! column in GOTM will vary, for example to account for water level -! fluctuations in tidally influenced estuaries. -! -! zeta_method -> method to prescribe the sea surface elevation -! 0: constant sea surface elevation -! 1: sea surface elevation from tidal constituents -! 2: sea surface elevation from file -! -! zeta_file -> filename for file with sea surface elevations -! (if zeta_method=2) -! -! zeta0 -> constant value for sea surface elevation -! (if zeta_method=0) -! -! The following 6 variables are used only if zeta_method=1 -! period1 -> period of 1. harmonic (eg. M2-tide) - [s] -! amp1 -> amplitude of 1. harmonic - [m] -! phase1 -> phase of 1. harmonic - [s] -! period2 -> period lsof 2. harmonic (eg. S2-tide) - [s] -! amp2 -> amplitude of 2. harmonic - [m] -! phase2 -> phase of 2. harmonic - [s] -! -!------------------------------------------------------------------------------- - &zetaspec - zeta_method= 0 - zeta_file= 'zeta.dat' - zeta_0= 0.00000 - period_1= 44714.0 - amp_1= 0.00000 - phase_1= 0.00000 - period_2= 43200.0 - amp_2= 0.50000 - phase_2= 0.00000 - / - -!------------------------------------------------------------------------------- -! wind waves -! -! Wind induced waves can be specified. Used in e.g. the spm module to account -! for wave-current interaction. -! -! wave_method -> method to prescribe the wind waves -! 0: nothing is done - all varibles equal 0 -! 1: constant values -! 2: time varying variables read from file -! -! wave_file -> filename for file wind waves -! (if wave_method=2) -! -! The following variables are used if wave_method=1 -! Hs -> constant value for significant wave-height -! Tz -> constant value for mean zero-crossing period -! phiw -> constant value for mean zero-crossing period -!------------------------------------------------------------------------------- - &wave_nml - wave_method= 0 - wave_file= 'wave.dat' - Hs= 0. - Tz= 0. - phiw= 0. - / - -!------------------------------------------------------------------------------- -! observed or prescribed velocity profiles -! -! vel_prof_method -> method to create initial or observed velocity profiles -! 0: start from zero inital velocities -! 1: (not implemented) -! 2: read profiles at different dates from "vel_prof_file" -! and interpolate to GOTM timestep -! -! vel_prof_file -> filename of file with u- and v profiles -! if vel_prof_method=2 -! -! vel_relax_tau -> relaxation time for velocity in -! (set to 1.e15 s for no relaxation) -! -! vel_relax_ramp -> duration of initial relaxation in [s] -! (set to 1.e15 for constant relaxation) -! -!------------------------------------------------------------------------------- - &velprofile - vel_prof_method= 0 - vel_prof_file= 'velprof.dat' - vel_relax_tau= 1.e15 - vel_relax_ramp= 1.e15 - / - -!------------------------------------------------------------------------------- -! turbulent dissipation rate profiles -! -! e_prof_method -> method to create initial or observed dissipation profiles -! 0: no observed dissipation rate profiles -! 1: (not implemented) -! 2: read profiles at different dates from "e_prof_file" -! and interpolate to GOTM timestep -! -! e_obs_const -> a constant filling value [W/kg] -! -! e_prof_file -> filename of file with dissipation rate profiles -! if e_prof_method=2 -! -!------------------------------------------------------------------------------- - &eprofile - e_prof_method= 0 - e_obs_const= 1.e-12 - e_prof_file= 'eps_mst.dat' - / - -!------------------------------------------------------------------------------- -! prescibred inital profile and inital surface boundary conditions for the -! dynamic buoyancy equation (only used if buoy_method=2 in gotmrun.inp) -! -! b_obs_surf -> prescribed initial buoyancy at the surface -! b_obs_NN -> prescribed initial value of N^2 (=buoyancy gradient) -! b_obs_sbf -> prescribed constant surface buoyancy flux -! -!------------------------------------------------------------------------------- - &bprofile - b_obs_surf= 0.0 - b_obs_NN= 1.e-4 - b_obs_sbf= 0.0 - / - -!------------------------------------------------------------------------------- -! observed oxygen profiles -! -! o2_prof_method -> method to create initial or observed oxygen profiles -! 0: no observed oxygen rate profiles -! 1: (not used) -! 2: read profiles at different dates from "o2_prof_file" -! and interpolate to GOTM timestep -! -! o2_unit -> which unit are the observations reported in -! 0: saturation (%) -! 1: mmol/m3 ??? -! 2: ml/m3 ??? -! -! o2_prof_file -> filename of file with oxygen profiles -! if o2_prof_method=2 -! -!------------------------------------------------------------------------------- - &o2_profile - o2_prof_method=0 - o2_units=1 - o2_prof_file='o2.dat' - / - -- GitLab