# written by HYDROLIB-core 0.5.2 [General] fileVersion = 1.09 # File format version (do not edit this) fileType = modelDef # File type. Do not edit this. program = D-Flow FM # Program version = 1.2.184.c515302e98dabd93c90604b48e23fe0ab436f488 # Version number of computational kernel autoStart = 0 # Autostart simulation after loading MDU (0: no, 1: autostart, 2: autostartstop) pathsRelativeToParent = 0 # Default: 0. Whether or not (1/0) to resolve file names (e.g. inside the *.ext file) relative to their direct parent, instead of to the toplevel MDU working dir. [Geometry] netFile = # Unstructured grid file *_net.nc bathymetryFile = # Removed since March 2022. See [geometry] keyword BedLevelFile. dryPointsFile = # Dry points file *.xyz (third column dummy z values), or dry areas polygon file *.pol (third column 1/-1: inside/outside) structureFile = # Hydraulic structure file (*.ini) iniFieldFile = # Initial values and parameter fields file waterLevIniFile = # Initial water levels sample file *.xyz using flood fill algorithm landBoundaryFile = # Land boundaries file *.ldb, used for visualization thinDamFile = # Polyline file *_thd.pli, containing thin dams fixedWeirFile = # Polyline file *_fxw.pliz, containing fixed weirs with rows x, y, crest level, left ground level, right ground level pillarFile = # Polyline file *_pillar.pliz, containing four colums with x, y, diameter and Cd coefficient useCaching = 0 # Use caching for geometrical/network-related items (0: no, 1: yes) vertPlizFile = # Vertical layering file *_vlay.pliz with rows x, y, Z, first Z, nr of layers, second Z, layer type frictFile = # 1D Roughness files (*.ini) crossDefFile = # 1D Cross section definition file (*.ini) crossLocFile = # 1D Cross section location file (*.ini) storageNodeFile = # 1D Storage node/manhole file (*.ini) 1d2dLinkFile = # File *.ini containing custom parameters for 1D2D links profLocFile = # Channel profile location file *_proflocation.xyz with rows x, y, z, profile number ref profDefFile = # Channel profile definition file *_profdefinition.def with definition for all profile numbers profDefXyzFile = # Channel profile definition file _profdefinition.def with definition for all profile numbers manholeFile = # File containing manholes (e.g. <*.dat>). partitionFile = # Domain partition polygon file *_part.pol for parallel run uniformWidth1D = 2.0 # Uniform width for channel profiles not specified by profloc dxWuiMin2D = 0.0 # Smallest fraction dx/wu , set dx > Dxwuimin2D*wu, Default = 0.1 waterLevIni = 0.0 # Initial water levels sample file *.xyz using flood fill algorithm bedLevUni = -5.0 # Uniform bed level used at missing z values if BedlevType > 2 bedSlope = 0.0 # Bed slope inclination if BedlevType > 2 bedLevType = 3 # Bathymetry specification blMeanBelow = -999.0 # If not -999d0, below this level the cell center bed level is the mean of surrouding net nodes blMinAbove = -999.0 # If not -999d0, above this level the cell center bed level is the min. of surrouding net nodes angLat = 0.0 # Angle of latitude S-N (deg), 0: no Coriolis angLon = 0.0 # Angle of longitude E-W (deg), 0: Greenwich, used in solar heat flux computation. conveyance2D = -1 # -1: R=HU,0: R=H, 1: R=A/P, 2: K=analytic-1D conv, 3: K=analytic-2D conv nonlin1D = 1 # Non-linear 1D volumes, 1 = Preisman slot, 2 = pipes closed (Nested Newton) nonlin2D = 0 # Non-linear 2D volumes, 1 = yes, only used if ibedlevtype=3 and Conveyance2D>=1 sillHeightMin = 0.0 # Weir treatment only if both sills larger than this value (m) makeOrthoCenters = 0 # Switch from circumcentres to orthocentres in geominit (i>=1: number of iterations, 0: do not use) dCenterInside = 1.0 # Limit cell center (1.0: in cell, 0.0: on c/g) baMin = 1e-06 # Minimum grid cell area, in combination with cut cells openBoundaryTolerance = 3.0 # Search tolerance factor between boundary polyline and grid cells, in cell size units renumberFlowNodes = 1 # Renumber the flow nodes (1: yes, 0: no) kmx = 0 # Maximum number of vertical layers layerType = 1 # Vertical layer type (1: all sigma, 2: all z, 3: use VertplizFile) numTopSig = 0 # Number of sigma layers in top of z-layer model numTopSigUniform = 1 # Number of sigma layers above z-layers in a z-sigma model sigmaGrowthFactor = 1.0 # Layer thickness growth factor from bed up dzTop = -999.0 # Z-layer thickness of layers above level Dztopuniabovez floorLevTopLay = -999.0 # Floor level of top layer dzTopUniAboveZ = -999.0 # Above this level layers will have uniform Dztop, below we use SigmaGrowthFactor keepZLayeringAtBed = 2 # 0:possibly very thin layer at bed, 1:bedlayerthickness == zlayerthickness, 2=equal thickness first two layers dxDoubleAt1DEndNodes = 1 # Extend 1D end nodes by 0.5 dx (1: yes, 0: no). changeVelocityAtStructures = 0 # Change the flow velocity at structures in the advection calculation changeStructureDimensions = 1 # Change the structure dimensions of (universal) weirs, orifices, bridges and general structures in case these dimensions exceed the dimensions of the channel [VolumeTables] useVolumeTables = 0 # Use 1D volume tables (0: no, 1: yes). increment = 0.2 # The height increment for the volume tables [m]. useVolumeTableFile = 0 # Read and write the volume table from/to file (1: yes, 0= no). [Numerics] CFLMax = 0.7 # Maximum Courant number EpsMaxlev = 1e-08 # Stop criterium for non linear iteration EpsMaxlevM = 1e-08 # Stop criterium for Nested Newton loop in non linear iteration advecType = 33 # Advection type (0: none, 1: Wenneker, 2: Wenneker q(uio-u), 3: Perot q(uio-u), 4: Perot q(ui-u), 5: Perot q(ui-u) without itself), 33: as 3 using links (faster) timeStepType = 2 # Time step handling (0: only transport, 1: transport + velocity update, 2: full implicit step-reduce, 3: step-Jacobi, 4: explicit) limTypHu = 0 # Limiter type for waterdepth in continuity eqn. (0: none, 1: minmod, 2: van Leer, 3: Koren, 4: monotone central) limTypMom = 4 # Limiter type for cell center advection velocity (0: none, 1: minmod, 2: van Leer, 3: Koren, 4: monotone central) limTypSa = 4 # Limiter type for salinity transport (0: none, 1: minmod, 2: van Leer, 3: Koren, 4: monotone central) icgSolver = 4 # Solver type (1: sobekGS_OMP, 2: sobekGS_OMPthreadsafe, 3: sobekGS, 4: sobekGS + Saadilud, 5: parallel/global Saad, 6: parallel/Petsc, 7: parallel/GS) maxDegree = 6 # Maximum degree in Gauss elimination fixedWeirScheme = 9 # Fixed weir scheme (0: none, 1: compact stencil, 2: whole tile lifted, full subgrid weir + factor) fixedWeirContraction = 1.0 # Fixed weir flow width contraction factor izBndPos = 0 # Position of z boundary (0: D3Dflow, 1: on net boundary, 2: on specified polyline) tlfSmo = 0.0 # Fourier smoothing time (s) on water level boundaries keepSTBndOnOutflow = 0 # Keep sal and tem signals on bnd also at outflow, 1=yes, 0=no=default=copy inside value on outflow slopeDrop2D = 0.0 # Apply drop losses only if local bed slope > Slopedrop2D, (<=0: no drop losses) drop1D = 0 # Apply drop losses in 1D (0: no, 1:yes) chkAdvd = 0.1 # Check advection terms if depth < chkadvdp, => less setbacks teta0 = 0.55 # Theta of time integration (0.5 < theta < 1) qhRelax = 0.01 cstBnd = 0 # Delft-3D type velocity treatment near boundaries for small coastal models (1: yes, 0: no) maxitVerticalForesterSal = 0 # Forester iterations for salinity (0: no vertical filter for salinity, > 0: max nr of iterations) maxitVerticalForesterTem = 0 # Forester iterations for temperature (0: no vertical filter for temperature, > 0: max nr of iterations) turbulenceModel = 3 # Turbulence model (0: none, 1: constant, 2: algebraic, 3: k-epsilon, 4: k-tau) turbulenceAdvection = 3 # Turbulence advection (0: none, 3: horizontally explicit and vertically implicit) antiCreep = 0 # Include anti-creep calculation (0: no, 1: yes) barocZLayBed = 0 # Use fix in barocp for zlaybed 0,1, 1=default) barocPOnBnd = 0 # Use fix in barocp for zlaybed 0,1, 1=default) maxWaterLevelDiff = 0.0 # upper bound (in m) on water level changes (<= 0: no bounds). Run will abort when violated. maxVelocityDiff = 0.0 # upper bound (in m/s) on velocity changes (<= 0: no bounds). Run will abort when violated. minTimestepBreak = 0.0 # smallest allowed timestep (in s), checked on a sliding average of several timesteps. Run will abort when violated. epsHu = 0.0001 # Threshold water depth for wet and dry cells [Physics] unifFrictCoef = 0.023 # Uniform friction coefficient (0: no friction) unifFrictType = 1 # Uniform friction type (0: Chezy, 1: Manning, 2: White-Colebrook, 3: idem, WAQUA style) unifFrictCoef1D = 0.023 # Uniform friction coefficient in 1D links (0: no friction) unifFrictCoefLin = 0.0 # Uniform linear friction coefficient (0: no friction) vicouv = 0.1 # Uniform horizontal eddy viscosity (m2/s) dicouv = 0.1 # Uniform horizontal eddy diffusivity (m2/s) vicoww = 5e-05 # Uniform vertical eddy viscosity (m2/s) dicoww = 5e-05 # Uniform vertical eddy diffusivity (m2/s) vicwminb = 0.0 # Minimum visc in prod and buoyancy term (m2/s) xlozmidov = 0.0 # Ozmidov length scale (m), default=0.0, no contribution of internal waves to vertical diffusion smagorinsky = 0.2 # Smagorinsky factor in horizontal turbulence, e.g. 0.15 elder = 0.0 # Elder factor in horizontal turbulence irov = 0 # 0=free slip, 1 = partial slip using wall_ks wall_ks = 0.0 # Wall roughness type (0: free slip, 1: partial slip using wall_ks) rhomean = 1000.0 # Average water density (kg/m3) idensform = 2 # Density calulation (0: uniform, 1: Eckart, 2: UNESCO, 3=UNESCO83, 13=3+pressure) ag = 9.81 # Gravitational acceleration tidalForcing = 0 # Tidal forcing, if jsferic=1 (0: no, 1: yes) ITcap = 0.0 # Upper limit on internal tides dissipation (W/m^2) doodsonStart = 55.565 # TRIWAQ: 55.565, D3D: 57.555 doodsonStop = 375.575 # TRIWAQ: 375.575, D3D: 275.555 doodsonEps = 0.0 # TRIWAQ = 0.0 400 cmps , D3D = 0.03 60 cmps villemonteCD1 = 1.0 # Calibration coefficient for Villemonte. Default = 1.0. villemonteCD2 = 10.0 # Calibration coefficient for Villemonte. Default = 10.0. salinity = 0 # Include salinity, (0: no, 1: yes) initialSalinity = 0.0 # Uniform initial salinity concentration (ppt) sal0AboveZLev = -999.0 # Vertical level (m) above which salinity is set 0 deltaSalinity = -999.0 # for testcases backgroundSalinity = 30.0 # Background salinity for eqn. of state (psu) if salinity not computed temperature = 0 # Include temperature (0: no, 1: only transport, 3: excess model of D3D, 5: composite (ocean) model) initialTemperature = 6.0 # Uniform initial water temperature (degC) backgroundWaterTemperature = 6.0 # Background water temperature for eqn. of state (deg C) if temperature not computed secchiDepth = 2.0 # Water clarity parameter (m) stanton = 0.0013 # Coefficient for convective heat flux, if negative, Ccon = abs(Stanton)*Cdwind dalton = 0.0013 # Coefficient for evaporative heat flux, if negative, Ceva = abs(Dalton)*Cdwind tempMax = -999.0 # Limit the temperature tempMin = 0.0 # Limit the temperature, if -999, tempmin=(-0.0575d0 - 2.154996d-4*sal)*sal saliMax = -999.0 # Limit the salinity saliMin = 0.0 # Limit the salinity heat_eachStep = 0 # 1=heat each timestep, 0=heat each usertimestep rhoAirRhoWater = 0 # windstress rhoa/rhow: 0=Rhoair/Rhomean, 1=Rhoair/rhow(), 2=rhoa0()/rhow(), 3=rhoa10()/Rhow() nudgeTimeUni = 3600.0 # Uniform nudge relaxation time iniWithNudge = 0 # Initialize salinity and temperature with nudge variables secondaryFlow = 0 # Secondary flow (0: no, 1: yes) betaSpiral = 0.0 # Weight factor of the spiral flow intensity on flow dispersion stresses (0d0 = disabled) [Sediment] Sedimentmodelnr = 0 # Sediment model nr, (0=no, 1=Krone, 2=SvR2007, 3=E-H, 4=MorphologyModule) MorFile = # Morphology settings file (*.mor) SedFile = # Sediment characteristics file (*.sed) [Wind] iCdTyp = 2 # Wind drag coefficient type (1: Const, 2: Smith&Banke (2 pts), 3: S&B (3 pts), 4: Charnock 1955, 5: Hwang 2005, 6: Wuest 2005, 7: Hersbach 2010 (2 pts), 8: 4+viscous). CdBreakpoints = 0.00063 0.00723 # Wind drag coefficient break points windSpeedBreakpoints = 0.0 100.0 # Wind speed break points (m/s) rhoAir = 1.205 # Air density (kg/m3) relativeWind = 0.0 # Wind speed relative to top-layer water speed*relativewind, 0d0=no relative wind, 1d0=using full top layer speed) windPartialDry = 1 # Reduce windstress on water if link partially dry, only for bedlevtyp=3, 0 = no, 1 = yes = default pavBnd = 0.0 # Average air pressure on open boundaries (N/m2) (only applied if > 0) pavIni = 0.0 # Average air pressure for initial water level correction (N/m2) (only applied if > 0) [Waves] waveModelNr = 0 # Wave model nr. (0: none, 1: fetch/depth limited hurdlestive, 2: Young-Verhagen, 3: SWAN, 5: uniform, 6: SWAN-NetCDF, 7: Offline Wave Coupling rouWav = FR84 # Friction model for wave induced shear stress: FR84 (default) or: MS90, HT91, GM79, DS88, BK67, CJ85, OY88, VR04 gammaX = 1.0 # Maximum wave height/water depth ratio [Time] refDate = 20210101 # Reference date (yyyymmdd) tZone = 0.0 # Time zone assigned to input time series tUnit = S # Time unit for start/stop times (D, H, M or S) dtUser = 300.0 # Time interval (s) for external forcing update dtNodal = 21600.0 # Time interval (s) for updating nodal factors in astronomical boundary conditions dtMax = 30.0 # Maximum computation timestep (s) dtInit = 1.0 # Initial computation timestep (s) autoTimestep = 1 # 0 = no, 1 = 2D (hor. out), 3=3D (hor. out), 5 = 3D (hor. inout + ver. inout), smallest dt autoTimestepNoStruct = 0 # 0 = no, 1 = yes (Exclude structure links (and neighbours) from time step limitation) autoTimestepNoQout = 1 # 0 = no, 1 = yes (Exclude negative qin terms from time step limitation) tStart = 26265600.0 # Start time w.r.t. RefDate (in TUnit) tStop = 26611200.0 # Stop time w.r.t. RefDate (in TUnit) startDateTime = 20211101000000 # Computation Startdatetime (yyyymmddhhmmss), when specified, overrides Tstart stopDateTime = 20211105000000 # Computation Stopdatetime (yyyymmddhhmmss), when specified, overrides Tstop updateRoughnessInterval = 86400.0 # Update interval for time dependent roughness parameters (in s) [Restart] restartFile = # Restart netcdf-file, either *_rst.nc or *_map.nc restartDateTime = yyyymmddhhmmss # Restart date and time (yyyymmddhhmmss) when restarting from *_map.nc [External Forcing] extForceFile = # Old format for external forcings file *.ext, link with tim/cmp-format boundary conditions specification extForceFileNew = # New format for external forcings file *.ext, link with bc-format boundary conditions specification rainfall = 0 # Include rainfall, (0=no, 1=yes) qExt = 0 # Include user Qin/out, externally provided, (0=no, 1=yes) evaporation = 0 # Include evaporation in water balance, (0=no, 1=yes) windExt = 1 # Include wind, externally provided, (0=no, 1=reserved for EC, 2=yes) [Hydrology] interceptionModel = 0 # Interception model (0: none, 1: on, via layer thickness) [Trachytopes] trtRou = N # Include alluvial and vegetation roughness (trachytopes) (Y: yes, N: no) trtDef = # File (*.ttd) including trachytope definitions trtL = # File (*.arl) including distribution of trachytope definitions dtTrt = 60.0 # Trachytope roughness update time interval (s) trtMxR = 8 # Maximum recursion level for composite trachytope definitions [Output] wrishp_crs = 0 # Write grid-snapped cross sections to shapefile (1: yes, 0: no) wrishp_weir = 0 # Write grid-snapped weirs to shapefile (1: yes, 0: no) wrishp_gate = 0 # Write grid-snapped gates to shapefile (1: yes, 0: no) wrishp_fxw = 0 # Write grid-snapped fixed weirs to shapefile (1: yes, 0: no) wrishp_thd = 0 # Write grid-snapped thin dams to shapefile (1: yes, 0: no) wrishp_obs = 0 # Write grid-snapped observation stations to shapefile (1: yes, 0: no) wrishp_emb = 0 # Write grid-snapped 1d2d embankments to shapefile (1: yes, 0: no) wrishp_dryArea = 0 # Write a shape file for dry areas wrishp_enc = 0 # Writing enclosures to shape file (0=no, 1=yes). wrishp_src = 0 # Write grid-snapped source-sinks to shapefile (1: yes, 0: no) wrishp_pump = 0 # Write grid-snapped pumps to shapefile (1: yes, 0: no) outputDir = # Output directory of map-, his-, rst-, dat- and timings-files, default: DFM_OUTPUT_. Set to . for current dir. waqOutputDir = # Output directory of WAQ communication files (flowgeom, vol, flo, etc.), default: DFM_DELWAQ_. Set to . for current dir. flowGeomFile = # Flow geometry NetCDF *_flowgeom.nc obsFile = # Points file *.xyn with observation stations with rows x, y, station name crsFile = # Polyline file *_crs.pli defining observation cross sections fouFile = # Fourier analysis input file *.fou fouUpdateStep = 0 # Fourier update step type: 0=every user time step, 1=every computational timestep, 2=same as history output. hisFile = # HisFile name *_his.nc hisInterval = 300.0 26265600.0 26611200.0 # History times (s), interval, starttime, stoptime (s), if starttime, stoptime are left blank, use whole simulation period xlsInterval = 0.0 # Interval (s) XLS history mapFile = # MapFile name *_map.nc mapInterval = 1800.0 26265600.0 26611200.0 # Map times (s), interval, starttime, stoptime (s), if starttime, stoptime are left blank, use whole simulation period rstInterval = 0.0 26265600.0 26611200.0 # Restart times (s), interval, starttime, stoptime (s), if starttime, stoptime are left blank, use whole simulation period mapFormat = 4 # Map file format, 1: netCDF, 2: Tecplot, 3: netCFD and Tecplot, 4: NetCDF-UGRID ncFormat = 3 # Format for all NetCDF output files (3: classic, 4: NetCDF4+HDF5) ncNoUnlimited = 0 # Write full-length time-dimension instead of unlimited dimension (1: yes, 0: no). (Might require NcFormat=4.) ncNoForcedFlush = 0 # Do not force flushing of map-like files every output timestep (1: yes, 0: no). ncWriteLatLon = 0 # Write extra lat-lon coordinates for all projected coordinate variables in each NetCDF file (for CF-compliancy). wrihis_balance = 1 # Write mass balance totals to his file (1: yes, 0: no) wrihis_sourceSink = 1 # Write sources-sinks statistics to his file (1: yes, 0: no) wrihis_structure_gen = 1 # Write general structure parameters to his file (1: yes, 0: no) wrihis_structure_dam = 1 # Write dam parameters to his file (1: yes, 0: no) wrihis_structure_pump = 1 # Write pump parameters to his file (1: yes, 0: no) wrihis_structure_gate = 1 # Write gate parameters to his file (1: yes, 0: no) wrihis_structure_weir = 1 # Write weir parameters to his file (1: yes, 0: no) wrihis_structure_orifice = 1 # Write orifice parameters to his file (1: yes, 0: no) wrihis_structure_bridge = 1 # Write bridge parameters to his file (1: yes, 0: no) wrihis_structure_culvert = 1 # Write culvert parameters to his file (1: yes, 0: no) wrihis_structure_longCulvert = 1 # Write long culvert parameters to his file (1: yes, 0: no) wrihis_structure_damBreak = 1 # Write dam break parameters to his file (1: yes, 0: no) wrihis_structure_uniWeir = 1 # Write universal weir parameters to his file (1: yes, 0: no) wrihis_structure_compound = 1 # Write compound structure parameters to his file (1: yes, 0: no) wrihis_turbulence = 1 # Write k, eps and vicww to his file (1: yes, 0: no) wrihis_wind = 1 # Write wind velocities to his file (1: yes, 0: no) wrihis_rain = 1 # Write precipitation to his file (1: yes, 0: no) wrihis_infiltration = 1 # Write infiltration to his file (1: yes, 0: no) wrihis_temperature = 0 # Write temperature to his file (1: yes, 0: no) wrihis_waves = 1 # Write wave data to his file (1: yes, 0: no) wrihis_heat_fluxes = 0 # Write heat fluxes to his file (1: yes, 0: no) wrihis_salinity = 0 # Write salinity to his file (1: yes, 0: no) wrihis_density = 1 # Write density to his file (1: yes, 0: no) wrihis_waterlevel_s1 = 1 # Write water level to his file (1: yes, 0: no) wrihis_bedlevel = 1 # Write bed level to his file (1: yes, 0: no) wrihis_waterdepth = 0 # Write water depth to his file (1: yes, 0: no) wrihis_velocity_vector = 1 # Write velocity vectors to his file (1: yes, 0: no) wrihis_upward_velocity_component = 0 # Write upward velocity to his file (1: yes, 0: no) wrihis_velocity = 0 # Write velocity magnitude to his file (1: yes, 0: no) wrihis_discharge = 0 # Write discharge magnitude to his file (1: yes, 0: no) wrihis_sediment = 1 # Write sediment transport to his file (1: yes, 0: no) wrihis_constituents = 1 # Write tracers to his file (1: yes, 0: no) wrihis_zcor = 1 # Write vertical coordinates to his file (1: yes, 0: no) wrihis_lateral = 1 # Write lateral data to his file (1: yes, 0: no) wrihis_taucurrent = 1 # Write mean bed shear stress to his file (1: yes, 0: no) wrimap_waterLevel_s0 = 1 # Write water levels for previous time step to map file (1: yes, 0: no) wrimap_waterLevel_s1 = 1 # Write water levels to map file (1: yes, 0: no) wrimap_evaporation = 0 # Write evaporation to map file (1: yes, 0: no) wrimap_waterdepth = 1 # Write water depths to map file (1: yes, 0: no) wrimap_velocity_component_u0 = 1 # Write velocity component for previous time step to map file (1: yes, 0: no) wrimap_velocity_component_u1 = 1 # Write velocity component to map file (1: yes, 0: no) wrimap_velocity_vector = 1 # Write cell-center velocity vectors to map file (1: yes, 0: no) wrimap_velocity_magnitude = 1 # Write cell-center velocity vector magnitude to map file (1: yes, 0: no) wrimap_upward_velocity_component = 0 # Write upward velocity component on cell interfaces (1: yes, 0: no) wrimap_density_rho = 1 # Write flow density to map file (1: yes, 0: no) wrimap_horizontal_viscosity_viu = 1 # Write horizontal viscosity to map file (1: yes, 0: no) wrimap_horizontal_diffusivity_diu = 1 # Write horizontal diffusivity to map file (1: yes, 0: no) wrimap_flow_flux_q1 = 1 # Write flow flux to map file (1: yes, 0: no) wrimap_spiral_flow = 1 # Write spiral flow to map file, (1: yes, 0: no). wrimap_numLimdt = 1 # Write the number times a cell was Courant limiting to map file (1: yes, 0: no). (Consider using Wrimap_flow_analysis instead.) wrimap_tauCurrent = 1 # Write the shear stress to map file (1: yes, 0: no) wrimap_chezy = 1 # Write the chezy values in flow elements to map file (1: yes, 0: no) wrimap_turbulence = 1 # Write vicww, k and eps to map file (1: yes, 0: no) wrimap_rain = 0 # Write rainfall rates to map file (1: yes, 0: no) wrimap_wind = 1 # Write wind velocities to map file (1: yes, 0: no) writek_CdWind = 0 # Write wind friction coeffs to tek file (1: yes, 0: no) wrimap_heat_fluxes = 0 # Write heat fluxes to map file, (1: yes, 0: no). wrimap_wet_waterDepth_threshold = 2e-05 # Waterdepth threshold above which a grid point counts as 'wet'. Used for Wrimap_time_water_on_ground. wrimap_time_water_on_ground = 0 # Write cumulative time when water is above ground level to map file, only for 1D nodes (1: yes, 0: no) wrimap_freeboard = 0 # Write freeboard to map file, only for 1D nodes (1: yes, 0: no) wrimap_waterDepth_on_ground = 0 # Write waterdepth that is above ground level to map file, only for 1D nodes (1: yes, 0: no) wrimap_volume_on_ground = 0 # Write volume that is above ground level to map file, only for 1D nodes (1: yes, 0: no) wrimap_total_net_inflow_1d2d = 0 # Write current total 1d2d net inflow (discharge) and cumulative total 1d2d net inflow (volume) to map file, only for 1D nodes (1: yes, 0: no) wrimap_total_net_inflow_lateral = 0 # Write current total lateral net inflow (discharge) and cumulative total net lateral inflow (volume) to map file, only for 1D nodes (1: yes, 0: no) wrimap_water_level_gradient = 0 # Write water level gradient to map file, only on 1D links (1: yes, 0: no) wrimap_tidal_potential = 1 # Write tidal potential to map file (1: yes, 0: no) wrimap_SAL_potential = 1 # Write self attraction and loading potential to map file (1: yes, 0: no) wrimap_internal_tides_dissipation = 1 # Write internal tides dissipation to map file (1: yes, 0: no) wrimap_flow_analysis = 0 # Write flow analysis data to map file (1: yes, 0: no) mapOutputTimeVector = # File (*.mpt) containing fixed map output times (s) w.r.t. RefDate fullGridOutput = 0 # Full grid output mode for layer positions (0: compact, 1: full time-varying grid layer data) eulerVelocities = 0 # Euler velocities output (0: GLM, 1: Euler velocities) classMapFile = # ClassMapFile name *_clm.nc waterLevelClasses = 0.0 # Class map's list of class values for water levels waterDepthClasses = 0.0 # Class map's list of class values for water depths classMapInterval = 0.0 26265600.0 26611200.0 # Class map times (s), interval, starttime, stoptime (s), if starttime, stoptime are left blank, use whole simulation period waqInterval = 0.0 26265600.0 26611200.0 # DELWAQ output times, given as "interval" "start period" "end period" (s) statsInterval = 3600.0 # Screen step output interval in seconds simulation time, if negative in seconds wall clock time timingsInterval = 0.0 # Timings statistics output interval richardsonOnOutput = 0 # Write Richardson number, (1: yes, 0: no). [Calibration] UseCalibration = 0 # Activate calibration factor friction multiplier (1 = yes, 0 = no) DefinitionFile = # File (*.cld) containing calibration definitions AreaFile = # File (*.cll) containing area distribution of calibration definitions [Grw] GroundWater = 0 # 0=No (horizontal) groundwater flow, 1=With groundwater flow Infiltrationmodel = 0 # Infiltration method (0: No infiltration1: Interception layer2: Constant infiltration capacity3: model unsaturated/saturated (with grw)4: Horton) Hinterceptionlayer = 0.0 # Intercept this amount of rain (m) UnifInfiltrationCapacity = 0.0 # Uniform maximum infiltration capacity (m/s) Conductivity = 0.0 # Non-dimensionless K conductivity saturated (m/s), Q = K*A*i (m3/s) h_aquiferuni = 20.0 # bgrw = bl - h_aquiferuni (m), if negative, bgrw = bgrwuni bgrwuni = # uniform level of impervious layer, only used if h_aquiferuni is negative. h_unsatini = 0.200000002980232 # Initial level groundwater is bedlevel - h_unsatini (m), if negative, sgrw = sgrwini sgrwini = # Initial groundwater level, if h_unsatini < 0. [Processes] SubstanceFile = # substance file AdditionalHistoryOutputFile = # extra history output file StatisticsFile = # statistics file ThetaVertical = 0.0 # theta vertical for waq DtProcesses = 0.0 # waq processes time step DtMassBalance = 0.0 # waq mass balance output time step ProcessFluxIntegration = 1 # Process fluxes integration option (1: WAQ, 2: D-Flow FM) Wriwaqbot3Doutput = 0 # Write 3D water quality bottom variables (1: yes, 0: no) VolumeDryThreshold = 0.001 # Volume below which segments are marked as dry. (m3) DepthDryThreshold = 0.001 # Water depth below which segments are marked as dry. (m) [Veg] Vegetationmodelnr = 0 # Vegetation model nr, (0=no, 1=Baptist DFM) Clveg = 0.8 # Stem distance factor, default 0.8 () Cdveg = 0.7 # Stem Cd coefficient , default 0.7 () Cbveg = 0.0 # Stem stiffness coefficient , default 0.0 () Rhoveg = 0.0 # Stem Rho, if > 0, -> bouyant stick procedure, default 0.0 (kg/m3) Stemheightstd = 0.0 # Stem height standard deviation fraction, e.g. 0.1 () Densvegminbap = 0.0 # Minimum vegetation density in Baptist formula (1/m2)