diff --git a/.gitignore b/.gitignore index 97be3732..b684e5b0 100644 --- a/.gitignore +++ b/.gitignore @@ -34,14 +34,11 @@ __pycache__/* htmlcov .tox .tox/* -.coverage -.coverage/* -# Translations -*.mo - - -# Stashes, etc. -.hg -*.tmp* -tests/_LargeFileStash +stats.dat +.ropeproject +.idea +*.ech +*.log +*.hbnhead +*.units.dbf diff --git a/HSP2/ADCALC.py b/HSP2/ADCALC.py index db05431b..522da24c 100644 --- a/HSP2/ADCALC.py +++ b/HSP2/ADCALC.py @@ -4,6 +4,7 @@ ''' from numpy import zeros +from numba import njit from HSP2.utilities import make_numba_dict # The clean way to get calculated data from adcalc() into advert() is to use a closure. @@ -127,7 +128,7 @@ def adcalc_(simlen, delts, nexits, crrat, ks, vol, ADFG, O, VOL, SROVOL, EROVOL, return -#@jit(nopython=True) +#@njit(cache=True) def advect(imat, conc, nexits, vols, vol, srovol, erovol, sovol, eovol): ''' Simulate advection of constituent totally entrained in water. Originally designed to be called as: advect(loop, imat, conc, omat, *ui['adcalcData']) @@ -140,9 +141,7 @@ def advect(imat, conc, nexits, vols, vol, srovol, erovol, sovol, eovol): # sovol = SOVOL[loop,:] # eovol = EOVOL[loop,:] - omat = 0.0 - if nexits > 1: - omat = zeros((nexits)) + omat = zeros((nexits)) if vol > 0.0: # reach/res contains water concs = conc conc = (imat + concs * (vols - srovol)) / (vol + erovol) # material entering during interval, weighted volume of outflow based on conditions at start of ivl (srovol), and weighted volume of outflow based on conditions at end of ivl (erovol) diff --git a/HSP2/GQUAL.py b/HSP2/GQUAL.py index fdaac444..e2da31da 100644 --- a/HSP2/GQUAL.py +++ b/HSP2/GQUAL.py @@ -1245,7 +1245,7 @@ def advqal(isqal,rsed,bsed,depscr,rosed,osed,nexits,rsqals,rbqals,errors): if bsed <= 0.0: # no bed sediments at end of interval bqal = -1.0e30 if abs(dsqal) > 0.0 or abs(rbqals > 0.0): - errors[4] += 1 # ERRMSG4: error-under these conditions these values should be zero + errors[5] += 1 # ERRMSG4: error-under these conditions these values should be zero else: # there is bed sediment at the end of the interval rbqal= dsqal + rbqals bqal = rbqal / bsed diff --git a/HSP2/HTRCH.py b/HSP2/HTRCH.py index e6db5c91..cbc3b6b4 100644 --- a/HSP2/HTRCH.py +++ b/HSP2/HTRCH.py @@ -34,12 +34,12 @@ 0.0026, 0.0026, 0.0027, 0.0027, 0.0028, 0.0028, 0.0027, 0.0026, 0.0024, 0.0023, 0.0022, 0.0021, 0.0021, 0.0020] -ERRMSG = [] +ERRMSGS =('HTRCH: Water temperature is above 66 C (150 F) -- In most cases, this indicates an instability in advection','') #ERRMSG0 def htrch(store, siminfo, uci, ts): '''Simulate heat exchange and water temperature''' - errorsV = zeros(len(ERRMSG), dtype=int) + errorsV = zeros(len(ERRMSGS), dtype=int) advectData = uci['advectData'] (nexits, vol, VOL, SROVOL, EROVOL, SOVOL, EOVOL) = advectData @@ -172,7 +172,7 @@ def htrch(store, siminfo, uci, ts): if tw > 66.0: if adfg < 2: - # errormsg: 'advect:tw problem ',dtw, airtmp + errorsV[0] += 1 # Water temperature is above 66 C (150 F). In most cases, this indicates an instability in advection. rtw = tw else: tw = tws @@ -369,7 +369,7 @@ def htrch(store, siminfo, uci, ts): for i in range(nexits): ts['OHEAT' + str(i+1)] = OHEAT[:, i] - return errorsV, ERRMSG + return errorsV, ERRMSGS def vapor(tmp): ''' # define vapor function based on temperature (deg c); vapor pressure is expressed in millibars''' diff --git a/HSP2/IQUAL.py b/HSP2/IQUAL.py index b93b97e5..85f1ad69 100644 --- a/HSP2/IQUAL.py +++ b/HSP2/IQUAL.py @@ -19,7 +19,7 @@ UNDEFINED: sliqsp ''' -ERRMSG = [] +ERRMSGS =('IQUAL: A constituent must be associated with overland flow in order to receive atmospheric deposition inputs','') #ERRMSG0 def iqual(store, siminfo, uci, ts): ''' Simulate washoff of quality constituents (other than solids, Heat, dox, and co2) @@ -35,7 +35,7 @@ def iqual(store, siminfo, uci, ts): flags = uci['IQUAL' + iqual + '_FLAGS'] constituents.append(flags['QUALID']) - errorsV = zeros(len(ERRMSG), dtype=int) + errorsV = zeros(len(ERRMSGS), dtype=int) delt60 = siminfo['delt'] / 60 # delt60 - simulation time interval in hours simlen = siminfo['steps'] tindex = siminfo['tindex'] @@ -118,6 +118,9 @@ def iqual(store, siminfo, uci, ts): elif iqadfgc == -1: ts['IQADCN'] = ts['IQADCN' + str(index) + ' 1'] + if QSOFG == 0 and (iqadfgf != 0 or iqadfgc != 0): + errorsV[0] += 1 # error - non-qualof cannot have atmospheric deposition + if 'IQADFX' not in ts: ts['IQADFX'] = zeros(simlen) if 'IQADCN' not in ts: @@ -229,5 +232,5 @@ def iqual(store, siminfo, uci, ts): IQADDR[loop] = adfxfx IQADEP[loop] = adtot - return errorsV, ERRMSG + return errorsV, ERRMSGS diff --git a/HSP2/IWTGAS.py b/HSP2/IWTGAS.py index c7bad658..03ef2b15 100644 --- a/HSP2/IWTGAS.py +++ b/HSP2/IWTGAS.py @@ -125,17 +125,23 @@ def iwtgas(store, siminfo, uci, ts): if slico2 >= 0.0: # there is co2 conc of surface lateral inflow soco2 = slico2 * slifac + soco2 * (1.0 - slifac) + SOHT[loop] = sotmp * suro * EFACTA # compute outflow of heat energy in water - units are deg. c-in./ivl + SODOXM[loop] = sodox * suro * MFACTA # calculate outflow mass of dox - units are mg-in./l-ivl + SOCO2M[loop] = soco2 * suro * MFACTA # calculate outflow mass of co2 - units are mg-in./l-ivl + SOTMP[loop] = (sotmp * 9.0 / 5.0) + 32.0 + SODOX[loop] = sodox + SOCO2[loop] = soco2 + else: sotmp = -1.0e30 sodox = -1.0e30 soco2 = -1.0e30 - SOHT[loop] = sotmp * suro * EFACTA # compute outflow of heat energy in water - units are deg. c-in./ivl - SODOXM[loop] = sodox * suro * MFACTA # calculate outflow mass of dox - units are mg-in./l-ivl - SOCO2M[loop] = soco2 * suro * MFACTA # calculate outflow mass of co2 - units are mg-in./l-ivl - - SOTMP[loop] = (sotmp * 9.0 / 5.0) + 32.0 - SODOX[loop] = sodox - SOCO2[loop] = soco2 + SOHT[loop] = 0.0 + SODOXM[loop] = 0.0 + SOCO2M[loop] = 0.0 + SOTMP[loop] = sotmp + SODOX[loop] = sodox + SOCO2[loop] = soco2 return errorsV, ERRMSG \ No newline at end of file diff --git a/HSP2/PQUAL.py b/HSP2/PQUAL.py index a355294d..3988f648 100644 --- a/HSP2/PQUAL.py +++ b/HSP2/PQUAL.py @@ -16,7 +16,7 @@ NEED to check all units conversions ''' -ERRMSG = [] +ERRMSGS =('PQUAL: A constituent must be associated with overland flow in order to receive atmospheric deposition inputs','') #ERRMSG0 # english system FACTA = 1.0 @@ -38,7 +38,7 @@ def pqual(store, siminfo, uci, ts): flags = uci['PQUAL' + pqual + '_FLAGS'] constituents.append(flags['QUALID']) - errorsV = zeros(len(ERRMSG), dtype=int) + errorsV = zeros(len(ERRMSGS), dtype=int) delt60 = siminfo['delt'] / 60 # delt60 - simulation time interval in hours simlen = siminfo['steps'] tindex = siminfo['tindex'] @@ -138,6 +138,9 @@ def pqual(store, siminfo, uci, ts): elif pqadfgc == -1: ts['PQADCN'] = ts['PQADCN' + str(index) + ' 1'] + if QSOFG == 0 and (pqadfgf != 0 or pqadfgc != 0): + errorsV[0] += 1 # error - non-qualof cannot have atmospheric deposition + if 'PQADFX' not in ts: ts['PQADFX'] = zeros(simlen) if 'PQADCN' not in ts: @@ -329,5 +332,5 @@ def pqual(store, siminfo, uci, ts): PQADDR[loop] = adfxfx PQADEP[loop] = adtot - return errorsV, ERRMSG + return errorsV, ERRMSGS diff --git a/HSP2/PSTEMP.py b/HSP2/PSTEMP.py index 92b94a0b..db3ea9e6 100644 --- a/HSP2/PSTEMP.py +++ b/HSP2/PSTEMP.py @@ -11,9 +11,9 @@ from HSP2.utilities import hoursval, initm, make_numba_dict -ERRMSG = ['SLTMP temperature less than 100C', # MSG0 - 'ULTMP temperature less than 100C', # MSG1 - 'LGTMP temperature less than 100C', # MSG2 +ERRMSG = ['SLTMP temperature less than -100C', # MSG0 + 'ULTMP temperature less than -100C', # MSG1 + 'LGTMP temperature less than -100C', # MSG2 'SLTMP temperature greater than 100C', # MSG3 'ULTMP temperature greater than 100C', # MSG4 'LGTMP temperature greater than 100C'] # MSG5 diff --git a/HSP2/PWATER.py b/HSP2/PWATER.py index a96e9660..1b7bd4a9 100644 --- a/HSP2/PWATER.py +++ b/HSP2/PWATER.py @@ -21,7 +21,7 @@ 'PWATER: Proute runoff did not converge', #ERRMSG6 'PWATER: UZI highly negative', #ERRMSG7 'PWATER: Reset AGWS to zero', #ERRMSG8 - 'PWATER: High Water Table code not implimented', #ERRMSG9 + 'PWATER: High Water Table code not implemented', #ERRMSG9 ) def pwater(store, siminfo, uci, ts): diff --git a/HSP2/SEDTRN.py b/HSP2/SEDTRN.py index 7fa02539..1ea39989 100644 --- a/HSP2/SEDTRN.py +++ b/HSP2/SEDTRN.py @@ -8,12 +8,18 @@ from HSP2.ADCALC import advect from HSP2.utilities import make_numba_dict -ERRMSG = [] +ERRMSGS =('SEDTRN: Warning -- bed storage of sediment size fraction sand is empty', #ERRMSG0 + 'SEDTRN: Warning -- bed storage of sediment size fraction silt is empty', #ERRMSG1 + 'SEDTRN: Warning -- bed storage of sediment size fraction clay is empty', #ERRMSG2 + 'SEDTRN: Warning -- bed depth appears excessive', #ERRMSG3 + 'SEDTRN: Fatal error ocurred in colby method- variable outside valid range- switching to toffaleti method', #ERRMSG4 + 'SEDTRN: Simulation of sediment requires all 3 "auxiliary flags" (AUX1FG, etc) in section HYDR must be turned on', #ERRMSG5 + 'SEDTRN: When specifying the initial composition of the bed, the fraction of sand, silt, and clay must sum to a value close to 1.0.') #ERRMSG6 def sedtrn(store, siminfo, uci, ts): ''' Simulate behavior of inorganic sediment''' - errorsV = zeros(len(ERRMSG), dtype=int) + errorsV = zeros(len(ERRMSGS), dtype=int) simlen = siminfo['steps'] delt = siminfo['delt'] @@ -31,6 +37,9 @@ def sedtrn(store, siminfo, uci, ts): # table SANDFG sandfg = ui['SANDFG'] # 1: Toffaleti method, 2:Colby method, 3:old HSPF power function + if ui['AUX3FG'] == 0: + errorsV[5] += 1 # error - sediment transport requires aux3fg to be on + # table SED-GENPARM bedwid = ui['BEDWID'] bedwrn = ui['BEDWRN'] @@ -99,7 +108,7 @@ def sedtrn(store, siminfo, uci, ts): clay_bedfr = ui['CLAYFR'] total_bedfr = sand_bedfr + silt_bedfr + clay_bedfr if abs(total_bedfr - 1.0) > 0.01: - pass # error message: sum of bed sediment fractions is not close enough to 1.0 + errorsV[6] += 1 # error message: sum of bed sediment fractions is not close enough to 1.0 # suspended sediment concentrations; table ssed-init sand_ssed1 = ui['SSED1'] @@ -390,17 +399,20 @@ def sedtrn(store, siminfo, uci, ts): osed4 += osed1 sand_rssed1 = sand_t_rsed7 = sand_rsed1 + sand_wt_rsed4 # total storage in mg.vol/l if sand_wt_rsed4 == 0.0: # warn that bed is empty - pass # errmsg + # errmsg + errorsV[0] += 1 # The bed storage of sediment size fraction sand is empty. osed4 += osed2 silt_rssed2 = silt_t_rsed8 = silt_rsed2 + silt_wt_rsed5 # total storage in mg.vol/l if silt_wt_rsed5 == 0.0: # warn that bed is empty - pass # errmsg + # errmsg + errorsV[1] += 1 # The bed storage of sediment size fraction silt is empty. osed4 += osed3 clay_rssed3 = clay_t_rsed9 = clay_rsed3 + clay_wt_rsed6 # total storage in mg.vol/l if clay_wt_rsed6 == 0.0: # warn that bed is empty - pass # errmsg + # errmsg + errorsV[2] += 1 # The bed storage of sediment size fraction clay is empty. # find the volume occupied by each fraction of bed sediment- ft3 or m3 volsed = (sand_wt_rsed4 / (sand_rho * 1.0e06) @@ -418,7 +430,8 @@ def sedtrn(store, siminfo, uci, ts): volsed = volsed / (1.0 - por) # allow for porosit beddep = volsed / (len_ * bedwid) # calculate thickness of bed- ft or m if beddep > bedwrn: - pass # Errormsg: warn that bed depth appears excessive + # Errormsg: warn that bed depth appears excessive + errorsV[3] += 1 svol = vol # svol is volume at start of time step, update for next time thru @@ -487,7 +500,7 @@ def sedtrn(store, siminfo, uci, ts): ts['OSED3' + str(i + 1)] = OSED3[:, i] ts['OSED4' + str(i + 1)] = OSED4[:, i] - return errorsV, ERRMSG + return errorsV, ERRMSGS def bdexch (avdepm, w, tau, taucd, taucs, m, vol, frcsed, susp, bed): @@ -644,8 +657,8 @@ def colby(v, db50, fhrad, fsl, tempr): if vx > v: break iv2 = iv1 + 1 - yy1 = log10(VG[iv1]) - yy2 = log10(VG[iv2]) + yy1 = log10(VG[iv1-1]) + yy2 = log10(VG[iv2-1]) yyratio = (log10(v) - yy1) / (yy2 - yy1) tmpr = min(100.0, max(32.0, tempr * 1.8 + 32.0)) diff --git a/HSP2/SNOW.py b/HSP2/SNOW.py index 1590d1e4..7dcc28a0 100644 --- a/HSP2/SNOW.py +++ b/HSP2/SNOW.py @@ -102,7 +102,7 @@ def _snow_(ui, ts): icefg = int(ui['ICEFG']) melev = ui['MELEV'] - packf = ui['PACKF'] # inital df.PKSNOW += df.PKICE fixed in uciReader + packf = ui['PACKF'] + ui['PACKI'] packi = ui['PACKI'] packw = ui['PACKW'] paktmp = ui['PAKTMP'] @@ -535,7 +535,7 @@ def _snow_(ui, ts): PACKF[step] = packf PACKI[step] = packi PACKW[step] = packw - PACK[step] = packf + packi + packw + PACK[step] = packf + packw # + packi PAKTMP[step] = paktmp PDEPTH[step] = pdepth PRAIN[step] = prain @@ -565,6 +565,7 @@ def vapor(SVP, temp): def hour6flag(siminfo, dofirst=False): '''timeseries with 1 at 6am and earlier each day, and zero otherwise''' hours24 = zeros(24) + hours24[0] = 1.0 hours24[1] = 1.0 hours24[2] = 1.0 hours24[3] = 1.0 diff --git a/HSP2/main.py b/HSP2/main.py index 64b440b9..e7d2c0a4 100644 --- a/HSP2/main.py +++ b/HSP2/main.py @@ -88,10 +88,12 @@ def main(hdfname, saveall=False, jupyterlab=True): ui['advectData'] = uci[(operation, 'ADCALC', segment)]['adcalcData'] # ui['STATES']['VOL'] = uci[(operation, 'HYDR', segment)]['STATES']['VOL'] ui['PARAMETERS']['HTFG'] = flags['HTRCH'] + ui['PARAMETERS']['AUX3FG'] = 0 if flags['HYDR']: ui['PARAMETERS']['LEN'] = uci[(operation, 'HYDR', segment)]['PARAMETERS']['LEN'] ui['PARAMETERS']['DELTH'] = uci[(operation, 'HYDR', segment)]['PARAMETERS']['DELTH'] ui['PARAMETERS']['DB50'] = uci[(operation, 'HYDR', segment)]['PARAMETERS']['DB50'] + ui['PARAMETERS']['AUX3FG'] = uci[(operation, 'HYDR', segment)]['PARAMETERS']['AUX3FG'] if activity == 'GQUAL': ui['advectData'] = uci[(operation, 'ADCALC', segment)]['adcalcData'] ui['PARAMETERS']['HTFG'] = flags['HTRCH'] diff --git a/HSP2tools/HBNOutput.py b/HSP2tools/HBNOutput.py new file mode 100644 index 00000000..536d9943 --- /dev/null +++ b/HSP2tools/HBNOutput.py @@ -0,0 +1,133 @@ +from struct import unpack +from numpy import fromfile +from pandas import DataFrame +from datetime import datetime, timedelta +from collections import defaultdict + +class HBNOutput: + def __init__(self, file_name): + self.data_frames = [] + self.file_name = file_name + self.simulation_duration_count = 0 + self.summary = [] + self.summarycols = [] + self.summaryindx = [] + + self.output_dictionary = {} + + self.tcodes = {1: 'Minutely', 2: 'Hourly', 3: 'Daily', 4: 'Monthly', 5: 'Yearly'} + + def read_data(self): + """ + Reads ALL data from hbn_file and return them in DataFrame + + Parameters + ---------- + hbn_file : str + Name/path of HBN created by HSPF. + + Returns + ------- + df_summary : DataFrame + Summary information of data found in HBN file (also saved to HDF5 file.) + """ + + data = fromfile(self.file_name, 'B') + if data[0] != 0xFD: + print('BAD HBN FILE - must start with magic number 0xFD') + return + + # Build layout maps of the file's contents + mapn = defaultdict(list) + mapd = defaultdict(list) + index = 1 # already used first byte (magic number) + while index < len(data): + rc1, rc2, rc3, rc, rectype, operation, id, activity = unpack('4BI8sI8s', data[index:index + 28]) + rc1 = int(rc1 >> 2) + rc2 = int(rc2) * 64 + rc1 # 2**6 + rc3 = int(rc3) * 16384 + rc2 # 2**14 + reclen = int(rc) * 4194304 + rc3 - 24 # 2**22 + + operation = operation.decode('ascii').strip() # Python3 converts to bytearray not string + activity = activity.decode('ascii').strip() + + if operation not in {'PERLND', 'IMPLND', 'RCHRES'}: + print('ALIGNMENT ERROR', operation) + + if rectype == 1: # data record + tcode = unpack('I', data[index + 32: index + 36])[0] + mapd[operation, id, activity, tcode].append((index, reclen)) + elif rectype == 0: # data names record + i = index + 28 + slen = 0 + while slen < reclen: + ln = unpack('I', data[i + slen: i + slen + 4])[0] + n = unpack(f'{ln}s', data[i + slen + 4: i + slen + 4 + ln])[0].decode('ascii').strip() + mapn[operation, id, activity].append(n.replace('-', '')) + slen += 4 + ln + else: + print('UNKNOW RECTYPE', rectype) + if reclen < 36: + index += reclen + 29 # found by trial and error + else: + index += reclen + 30 + + self.data_frames = [] + self.summary = [] + self.summarycols = ['Operation', 'Activity', 'segment', 'Frequency', 'Shape', 'Start', 'Stop'] + self.summaryindx = [] + for (operation, id, activity, tcode) in mapd: + rows = [] + times = [] + nvals = len(mapn[operation, id, activity]) + for (index, reclen) in mapd[operation, id, activity, tcode]: + yr, mo, dy, hr, mn = unpack('5I', data[index + 36: index + 56]) + dt = datetime(yr, mo, dy, 0, mn) + timedelta(hours=hr) + times.append(dt) + + index += 56 + row = unpack(f'{nvals}f', data[index:index + (4 * nvals)]) + rows.append(row) + dfname = f'{operation}_{activity}_{id:03d}_{tcode}' + if self.simulation_duration_count == 0: + self.simulation_duration_count = len(times) + df = DataFrame(rows, index=times, columns=mapn[operation, id, activity]).sort_index('index') + self.data_frames.append(df) + + self.summaryindx.append(dfname) + self.summary.append((operation, activity, str(id), self.tcodes[tcode], str(df.shape), df.index[0], df.index[-1])) + self.output_dictionary[dfname] = mapn[operation, id, activity] + + def get_time_series(self, name, time_unit): + """ + get a single time series based on: + 1. constituent name + 2. time_unit: yearly, monthly, full (default is 'full' simulation duration) + """ + target_tcode = 2 + for tcode_key in self.tcodes.keys(): + if self.tcodes[tcode_key].lower() == time_unit: + target_tcode = tcode_key + break + + target_data_frames = [] + for index_group_key in self.summaryindx: + if index_group_key.endswith(str(target_tcode)): + group_index = self.summaryindx.index(index_group_key) + target_data_frames.append(self.data_frames[group_index]) + + for data_frame in target_data_frames: + for key in data_frame.keys(): + if key == name: + return data_frame[key] + + return None + + @staticmethod + def save_time_series_to_file(file_name, time_series): + with open(file_name, 'w+') as f: + for row in range(len(time_series.index)): + dt = time_series.index[row] + dv = time_series.values[row] + # f.write(f'{dt},{"{:.2f}".format(dv)}\n') + f.write(f'{dt},{dv}\n') \ No newline at end of file diff --git a/HSP2tools/HDF5.py b/HSP2tools/HDF5.py new file mode 100644 index 00000000..6a65c272 --- /dev/null +++ b/HSP2tools/HDF5.py @@ -0,0 +1,216 @@ +from struct import unpack + +import h5py +from numpy import fromfile +from pandas import DataFrame +import pandas as pd +from datetime import datetime, timedelta +from collections import defaultdict + +class HDF5: + def __init__(self, file_name): + self.data_frames = [] + self.file_name = file_name + self.simulation_duration_count = 0 + self.summary = [] + self.summarycols = [] + self.summaryindx = [] + + self.time_index = [] # this will be shared with all time series + self.data_dictionary = {} + # self.dd_implnd = {} + # self.dd_perlnd = {} + # self.dd_rchres = {} + self.dd_key_separator = ':' + self.start_time = None + self.end_time = None + + self.tcodes = {1: 'Minutely', 2: 'Hourly', 3: 'Daily', 4: 'Monthly', 5: 'Yearly'} + + def open_output(self): + """ + Reads ALL data dictionary from hdf5_file's /RESULTS group + + Parameters + ---------- + hdf5_file : str + Name/path of HBN created by HSPF. + + Populate + ------- + data_dictionary : {} + Summary information of data found in HDF5 file HSP2 outputs + """ + with h5py.File(self.file_name, "r") as f: + if self.start_time is None or self.end_time is None: + str_starttime = f.get('/CONTROL/GLOBAL')['table'].fields('Info')[1].astype('datetime64[D]') + str_endtime = f.get('/CONTROL/GLOBAL')['table'].fields('Info')[2].astype('datetime64[D]') + self.start_time = pd.to_datetime(str_starttime) + self.end_time = pd.to_datetime(str_endtime) + if len(self.time_index) == 0: + self.time_index = list( + pd.date_range(self.start_time, self.end_time, freq='H')[:-1]) # issue in HDF5 table! + + section = f.get('/RESULTS') + opn_keys = list(section.keys()) + for opn_key in opn_keys: + opn_output_grp = section[opn_key] # e.g. opn_key = IMPLND_I001 + opn_output_keys = list(opn_output_grp.keys()) + for opn_output_key in opn_output_keys: + dd_key = opn_key + self.dd_key_separator + opn_output_key + data_table = section[opn_key][opn_output_key]['table'] # e.g. opn_output_key = IQUAL + all_table_attrs = list(data_table.attrs) + field_indices = {} + for table_attr in all_table_attrs: + str_attr_value = '' + try: + str_attr_value = data_table.attrs[table_attr].astype( + 'unicode') # e.g. table_attr = FIELD_2_NAME + except: + str_attr_value = '' + if (not str_attr_value == '') and table_attr.startswith('FIELD') and table_attr.endswith('NAME'): + # convert FIELD_n_NAME to lookup of field index <-> field name' + name_parts = table_attr.split('_') + field_indices[int(name_parts[1])] = str_attr_value + self.data_dictionary[dd_key] = field_indices + self.data_dictionary[dd_key + f'{self.dd_key_separator}values'] = None + ''' + if len(self.time_index) == 0: + # alternatively, could construct the time index from the start and end times above + self.time_index = list( + pd.date_range(self.start_time, self.end_time, freq='H')[:-1]) # issue in HDF5 table! + # reading row by row is VERY VERY SLOW! so this is left here to warn you. + # for row in range(data_table.attrs['NROWS']): + # dt = pd.to_datetime(data_table.fields('index')[row].astype('datetime64[D]')) + # self.time_index.append(dt) + ''' + pass + pass + pass + pass + + def screen_dd_key(self, opn_type, opn_ids): + dd_keys_to_read = [] + key_prefix = opn_type + if opn_type == 'IMPLND': + key_prefix += '_I' + elif opn_type == 'PERLND': + key_prefix += '_P' + elif opn_type == 'RCHRES': + key_prefix += '_R' + + for key in self.data_dictionary.keys(): + if not key.startswith(opn_type): + continue + if key.endswith('values'): + continue + parts = key.split(self.dd_key_separator) + try: + opn_id = int(parts[0][len(key_prefix):]) + if opn_ids is None or len(opn_ids) == 0: + dd_keys_to_read.append(key) + elif opn_id in opn_ids: + dd_keys_to_read.append(key) + except: + pass + + return dd_keys_to_read + + def read_output_from_table(self, table_key): + (opn_key, activity_key) = table_key.split(self.dd_key_separator) + mapn = [] + mapn_keys = list(self.data_dictionary[table_key].keys()) + mapn_keys.sort() + for mapn_key in mapn_keys: + mapn.append(self.data_dictionary[table_key][mapn_key]) + with h5py.File(self.file_name, "r") as f: + section = f.get('/RESULTS') + data_table = section[opn_key][activity_key]['table'] # e.g. activity_key = IQUAL + data_table_rows = list(data_table) + rows = [] + for row in data_table_rows: + rows.append(list(row)[1:]) + self.data_dictionary[table_key + f'{self.dd_key_separator}values'] = \ + DataFrame(rows, index=self.time_index, columns=mapn[1:]) + + def read_output(self, opn_type, opn_ids=None): + if len(self.data_dictionary) == 0: + return + dd_keys_to_read = self.screen_dd_key(opn_type, opn_ids) + for dd_key_to_read in dd_keys_to_read: + self.read_output_from_table(dd_key_to_read) + + def find_output_activity(self, constituent): + # has to search for it based on constituent name + # assuming all of the output items are unique in any given operation + if self.data_dictionary is None or len(self.data_dictionary) == 0: + return None + for key in self.data_dictionary.keys(): + if key.endswith('values'): + continue + name_indices = self.data_dictionary[key].keys() + for name_index in name_indices: + if self.data_dictionary[key][name_index] == constituent.upper(): + (opn_key, activity) = key.split(self.dd_key_separator) + return activity + return None + + def get_time_series(self, operation, id, constituent, activity=None): + """ + get a single time series based on: + 1. operation: e.g. IMPLND, PERLND, RCHRES + 2. id: e.g. 1, 2, 3, ... + 3. constituent: e.g. SUPY, PERO, SOQUAL etc + 4. activity: e.g. IQUAL, IWATER, PWATER, PWTGAS, SNOW etc, could leave blank, the program will look for it + + the above inputs will be used to build data_table_key: e.g. IMPLND_I001:IQUAL + 5. duration: yearly, monthly, full (default is 'full' simulation duration) <-- hdf5 output currently only has 2 + """ + data_table_key = operation.upper() + key_opn = operation.upper() + key_id = f'{id:03}' + + if activity is None: + activity = self.find_output_activity(constituent) + + key_act = activity.upper() + if key_opn == 'IMPLND': + data_table_key += f'_I{key_id}' + self.dd_key_separator + key_act + elif key_opn == 'PERLND': + data_table_key += f'_P{key_id}' + self.dd_key_separator + key_act + elif key_opn == 'RCHRES': + data_table_key += f'_R{key_id}' + self.dd_key_separator + key_act + + data_value_key = f'{data_table_key}{self.dd_key_separator}values' + if data_value_key in self.data_dictionary: + if self.data_dictionary[data_value_key] is None: + self.read_output_from_table(data_table_key) + else: + return None + + # the data frames in the in-memory collection for a table + # don't have the first 'index' column from the h5 files + # so the actual index in the in-memory collection will be (df_index - 1) + # regardless, the collection is keyed on constituent name, so it's easy to find. + # this search is just to be double sure that the constituent is legit + df_index = -1 + for key in self.data_dictionary[data_table_key].keys(): + if operation.upper() == 'IMPLND' and key_act == 'IQUAL': + if self.data_dictionary[data_table_key][key].endswith(constituent.upper()): + df_index = key + elif self.data_dictionary[data_table_key][key] == constituent.upper(): + df_index = key + + if df_index >= 0: + return self.data_dictionary[data_value_key][constituent.upper()] + else: + return None + + @staticmethod + def save_time_series_to_file(file_name, time_series): + with open(file_name, 'w+') as f: + for row in range(len(time_series.index)): + dt = time_series.index[row] + dv = time_series.values[row] + # f.write(f'{dt},{"{:.2f}".format(dv)}\n') + f.write(f'{dt},{dv}\n') \ No newline at end of file diff --git a/HSP2tools/readUCI.py b/HSP2tools/readUCI.py index 0048bfa7..828ddf60 100644 --- a/HSP2tools/readUCI.py +++ b/HSP2tools/readUCI.py @@ -481,7 +481,7 @@ def operation(info, llines, op): if cat == 'SKIP': continue if cat in {'PARAMETERS', 'STATES', 'FLAGS', 'ACTIVITY','INFO'}: - df = concat([temp[1] for temp in history[path,cat]], axis='columns') + df = concat([temp[1] for temp in history[path,cat]], axis='columns', sort=False) df = fix_df(df, op, path, ddfaults, valid) if cat == 'ACTIVITY' and op == 'PERLND': df = df.rename(columns = {'AIRTFG':'ATEMP', 'SNOWFG':'SNOW', diff --git a/HSP2tools/readWDM.py b/HSP2tools/readWDM.py index bedb6b13..7bde7f68 100644 --- a/HSP2tools/readWDM.py +++ b/HSP2tools/readWDM.py @@ -23,6 +23,7 @@ freq = {7:'100YS', 6:'YS', 5:'MS', 4:'D', 3:'H', 2:'min', 1:'S'} # pandas date_range() frequency by TCODE, TGROUP + def readWDM(wdmfile, hdffile, jupyterlab=True): iarray = np.fromfile(wdmfile, dtype=np.int32) farray = np.fromfile(wdmfile, dtype=np.float32) @@ -155,6 +156,140 @@ def readWDM(wdmfile, hdffile, jupyterlab=True): return dfsummary +''' +Get single time series data from a WDM file +based on a collection of attributes (name-value pairs) +''' +def get_wdm_data_set(wdmfile, attributes): + if attributes == None: + return None + + search_loc = attributes['location'] + search_cons = attributes['constituent'] + search_dsn = attributes['dsn'] + + iarray = np.fromfile(wdmfile, dtype=np.int32) + farray = np.fromfile(wdmfile, dtype=np.float32) + + if iarray[0] != -998: + print('Not a WDM file, magic number is not -990. Stopping!') + return None + nrecords = iarray[28] # first record is File Definition Record + ntimeseries = iarray[31] + + dsnlist = [] + for index in range(512, nrecords * 512, 512): + if not (iarray[index]==0 and iarray[index+1]==0 and iarray[index+2]==0 and iarray[index+3]==0) and iarray[index+5]==1: + dsnlist.append(index) + if len(dsnlist) != ntimeseries: + print('PROGRAM ERROR, wrong number of DSN records found') + + summary = [] + summaryindx = [] + + # check to see which extra attributes are on each dsn + columns_to_add = [] + search = ['STAID', 'STNAM', 'SCENARIO', 'CONSTITUENT', 'LOCATION'] + ''' + for att in search: + found_in_all = True + for index in dsnlist: + dattr = {} + psa = iarray[index + 9] + if psa > 0: + sacnt = iarray[index + psa - 1] + for i in range(psa + 1, psa + 1 + 2 * sacnt, 2): + id = iarray[index + i] + ptr = iarray[index + i + 1] - 1 + index + if id not in attrinfo: + continue + name, atype, length = attrinfo[id] + if atype == 'I': + dattr[name] = iarray[ptr] + elif atype == 'R': + dattr[name] = farray[ptr] + else: + dattr[name] = ''.join([itostr(iarray[k]) for k in range(ptr, ptr + length // 4)]).strip() + if att not in dattr: + found_in_all = False + if found_in_all: + columns_to_add.append(att) + ''' + + for index in dsnlist: + # get layout information for TimeSeries Dataset frame + dsn = iarray[index+4] + psa = iarray[index+9] + if psa > 0: + sacnt = iarray[index+psa-1] + pdat = iarray[index+10] + pdatv = iarray[index+11] + frepos = iarray[index+pdat] + + print(f'{dsn} reading from wdm') + + # get attributes + dattr = {'TSBDY':1, 'TSBHR':1, 'TSBMO':1, 'TSBYR':1900, 'TFILL':-999.} # preset defaults + for i in range(psa+1, psa+1 + 2*sacnt, 2): + id = iarray[index + i] + ptr = iarray[index + i + 1] - 1 + index + if id not in attrinfo: + # print('PROGRAM ERROR: ATTRIBUTE INDEX not found', id, 'Attribute pointer', iarray[index + i+1]) + continue + + name, atype, length = attrinfo[id] + if atype == 'I': + dattr[name] = iarray[ptr] + elif atype == 'R': + dattr[name] = farray[ptr] + else: + dattr[name] = ''.join([itostr(iarray[k]) for k in range(ptr, ptr + length//4)]).strip() + + if (search_dsn > 0 and search_dsn == dsn): + pass + else: + # could do more attribute based filtering here such as constituent, location etc + if (search_cons == dattr['TSTYPE']): + pass + else: + continue + + # Get timeseries timebase data + records = [] + for i in range(pdat+1, pdatv-1): + a = iarray[index+i] + if a != 0: + records.append(splitposition(a)) + if len(records) == 0: + continue # WDM preallocation, but nothing saved here yet + + srec, soffset = records[0] + start = splitdate(iarray[srec*512 + soffset]) + + sprec, spoffset = splitposition(frepos) + finalindex = sprec * 512 + spoffset + + # calculate number of data points in each group, tindex is final index for storage + tgroup = dattr['TGROUP'] + tstep = dattr['TSSTEP'] + tcode = dattr['TCODE'] + cindex = pd.date_range(start=start, periods=len(records)+1, freq=freq[tgroup]) + tindex = pd.date_range(start=start, end=cindex[-1], freq=str(tstep) + freq[tcode]) + counts = np.diff(np.searchsorted(tindex, cindex)) + + ## Get timeseries data + floats = np.zeros(sum(counts), dtype=np.float32) + findex = 0 + for (rec,offset),count in zip(records, counts): + findex = getfloats(iarray, farray, floats, findex, rec, offset, count, finalindex, tcode, tstep) + + ts = pd.Series(floats[:findex], index=tindex[:findex]) + df = pd.DataFrame({'ts': ts}) + return df + + return None + + def todatetime(yr=1900, mo=1, dy=1, hr=0): '''takes yr,mo,dy,hr information then returns its datetime64''' if hr == 24: @@ -283,3 +418,4 @@ def adjustNval(ldate, ltstep, tstep, ltcode, tcode, comp, nval): str(nval) + ',', str(lnval), ')') return nval + diff --git a/README.md b/README.md index 5f766927..356dc7b3 100644 --- a/README.md +++ b/README.md @@ -31,6 +31,27 @@ to run HSP2. legacy WDM and UCI files to HDF5 files for HSP2, and to provide additional new and legacy capabilities. +**tests** contains unit testing code for testing code conversion (convert\conversion_test) and code performance + + +## Installation Instructions + +HSP2 is designed to work with Python 3.6, 3.7 and 3.8. + +Follow these steps to install. + +#### 1. Install the Anaconda Python Distribution + +We recommend installing the [latest release](https://docs.anaconda.com/anaconda/reference/release-notes/) of [**Anaconda Individual Edition**](https://www.anaconda.com/distribution). Follow their [installation](https://docs.anaconda.com/anaconda/install/) documentation. + +#### 2. Clone or Download this HSPsquared repository + +From this Github site, click on the green "Code" dropdown button near the upper right. Select to either Open in GitHub Desktop (i.e. git clone) or "Download ZIP". We recommend using GitHub Desktop, to most easily receive updates. + +Place your copy of the HSPsquared folder in any convenient location on your computer. + +#### 3. Create a Conda Environment for HSP2 Modeling (optional) + ## Installation Instructions diff --git a/tests/__init__.py b/tests/__init__.py new file mode 100644 index 00000000..e69de29b diff --git a/tests/convert/__init__.py b/tests/convert/__init__.py new file mode 100644 index 00000000..e69de29b diff --git a/tests/convert/conversion_test.py b/tests/convert/conversion_test.py new file mode 100644 index 00000000..4a6d73f7 --- /dev/null +++ b/tests/convert/conversion_test.py @@ -0,0 +1,10 @@ +from tests.convert.regression_base import RegressTestBase + + +class ConversionRegressionTest(RegressTestBase): + def __init__(self): + super(ConversionRegressionTest, self).__init__() + +if __name__ == '__main__': + my_test = ConversionRegressionTest() + my_test.run_test() \ No newline at end of file diff --git a/tests/convert/regression_base.py b/tests/convert/regression_base.py new file mode 100644 index 00000000..fb95dd9d --- /dev/null +++ b/tests/convert/regression_base.py @@ -0,0 +1,171 @@ +import os +import inspect +import webbrowser +from HSP2tools.readWDM import get_wdm_data_set +from HSP2tools.HBNOutput import HBNOutput +from HSP2tools.HDF5 import HDF5 +import pandas as pd +import numpy as np + + +class RegressTestBase(object): + def __init__(self): + self.test_dir = '' + self.test_meta = {} + self.compare_tcodes = [2] # control time unit for comparison + # self.compare_cases = ['test05', 'test09', 'test10', 'test10b', 'Calleg', 'GRW_Plaster', 'ZRW_WestIndian'] + self.compare_cases = ['test10'] # control test cases for comparison + + def run_one_test_wdm(self, testdir): + attributes = {'location': 'unk', 'dsn': 39, 'constituent': 'PREC'} + filename = '' + df = get_wdm_data_set(filename, attributes) + x = [] + y = [] + + def get_hbn_data(self, test_dir): + sub_dirs = os.listdir(test_dir) + hbn_files = [] + for sub_dir in sub_dirs: + if sub_dir.__contains__('HSPFresults'): + files = os.listdir(os.path.join(test_dir, sub_dir)) + for file in files: + if file.endswith('.hbn'): + hbn_files.append(os.path.join(test_dir, sub_dir, file)) + break + + if len(hbn_files) == 0: + return [] + + hbn_data = [] + for hbn_file_name in hbn_files: + hbn_output = HBNOutput(hbn_file_name) + hbn_output.read_data() + # tser = hbn_output.get_time_series('SOQUALCOD', 'hourly') + # HBNOutput.save_time_series_to_file(os.path.join(os.path.split(hbn_output.file_name)[0], 'zhbn.txt'), tser) + hbn_data.append(hbn_output) + + return hbn_data + + def get_hdf5_data(self, test_dir): + sub_dirs = os.listdir(test_dir) + h5_files = [] + for sub_dir in sub_dirs: + if sub_dir.__contains__('HSP2results'): + files = os.listdir(os.path.join(test_dir, sub_dir)) + for file in files: + if file.endswith('.h5'): + h5_files.append(os.path.join(test_dir, sub_dir, file)) + break + + if len(h5_files) == 0: + return [] + + h5_data = [] + for h5_file_name in h5_files: + h5_output = HDF5(h5_file_name) + # h5_output.read_output() + h5_output.open_output() + h5_output.read_output('IMPLND') + # tser = h5_output.get_time_series('SOQUALCOD', 'hourly') + # HBNOutput.save_time_series_to_file(os.path.join(os.path.split(h5_output.file_name)[0], 'zh5.txt'), tser) + h5_data.append(h5_output) + + return h5_data + + def run_one_test(self, test_dir): + # after getting the outputs from both hbn and hdf5 + # compare them one at a time + # output comparison result in HTML format + + hbn_data = self.get_hbn_data(test_dir) + hdf5_data = self.get_hdf5_data(test_dir) + + style_th = 'style="text-align:left"' + style_header = 'style="border:1px solid; background-color:#EEEEEE"' + html = '\n' + for hbn_dataset in hbn_data: + for key in hbn_dataset.output_dictionary.keys(): + # key = f'{operation}_{activity}_{id:03d}_{tcode}' + tcode = int(key[key.rindex('_')+1:]) + if tcode not in self.compare_tcodes: + # only compare hourly outputs + continue + + html += f'\n' + html += f'\n' + (operation, activity, opn_id, tcode) = key.split('_') + for cons in hbn_dataset.output_dictionary[key]: + # get the operation type: IMPLND, PERLND, RCHRES + # get the operation id + # get the activity + # now with the 4 pieces of info, opn_type, opn_id, activity, and cons: + # get single output time series from HBNOutput object + # get single output time series from HDF5 object + # compare and generate HTML report + hbn_time_series = hbn_dataset.get_time_series(cons, 'hourly') + h5_time_series = hdf5_data[0].get_time_series(operation, int(opn_id), cons, activity) + # hbn_s = pd.Series(hbn_time_series.values) + # h5_s = pd.Series(h5_time_series.values) + + missing_data_h5 = '' + missing_data_hbn = '' + if hbn_time_series is None: + missing_data_hbn = f'not in hbn' + if h5_time_series is None: + missing_data_h5 = f'not in h5' + if len(missing_data_h5) > 0 or len(missing_data_hbn) > 0: + html += f'\n' + else: + max_diff1 = (hbn_time_series.values - h5_time_series.values).max() + max_diff2 = (h5_time_series.values - hbn_time_series.values).max() + max_diff = max(max_diff1, max_diff2) + match = False + if np.allclose(hbn_time_series, h5_time_series, rtol=1e-2, atol=1e-2, equal_nan=False): + match = True + match_symbol = f'X' + if match: + match_symbol = f'' + + html += f'\n' + pass + + html += f'
{key}
ConstituentMax DiffMatchNote
-{cons}NANA{missing_data_h5}
{missing_data_hbn}
-{cons}{max_diff}{match_symbol}
\n' + + return html + + def run_test(self): + # find all tests + current_directory = os.path.dirname(os.path.abspath(inspect.getframeinfo(inspect.currentframe()).filename)) + source_root_path = os.path.split(os.path.split(current_directory)[0])[0] + test_path = os.path.join(source_root_path, "tests") + + html_file = os.path.join(test_path, 'test_report_conversion.html') + text_file = open(html_file, "w") + text_file.write('

CONVERSION TEST REPORT

\n') + + test_dirs = os.listdir(test_path) + test_dirs_selected = [] + for test_dir in test_dirs: + if test_dir in self.compare_cases: + test_dirs_selected.append(test_dir) + + test_case_count = 1 + for test_dir in test_dirs_selected: + if test_dir not in self.compare_cases: + continue + else: + print(f'conversion test case: {test_dir} ({test_case_count} of {len(test_dirs_selected)})') + text_file.write(f'

{os.path.join(test_path, test_dir)}

\n') + one_test_report = self.run_one_test(os.path.join(test_path, test_dir)) + text_file.write(one_test_report) + test_case_count += 1 + + text_file.write("\n") + text_file.close() + print('conversion tests are done.') + + try: + webbrowser.open_new_tab('file://' + html_file) + except: + print("Error writing test results to " + html_file) diff --git a/tests/instruction.txt b/tests/instruction.txt new file mode 100644 index 00000000..1e4c09b4 --- /dev/null +++ b/tests/instruction.txt @@ -0,0 +1,10 @@ +The steps: + +1. Update your code base on develop branch +2. Run the 'tests\test10\HSPFresults\test10.uci' to generate the 3 HBN output files +3. Re-Run 3-step process in HSP2_Driver.py code in 'tests\test10\HSP2results\' to update your test10.h5 output file +4. Run the 'tests\convert\conversion_test.py' code to see conversion testing report + +The conversion testing report is in HTML format (i.e. test_report_conversion.html) +It should pop up in a web browser after the testing program finish, if not, +one can open the html file in a browser. diff --git a/tests/test10/HSPFresults/test10.ech b/tests/test10/HSPFresults/test10.ech deleted file mode 100644 index 86d7de68..00000000 --- a/tests/test10/HSPFresults/test10.ech +++ /dev/null @@ -1,3477 +0,0 @@ - FOUND RUN - FOUND END RUN - ************************************************************ - * * - * Hydrological Simulation Program - FORTRAN * - * * - ************************************************************ - - Developed for: Modified and Maintained by - - U.S. Environmental RESPEC, Inc. - Protection Agency (605)394-6512 - Office of Research email: hspf@respec.com - and Development - Center for Exposure - Assessment Modeling - Athens, Georgia - (706)355-8400 - email: ceam@epamail.epa.gov - - In cooperation with: - - U.S. Geological Survey Release 12.5 - Water Resources Discipline September 2018 - Office of Surface Water - Reston, Virginia - email: h2osoft@usgs.gov - - - Start of Job - - PREPROCESSING USERS CONTROL INPUT. - - SEARCHING FOR BOUNDARIES OF NEXT DATA SET IN USERS CONTROL INPUT. - - FOUND RUN - FOUND END RUN - - INTERPRETING RUN DATA SET IN USERS CONTROL INPUT - - FOUND GLOBAL - FOUND END GLOBAL - FOUND FILES - FOUND END FILES - FOUND OPN SEQUENCE - FOUND END OPN SEQUENCE - FOUND PERLND - FOUND END PERLND - FOUND IMPLND - FOUND END IMPLND - FOUND RCHRES - FOUND END RCHRES - FOUND FTABLES - FOUND END FTABLES - FOUND DISPLY - FOUND END DISPLY - FOUND GENER - FOUND END GENER - FOUND PLTGEN - FOUND END PLTGEN - FOUND EXT SOURCES - FOUND END EXT SOURCES - FOUND SCHEMATIC - FOUND END SCHEMATIC - FOUND MASS-LINK - FOUND END MASS-LINK - FOUND NETWORK - FOUND END NETWORK - - - ==================================================================================================================================== - PROCESSING GLOBAL BLOCK - - GENERAL RUN INFORMATION: Version 11 test run: PERLND and IMPLND w/ RCHRES (sediment, water quality) - - START 1976 END 1976 - - START AND END DATE/TIMES TRANSLATE TO THE FOLLOWING, IN INTERNAL FORMAT: 1975/12/31 24:60 1976/12/31 24:60 - - RUN INTERPRETER OUTPUT LEVEL HAS BEEN SET TO: 3 - RUNTIME SPECIAL ACTION OUTPUT LEVEL HAS BEEN SET TO: 2 - - SYSTEM HAS BEEN ASKED TO INTERPRET AND EXECUTE THE RUN. RUNFG = 1 - THE UNIT SYSTEM OF THE RUN WILL BE ENGLISH. EMFG = 1 - - FINISHED PROCESSING GLOBAL BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - CATEGORY BLOCK NOT FOUND - - FINISHED PROCESSING CATEGORY BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING OPN SEQUENCE BLOCK - - - USERS CONTROL INPUT IS: - OPN SEQUENCE - INGRP INDELT 01:00 - PERLND 1 - RCHRES 1 - DISPLY 5 - DISPLY 1 - GENER 1 - DISPLY 2 - RCHRES 2 - RCHRES 3 - RCHRES 4 - PLTGEN 2 - IMPLND 1 - RCHRES 5 - DISPLY 3 - GENER 2 - DISPLY 4 - PLTGEN 1 - END INGRP - END OPN SEQUENCE - - FINISHED PROCESSING OPN SEQUENCE BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING FTABLES BLOCK - - USERS CONTROL INPUT IS: - FTABLES - FTABLE 1 - ROWS COLS *** - 14 6 - WINTER SUMMER SPLWAY *** - DEPTH AREA VOLUME OUTLET OUTLET DISCH *** - (FT) (ACRES) (AC-FT) DISCH DISCH (CFS) *** - (CFS) (CFS) *** - .000 .000 .0000 .0000 .0000 .0000 - 2.000 1.212 1.2120 0.0000 .0000 .0000 - 4.000 2.424 4.8480 0.0000 .0000 .0000 - 6.000 3.636 10.9080 0.0000 .0000 .0000 - 8.000 4.848 19.3920 0.0000 .0000 .0000 - 10.000 6.061 30.3050 0.0000 .0000 .0000 - 12.000 7.273 43.6380 5.0000 3.5000 .0000 - 14.000 8.485 59.3950 6.2500 4.3750 .0000 - 16.000 9.697 77.5760 7.5000 5.2500 .0000 - 18.000 10.909 98.1810 8.7500 6.1250 .0000 - 20.000 12.121 121.2100 10.0000 7.0000 .0000 - 21.000 12.727 133.6360 10.6250 7.4375 50.0000 - 22.000 13.333 146.6630 11.2500 7.8750 100.0000 - 23.000 13.939 160.3030 11.8750 8.3125 500.0000 - END FTABLE 1 - - FTABLE 2 - ROWS COLS *** - 13 4 - DEPTH AREA VOLUME DISCH FLO-THRU *** - (FT) (ACRES) (AC-FT) (CFS) (MIN) *** - .000 .000 .0000 .000 0.0 - .167 .071 .0109 1.2241 6.5 - .333 .081 .0236 3.9148 4.4 - .500 .091 .0379 7.8193 3.5 - .667 .101 .0539 12.9032 3.0 - .833 .111 .0715 19.1853 2.7 - 1.000 .121 .0909 26.7046 2.5 - 1.333 .141 .1347 45.6529 2.1 - 1.667 .162 .1852 70.1757 1.9 - 2.000 .182 .2424 100.7192 1.7 - 2.667 .586 .4983 201.9005 1.8 - 3.333 .990 1.0236 344.6344 2.2 - 4.000 1.394 1.8182 537.0775 2.5 - END FTABLE 2 - - FTABLE 3 - ROWS COLS *** - 13 4 - DEPTH AREA VOLUME DISCH FLO-THRU *** - (FT) (ACRES) (AC-FT) (CFS) (MIN) *** - .000 .000 .0000 .000 0.0 - .167 .071 .0109 1.4992 5.3 - .333 .081 .0236 4.7947 3.6 - .500 .091 .0379 9.5766 2.9 - .667 .101 .0539 15.8032 2.5 - .833 .111 .0715 23.4971 2.2 - 1.000 .121 .0909 32.7063 2.0 - 1.333 .141 .1347 55.9132 1.7 - 1.667 .162 .1852 85.9474 1.6 - 2.000 .182 .2424 123.3553 1.4 - 2.667 .586 .4983 247.2766 1.5 - 3.333 .990 1.0236 422.0892 1.8 - 4.000 1.394 1.8182 657.7828 2.0 - END FTABLE 3 - - FTABLE 4 - ROWS COLS *** - 13 4 - DEPTH AREA VOLUME DISCH FLO-THRU *** - (FT) (ACRES) (AC-FT) (CFS) (MIN) *** - .000 .000 .0000 .000 0.0 - .250 .848 .1970 .9024 158.5 - .500 .970 .4242 2.8860 106.7 - .750 1.091 .6818 5.7642 85.9 - 1.000 1.212 .9697 9.5120 74.0 - 1.250 1.333 1.2879 14.1431 66.1 - 1.500 1.455 1.6364 19.6862 60.3 - 2.000 1.697 2.4242 33.6545 52.3 - 2.500 1.939 3.3333 51.7323 46.8 - 3.000 2.182 4.3636 74.2486 42.7 - 4.000 11.879 11.3939 155.5774 53.2 - 5.000 21.576 28.1212 296.8633 68.8 - 6.000 31.273 54.5454 522.1440 75.8 - END FTABLE 4 - - FTABLE 5 - ROWS COLS *** - 13 4 - DEPTH AREA VOLUME DISCH FLO-THRU *** - (FT) (ACRES) (AC-FT) (CFS) (MIN) *** - .000 .000 .0000 .000 0.0 - .333 1.697 .5253 1.5869 240.3 - .667 1.939 1.1313 5.0752 161.8 - 1.000 2.182 1.8182 10.1370 130.2 - 1.333 2.424 2.5859 16.7279 112.2 - 1.667 2.667 3.4343 24.8719 100.2 - 2.000 2.909 4.3636 34.6200 91.5 - 2.667 3.394 6.4646 59.1848 79.3 - 3.333 3.879 8.8889 90.9763 70.9 - 4.000 4.364 11.6364 130.5731 64.7 - 5.333 36.687 39.0034 284.8886 99.4 - 6.667 69.010 109.4680 593.7734 133.8 - 8.000 101.333 223.0302 1129.6948 143.3 - END FTABLE 5 - END FTABLES - - FINISHED PROCESSING FTABLES BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING MASS LINK BLOCK - - - USERS CONTROL INPUT IS: - MASS-LINK - - MASS-LINK 1 - <-Grp> <-Member-><--Mult--> <-Grp> <-Member-> *** - # #<-factor-> # # *** - PERLND PWATER PERO 0.0833333 RCHRES INFLOW IVOL - PERLND PWTGAS POHT RCHRES INFLOW IHEAT - PERLND PWTGAS PODOXM RCHRES INFLOW OXIF 1 - PERLND PWTGAS POCO2M RCHRES INFLOW PHIF 2 - END MASS-LINK 1 - - MASS-LINK 2 - <-Grp> <-Member-><--Mult--> <-Grp> <-Member-> *** - # #<-factor-> # # *** - IMPLND IWATER SURO 0.0833333 RCHRES INFLOW IVOL - IMPLND SOLIDS SOSLD 0.10 RCHRES INFLOW ISED 1 - IMPLND SOLIDS SOSLD 0.46 RCHRES INFLOW ISED 2 - IMPLND SOLIDS SOSLD 0.44 RCHRES INFLOW ISED 3 - IMPLND IWTGAS SOHT RCHRES INFLOW IHEAT - IMPLND IWTGAS SODOXM RCHRES INFLOW OXIF 1 - IMPLND IWTGAS SOCO2M RCHRES INFLOW PHIF 2 - IMPLND IQUAL SOQUAL RCHRES INFLOW OXIF 2 - END MASS-LINK 2 - - MASS-LINK 3 - <-Grp> <-Member-><--Mult--> <-Grp> <-Member-> *** - # #<-factor-> # # *** - RCHRES OFLOW 1 RCHRES INFLOW - END MASS-LINK 3 - - MASS-LINK 4 - <-Grp> <-Member-><--Mult--> <-Grp> <-Member-> *** - # #<-factor-> # # *** - RCHRES OFLOW 2 RCHRES INFLOW - END MASS-LINK 4 - - MASS-LINK 5 - <-Grp> <-Member-><--Mult--> <-Grp> <-Member-> *** - # #<-factor-> # # *** - RCHRES ROFLOW RCHRES INFLOW - END MASS-LINK 5 - - END MASS-LINK - - FINISHED PROCESSING MASS LINK BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING PERLND BLOCK - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING PERVIOUS LAND-SEGMENT NO: 1 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - AIRTFG SNOWFG PWATFG SEDFG PSTFG PWGFG PQALFG MSTLFG PESTFG NITRFG PHOSFG TRACFG - 0 1 1 0 1 1 0 0 0 0 0 0 - - Printout level flags Print-ivl Print-yrend - ATEMP SNOW PWAT SED PSTMP PWTG RQAL MSTL PEST NITR PHOS TRAC PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 4 4 1 12 - - Binary Output level flags Print-ivl Print-yrend - ATEMP SNOW PWAT SED PSTMP PWTG RQAL MSTL PEST NITR PHOS TRAC PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 4 4 1 9 - - Perv Land-segment id Unit systems Print-file nos BinaryOutfileNos - IUNITS OUNITS English Metric English Metric - BICKNELL FARM 1 1 1 0 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SNOW - - ICEFG - 1 - - SNOPFG VMKFG - 0 0 - - LAT MELEV SHADE SNOWCF COVIND KMELT TBASE - degrees (ft) (in) (in/d.F) (F) - 42. 520. 0.0 1.45 0.5 0.00 32.0 - - RDCSN TSNOW SNOEVP CCFACT MWATER MGMELT - (deg F) (in/day) - 0.12 32. 0.05 0.5 0.08 0.0001 - - Pack-snow Pack-ice Pack-watr RDENPF DULL PAKTMP - (in) (in) (in) (deg F) - 1.4 0.2 0.1 0.2 375. 27.5 - - COVINX XLNMLT SKYCLR - (in) (in) - 0.50 0.0 1.0 - - FINISHED PROCESSING INPUT FOR SECTION SNOW - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PWATER - - CSNOFG RTOPFG UZFG VCSFG VUZFG VNNFG VIFWFG VIRCFG VLEFG IFFCFG HWTFG IRRGFG IFRDFG NCANPY - 1 0 0 1 1 1 0 0 1 1 0 0 0 0 - - FOREST LZSN INFILT LSUR SLSUR KVARY AGWRC - (inches) (in/hr) (feet) (1/inches) (1/day) - 0.010 8.0 0.150 250. 0.050 0.5 0.98 - - PETMAX PETMIN INFEXP INFILD DEEPFR BASETP AGWETP - (degF) (degF) - 40. 35. 2.0 2.0 0.10 0.0 0.08 - - CEPSC UZSN NSUR INTFW IRC LZETP - (inches) (inches)(nManning) (1/day) - 0.00 0.01 0.1 1.0 0.60 0.00 - - FZG FZGL - (/in) - 1.00 0.100 - - Values of Interception Storage at start of each calendar month (inches): - JAN FEB MAR APR MAY JUN JUL AUG SEP OCT NOV DEC - 0.04 0.04 0.03 0.03 0.03 0.03 0.10 0.17 0.19 0.14 0.05 0.04 - - Values of Upper Zone Storage at start of each calendar month (inches): - JAN FEB MAR APR MAY JUN JUL AUG SEP OCT NOV DEC - 0.4 0.4 0.4 0.4 1.6 1.1 1.1 1.3 1.3 1.3 1.1 0.9 - - Values of Manning's N at start of each calendar month: - JAN FEB MAR APR MAY JUN JUL AUG SEP OCT NOV DEC - 0.30 0.30 0.30 0.30 0.27 0.25 0.25 0.25 0.25 0.25 0.35 0.33 - - Values of Lower Zone ET at start of each calendar month: - JAN FEB MAR APR MAY JUN JUL AUG SEP OCT NOV DEC - 0.20 0.20 0.20 0.23 0.23 0.25 0.60 0.80 0.75 0.50 0.30 0.20 - - Segment-wide storages (inches): - CEPS SURS UZS IFWS LZS AGWS GWVS - 0.05 0.0 0.15 0.0 4.0 0.05 0.05 - - FINISHED PROCESSING INPUT FOR SECTION PWATER - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PSTEMP - - Flags for section PSTEMP - SLTVFG ULTVFG LGTVFG TSOPFG - 0 0 0 0 - - ASLT BSLT ULTP1 ULTP2 LGTP1 LGTP2 - (deg F) (deg F/F) - 14.5 .365 1.2 4.0 1.2 6.0 - - Initial temperatures - AIRTC SLTMP ULTMP LGTMP - (deg F) (deg F) (deg F) (deg F) - 60.0 60.0 60.0 60.0 - - FINISHED PROCESSING INPUT FOR SECTION PSTEMP - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PWTGAS - - Flags for section PWTGAS - IDVFG ICVFG GDVFG GVCFG - 0 0 0 0 - - Second group of PWTGAS parms - ELEV IDOXP ICO2P ADOXP ACO2P - (ft) (mg/l) (mgC/l) (mg/l) (mgC/l) - 500. 6. .05 5. .05 - - Lateral inflow weighting factors for PWGTAS and PQUAL - SDLFAC SLIFAC ILIFAC ALIFAC - 0.00 0.00 0.00 0.00 - - Initial water temperatures - SOTMP IOTMP AOTMP - (deg F) (deg F) (deg F) - 60.0 60.0 60.0 - - Initial DO and CO2 concentrations - SODOX SOCO2 IODOX IOCO2 AODOX AOCO2 - (mg/l) (mgC/l) (mg/l) (mgC/l) (mg/l) (mgC/l) - 0.00 0.00 0.00 0.00 0.00 0.00 - - FINISHED PROCESSING INPUT FOR SECTION PWTGAS - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING PERVIOUS LAND-SEGMENT NO. 1 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - FINISHED PROCESSING PERLND BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING IMPLND BLOCK - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING IMPERVIOUS LAND-SEGMENT NO: 1 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - AIRTFG SNOWFG IWATFG SLDFG IWGFG IQALFG - 0 1 1 1 1 1 - - Printout level flags Print-ivl Print-yrend - ATEMP SNOW IWAT SLD IWTG IQAL PIVL PYREND - 4 4 4 4 4 4 1 12 - - Binary Output level flags Print-ivl Print-yrend - ATEMP SNOW IWAT SLD IWTG IQAL PIVL PYREND - 4 4 4 4 4 4 1 9 - - Imperv Land-segment id Unit systems Print-file nos BinaryOutfileNos - IUNITS OUNITS English Metric English Metric - DONIGIAN INDUSTRY 1 1 1 0 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SNOW - - Ice- - flag - 1 - - SNOPFG VMKFG - 0 0 - - LAT MELEV SHADE SNOWCF COVIND KMELT TBASE - degrees (ft) (in) (in/d.F) (F) - 42. 450. 0.0 1.45 0.5 0.00 32.0 - - RDCSN TSNOW SNOEVP CCFACT MWATER MGMELT - (deg F) (in/day) - 0.12 32. 0.05 0.5 0.08 0.0001 - - Pack-snow Pack-ice Pack-watr RDENPF DULL PAKTMP - (in) (in) (in) (deg F) - 1.4 0.2 0.1 0.2 375. 27.5 - - COVINX XLNMLT SKYCLR - (in) (in) - 0.50 0.0 1.0 - - FINISHED PROCESSING INPUT FOR SECTION SNOW - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION IWATER - - CSNOFG RTOPFG VRSFG VNNFG RTLIFG - 1 0 0 0 1 - - LSUR SLSUR NSUR RETSC - (ft) (nManning) (in) - 200. .010 .010 .01 - - PETMAX PETMIN - (deg F) (deg F) - 40. 35. - - Storages (inches): - RETS SURS - .01 .01 - - FINISHED PROCESSING INPUT FOR SECTION IWATER - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SOLIDS - - VASDFG VRSDFG SDOPFG - 0 0 0 - - KEIM JEIM ACCSDP REMSDP - (tns/ac.d) (/day) - .08 1.9 .01 .5 - - Initial solids storage (tons/acre) - 0.2 - - FINISHED PROCESSING INPUT FOR SECTION SOLIDS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION IWTGAS - - Flags for section IWTGAS - WTFVFG CSNOFG - 0 0 - - Second group of IWTGAS parms - ELEV AWTF BWTF - (ft) (deg F) (deg F/F) - 410. 40. 0.8 - - SDLFAC SLIFAC - 0.00 0.00 - - SOTMP SODOX SOCO2 - (deg F) (mg/l) (mgC/l) - 60.0 0.00 0.00 - - FINISHED PROCESSING INPUT FOR SECTION IWTGAS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION IQUAL - - NQUAL - 1 - - Atmospheric Deposition Flags - QUAL1 QUAL2 QUAL3 QUAL4 QUAL5 QUAL6 QUAL7 QUAL8 QUAL9 QUAL10 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - CON NAME QTYID QSDFP VPFWFG QSOFP VQOFG - COD LB 1 0 1 0 - - Storage on surface and nonseasonal parameters - SQO POTFW ACQOP SQOLIM WSQOP - (qty/ac) (qty/ton) (qty/ (qty/ac) (in/hr) - ac.day) - 1.20 .175 .02 2.0 1.7 - - FINISHED PROCESSING INPUT FOR SECTION IQUAL - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING IMPERVIOUS LAND-SEGMENT NO. 1 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - FINISHED PROCESSING IMPLND BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING RCHRES BLOCK - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING RCHRES NO: 1 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - HYDRFG ADFG CONSFG HTFG SEDFG GQUALFG OXFG NUTFG PLKFG PHFG - 1 1 1 1 1 1 1 1 1 1 - - Printout level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 5 5 5 5 5 5 5 5 5 5 1 12 - - Binary Output level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 1 9 - - Reach/reservoir-id NEXITS Unit systems Print-file nos Lake- BinaryOutfileNos - IUNITS OUNITS English Metric flag English Metric - MEIER POND 2 1 1 1 0 1 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HYDR - - VCONFG AUX1FG AUX2FG AUX3FG ODFV-flags for ODGT-flags for FUNCT-flags for - each poss. exit poss. exit each poss. exit - 0 1 1 1 -1 6 0 0 0 0 0 0 0 0 1 1 1 1 1 - - MILES FT FT IN - DSN FTBN LEN DELTH STCOR KS DB50 - 00 1 0.5 1. 0.00 .5 1.000E-02 - - Values of irrigation withdrawal parameters - IREXIT IRMINV (ac.ft) - 0.00 0.00 - - (acre-ft) CAT Init value of COLIND for each poss exit Init value of OUTDGT for each poss exit (ft3/s) - VOL - 1 2 3 4 5 1 2 3 4 5 - 30. 4.0 5.0 4.00 4.00 4.00 0.00 0.00 0.00 0.00 0.00 - - INITIAL TOTAL OUTFLOW RATE: 0.000E+00 - - INITIAL OUTFLOWS THROUGH INDIVIDUAL EXITS: - EXIT 1 2 - FLOW 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 1 - DEP STAGE SAREA AVDEP TWID HRAD - FT FT ACRES FT FT FT - 9.950E+00 9.950E+00 6.030E+00 4.975E+00 9.950E+01 4.523E+00 - - AUXILIARY STATE VARIABLES - GROUP 2 - AVVEL AVSECT - FT/SEC FT2 - 0.000E+00 4.950E+02 - - AUXILIARY STATE VARIABLES - GROUP 3 - USTAR TAU - FT/SEC LB/FT2 - 0.000E+00 0.000E+00 - - FINISHED PROCESSING INPUT FOR SECTION HYDR - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION ADCALC - - CRRAT VOL - (acre-ft) - 1.50 0.00 - - FINISHED PROCESSING INPUT FOR SECTION ADCALC - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION CONS - - NCONS - 1 - - Atmospheric Deposition Flags - CONS1 CONS2 CONS3 CONS4 CONS5 CONS6 CONS7 CONS8 CONS9 CONS10 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units fact id - ALKALINITY 1000. MG/L 35.31 KG - - FINISHED PROCESSING INPUT FOR SECTION CONS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HTRCH - - BEDFLG TGFLG TSTOP - 0 2 55 - - ELEV ELDAT CFSAEX KATRAD KCOND KEVAP - (ft) (ft) - 450. 100. .95 9.37 6.12 2.24 - - SHADFG TOPFL VEGFL NSSP LATDEG LONDEG LONSTD - (deg) (deg) (deg) - 0.00 41.0 42.0 0.00 40.0 -90.0 -90.0 - - TW AIRTMP - (deg F) (deg F) - 60. 40. - - FINISHED PROCESSING INPUT FOR SECTION HTRCH - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SEDTRN - - SNDFG - 3 - - BEDWID BEDWRN POR - (ft) (ft) - 200. 4. 0.500 - - SAND PARAMETERS - - D W RHO KSAND EXPSND - (in) (in/sec) - .014 2.5 2.65 1.5 1.2 - - SILT PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .00063 .0066 2.2 .2 .4 .5 - - CLAY PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .000055 .000034 2.0 .15 .3 .75 - - Suspended sed concs (mg/l) - SSED(1) SSED(2) SSED(3) - (mg/l) (mg/l) (mg/l) - 5. 20. 30. - - Init bed Initial fraction of each size - thickness of sediment in the bed - (ft) Sand Silt Clay - 2. .8 .1 .1 - - FINISHED PROCESSING INPUT FOR SECTION SEDTRN - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION GQUAL - - NGQUAL <----Flags indicating sources of input data------------> Latitude - TEMPFG PHFLAG ROXFG CLDFG SDFG PHYTFG (Degrees) - 1 1 1 2 1 1 1 42 - - Atmospheric Deposition Flags - GQUAL1 GQUAL2 GQUAL3 GQUAL4 GQUAL5 GQUAL6 GQUAL7 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units(/l) fact id - PESTICIDE B4 10. UG 1.E6 G - - <-----------Degradation process flags -----------------> Sediment - Hydrol Oxid Photol Volatil Biodeg General assoc - 1 1 1 1 1 1 1 - - <-Flags indicating whether qual is a daughter through--> Source of - Hydrol Oxid Photol Volatil Biodeg General biomass data - 0 0 0 0 0 0 2 - - KA KB KN THHYD - (/M-sec) (/M-sec) (/sec) - .001 .01 .001 1.03 - - KOX THOX - (/M.sec) - .1 1.03 - - Items 1 thru 18 below are molar absorption coefficients, for each of the 18 wavelengths (l/mole.cm). - Item 19 is the quantum yield (mole/Einstein). - Item 20 is the temperature correction parameter (theta). - 848. 544. 330. 195. 120. 68. 41. 23. 13. 7. 4. 1. .1 - 0.00 0.00 0.00 0.00 0.00 .3 1.1 - - CFGAS - .001 - - BIOCON THBIO BIO - (1/mg/day) (mg/l) - .01 1.07 10. - - FSTDEC THFST - (/day) - .2 1.07 - - Decay rate (/day) & temp correction coeff. for qual on sediment: - <----Suspended-----><-----Bed----------> - Rate Theta Rate Theta - 0.00 1.07 .002 1.07 - - Partition coefficients (l/mg) for: - <--------Suspended-----------><-------------Bed------------> - Sand Silt Clay Sand Silt Clay - .0001 .001 .001 .0001 .001 .001 - - Adsorption/desorption rate parameters (/day) for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 150. 150. 150. .25 .25 .25 - - Adsorption/desorption temp correction parameters for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 1.07 1.07 1.07 1.07 1.07 1.07 - - Initial concentrations on sediment (concu/mg): - <---------Suspended-----------><-------------Bed-----------> - Sand Silt Clay Sand Silt Clay - .001 .01 .01 .001 .01 .01 - - TWAT PHVAL ROC CLD SDCNC PHY - (deg F) (mole/l) (tenths) (mg/l) (mg/l) - 60.0 7.00 1.E-5 0.00 0.00 0.00 - - Values of base absorbance coeff (/cm) for each of the 18 light wavelengths: - .008 .009 .010 .011 .011 .011 .012 .013 .015 .016 .017 .018 .019 - .020 .021 .022 .024 .024 - - Values of sediment absorbance coefficient (l/mg.cm) for each of the 18 light wavelengths: - .001 .001 .001 .001 .001 .001 .001 .001 .002 .002 .002 .002 .002 - .002 .002 .002 .002 .002 - - Values of the phytoplankton absorbance coefficient (l/mg.cm), for each of the 18 light wavelengths: - .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 - .0007 .0007 .0007 .0007 .0007 - - Values of light extinction efficiency of cloud cover, for each of the 18 light wavelengths: - .10 .10 .10 .15 .15 .15 .15 .17 .17 .17 .17 .18 .19 - .20 .21 .21 .21 .21 - - REAMFG, DOPFG - 2 0 - - CFOREA - 5. - - FINISHED PROCESSING INPUT FOR SECTION GQUAL - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - - BENF - 1 - - SCRVEL SCRMUL - (ft/sec) - 3. 2.00 - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION OXRX - - BENOD TCBEN EXPOD BRBOD(1) BRBOD(2) EXPREL - (mg/m2.hr) (mg/m2.hr)(mg/m2.hr) - 10. 1.1 1.2 20. 25. 1.3 - - KBOD20 TCBOD KODSET SUPSAT - ( /hr) (ft/hr) - .1 1.08 8. 1.15 - - DOX BOD SATDO - (mg/l) (mg/l) (mg/l) - 8. 100. 10.0 - - FINISHED PROCESSING INPUT FOR SECTION OXRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION NUTRX - - TAMFG NO2FG PO4FG AMVFG DENFG ADNHFG ADPOFG PHFLAG - 1 1 1 1 1 0 0 2 - - Atmospheric Deposition Flags - NO3 NH3 PO4 - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - CVBO CVBPC CVBPN BPCNTC - (mg/mg)(mols/mol)(mols/mol) (percent) - 1.98 106. 16.0 49.0 - - BRTAM(1) BRTAM(2) BRPO4(1) BRPO4(2) ANAER - (mg/m2.hr)(mg/m2.hr)(mg/m2.hr)(mg/m2.hr) (mg/l) - 11.0 33.0 1.1 2.2 0.0005 - - KTAM20 KNO220 TCNIT KNO320 TCDEN DENOXT - (/hr) (/hr) (/hr) (mg/l) - .002 .004 1.07 .001 1.04 0.2 - - EXPNVG EXPNVL - .50 0.6667 - - NO3 TAM NO2 PO4 PHVAL - (mg/l) (mg/l) (mg/l) (mg/l) (ph) - 40. 10. 1. 50. 7.0 - - FINISHED PROCESSING INPUT FOR SECTION NUTRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PLANK - - PHYFG ZOOFG BALFG SDLTFG AMRFG DECFG NSFG ZFOOD BNPFG - 1 1 1 1 1 0 1 2 0 - - Atmospheric Deposition Flags - ORN ORP ORC - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - RATCLP NONREF LITSED ALNPR EXTB MALGR PARADF - (/ft) (/hr) - 0.600 0.500 0.00 1.00 4.5 0.300 1.00 - - CMMLT CMMN CMMNP CMMP TALGRH TALGRL TALGRM - (ly/min) (mg/l) (mg/l) (mg/l) (deg F) (deg F) (deg F) - 3.300E-02 4.500E-02 2.840E-02 1.500E-02 95.0 43.0 77.0 - - ALR20 ALDH ALDL OXALD NALDH PALDH - (/hr) (/hr) (/hr) (/hr) (mg/l) (mg/l) - 4.000E-03 1.000E-02 1.000E-03 3.000E-02 0.00 0.00 - - NMINGR PMINGR CMINGR LMINGR NMINC - mg/l mg/l mg/l ly/min mg/l - 1.000E-03 1.000E-03 1.000E-03 1.000E-03 1.000E-03 - - SEED MXSTAY OREF CLALDH PHYSET REFSET - (mg/l) (mg/l) (ft3/s) (ug/l) (ft/hr) (ft/hr) - .1 .1 1.000E-04 50.0 .5 .5 - - MZOEAT ZFIL20 ZRES20 ZD OXZD - (mg/mg.hr) (l/mg.hr) (/hr) (/hr) (/hr) - 5.500E-02 .2 1.500E-03 1.000E-04 3.000E-02 - - TCZFIL TCZRES ZEXDEL ZOMASS - (mg/org) - 1.17 1.07 0.700 3.000E-04 - - MBAL CFBALR CFBALG MINBAL CAMPR FRAVL NMAXFX - (mg/m2) (mg/m2) (mg/l) (mg/l) - 600. 1.00 1.00 1.000E-04 1.000E-03 0.00 10.0 - - FRRIF CMMV RIFCQ1 RIFCQ2 RIFCQ3 - (ft/s) (cfs) (cfs) (cfs) - 1.00 1.00 0.00 0.00 0.00 - - RIFVEL1 RIFVEL2 RIFVEL3 RIFVEL4 RIFDEP1 RIFDEP2 RIFDEP3 RIFDEP4 - - 1.00 1.00 1.00 1.00 1.00 1.00 1.00 1.00 - - PHYTO ZOO BENAL ORN ORP ORC - (mg/l) (org/l) (mg/m2) (mg/l) (mg/l) (mg/l) - 40. 200. 5. 20. 20. 20. - - FINISHED PROCESSING INPUT FOR SECTION PLANK - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PHCARB - - PHCNT ALKCON - 50 1 - - CFCINV BRCO2(1) BRCO2(2) - (mg/m2.hr)(mg/m2.hr) - 0.913 62.0 62.0 - - TIC CO2 PH - (mg/l) (mg/l) - 20. 5. 8.5 - - FINISHED PROCESSING INPUT FOR SECTION PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING RCHRES NO. 1 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING RCHRES NO: 2 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - HYDRFG ADFG CONSFG HTFG SEDFG GQUALFG OXFG NUTFG PLKFG PHFG - 1 1 1 1 1 1 1 1 1 1 - - Printout level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 5 5 5 5 5 5 5 5 5 5 1 12 - - Binary Output level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 1 9 - - Reach/reservoir-id NEXITS Unit systems Print-file nos Lake- BinaryOutfileNos - IUNITS OUNITS English Metric flag English Metric - OUTLET 1 1 1 1 0 0 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HYDR - - VCONFG AUX1FG AUX2FG AUX3FG ODFV-flags for ODGT-flags for FUNCT-flags for - each poss. exit poss. exit each poss. exit - 0 1 1 1 4 0 0 0 0 0 0 0 0 0 1 1 1 1 1 - - MILES FT FT IN - DSN FTBN LEN DELTH STCOR KS DB50 - 00 2 0.25 20. 0.00 .5 1.000E-02 - - Values of irrigation withdrawal parameters - IREXIT IRMINV (ac.ft) - 0.00 0.00 - - (acre-ft) CAT Init value of COLIND for each poss exit Init value of OUTDGT for each poss exit (ft3/s) - VOL - 1 2 3 4 5 1 2 3 4 5 - 0.0 4.0 4.00 4.00 4.00 4.00 0.00 0.00 0.00 0.00 0.00 - - INITIAL TOTAL OUTFLOW RATE: 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 1 - DEP STAGE SAREA AVDEP TWID HRAD - FT FT ACRES FT FT FT - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 2 - AVVEL AVSECT - FT/SEC FT2 - 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 3 - USTAR TAU - FT/SEC LB/FT2 - 0.000E+00 0.000E+00 - - FINISHED PROCESSING INPUT FOR SECTION HYDR - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION ADCALC - - CRRAT VOL - (acre-ft) - 1.50 0.00 - - FINISHED PROCESSING INPUT FOR SECTION ADCALC - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION CONS - - NCONS - 1 - - Atmospheric Deposition Flags - CONS1 CONS2 CONS3 CONS4 CONS5 CONS6 CONS7 CONS8 CONS9 CONS10 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units fact id - ALKALINITY 1000. MG/L 35.31 KG - - FINISHED PROCESSING INPUT FOR SECTION CONS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HTRCH - - BEDFLG TGFLG TSTOP - 0 2 55 - - ELEV ELDAT CFSAEX KATRAD KCOND KEVAP - (ft) (ft) - 450. 100. .95 9.37 6.12 2.24 - - SHADFG TOPFL VEGFL NSSP LATDEG LONDEG LONSTD - (deg) (deg) (deg) - 0.00 41.0 42.0 0.00 40.0 -90.0 -90.0 - - TW AIRTMP - (deg F) (deg F) - 60. 40. - - FINISHED PROCESSING INPUT FOR SECTION HTRCH - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SEDTRN - - SNDFG - 3 - - BEDWID BEDWRN POR - (ft) (ft) - 1.33 3. 0.500 - - SAND PARAMETERS - - D W RHO KSAND EXPSND - (in) (in/sec) - .014 2.5 2.65 1.5 1.2 - - SILT PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .00063 .0066 2.2 1.E-10 500. .5 - - CLAY PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .000055 .000034 2.0 1.E-10 500. .75 - - Suspended sed concs (mg/l) - SSED(1) SSED(2) SSED(3) - (mg/l) (mg/l) (mg/l) - 5. 20. 30. - - Init bed Initial fraction of each size - thickness of sediment in the bed - (ft) Sand Silt Clay - 2. .8 .1 .1 - - FINISHED PROCESSING INPUT FOR SECTION SEDTRN - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION GQUAL - - NGQUAL <----Flags indicating sources of input data------------> Latitude - TEMPFG PHFLAG ROXFG CLDFG SDFG PHYTFG (Degrees) - 1 1 1 2 1 1 1 42 - - Atmospheric Deposition Flags - GQUAL1 GQUAL2 GQUAL3 GQUAL4 GQUAL5 GQUAL6 GQUAL7 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units(/l) fact id - PESTICIDE B4 10. UG 1.E6 G - - <-----------Degradation process flags -----------------> Sediment - Hydrol Oxid Photol Volatil Biodeg General assoc - 1 1 1 1 1 1 1 - - <-Flags indicating whether qual is a daughter through--> Source of - Hydrol Oxid Photol Volatil Biodeg General biomass data - 0 0 0 0 0 0 2 - - KA KB KN THHYD - (/M-sec) (/M-sec) (/sec) - .001 .01 .001 1.03 - - KOX THOX - (/M.sec) - .1 1.03 - - Items 1 thru 18 below are molar absorption coefficients, for each of the 18 wavelengths (l/mole.cm). - Item 19 is the quantum yield (mole/Einstein). - Item 20 is the temperature correction parameter (theta). - 848. 544. 330. 195. 120. 68. 41. 23. 13. 7. 4. 1. .1 - 0.00 0.00 0.00 0.00 0.00 .3 1.1 - - CFGAS - .001 - - BIOCON THBIO BIO - (1/mg/day) (mg/l) - .01 1.07 10. - - FSTDEC THFST - (/day) - .2 1.07 - - Decay rate (/day) & temp correction coeff. for qual on sediment: - <----Suspended-----><-----Bed----------> - Rate Theta Rate Theta - 0.00 1.07 .002 1.07 - - Partition coefficients (l/mg) for: - <--------Suspended-----------><-------------Bed------------> - Sand Silt Clay Sand Silt Clay - .0001 .001 .001 1.E-10 1.E-10 1.E-10 - - Adsorption/desorption rate parameters (/day) for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 150. 150. 150. 1000. 1000. 1000. - - Adsorption/desorption temp correction parameters for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 1.07 1.07 1.07 1.07 1.07 1.07 - - Initial concentrations on sediment (concu/mg): - <---------Suspended-----------><-------------Bed-----------> - Sand Silt Clay Sand Silt Clay - .001 .01 .01 0. 0. 0. - - TWAT PHVAL ROC CLD SDCNC PHY - (deg F) (mole/l) (tenths) (mg/l) (mg/l) - 60.0 7.00 1.E-5 0.00 0.00 0.00 - - Values of base absorbance coeff (/cm) for each of the 18 light wavelengths: - .008 .009 .010 .011 .011 .011 .012 .013 .015 .016 .017 .018 .019 - .020 .021 .022 .024 .024 - - Values of sediment absorbance coefficient (l/mg.cm) for each of the 18 light wavelengths: - .001 .001 .001 .001 .001 .001 .001 .001 .002 .002 .002 .002 .002 - .002 .002 .002 .002 .002 - - Values of the phytoplankton absorbance coefficient (l/mg.cm), for each of the 18 light wavelengths: - .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 - .0007 .0007 .0007 .0007 .0007 - - Values of light extinction efficiency of cloud cover, for each of the 18 light wavelengths: - .10 .10 .10 .15 .15 .15 .15 .17 .17 .17 .17 .18 .19 - .20 .21 .21 .21 .21 - - REAMFG, DOPFG - 1 0 - - REAKT TCGINV - (/ft) - 8.000E-02 1.05 - - FINISHED PROCESSING INPUT FOR SECTION GQUAL - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - - BENF - 0 - - SCRVEL SCRMUL - (ft/sec) - 3. 2.00 - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION OXRX - - KBOD20 TCBOD KODSET SUPSAT - ( /hr) (ft/hr) - .1 1.08 8. 1.15 - - DOX BOD SATDO - (mg/l) (mg/l) (mg/l) - 8. 100. 10.0 - - FINISHED PROCESSING INPUT FOR SECTION OXRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION NUTRX - - TAMFG NO2FG PO4FG AMVFG DENFG ADNHFG ADPOFG PHFLAG - 1 1 1 1 1 0 0 2 - - Atmospheric Deposition Flags - NO3 NH3 PO4 - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - CVBO CVBPC CVBPN BPCNTC - (mg/mg)(mols/mol)(mols/mol) (percent) - 1.98 106. 16.0 49.0 - - BRTAM(1) BRTAM(2) BRPO4(1) BRPO4(2) ANAER - (mg/m2.hr)(mg/m2.hr)(mg/m2.hr)(mg/m2.hr) (mg/l) - 11.0 33.0 1.1 2.2 0.0005 - - KTAM20 KNO220 TCNIT KNO320 TCDEN DENOXT - (/hr) (/hr) (/hr) (mg/l) - .002 .004 1.07 .001 1.04 0.2 - - EXPNVG EXPNVL - .50 0.6667 - - NO3 TAM NO2 PO4 PHVAL - (mg/l) (mg/l) (mg/l) (mg/l) (ph) - 40. 10. 1. 50. 7.0 - - FINISHED PROCESSING INPUT FOR SECTION NUTRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PLANK - - PHYFG ZOOFG BALFG SDLTFG AMRFG DECFG NSFG ZFOOD BNPFG - 1 1 1 1 1 0 1 2 0 - - Atmospheric Deposition Flags - ORN ORP ORC - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - RATCLP NONREF LITSED ALNPR EXTB MALGR PARADF - (/ft) (/hr) - 0.600 0.500 0.00 1.00 4.5 0.300 1.00 - - CMMLT CMMN CMMNP CMMP TALGRH TALGRL TALGRM - (ly/min) (mg/l) (mg/l) (mg/l) (deg F) (deg F) (deg F) - 3.300E-02 4.500E-02 2.840E-02 1.500E-02 95.0 43.0 77.0 - - ALR20 ALDH ALDL OXALD NALDH PALDH - (/hr) (/hr) (/hr) (/hr) (mg/l) (mg/l) - 4.000E-03 1.000E-02 1.000E-03 3.000E-02 0.00 0.00 - - NMINGR PMINGR CMINGR LMINGR NMINC - mg/l mg/l mg/l ly/min mg/l - 1.000E-03 1.000E-03 1.000E-03 1.000E-03 1.000E-03 - - SEED MXSTAY OREF CLALDH PHYSET REFSET - (mg/l) (mg/l) (ft3/s) (ug/l) (ft/hr) (ft/hr) - .1 .1 1.000E-04 50.0 .5 .5 - - MZOEAT ZFIL20 ZRES20 ZD OXZD - (mg/mg.hr) (l/mg.hr) (/hr) (/hr) (/hr) - 5.500E-02 .2 1.500E-03 1.000E-04 3.000E-02 - - TCZFIL TCZRES ZEXDEL ZOMASS - (mg/org) - 1.17 1.07 0.700 3.000E-04 - - MBAL CFBALR CFBALG MINBAL CAMPR FRAVL NMAXFX - (mg/m2) (mg/m2) (mg/l) (mg/l) - 600. 1.00 1.00 1.000E-04 1.000E-03 0.00 10.0 - - FRRIF CMMV RIFCQ1 RIFCQ2 RIFCQ3 - (ft/s) (cfs) (cfs) (cfs) - 1.00 1.00 0.00 0.00 0.00 - - RIFVEL1 RIFVEL2 RIFVEL3 RIFVEL4 RIFDEP1 RIFDEP2 RIFDEP3 RIFDEP4 - - 1.00 1.00 1.00 1.00 1.00 1.00 1.00 1.00 - - PHYTO ZOO BENAL ORN ORP ORC - (mg/l) (org/l) (mg/m2) (mg/l) (mg/l) (mg/l) - 40. 200. 5. 20. 20. 20. - - FINISHED PROCESSING INPUT FOR SECTION PLANK - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PHCARB - - PHCNT ALKCON - 50 1 - - CFCINV BRCO2(1) BRCO2(2) - (mg/m2.hr)(mg/m2.hr) - 0.913 62.0 62.0 - - TIC CO2 PH - (mg/l) (mg/l) - 20. 5. 8.5 - - FINISHED PROCESSING INPUT FOR SECTION PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING RCHRES NO. 2 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING RCHRES NO: 3 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - HYDRFG ADFG CONSFG HTFG SEDFG GQUALFG OXFG NUTFG PLKFG PHFG - 1 1 1 1 1 1 1 1 1 1 - - Printout level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 5 5 5 5 5 5 5 5 5 5 1 12 - - Binary Output level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 1 9 - - Reach/reservoir-id NEXITS Unit systems Print-file nos Lake- BinaryOutfileNos - IUNITS OUNITS English Metric flag English Metric - SPILLWAY 1 1 1 1 0 0 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HYDR - - VCONFG AUX1FG AUX2FG AUX3FG ODFV-flags for ODGT-flags for FUNCT-flags for - each poss. exit poss. exit each poss. exit - 0 1 1 1 4 0 0 0 0 0 0 0 0 0 1 1 1 1 1 - - MILES FT FT IN - DSN FTBN LEN DELTH STCOR KS DB50 - 00 3 0.25 30. 0.00 .5 1.000E-02 - - Values of irrigation withdrawal parameters - IREXIT IRMINV (ac.ft) - 0.00 0.00 - - (acre-ft) CAT Init value of COLIND for each poss exit Init value of OUTDGT for each poss exit (ft3/s) - VOL - 1 2 3 4 5 1 2 3 4 5 - 0.0 4.0 4.00 4.00 4.00 4.00 0.00 0.00 0.00 0.00 0.00 - - INITIAL TOTAL OUTFLOW RATE: 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 1 - DEP STAGE SAREA AVDEP TWID HRAD - FT FT ACRES FT FT FT - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 2 - AVVEL AVSECT - FT/SEC FT2 - 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 3 - USTAR TAU - FT/SEC LB/FT2 - 0.000E+00 0.000E+00 - - FINISHED PROCESSING INPUT FOR SECTION HYDR - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION ADCALC - - CRRAT VOL - (acre-ft) - 1.50 0.00 - - FINISHED PROCESSING INPUT FOR SECTION ADCALC - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION CONS - - NCONS - 1 - - Atmospheric Deposition Flags - CONS1 CONS2 CONS3 CONS4 CONS5 CONS6 CONS7 CONS8 CONS9 CONS10 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units fact id - ALKALINITY 1000. MG/L 35.31 KG - - FINISHED PROCESSING INPUT FOR SECTION CONS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HTRCH - - BEDFLG TGFLG TSTOP - 0 2 55 - - ELEV ELDAT CFSAEX KATRAD KCOND KEVAP - (ft) (ft) - 450. 100. .95 9.37 6.12 2.24 - - SHADFG TOPFL VEGFL NSSP LATDEG LONDEG LONSTD - (deg) (deg) (deg) - 0.00 41.0 42.0 0.00 40.0 -90.0 -90.0 - - TW AIRTMP - (deg F) (deg F) - 60. 40. - - FINISHED PROCESSING INPUT FOR SECTION HTRCH - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SEDTRN - - SNDFG - 3 - - BEDWID BEDWRN POR - (ft) (ft) - 1.33 3. 0.500 - - SAND PARAMETERS - - D W RHO KSAND EXPSND - (in) (in/sec) - .014 2.5 2.65 1.5 1.2 - - SILT PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .00063 .0066 2.2 1.E-10 500. .5 - - CLAY PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .000055 .000034 2.0 1.E-10 500. .75 - - Suspended sed concs (mg/l) - SSED(1) SSED(2) SSED(3) - (mg/l) (mg/l) (mg/l) - 5. 20. 30. - - Init bed Initial fraction of each size - thickness of sediment in the bed - (ft) Sand Silt Clay - 2. .8 .1 .1 - - FINISHED PROCESSING INPUT FOR SECTION SEDTRN - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION GQUAL - - NGQUAL <----Flags indicating sources of input data------------> Latitude - TEMPFG PHFLAG ROXFG CLDFG SDFG PHYTFG (Degrees) - 1 1 1 2 1 1 1 42 - - Atmospheric Deposition Flags - GQUAL1 GQUAL2 GQUAL3 GQUAL4 GQUAL5 GQUAL6 GQUAL7 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units(/l) fact id - PESTICIDE B4 10. UG 1.E6 G - - <-----------Degradation process flags -----------------> Sediment - Hydrol Oxid Photol Volatil Biodeg General assoc - 1 1 1 1 1 1 1 - - <-Flags indicating whether qual is a daughter through--> Source of - Hydrol Oxid Photol Volatil Biodeg General biomass data - 0 0 0 0 0 0 2 - - KA KB KN THHYD - (/M-sec) (/M-sec) (/sec) - .001 .01 .001 1.03 - - KOX THOX - (/M.sec) - .1 1.03 - - Items 1 thru 18 below are molar absorption coefficients, for each of the 18 wavelengths (l/mole.cm). - Item 19 is the quantum yield (mole/Einstein). - Item 20 is the temperature correction parameter (theta). - 848. 544. 330. 195. 120. 68. 41. 23. 13. 7. 4. 1. .1 - 0.00 0.00 0.00 0.00 0.00 .3 1.1 - - CFGAS - .001 - - BIOCON THBIO BIO - (1/mg/day) (mg/l) - .01 1.07 10. - - FSTDEC THFST - (/day) - .2 1.07 - - Decay rate (/day) & temp correction coeff. for qual on sediment: - <----Suspended-----><-----Bed----------> - Rate Theta Rate Theta - 0.00 1.07 .002 1.07 - - Partition coefficients (l/mg) for: - <--------Suspended-----------><-------------Bed------------> - Sand Silt Clay Sand Silt Clay - .0001 .001 .001 1.E-10 1.E-10 1.E-10 - - Adsorption/desorption rate parameters (/day) for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 150. 150. 150. 1000. 1000. 1000. - - Adsorption/desorption temp correction parameters for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 1.07 1.07 1.07 1.07 1.07 1.07 - - Initial concentrations on sediment (concu/mg): - <---------Suspended-----------><-------------Bed-----------> - Sand Silt Clay Sand Silt Clay - .001 .01 .01 0. 0. 0. - - TWAT PHVAL ROC CLD SDCNC PHY - (deg F) (mole/l) (tenths) (mg/l) (mg/l) - 60.0 7.00 1.E-5 0.00 0.00 0.00 - - Values of base absorbance coeff (/cm) for each of the 18 light wavelengths: - .008 .009 .010 .011 .011 .011 .012 .013 .015 .016 .017 .018 .019 - .020 .021 .022 .024 .024 - - Values of sediment absorbance coefficient (l/mg.cm) for each of the 18 light wavelengths: - .001 .001 .001 .001 .001 .001 .001 .001 .002 .002 .002 .002 .002 - .002 .002 .002 .002 .002 - - Values of the phytoplankton absorbance coefficient (l/mg.cm), for each of the 18 light wavelengths: - .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 - .0007 .0007 .0007 .0007 .0007 - - Values of light extinction efficiency of cloud cover, for each of the 18 light wavelengths: - .10 .10 .10 .15 .15 .15 .15 .17 .17 .17 .17 .18 .19 - .20 .21 .21 .21 .21 - - REAMFG, DOPFG - 1 0 - - REAKT TCGINV - (/ft) - 8.000E-02 1.05 - - FINISHED PROCESSING INPUT FOR SECTION GQUAL - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - - BENF - 0 - - SCRVEL SCRMUL - (ft/sec) - 3. 2.00 - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION OXRX - - KBOD20 TCBOD KODSET SUPSAT - ( /hr) (ft/hr) - .1 1.08 8. 1.15 - - DOX BOD SATDO - (mg/l) (mg/l) (mg/l) - 8. 100. 10.0 - - FINISHED PROCESSING INPUT FOR SECTION OXRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION NUTRX - - TAMFG NO2FG PO4FG AMVFG DENFG ADNHFG ADPOFG PHFLAG - 1 1 1 1 1 0 0 2 - - Atmospheric Deposition Flags - NO3 NH3 PO4 - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - CVBO CVBPC CVBPN BPCNTC - (mg/mg)(mols/mol)(mols/mol) (percent) - 1.98 106. 16.0 49.0 - - BRTAM(1) BRTAM(2) BRPO4(1) BRPO4(2) ANAER - (mg/m2.hr)(mg/m2.hr)(mg/m2.hr)(mg/m2.hr) (mg/l) - 11.0 33.0 1.1 2.2 0.0005 - - KTAM20 KNO220 TCNIT KNO320 TCDEN DENOXT - (/hr) (/hr) (/hr) (mg/l) - .002 .004 1.07 .001 1.04 0.2 - - EXPNVG EXPNVL - .50 0.6667 - - NO3 TAM NO2 PO4 PHVAL - (mg/l) (mg/l) (mg/l) (mg/l) (ph) - 40. 10. 1. 50. 7.0 - - FINISHED PROCESSING INPUT FOR SECTION NUTRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PLANK - - PHYFG ZOOFG BALFG SDLTFG AMRFG DECFG NSFG ZFOOD BNPFG - 1 1 1 1 1 0 1 2 0 - - Atmospheric Deposition Flags - ORN ORP ORC - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - RATCLP NONREF LITSED ALNPR EXTB MALGR PARADF - (/ft) (/hr) - 0.600 0.500 0.00 1.00 4.5 0.300 1.00 - - CMMLT CMMN CMMNP CMMP TALGRH TALGRL TALGRM - (ly/min) (mg/l) (mg/l) (mg/l) (deg F) (deg F) (deg F) - 3.300E-02 4.500E-02 2.840E-02 1.500E-02 95.0 43.0 77.0 - - ALR20 ALDH ALDL OXALD NALDH PALDH - (/hr) (/hr) (/hr) (/hr) (mg/l) (mg/l) - 4.000E-03 1.000E-02 1.000E-03 3.000E-02 0.00 0.00 - - NMINGR PMINGR CMINGR LMINGR NMINC - mg/l mg/l mg/l ly/min mg/l - 1.000E-03 1.000E-03 1.000E-03 1.000E-03 1.000E-03 - - SEED MXSTAY OREF CLALDH PHYSET REFSET - (mg/l) (mg/l) (ft3/s) (ug/l) (ft/hr) (ft/hr) - .1 .1 1.000E-04 50.0 .5 .5 - - MZOEAT ZFIL20 ZRES20 ZD OXZD - (mg/mg.hr) (l/mg.hr) (/hr) (/hr) (/hr) - 5.500E-02 .2 1.500E-03 1.000E-04 3.000E-02 - - TCZFIL TCZRES ZEXDEL ZOMASS - (mg/org) - 1.17 1.07 0.700 3.000E-04 - - MBAL CFBALR CFBALG MINBAL CAMPR FRAVL NMAXFX - (mg/m2) (mg/m2) (mg/l) (mg/l) - 600. 1.00 1.00 1.000E-04 1.000E-03 0.00 10.0 - - FRRIF CMMV RIFCQ1 RIFCQ2 RIFCQ3 - (ft/s) (cfs) (cfs) (cfs) - 1.00 1.00 0.00 0.00 0.00 - - RIFVEL1 RIFVEL2 RIFVEL3 RIFVEL4 RIFDEP1 RIFDEP2 RIFDEP3 RIFDEP4 - - 1.00 1.00 1.00 1.00 1.00 1.00 1.00 1.00 - - PHYTO ZOO BENAL ORN ORP ORC - (mg/l) (org/l) (mg/m2) (mg/l) (mg/l) (mg/l) - 40. 200. 5. 20. 20. 20. - - FINISHED PROCESSING INPUT FOR SECTION PLANK - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PHCARB - - PHCNT ALKCON - 50 1 - - CFCINV BRCO2(1) BRCO2(2) - (mg/m2.hr)(mg/m2.hr) - 0.913 62.0 62.0 - - TIC CO2 PH - (mg/l) (mg/l) - 20. 5. 8.5 - - FINISHED PROCESSING INPUT FOR SECTION PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING RCHRES NO. 3 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING RCHRES NO: 4 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - HYDRFG ADFG CONSFG HTFG SEDFG GQUALFG OXFG NUTFG PLKFG PHFG - 1 1 1 1 1 1 1 1 1 1 - - Printout level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 5 5 5 5 5 5 5 5 5 5 1 12 - - Binary Output level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 1 9 - - Reach/reservoir-id NEXITS Unit systems Print-file nos Lake- BinaryOutfileNos - IUNITS OUNITS English Metric flag English Metric - UPPER KITTLE CREEK 1 1 1 1 0 0 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HYDR - - VCONFG AUX1FG AUX2FG AUX3FG ODFV-flags for ODGT-flags for FUNCT-flags for - each poss. exit poss. exit each poss. exit - 0 1 1 1 4 0 0 0 0 0 0 0 0 0 1 1 1 1 1 - - MILES FT FT IN - DSN FTBN LEN DELTH STCOR KS DB50 - 00 4 2.0 40. 0.00 .5 1.000E-02 - - Values of irrigation withdrawal parameters - IREXIT IRMINV (ac.ft) - 0.00 0.00 - - (acre-ft) CAT Init value of COLIND for each poss exit Init value of OUTDGT for each poss exit (ft3/s) - VOL - 1 2 3 4 5 1 2 3 4 5 - 0.0 4.0 4.00 4.00 4.00 4.00 0.00 0.00 0.00 0.00 0.00 - - INITIAL TOTAL OUTFLOW RATE: 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 1 - DEP STAGE SAREA AVDEP TWID HRAD - FT FT ACRES FT FT FT - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 2 - AVVEL AVSECT - FT/SEC FT2 - 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 3 - USTAR TAU - FT/SEC LB/FT2 - 0.000E+00 0.000E+00 - - FINISHED PROCESSING INPUT FOR SECTION HYDR - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION ADCALC - - CRRAT VOL - (acre-ft) - 1.50 0.00 - - FINISHED PROCESSING INPUT FOR SECTION ADCALC - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION CONS - - NCONS - 1 - - Atmospheric Deposition Flags - CONS1 CONS2 CONS3 CONS4 CONS5 CONS6 CONS7 CONS8 CONS9 CONS10 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units fact id - ALKALINITY 1000. MG/L 35.31 KG - - FINISHED PROCESSING INPUT FOR SECTION CONS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HTRCH - - BEDFLG TGFLG TSTOP - 0 2 55 - - ELEV ELDAT CFSAEX KATRAD KCOND KEVAP - (ft) (ft) - 450. 100. .95 9.37 6.12 2.24 - - SHADFG TOPFL VEGFL NSSP LATDEG LONDEG LONSTD - (deg) (deg) (deg) - 0.00 41.0 42.0 0.00 40.0 -90.0 -90.0 - - TW AIRTMP - (deg F) (deg F) - 60. 40. - - FINISHED PROCESSING INPUT FOR SECTION HTRCH - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SEDTRN - - SNDFG - 3 - - BEDWID BEDWRN POR - (ft) (ft) - 2.0 2. 0.500 - - SAND PARAMETERS - - D W RHO KSAND EXPSND - (in) (in/sec) - .014 2.5 2.65 1.5 1.2 - - SILT PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .00063 .0066 2.2 .2 .4 .5 - - CLAY PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .000055 .000034 2.0 .15 .3 .75 - - Suspended sed concs (mg/l) - SSED(1) SSED(2) SSED(3) - (mg/l) (mg/l) (mg/l) - 5. 20. 30. - - Init bed Initial fraction of each size - thickness of sediment in the bed - (ft) Sand Silt Clay - 1. .8 .1 .1 - - FINISHED PROCESSING INPUT FOR SECTION SEDTRN - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION GQUAL - - NGQUAL <----Flags indicating sources of input data------------> Latitude - TEMPFG PHFLAG ROXFG CLDFG SDFG PHYTFG (Degrees) - 1 1 1 2 1 1 1 42 - - Atmospheric Deposition Flags - GQUAL1 GQUAL2 GQUAL3 GQUAL4 GQUAL5 GQUAL6 GQUAL7 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units(/l) fact id - PESTICIDE B4 10. UG 1.E6 G - - <-----------Degradation process flags -----------------> Sediment - Hydrol Oxid Photol Volatil Biodeg General assoc - 1 1 1 1 1 1 1 - - <-Flags indicating whether qual is a daughter through--> Source of - Hydrol Oxid Photol Volatil Biodeg General biomass data - 0 0 0 0 0 0 2 - - KA KB KN THHYD - (/M-sec) (/M-sec) (/sec) - .001 .01 .001 1.03 - - KOX THOX - (/M.sec) - .1 1.03 - - Items 1 thru 18 below are molar absorption coefficients, for each of the 18 wavelengths (l/mole.cm). - Item 19 is the quantum yield (mole/Einstein). - Item 20 is the temperature correction parameter (theta). - 848. 544. 330. 195. 120. 68. 41. 23. 13. 7. 4. 1. .1 - 0.00 0.00 0.00 0.00 0.00 .3 1.1 - - CFGAS - .001 - - BIOCON THBIO BIO - (1/mg/day) (mg/l) - .01 1.07 10. - - FSTDEC THFST - (/day) - .2 1.07 - - Decay rate (/day) & temp correction coeff. for qual on sediment: - <----Suspended-----><-----Bed----------> - Rate Theta Rate Theta - 0.00 1.07 .002 1.07 - - Partition coefficients (l/mg) for: - <--------Suspended-----------><-------------Bed------------> - Sand Silt Clay Sand Silt Clay - .0001 .001 .001 .0001 .001 .001 - - Adsorption/desorption rate parameters (/day) for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 150. 150. 150. .25 .25 .25 - - Adsorption/desorption temp correction parameters for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 1.07 1.07 1.07 1.07 1.07 1.07 - - Initial concentrations on sediment (concu/mg): - <---------Suspended-----------><-------------Bed-----------> - Sand Silt Clay Sand Silt Clay - .001 .01 .01 .001 .01 .01 - - TWAT PHVAL ROC CLD SDCNC PHY - (deg F) (mole/l) (tenths) (mg/l) (mg/l) - 60.0 7.00 1.E-5 0.00 0.00 0.00 - - Values of base absorbance coeff (/cm) for each of the 18 light wavelengths: - .008 .009 .010 .011 .011 .011 .012 .013 .015 .016 .017 .018 .019 - .020 .021 .022 .024 .024 - - Values of sediment absorbance coefficient (l/mg.cm) for each of the 18 light wavelengths: - .001 .001 .001 .001 .001 .001 .001 .001 .002 .002 .002 .002 .002 - .002 .002 .002 .002 .002 - - Values of the phytoplankton absorbance coefficient (l/mg.cm), for each of the 18 light wavelengths: - .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 - .0007 .0007 .0007 .0007 .0007 - - Values of light extinction efficiency of cloud cover, for each of the 18 light wavelengths: - .10 .10 .10 .15 .15 .15 .15 .17 .17 .17 .17 .18 .19 - .20 .21 .21 .21 .21 - - REAMFG, DOPFG - 3 0 - - TCGINV REAK EXPRED EXPREV - (/hr) - 1.05 2.0 -1.1 1.1 - - FINISHED PROCESSING INPUT FOR SECTION GQUAL - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - - BENF - 1 - - SCRVEL SCRMUL - (ft/sec) - 3. 2.00 - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION OXRX - - BENOD TCBEN EXPOD BRBOD(1) BRBOD(2) EXPREL - (mg/m2.hr) (mg/m2.hr)(mg/m2.hr) - 10. 1.1 1.2 20. 25. 1.3 - - KBOD20 TCBOD KODSET SUPSAT - ( /hr) (ft/hr) - .1 1.08 8. 1.15 - - DOX BOD SATDO - (mg/l) (mg/l) (mg/l) - 8. 100. 10.0 - - FINISHED PROCESSING INPUT FOR SECTION OXRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION NUTRX - - TAMFG NO2FG PO4FG AMVFG DENFG ADNHFG ADPOFG PHFLAG - 1 1 1 1 1 0 0 2 - - Atmospheric Deposition Flags - NO3 NH3 PO4 - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - CVBO CVBPC CVBPN BPCNTC - (mg/mg)(mols/mol)(mols/mol) (percent) - 1.98 106. 16.0 49.0 - - BRTAM(1) BRTAM(2) BRPO4(1) BRPO4(2) ANAER - (mg/m2.hr)(mg/m2.hr)(mg/m2.hr)(mg/m2.hr) (mg/l) - 11.0 33.0 1.1 2.2 0.0005 - - KTAM20 KNO220 TCNIT KNO320 TCDEN DENOXT - (/hr) (/hr) (/hr) (mg/l) - .002 .004 1.07 .001 1.04 0.2 - - EXPNVG EXPNVL - .50 0.6667 - - NO3 TAM NO2 PO4 PHVAL - (mg/l) (mg/l) (mg/l) (mg/l) (ph) - 40. 10. 1. 50. 7.0 - - FINISHED PROCESSING INPUT FOR SECTION NUTRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PLANK - - PHYFG ZOOFG BALFG SDLTFG AMRFG DECFG NSFG ZFOOD BNPFG - 1 1 1 1 1 0 1 2 0 - - Atmospheric Deposition Flags - ORN ORP ORC - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - RATCLP NONREF LITSED ALNPR EXTB MALGR PARADF - (/ft) (/hr) - 0.600 0.500 0.00 1.00 4.5 0.300 1.00 - - CMMLT CMMN CMMNP CMMP TALGRH TALGRL TALGRM - (ly/min) (mg/l) (mg/l) (mg/l) (deg F) (deg F) (deg F) - 3.300E-02 4.500E-02 2.840E-02 1.500E-02 95.0 43.0 77.0 - - ALR20 ALDH ALDL OXALD NALDH PALDH - (/hr) (/hr) (/hr) (/hr) (mg/l) (mg/l) - 4.000E-03 1.000E-02 1.000E-03 3.000E-02 0.00 0.00 - - NMINGR PMINGR CMINGR LMINGR NMINC - mg/l mg/l mg/l ly/min mg/l - 1.000E-03 1.000E-03 1.000E-03 1.000E-03 1.000E-03 - - SEED MXSTAY OREF CLALDH PHYSET REFSET - (mg/l) (mg/l) (ft3/s) (ug/l) (ft/hr) (ft/hr) - .1 .1 1.000E-04 50.0 .5 .5 - - MZOEAT ZFIL20 ZRES20 ZD OXZD - (mg/mg.hr) (l/mg.hr) (/hr) (/hr) (/hr) - 5.500E-02 .2 1.500E-03 1.000E-04 3.000E-02 - - TCZFIL TCZRES ZEXDEL ZOMASS - (mg/org) - 1.17 1.07 0.700 3.000E-04 - - MBAL CFBALR CFBALG MINBAL CAMPR FRAVL NMAXFX - (mg/m2) (mg/m2) (mg/l) (mg/l) - 600. 1.00 1.00 1.000E-04 1.000E-03 0.00 10.0 - - FRRIF CMMV RIFCQ1 RIFCQ2 RIFCQ3 - (ft/s) (cfs) (cfs) (cfs) - 1.00 1.00 0.00 0.00 0.00 - - RIFVEL1 RIFVEL2 RIFVEL3 RIFVEL4 RIFDEP1 RIFDEP2 RIFDEP3 RIFDEP4 - - 1.00 1.00 1.00 1.00 1.00 1.00 1.00 1.00 - - PHYTO ZOO BENAL ORN ORP ORC - (mg/l) (org/l) (mg/m2) (mg/l) (mg/l) (mg/l) - 40. 200. 5. 20. 20. 20. - - FINISHED PROCESSING INPUT FOR SECTION PLANK - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PHCARB - - PHCNT ALKCON - 50 1 - - CFCINV BRCO2(1) BRCO2(2) - (mg/m2.hr)(mg/m2.hr) - 0.913 62.0 62.0 - - TIC CO2 PH - (mg/l) (mg/l) - 20. 5. 8.5 - - FINISHED PROCESSING INPUT FOR SECTION PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING RCHRES NO. 4 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING RCHRES NO: 5 TIME STEP(DELT): 60 MINS - - PROCESSING GENERAL INPUT - - HYDRFG ADFG CONSFG HTFG SEDFG GQUALFG OXFG NUTFG PLKFG PHFG - 1 1 1 1 1 1 1 1 1 1 - - Printout level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 1 12 - - Binary Output level flags Print-ivl Print-yrend - HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYREND - 4 4 4 4 4 4 4 4 4 4 1 9 - - Reach/reservoir-id NEXITS Unit systems Print-file nos Lake- BinaryOutfileNos - IUNITS OUNITS English Metric flag English Metric - LOWER KITTLE CREEK 1 1 1 1 0 0 0 0 - - FINISHED PROCESSING GENERAL INPUT - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HYDR - - VCONFG AUX1FG AUX2FG AUX3FG ODFV-flags for ODGT-flags for FUNCT-flags for - each poss. exit poss. exit each poss. exit - 0 1 1 1 4 0 0 0 0 0 0 0 0 0 1 1 1 1 1 - - MILES FT FT IN - DSN FTBN LEN DELTH STCOR KS DB50 - 00 5 3.0 40. 0.00 .5 1.000E-02 - - Values of irrigation withdrawal parameters - IREXIT IRMINV (ac.ft) - 0.00 0.00 - - (acre-ft) CAT Init value of COLIND for each poss exit Init value of OUTDGT for each poss exit (ft3/s) - VOL - 1 2 3 4 5 1 2 3 4 5 - 0.0 4.0 4.00 4.00 4.00 4.00 0.00 0.00 0.00 0.00 0.00 - - INITIAL TOTAL OUTFLOW RATE: 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 1 - DEP STAGE SAREA AVDEP TWID HRAD - FT FT ACRES FT FT FT - 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 2 - AVVEL AVSECT - FT/SEC FT2 - 0.000E+00 0.000E+00 - - AUXILIARY STATE VARIABLES - GROUP 3 - USTAR TAU - FT/SEC LB/FT2 - 0.000E+00 0.000E+00 - - FINISHED PROCESSING INPUT FOR SECTION HYDR - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION ADCALC - - CRRAT VOL - (acre-ft) - 1.50 0.00 - - FINISHED PROCESSING INPUT FOR SECTION ADCALC - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION CONS - - NCONS - 1 - - Atmospheric Deposition Flags - CONS1 CONS2 CONS3 CONS4 CONS5 CONS6 CONS7 CONS8 CONS9 CONS10 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units fact id - ALKALINITY 1000. MG/L 35.31 KG - - FINISHED PROCESSING INPUT FOR SECTION CONS - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION HTRCH - - BEDFLG TGFLG TSTOP - 0 2 55 - - ELEV ELDAT CFSAEX KATRAD KCOND KEVAP - (ft) (ft) - 450. 100. .95 9.37 6.12 2.24 - - SHADFG TOPFL VEGFL NSSP LATDEG LONDEG LONSTD - (deg) (deg) (deg) - 0.00 41.0 42.0 0.00 40.0 -90.0 -90.0 - - TW AIRTMP - (deg F) (deg F) - 60. 40. - - FINISHED PROCESSING INPUT FOR SECTION HTRCH - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION SEDTRN - - SNDFG - 3 - - BEDWID BEDWRN POR - (ft) (ft) - 2.66 2. 0.500 - - SAND PARAMETERS - - D W RHO KSAND EXPSND - (in) (in/sec) - .014 2.5 2.65 1.5 1.2 - - SILT PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .00063 .0066 2.2 .2 .4 .5 - - CLAY PARAMETERS - - D W RHO TAUCD TAUCS M - (in) (in/sec) (gm/cm3) (lb/ft2) (lb/ft2)(lb/ft2.d) - .000055 .000034 2.0 .15 .3 .75 - - Suspended sed concs (mg/l) - SSED(1) SSED(2) SSED(3) - (mg/l) (mg/l) (mg/l) - 5. 20. 30. - - Init bed Initial fraction of each size - thickness of sediment in the bed - (ft) Sand Silt Clay - 1. .8 .1 .1 - - FINISHED PROCESSING INPUT FOR SECTION SEDTRN - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION GQUAL - - NGQUAL <----Flags indicating sources of input data------------> Latitude - TEMPFG PHFLAG ROXFG CLDFG SDFG PHYTFG (Degrees) - 1 1 1 2 1 1 1 42 - - Atmospheric Deposition Flags - GQUAL1 GQUAL2 GQUAL3 GQUAL4 GQUAL5 GQUAL6 GQUAL7 - FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON FLX CON - 0 0 0 0 0 0 0 0 0 0 0 0 0 0 - - Substance id Concentration Conv Qty- - Init-val Units(/l) fact id - PESTICIDE B4 10. UG 1.E6 G - - <-----------Degradation process flags -----------------> Sediment - Hydrol Oxid Photol Volatil Biodeg General assoc - 1 1 1 1 1 1 1 - - <-Flags indicating whether qual is a daughter through--> Source of - Hydrol Oxid Photol Volatil Biodeg General biomass data - 0 0 0 0 0 0 2 - - KA KB KN THHYD - (/M-sec) (/M-sec) (/sec) - .001 .01 .001 1.03 - - KOX THOX - (/M.sec) - .1 1.03 - - Items 1 thru 18 below are molar absorption coefficients, for each of the 18 wavelengths (l/mole.cm). - Item 19 is the quantum yield (mole/Einstein). - Item 20 is the temperature correction parameter (theta). - 848. 544. 330. 195. 120. 68. 41. 23. 13. 7. 4. 1. .1 - 0.00 0.00 0.00 0.00 0.00 .3 1.1 - - CFGAS - .001 - - BIOCON THBIO BIO - (1/mg/day) (mg/l) - .01 1.07 10. - - FSTDEC THFST - (/day) - .2 1.07 - - Decay rate (/day) & temp correction coeff. for qual on sediment: - <----Suspended-----><-----Bed----------> - Rate Theta Rate Theta - 0.00 1.07 .002 1.07 - - Partition coefficients (l/mg) for: - <--------Suspended-----------><-------------Bed------------> - Sand Silt Clay Sand Silt Clay - .0001 .001 .001 .0001 .001 .001 - - Adsorption/desorption rate parameters (/day) for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 150. 150. 150. .25 .25 .25 - - Adsorption/desorption temp correction parameters for: - <--------Suspended-----------><------------Bed------------> - Sand Silt Clay Sand Silt Clay - 1.07 1.07 1.07 1.07 1.07 1.07 - - Initial concentrations on sediment (concu/mg): - <---------Suspended-----------><-------------Bed-----------> - Sand Silt Clay Sand Silt Clay - .001 .01 .01 .001 .01 .01 - - TWAT PHVAL ROC CLD SDCNC PHY - (deg F) (mole/l) (tenths) (mg/l) (mg/l) - 60.0 7.00 1.E-5 0.00 0.00 0.00 - - Values of base absorbance coeff (/cm) for each of the 18 light wavelengths: - .008 .009 .010 .011 .011 .011 .012 .013 .015 .016 .017 .018 .019 - .020 .021 .022 .024 .024 - - Values of sediment absorbance coefficient (l/mg.cm) for each of the 18 light wavelengths: - .001 .001 .001 .001 .001 .001 .001 .001 .002 .002 .002 .002 .002 - .002 .002 .002 .002 .002 - - Values of the phytoplankton absorbance coefficient (l/mg.cm), for each of the 18 light wavelengths: - .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 .0007 - .0007 .0007 .0007 .0007 .0007 - - Values of light extinction efficiency of cloud cover, for each of the 18 light wavelengths: - .10 .10 .10 .15 .15 .15 .15 .17 .17 .17 .17 .18 .19 - .20 .21 .21 .21 .21 - - REAMFG, DOPFG - 2 0 - - TCGINV - 1.05 - - FINISHED PROCESSING INPUT FOR SECTION GQUAL - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - - BENF - 1 - - SCRVEL SCRMUL - (ft/sec) - 3. 2.00 - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION OXRX - - BENOD TCBEN EXPOD BRBOD(1) BRBOD(2) EXPREL - (mg/m2.hr) (mg/m2.hr)(mg/m2.hr) - 10. 1.1 1.2 20. 25. 1.3 - - KBOD20 TCBOD KODSET SUPSAT - ( /hr) (ft/hr) - .1 1.08 8. 1.15 - - DOX BOD SATDO - (mg/l) (mg/l) (mg/l) - 8. 100. 10.0 - - FINISHED PROCESSING INPUT FOR SECTION OXRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION NUTRX - - TAMFG NO2FG PO4FG AMVFG DENFG ADNHFG ADPOFG PHFLAG - 1 1 1 1 1 0 0 2 - - Atmospheric Deposition Flags - NO3 NH3 PO4 - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - CVBO CVBPC CVBPN BPCNTC - (mg/mg)(mols/mol)(mols/mol) (percent) - 1.98 106. 16.0 49.0 - - BRTAM(1) BRTAM(2) BRPO4(1) BRPO4(2) ANAER - (mg/m2.hr)(mg/m2.hr)(mg/m2.hr)(mg/m2.hr) (mg/l) - 11.0 33.0 1.1 2.2 0.0005 - - KTAM20 KNO220 TCNIT KNO320 TCDEN DENOXT - (/hr) (/hr) (/hr) (mg/l) - .002 .004 1.07 .001 1.04 0.2 - - EXPNVG EXPNVL - .50 0.6667 - - NO3 TAM NO2 PO4 PHVAL - (mg/l) (mg/l) (mg/l) (mg/l) (ph) - 40. 10. 1. 50. 7.0 - - FINISHED PROCESSING INPUT FOR SECTION NUTRX - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PLANK - - PHYFG ZOOFG BALFG SDLTFG AMRFG DECFG NSFG ZFOOD BNPFG - 1 1 1 1 1 0 1 2 0 - - Atmospheric Deposition Flags - ORN ORP ORC - FLX CON FLX CON FLX CON - 0 0 0 0 0 0 - - RATCLP NONREF LITSED ALNPR EXTB MALGR PARADF - (/ft) (/hr) - 0.600 0.500 0.00 1.00 4.5 0.300 1.00 - - CMMLT CMMN CMMNP CMMP TALGRH TALGRL TALGRM - (ly/min) (mg/l) (mg/l) (mg/l) (deg F) (deg F) (deg F) - 3.300E-02 4.500E-02 2.840E-02 1.500E-02 95.0 43.0 77.0 - - ALR20 ALDH ALDL OXALD NALDH PALDH - (/hr) (/hr) (/hr) (/hr) (mg/l) (mg/l) - 4.000E-03 1.000E-02 1.000E-03 3.000E-02 0.00 0.00 - - NMINGR PMINGR CMINGR LMINGR NMINC - mg/l mg/l mg/l ly/min mg/l - 1.000E-03 1.000E-03 1.000E-03 1.000E-03 1.000E-03 - - SEED MXSTAY OREF CLALDH PHYSET REFSET - (mg/l) (mg/l) (ft3/s) (ug/l) (ft/hr) (ft/hr) - .1 .1 1.000E-04 50.0 .5 .5 - - MZOEAT ZFIL20 ZRES20 ZD OXZD - (mg/mg.hr) (l/mg.hr) (/hr) (/hr) (/hr) - 5.500E-02 .2 1.500E-03 1.000E-04 3.000E-02 - - TCZFIL TCZRES ZEXDEL ZOMASS - (mg/org) - 1.17 1.07 0.700 3.000E-04 - - MBAL CFBALR CFBALG MINBAL CAMPR FRAVL NMAXFX - (mg/m2) (mg/m2) (mg/l) (mg/l) - 600. 1.00 1.00 1.000E-04 1.000E-03 0.00 10.0 - - FRRIF CMMV RIFCQ1 RIFCQ2 RIFCQ3 - (ft/s) (cfs) (cfs) (cfs) - 1.00 1.00 0.00 0.00 0.00 - - RIFVEL1 RIFVEL2 RIFVEL3 RIFVEL4 RIFDEP1 RIFDEP2 RIFDEP3 RIFDEP4 - - 1.00 1.00 1.00 1.00 1.00 1.00 1.00 1.00 - - PHYTO ZOO BENAL ORN ORP ORC - (mg/l) (org/l) (mg/m2) (mg/l) (mg/l) (mg/l) - 40. 200. 5. 20. 20. 20. - - FINISHED PROCESSING INPUT FOR SECTION PLANK - ------------------------------------------------------------------------------------------------------------------------------------ - - PROCESSING INPUT FOR SECTION PHCARB - - PHCNT ALKCON - 50 1 - - CFCINV BRCO2(1) BRCO2(2) - (mg/m2.hr)(mg/m2.hr) - 0.913 62.0 62.0 - - TIC CO2 PH - (mg/l) (mg/l) - 20. 5. 8.5 - - FINISHED PROCESSING INPUT FOR SECTION PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING INPUT FOR SECTIONS OXRX, NUTRX, PLANK, AND PHCARB - ------------------------------------------------------------------------------------------------------------------------------------ - - FINISHED PROCESSING RCHRES NO. 5 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - FINISHED PROCESSING RCHRES BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING DISPLY BLOCK - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING DISPLY OPERATION NO. 5 TIME INTERVAL 60 MINS - - Title of display Transform Data for short-span display Data for long-span display - code PIVL Digits File-no. PYRFG Digits File-no. PYREND - WATER TEMP,MEIER POND (DEGF) AVER 0 4 1 2 66 12 - - Convert DegC to F Display negative data - A B THRSH1 THRSH2 - 1.00 0.00 0.00 0.00 - - FINISHED PROCESSING DISPLAY OPERATION NO. 5 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING DISPLY OPERATION NO. 1 TIME INTERVAL 60 MINS - - Title of display Transform Data for short-span display Data for long-span display - code PIVL Digits File-no. PYRFG Digits File-no. PYREND - O2 CONC, MEIER POND (mg/l) AVER 0 4 1 2 66 12 - - Convert DegC to F Display negative data - A B THRSH1 THRSH2 - 1.00 0.00 0.00 0.00 - - FINISHED PROCESSING DISPLAY OPERATION NO. 1 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING DISPLY OPERATION NO. 2 TIME INTERVAL 60 MINS - - Title of display Transform Data for short-span display Data for long-span display - code PIVL Digits File-no. PYRFG Digits File-no. PYREND - PEST SED CONC, POND (mg/kg) AVER 0 4 1 2 66 12 - - Convert DegC to F Display negative data - A B THRSH1 THRSH2 - 1.00 0.00 0.00 0.00 - - FINISHED PROCESSING DISPLAY OPERATION NO. 2 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING DISPLY OPERATION NO. 3 TIME INTERVAL 60 MINS - - Title of display Transform Data for short-span display Data for long-span display - code PIVL Digits File-no. PYRFG Digits File-no. PYREND - O2 CONC,LOWER KITTLE C(mg/l) AVER 0 4 1 2 66 12 - - Convert DegC to F Display negative data - A B THRSH1 THRSH2 - 1.00 0.00 0.00 0.00 - - FINISHED PROCESSING DISPLAY OPERATION NO. 3 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING DISPLY OPERATION NO. 4 TIME INTERVAL 60 MINS - - Title of display Transform Data for short-span display Data for long-span display - code PIVL Digits File-no. PYRFG Digits File-no. PYREND - PEST SED CONC,L KTL C(mg/kg) AVER 0 4 1 2 66 12 - - Convert DegC to F Display negative data - A B THRSH1 THRSH2 - 1.00 0.00 0.00 0.00 - - FINISHED PROCESSING DISPLAY OPERATION NO. 4 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - FINISHED PROCESSING DISPLY BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING GENER BLOCK - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING INPUT FOR TRANSGENERATION OPERATION NO. 1 TIME INTERVAL= 60 MINS - - OPCODE NTS - 19 1 - - FINISHED PROCESSING TRANSGENERATION OPERATION NO. 1 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING INPUT FOR TRANSGENERATION OPERATION NO. 2 TIME INTERVAL= 60 MINS - - OPCODE NTS - 19 1 - - FINISHED PROCESSING TRANSGENERATION OPERATION NO. 2 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - FINISHED PROCESSING GENER BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING PLTGEN BLOCK - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING PLTGEN OPERATION NO. 2 - - PLOTFL NPT NMN LABLFG PYREND PIVL TYPEFG - 95 3 1 0 9 6 1 - - General plot title: Y-axis label: - SIMULATED VALS RELATED TO TEMP&PH,RCH 4 - - YMIN YMAX IVLIN THRESH - (ivl/in) - 0. 150. 20.-1.000E+30 - - Curve label: LINTYP INTEQ COLCOD TRAN - AVDEP FOR RCH 4 0 7 1 LAST - - Curve label: LINTYP INTEQ COLCOD TRAN - TW FOR RCH 4 0 8 2 LAST - - Curve label: LINTYP INTEQ COLCOD TRAN - PH FOR RCH 4 0 9 2 LAST - - Curve label: LINTYP INTEQ COLCOD TRAN - HTEXCH FOR RCH 4 0 10 2 - - FINISHED PROCESSING PLTGEN OPERATION NO. 2 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - PROCESSING PLTGEN OPERATION NO. 1 - - PLOTFL NPT NMN LABLFG PYREND PIVL TYPEFG - 94 0 2 0 9 24 1 - - General plot title: Y-axis label: - SIMULATED FLOWS (CFS) CFS - - YMIN YMAX IVLIN THRESH - (ivl/in) - 0. 150. 20.-1.000E+30 - - Curve label: LINTYP INTEQ COLCOD TRAN - TOTAL POND OUTFL 0 7 1 AVER - - Curve label: LINTYP INTEQ COLCOD TRAN - LOWER KITTLE CR 0 8 2 AVER - - FINISHED PROCESSING PLTGEN OPERATION NO. 1 - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - FINISHED PROCESSING PLTGEN BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - SPEC-ACTIONS BLOCK NOT FOUND - - FINISHED PROCESSING SPEC-ACTIONS BLOCK - ==================================================================================================================================== - - ==================================================================================================================================== - PROCESSING BLOCKS CONTAINING TIME SERIES LINKAGES - - INGROUP NO. 1 OSVSZ=22500 INPAD WIDTH= 6786 INTERVALS MAXROW= 73 RUNWID= 0 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION PERLND 1 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 39 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 123 120 SAME 1.000E+00 ATEMP AIRTMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL PETINP 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WINMOV 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 126 1440 SAME 1.000E+00 EXTNL DTMPG 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - PWATER PERO 1 1 5.000E+02 RCHRES 1 INFLOW IVOL 1 1 - PWTGAS POHT 1 1 6.000E+03 RCHRES 1 INFLOW IHEAT 1 1 - PWTGAS PODOXM 1 1 6.000E+03 RCHRES 1 INFLOW OXIF 1 1 - PWTGAS POCO2M 1 1 6.000E+03 RCHRES 1 INFLOW PHIF 2 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION RCHRES 1 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 39 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 123 120 SAME 1.000E+00 EXTNL GATMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL POTEV 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WIND 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 126 1440 SAME 1.000E+00 EXTNL DEWTMP 1 1 - WDM1 140 1440 SAME 1.000E+00 EXTNL COLIND 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - PERLND 1 PWATER PERO 1 1 5.000E+02 INFLOW IVOL 1 1 - PERLND 1 PWTGAS POHT 1 1 6.000E+03 INFLOW IHEAT 1 1 - PERLND 1 PWTGAS PODOXM 1 1 6.000E+03 INFLOW OXIF 1 1 - PERLND 1 PWTGAS POCO2M 1 1 6.000E+03 INFLOW PHIF 2 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - OFLOW OVOL 1 1 1.000E+00 RCHRES 2 INFLOW IVOL 1 1 - OFLOW OCON 1 1 1.000E+00 RCHRES 2 INFLOW ICON 1 1 - OFLOW OHEAT 1 1 1.000E+00 RCHRES 2 INFLOW IHEAT 1 1 - OFLOW OSED 1 1 1.000E+00 RCHRES 2 INFLOW ISED 1 1 - OFLOW OSED 1 2 1.000E+00 RCHRES 2 INFLOW ISED 2 1 - OFLOW OSED 1 3 1.000E+00 RCHRES 2 INFLOW ISED 3 1 - OFLOW ODQAL 1 1 1.000E+00 RCHRES 2 INFLOW IDQAL 1 1 - OFLOW OSQAL 1 1 1.000E+00 RCHRES 2 INFLOW ISQAL 1 1 - OFLOW OSQAL 1 2 1.000E+00 RCHRES 2 INFLOW ISQAL 2 1 - OFLOW OSQAL 1 3 1.000E+00 RCHRES 2 INFLOW ISQAL 3 1 - OFLOW OXCF2 1 1 1.000E+00 RCHRES 2 INFLOW OXIF 1 1 - OFLOW OXCF2 1 2 1.000E+00 RCHRES 2 INFLOW OXIF 2 1 - OFLOW NUCF9 1 1 1.000E+00 RCHRES 2 INFLOW NUIF1 1 1 - OFLOW NUCF9 1 2 1.000E+00 RCHRES 2 INFLOW NUIF1 2 1 - OFLOW NUCF9 1 3 1.000E+00 RCHRES 2 INFLOW NUIF1 3 1 - OFLOW NUCF9 1 4 1.000E+00 RCHRES 2 INFLOW NUIF1 4 1 - OFLOW OSNH4 1 1 1.000E+00 RCHRES 2 INFLOW NUIF2 1 1 - OFLOW OSNH4 1 2 1.000E+00 RCHRES 2 INFLOW NUIF2 2 1 - OFLOW OSNH4 1 3 1.000E+00 RCHRES 2 INFLOW NUIF2 3 1 - OFLOW OSPO4 1 1 1.000E+00 RCHRES 2 INFLOW NUIF2 1 2 - OFLOW OSPO4 1 2 1.000E+00 RCHRES 2 INFLOW NUIF2 2 2 - OFLOW OSPO4 1 3 1.000E+00 RCHRES 2 INFLOW NUIF2 3 2 - OFLOW PKCF2 1 1 1.000E+00 RCHRES 2 INFLOW PKIF 1 1 - OFLOW PKCF2 1 2 1.000E+00 RCHRES 2 INFLOW PKIF 2 1 - OFLOW PKCF2 1 3 1.000E+00 RCHRES 2 INFLOW PKIF 3 1 - OFLOW PKCF2 1 4 1.000E+00 RCHRES 2 INFLOW PKIF 4 1 - OFLOW PKCF2 1 5 1.000E+00 RCHRES 2 INFLOW PKIF 5 1 - OFLOW PHCF2 1 1 1.000E+00 RCHRES 2 INFLOW PHIF 1 1 - OFLOW PHCF2 1 2 1.000E+00 RCHRES 2 INFLOW PHIF 2 1 - OFLOW OVOL 2 1 1.000E+00 RCHRES 3 INFLOW IVOL 1 1 - OFLOW OCON 2 1 1.000E+00 RCHRES 3 INFLOW ICON 1 1 - OFLOW OHEAT 2 1 1.000E+00 RCHRES 3 INFLOW IHEAT 1 1 - OFLOW OSED 2 1 1.000E+00 RCHRES 3 INFLOW ISED 1 1 - OFLOW OSED 2 2 1.000E+00 RCHRES 3 INFLOW ISED 2 1 - OFLOW OSED 2 3 1.000E+00 RCHRES 3 INFLOW ISED 3 1 - OFLOW ODQAL 2 1 1.000E+00 RCHRES 3 INFLOW IDQAL 1 1 - OFLOW OSQAL 2 1 1.000E+00 RCHRES 3 INFLOW ISQAL 1 1 - OFLOW OSQAL 2 2 1.000E+00 RCHRES 3 INFLOW ISQAL 2 1 - OFLOW OSQAL 2 3 1.000E+00 RCHRES 3 INFLOW ISQAL 3 1 - OFLOW OXCF2 2 1 1.000E+00 RCHRES 3 INFLOW OXIF 1 1 - OFLOW OXCF2 2 2 1.000E+00 RCHRES 3 INFLOW OXIF 2 1 - OFLOW NUCF9 2 1 1.000E+00 RCHRES 3 INFLOW NUIF1 1 1 - OFLOW NUCF9 2 2 1.000E+00 RCHRES 3 INFLOW NUIF1 2 1 - OFLOW NUCF9 2 3 1.000E+00 RCHRES 3 INFLOW NUIF1 3 1 - OFLOW NUCF9 2 4 1.000E+00 RCHRES 3 INFLOW NUIF1 4 1 - OFLOW OSNH4 2 1 1.000E+00 RCHRES 3 INFLOW NUIF2 1 1 - OFLOW OSNH4 2 2 1.000E+00 RCHRES 3 INFLOW NUIF2 2 1 - OFLOW OSNH4 2 3 1.000E+00 RCHRES 3 INFLOW NUIF2 3 1 - OFLOW OSPO4 2 1 1.000E+00 RCHRES 3 INFLOW NUIF2 1 2 - OFLOW OSPO4 2 2 1.000E+00 RCHRES 3 INFLOW NUIF2 2 2 - OFLOW OSPO4 2 3 1.000E+00 RCHRES 3 INFLOW NUIF2 3 2 - OFLOW PKCF2 2 1 1.000E+00 RCHRES 3 INFLOW PKIF 1 1 - OFLOW PKCF2 2 2 1.000E+00 RCHRES 3 INFLOW PKIF 2 1 - OFLOW PKCF2 2 3 1.000E+00 RCHRES 3 INFLOW PKIF 3 1 - OFLOW PKCF2 2 4 1.000E+00 RCHRES 3 INFLOW PKIF 4 1 - OFLOW PKCF2 2 5 1.000E+00 RCHRES 3 INFLOW PKIF 5 1 - OFLOW PHCF2 2 1 1.000E+00 RCHRES 3 INFLOW PHIF 1 1 - OFLOW PHCF2 2 2 1.000E+00 RCHRES 3 INFLOW PHIF 2 1 - HTRCH TW 1 1 1.000E+00 DISPLY 5 INPUT TIMSER 1 1 - OXRX DOX 1 1 1.000E+00 DISPLY 1 INPUT TIMSER 1 1 - GQUAL RSQAL 12 1 1.000E+00 GENER 1 INPUT ONE 1 1 - SEDTRN RSED 10 1 1.000E+00 GENER 1 INPUT TWO 1 1 - HYDR ROVOL 1 1 1.210E+01 PLTGEN 1 INPUT MEAN 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION DISPLY 5 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 1 HTRCH TW 1 1 1.000E+00 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION DISPLY 1 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 1 OXRX DOX 1 1 1.000E+00 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION GENER 1 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 1 GQUAL RSQAL 12 1 1.000E+00 INPUT ONE 1 1 - RCHRES 1 SEDTRN RSED 10 1 1.000E+00 INPUT TWO 1 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - OUTPUT TIMSER 1 1 1.100E+00 DISPLY 2 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION DISPLY 2 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - GENER 1 OUTPUT TIMSER 1 1 1.100E+00 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION RCHRES 2 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 39 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 123 120 SAME 1.000E+00 EXTNL GATMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL POTEV 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WIND 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 126 1440 SAME 1.000E+00 EXTNL DEWTMP 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 1 OFLOW OVOL 1 1 1.000E+00 INFLOW IVOL 1 1 - RCHRES 1 OFLOW OCON 1 1 1.000E+00 INFLOW ICON 1 1 - RCHRES 1 OFLOW OHEAT 1 1 1.000E+00 INFLOW IHEAT 1 1 - RCHRES 1 OFLOW OSED 1 1 1.000E+00 INFLOW ISED 1 1 - RCHRES 1 OFLOW OSED 1 2 1.000E+00 INFLOW ISED 2 1 - RCHRES 1 OFLOW OSED 1 3 1.000E+00 INFLOW ISED 3 1 - RCHRES 1 OFLOW ODQAL 1 1 1.000E+00 INFLOW IDQAL 1 1 - RCHRES 1 OFLOW OSQAL 1 1 1.000E+00 INFLOW ISQAL 1 1 - RCHRES 1 OFLOW OSQAL 1 2 1.000E+00 INFLOW ISQAL 2 1 - RCHRES 1 OFLOW OSQAL 1 3 1.000E+00 INFLOW ISQAL 3 1 - RCHRES 1 OFLOW OXCF2 1 1 1.000E+00 INFLOW OXIF 1 1 - RCHRES 1 OFLOW OXCF2 1 2 1.000E+00 INFLOW OXIF 2 1 - RCHRES 1 OFLOW NUCF9 1 1 1.000E+00 INFLOW NUIF1 1 1 - RCHRES 1 OFLOW NUCF9 1 2 1.000E+00 INFLOW NUIF1 2 1 - RCHRES 1 OFLOW NUCF9 1 3 1.000E+00 INFLOW NUIF1 3 1 - RCHRES 1 OFLOW NUCF9 1 4 1.000E+00 INFLOW NUIF1 4 1 - RCHRES 1 OFLOW OSNH4 1 1 1.000E+00 INFLOW NUIF2 1 1 - RCHRES 1 OFLOW OSNH4 1 2 1.000E+00 INFLOW NUIF2 2 1 - RCHRES 1 OFLOW OSNH4 1 3 1.000E+00 INFLOW NUIF2 3 1 - RCHRES 1 OFLOW OSPO4 1 1 1.000E+00 INFLOW NUIF2 1 2 - RCHRES 1 OFLOW OSPO4 1 2 1.000E+00 INFLOW NUIF2 2 2 - RCHRES 1 OFLOW OSPO4 1 3 1.000E+00 INFLOW NUIF2 3 2 - RCHRES 1 OFLOW PKCF2 1 1 1.000E+00 INFLOW PKIF 1 1 - RCHRES 1 OFLOW PKCF2 1 2 1.000E+00 INFLOW PKIF 2 1 - RCHRES 1 OFLOW PKCF2 1 3 1.000E+00 INFLOW PKIF 3 1 - RCHRES 1 OFLOW PKCF2 1 4 1.000E+00 INFLOW PKIF 4 1 - RCHRES 1 OFLOW PKCF2 1 5 1.000E+00 INFLOW PKIF 5 1 - RCHRES 1 OFLOW PHCF2 1 1 1.000E+00 INFLOW PHIF 1 1 - RCHRES 1 OFLOW PHCF2 1 2 1.000E+00 INFLOW PHIF 2 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - ROFLOW ROVOL 1 1 1.000E+00 RCHRES 4 INFLOW IVOL 1 1 - ROFLOW ROCON 1 1 1.000E+00 RCHRES 4 INFLOW ICON 1 1 - ROFLOW ROHEAT 1 1 1.000E+00 RCHRES 4 INFLOW IHEAT 1 1 - ROFLOW ROSED 1 1 1.000E+00 RCHRES 4 INFLOW ISED 1 1 - ROFLOW ROSED 2 1 1.000E+00 RCHRES 4 INFLOW ISED 2 1 - ROFLOW ROSED 3 1 1.000E+00 RCHRES 4 INFLOW ISED 3 1 - ROFLOW RODQAL 1 1 1.000E+00 RCHRES 4 INFLOW IDQAL 1 1 - ROFLOW ROSQAL 1 1 1.000E+00 RCHRES 4 INFLOW ISQAL 1 1 - ROFLOW ROSQAL 2 1 1.000E+00 RCHRES 4 INFLOW ISQAL 2 1 - ROFLOW ROSQAL 3 1 1.000E+00 RCHRES 4 INFLOW ISQAL 3 1 - ROFLOW OXCF1 1 1 1.000E+00 RCHRES 4 INFLOW OXIF 1 1 - ROFLOW OXCF1 2 1 1.000E+00 RCHRES 4 INFLOW OXIF 2 1 - ROFLOW NUCF1 1 1 1.000E+00 RCHRES 4 INFLOW NUIF1 1 1 - ROFLOW NUCF1 2 1 1.000E+00 RCHRES 4 INFLOW NUIF1 2 1 - ROFLOW NUCF1 3 1 1.000E+00 RCHRES 4 INFLOW NUIF1 3 1 - ROFLOW NUCF1 4 1 1.000E+00 RCHRES 4 INFLOW NUIF1 4 1 - ROFLOW NUCF2 1 1 1.000E+00 RCHRES 4 INFLOW NUIF2 1 1 - ROFLOW NUCF2 2 1 1.000E+00 RCHRES 4 INFLOW NUIF2 2 1 - ROFLOW NUCF2 3 1 1.000E+00 RCHRES 4 INFLOW NUIF2 3 1 - ROFLOW NUCF2 1 2 1.000E+00 RCHRES 4 INFLOW NUIF2 1 2 - ROFLOW NUCF2 2 2 1.000E+00 RCHRES 4 INFLOW NUIF2 2 2 - ROFLOW NUCF2 3 2 1.000E+00 RCHRES 4 INFLOW NUIF2 3 2 - ROFLOW PKCF1 1 1 1.000E+00 RCHRES 4 INFLOW PKIF 1 1 - ROFLOW PKCF1 2 1 1.000E+00 RCHRES 4 INFLOW PKIF 2 1 - ROFLOW PKCF1 3 1 1.000E+00 RCHRES 4 INFLOW PKIF 3 1 - ROFLOW PKCF1 4 1 1.000E+00 RCHRES 4 INFLOW PKIF 4 1 - ROFLOW PKCF1 5 1 1.000E+00 RCHRES 4 INFLOW PKIF 5 1 - ROFLOW PHCF1 1 1 1.000E+00 RCHRES 4 INFLOW PHIF 1 1 - ROFLOW PHCF1 2 1 1.000E+00 RCHRES 4 INFLOW PHIF 2 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION RCHRES 3 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 39 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 123 120 SAME 1.000E+00 EXTNL GATMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL POTEV 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WIND 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 126 1440 SAME 1.000E+00 EXTNL DEWTMP 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 1 OFLOW OVOL 2 1 1.000E+00 INFLOW IVOL 1 1 - RCHRES 1 OFLOW OCON 2 1 1.000E+00 INFLOW ICON 1 1 - RCHRES 1 OFLOW OHEAT 2 1 1.000E+00 INFLOW IHEAT 1 1 - RCHRES 1 OFLOW OSED 2 1 1.000E+00 INFLOW ISED 1 1 - RCHRES 1 OFLOW OSED 2 2 1.000E+00 INFLOW ISED 2 1 - RCHRES 1 OFLOW OSED 2 3 1.000E+00 INFLOW ISED 3 1 - RCHRES 1 OFLOW ODQAL 2 1 1.000E+00 INFLOW IDQAL 1 1 - RCHRES 1 OFLOW OSQAL 2 1 1.000E+00 INFLOW ISQAL 1 1 - RCHRES 1 OFLOW OSQAL 2 2 1.000E+00 INFLOW ISQAL 2 1 - RCHRES 1 OFLOW OSQAL 2 3 1.000E+00 INFLOW ISQAL 3 1 - RCHRES 1 OFLOW OXCF2 2 1 1.000E+00 INFLOW OXIF 1 1 - RCHRES 1 OFLOW OXCF2 2 2 1.000E+00 INFLOW OXIF 2 1 - RCHRES 1 OFLOW NUCF9 2 1 1.000E+00 INFLOW NUIF1 1 1 - RCHRES 1 OFLOW NUCF9 2 2 1.000E+00 INFLOW NUIF1 2 1 - RCHRES 1 OFLOW NUCF9 2 3 1.000E+00 INFLOW NUIF1 3 1 - RCHRES 1 OFLOW NUCF9 2 4 1.000E+00 INFLOW NUIF1 4 1 - RCHRES 1 OFLOW OSNH4 2 1 1.000E+00 INFLOW NUIF2 1 1 - RCHRES 1 OFLOW OSNH4 2 2 1.000E+00 INFLOW NUIF2 2 1 - RCHRES 1 OFLOW OSNH4 2 3 1.000E+00 INFLOW NUIF2 3 1 - RCHRES 1 OFLOW OSPO4 2 1 1.000E+00 INFLOW NUIF2 1 2 - RCHRES 1 OFLOW OSPO4 2 2 1.000E+00 INFLOW NUIF2 2 2 - RCHRES 1 OFLOW OSPO4 2 3 1.000E+00 INFLOW NUIF2 3 2 - RCHRES 1 OFLOW PKCF2 2 1 1.000E+00 INFLOW PKIF 1 1 - RCHRES 1 OFLOW PKCF2 2 2 1.000E+00 INFLOW PKIF 2 1 - RCHRES 1 OFLOW PKCF2 2 3 1.000E+00 INFLOW PKIF 3 1 - RCHRES 1 OFLOW PKCF2 2 4 1.000E+00 INFLOW PKIF 4 1 - RCHRES 1 OFLOW PKCF2 2 5 1.000E+00 INFLOW PKIF 5 1 - RCHRES 1 OFLOW PHCF2 2 1 1.000E+00 INFLOW PHIF 1 1 - RCHRES 1 OFLOW PHCF2 2 2 1.000E+00 INFLOW PHIF 2 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - ROFLOW ROVOL 1 1 1.000E+00 RCHRES 4 INFLOW IVOL 1 1 - ROFLOW ROCON 1 1 1.000E+00 RCHRES 4 INFLOW ICON 1 1 - ROFLOW ROHEAT 1 1 1.000E+00 RCHRES 4 INFLOW IHEAT 1 1 - ROFLOW ROSED 1 1 1.000E+00 RCHRES 4 INFLOW ISED 1 1 - ROFLOW ROSED 2 1 1.000E+00 RCHRES 4 INFLOW ISED 2 1 - ROFLOW ROSED 3 1 1.000E+00 RCHRES 4 INFLOW ISED 3 1 - ROFLOW RODQAL 1 1 1.000E+00 RCHRES 4 INFLOW IDQAL 1 1 - ROFLOW ROSQAL 1 1 1.000E+00 RCHRES 4 INFLOW ISQAL 1 1 - ROFLOW ROSQAL 2 1 1.000E+00 RCHRES 4 INFLOW ISQAL 2 1 - ROFLOW ROSQAL 3 1 1.000E+00 RCHRES 4 INFLOW ISQAL 3 1 - ROFLOW OXCF1 1 1 1.000E+00 RCHRES 4 INFLOW OXIF 1 1 - ROFLOW OXCF1 2 1 1.000E+00 RCHRES 4 INFLOW OXIF 2 1 - ROFLOW NUCF1 1 1 1.000E+00 RCHRES 4 INFLOW NUIF1 1 1 - ROFLOW NUCF1 2 1 1.000E+00 RCHRES 4 INFLOW NUIF1 2 1 - ROFLOW NUCF1 3 1 1.000E+00 RCHRES 4 INFLOW NUIF1 3 1 - ROFLOW NUCF1 4 1 1.000E+00 RCHRES 4 INFLOW NUIF1 4 1 - ROFLOW NUCF2 1 1 1.000E+00 RCHRES 4 INFLOW NUIF2 1 1 - ROFLOW NUCF2 2 1 1.000E+00 RCHRES 4 INFLOW NUIF2 2 1 - ROFLOW NUCF2 3 1 1.000E+00 RCHRES 4 INFLOW NUIF2 3 1 - ROFLOW NUCF2 1 2 1.000E+00 RCHRES 4 INFLOW NUIF2 1 2 - ROFLOW NUCF2 2 2 1.000E+00 RCHRES 4 INFLOW NUIF2 2 2 - ROFLOW NUCF2 3 2 1.000E+00 RCHRES 4 INFLOW NUIF2 3 2 - ROFLOW PKCF1 1 1 1.000E+00 RCHRES 4 INFLOW PKIF 1 1 - ROFLOW PKCF1 2 1 1.000E+00 RCHRES 4 INFLOW PKIF 2 1 - ROFLOW PKCF1 3 1 1.000E+00 RCHRES 4 INFLOW PKIF 3 1 - ROFLOW PKCF1 4 1 1.000E+00 RCHRES 4 INFLOW PKIF 4 1 - ROFLOW PKCF1 5 1 1.000E+00 RCHRES 4 INFLOW PKIF 5 1 - ROFLOW PHCF1 1 1 1.000E+00 RCHRES 4 INFLOW PHIF 1 1 - ROFLOW PHCF1 2 1 1.000E+00 RCHRES 4 INFLOW PHIF 2 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION RCHRES 4 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 131 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 122 120 SAME 1.000E+00 EXTNL GATMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL POTEV 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WIND 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 125 1440 SAME 1.000E+00 EXTNL DEWTMP 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 2 ROFLOW ROVOL 1 1 1.000E+00 INFLOW IVOL 1 1 - RCHRES 2 ROFLOW ROCON 1 1 1.000E+00 INFLOW ICON 1 1 - RCHRES 2 ROFLOW ROHEAT 1 1 1.000E+00 INFLOW IHEAT 1 1 - RCHRES 2 ROFLOW ROSED 1 1 1.000E+00 INFLOW ISED 1 1 - RCHRES 2 ROFLOW ROSED 2 1 1.000E+00 INFLOW ISED 2 1 - RCHRES 2 ROFLOW ROSED 3 1 1.000E+00 INFLOW ISED 3 1 - RCHRES 2 ROFLOW RODQAL 1 1 1.000E+00 INFLOW IDQAL 1 1 - RCHRES 2 ROFLOW ROSQAL 1 1 1.000E+00 INFLOW ISQAL 1 1 - RCHRES 2 ROFLOW ROSQAL 2 1 1.000E+00 INFLOW ISQAL 2 1 - RCHRES 2 ROFLOW ROSQAL 3 1 1.000E+00 INFLOW ISQAL 3 1 - RCHRES 2 ROFLOW OXCF1 1 1 1.000E+00 INFLOW OXIF 1 1 - RCHRES 2 ROFLOW OXCF1 2 1 1.000E+00 INFLOW OXIF 2 1 - RCHRES 2 ROFLOW NUCF1 1 1 1.000E+00 INFLOW NUIF1 1 1 - RCHRES 2 ROFLOW NUCF1 2 1 1.000E+00 INFLOW NUIF1 2 1 - RCHRES 2 ROFLOW NUCF1 3 1 1.000E+00 INFLOW NUIF1 3 1 - RCHRES 2 ROFLOW NUCF1 4 1 1.000E+00 INFLOW NUIF1 4 1 - RCHRES 2 ROFLOW NUCF2 1 1 1.000E+00 INFLOW NUIF2 1 1 - RCHRES 2 ROFLOW NUCF2 2 1 1.000E+00 INFLOW NUIF2 2 1 - RCHRES 2 ROFLOW NUCF2 3 1 1.000E+00 INFLOW NUIF2 3 1 - RCHRES 2 ROFLOW NUCF2 1 2 1.000E+00 INFLOW NUIF2 1 2 - RCHRES 2 ROFLOW NUCF2 2 2 1.000E+00 INFLOW NUIF2 2 2 - RCHRES 2 ROFLOW NUCF2 3 2 1.000E+00 INFLOW NUIF2 3 2 - RCHRES 2 ROFLOW PKCF1 1 1 1.000E+00 INFLOW PKIF 1 1 - RCHRES 2 ROFLOW PKCF1 2 1 1.000E+00 INFLOW PKIF 2 1 - RCHRES 2 ROFLOW PKCF1 3 1 1.000E+00 INFLOW PKIF 3 1 - RCHRES 2 ROFLOW PKCF1 4 1 1.000E+00 INFLOW PKIF 4 1 - RCHRES 2 ROFLOW PKCF1 5 1 1.000E+00 INFLOW PKIF 5 1 - RCHRES 2 ROFLOW PHCF1 1 1 1.000E+00 INFLOW PHIF 1 1 - RCHRES 2 ROFLOW PHCF1 2 1 1.000E+00 INFLOW PHIF 2 1 - RCHRES 3 ROFLOW ROVOL 1 1 1.000E+00 INFLOW IVOL 1 1 - RCHRES 3 ROFLOW ROCON 1 1 1.000E+00 INFLOW ICON 1 1 - RCHRES 3 ROFLOW ROHEAT 1 1 1.000E+00 INFLOW IHEAT 1 1 - RCHRES 3 ROFLOW ROSED 1 1 1.000E+00 INFLOW ISED 1 1 - RCHRES 3 ROFLOW ROSED 2 1 1.000E+00 INFLOW ISED 2 1 - RCHRES 3 ROFLOW ROSED 3 1 1.000E+00 INFLOW ISED 3 1 - RCHRES 3 ROFLOW RODQAL 1 1 1.000E+00 INFLOW IDQAL 1 1 - RCHRES 3 ROFLOW ROSQAL 1 1 1.000E+00 INFLOW ISQAL 1 1 - RCHRES 3 ROFLOW ROSQAL 2 1 1.000E+00 INFLOW ISQAL 2 1 - RCHRES 3 ROFLOW ROSQAL 3 1 1.000E+00 INFLOW ISQAL 3 1 - RCHRES 3 ROFLOW OXCF1 1 1 1.000E+00 INFLOW OXIF 1 1 - RCHRES 3 ROFLOW OXCF1 2 1 1.000E+00 INFLOW OXIF 2 1 - RCHRES 3 ROFLOW NUCF1 1 1 1.000E+00 INFLOW NUIF1 1 1 - RCHRES 3 ROFLOW NUCF1 2 1 1.000E+00 INFLOW NUIF1 2 1 - RCHRES 3 ROFLOW NUCF1 3 1 1.000E+00 INFLOW NUIF1 3 1 - RCHRES 3 ROFLOW NUCF1 4 1 1.000E+00 INFLOW NUIF1 4 1 - RCHRES 3 ROFLOW NUCF2 1 1 1.000E+00 INFLOW NUIF2 1 1 - RCHRES 3 ROFLOW NUCF2 2 1 1.000E+00 INFLOW NUIF2 2 1 - RCHRES 3 ROFLOW NUCF2 3 1 1.000E+00 INFLOW NUIF2 3 1 - RCHRES 3 ROFLOW NUCF2 1 2 1.000E+00 INFLOW NUIF2 1 2 - RCHRES 3 ROFLOW NUCF2 2 2 1.000E+00 INFLOW NUIF2 2 2 - RCHRES 3 ROFLOW NUCF2 3 2 1.000E+00 INFLOW NUIF2 3 2 - RCHRES 3 ROFLOW PKCF1 1 1 1.000E+00 INFLOW PKIF 1 1 - RCHRES 3 ROFLOW PKCF1 2 1 1.000E+00 INFLOW PKIF 2 1 - RCHRES 3 ROFLOW PKCF1 3 1 1.000E+00 INFLOW PKIF 3 1 - RCHRES 3 ROFLOW PKCF1 4 1 1.000E+00 INFLOW PKIF 4 1 - RCHRES 3 ROFLOW PKCF1 5 1 1.000E+00 INFLOW PKIF 5 1 - RCHRES 3 ROFLOW PHCF1 1 1 1.000E+00 INFLOW PHIF 1 1 - RCHRES 3 ROFLOW PHCF1 2 1 1.000E+00 INFLOW PHIF 2 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - ROFLOW ROVOL 1 1 1.000E+00 RCHRES 5 INFLOW IVOL 1 1 - ROFLOW ROCON 1 1 1.000E+00 RCHRES 5 INFLOW ICON 1 1 - ROFLOW ROHEAT 1 1 1.000E+00 RCHRES 5 INFLOW IHEAT 1 1 - ROFLOW ROSED 1 1 1.000E+00 RCHRES 5 INFLOW ISED 1 1 - ROFLOW ROSED 2 1 1.000E+00 RCHRES 5 INFLOW ISED 2 1 - ROFLOW ROSED 3 1 1.000E+00 RCHRES 5 INFLOW ISED 3 1 - ROFLOW RODQAL 1 1 1.000E+00 RCHRES 5 INFLOW IDQAL 1 1 - ROFLOW ROSQAL 1 1 1.000E+00 RCHRES 5 INFLOW ISQAL 1 1 - ROFLOW ROSQAL 2 1 1.000E+00 RCHRES 5 INFLOW ISQAL 2 1 - ROFLOW ROSQAL 3 1 1.000E+00 RCHRES 5 INFLOW ISQAL 3 1 - ROFLOW OXCF1 1 1 1.000E+00 RCHRES 5 INFLOW OXIF 1 1 - ROFLOW OXCF1 2 1 1.000E+00 RCHRES 5 INFLOW OXIF 2 1 - ROFLOW NUCF1 1 1 1.000E+00 RCHRES 5 INFLOW NUIF1 1 1 - ROFLOW NUCF1 2 1 1.000E+00 RCHRES 5 INFLOW NUIF1 2 1 - ROFLOW NUCF1 3 1 1.000E+00 RCHRES 5 INFLOW NUIF1 3 1 - ROFLOW NUCF1 4 1 1.000E+00 RCHRES 5 INFLOW NUIF1 4 1 - ROFLOW NUCF2 1 1 1.000E+00 RCHRES 5 INFLOW NUIF2 1 1 - ROFLOW NUCF2 2 1 1.000E+00 RCHRES 5 INFLOW NUIF2 2 1 - ROFLOW NUCF2 3 1 1.000E+00 RCHRES 5 INFLOW NUIF2 3 1 - ROFLOW NUCF2 1 2 1.000E+00 RCHRES 5 INFLOW NUIF2 1 2 - ROFLOW NUCF2 2 2 1.000E+00 RCHRES 5 INFLOW NUIF2 2 2 - ROFLOW NUCF2 3 2 1.000E+00 RCHRES 5 INFLOW NUIF2 3 2 - ROFLOW PKCF1 1 1 1.000E+00 RCHRES 5 INFLOW PKIF 1 1 - ROFLOW PKCF1 2 1 1.000E+00 RCHRES 5 INFLOW PKIF 2 1 - ROFLOW PKCF1 3 1 1.000E+00 RCHRES 5 INFLOW PKIF 3 1 - ROFLOW PKCF1 4 1 1.000E+00 RCHRES 5 INFLOW PKIF 4 1 - ROFLOW PKCF1 5 1 1.000E+00 RCHRES 5 INFLOW PKIF 5 1 - ROFLOW PHCF1 1 1 1.000E+00 RCHRES 5 INFLOW PHIF 1 1 - ROFLOW PHCF1 2 1 1.000E+00 RCHRES 5 INFLOW PHIF 2 1 - HYDR AVDEP 1 1 1.000E+00 PLTGEN 2 INPUT POINT 1 1 - HTRCH TW 1 1 1.000E+00 PLTGEN 2 INPUT POINT 2 1 - PHCARB PHST 3 1 1.000E+00 PLTGEN 2 INPUT POINT 3 1 - HTRCH HTEXCH 1 1 1.000E+00 PLTGEN 2 INPUT MEAN 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION PLTGEN 2 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 4 HYDR AVDEP 1 1 1.000E+00 INPUT POINT 1 1 - RCHRES 4 HTRCH TW 1 1 1.000E+00 INPUT POINT 2 1 - RCHRES 4 PHCARB PHST 3 1 1.000E+00 INPUT POINT 3 1 - RCHRES 4 HTRCH HTEXCH 1 1 1.000E+00 INPUT MEAN 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION IMPLND 1 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 131 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 122 120 SAME 1.000E+00 ATEMP AIRTMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL PETINP 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WINMOV 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 125 1440 SAME 1.000E+00 EXTNL DTMPG 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - IWATER SURO 1 1 2.500E+02 RCHRES 5 INFLOW IVOL 1 1 - SOLIDS SOSLD 1 1 3.000E+02 RCHRES 5 INFLOW ISED 1 1 - SOLIDS SOSLD 1 1 1.380E+03 RCHRES 5 INFLOW ISED 2 1 - SOLIDS SOSLD 1 1 1.320E+03 RCHRES 5 INFLOW ISED 3 1 - IWTGAS SOHT 1 1 3.000E+03 RCHRES 5 INFLOW IHEAT 1 1 - IWTGAS SODOXM 1 1 3.000E+03 RCHRES 5 INFLOW OXIF 1 1 - IWTGAS SOCO2M 1 1 3.000E+03 RCHRES 5 INFLOW PHIF 2 1 - IQUAL SOQUAL 1 1 3.000E+03 RCHRES 5 INFLOW OXIF 2 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION RCHRES 5 - - INPUT TIMESERIES - - FROM EXTERNAL SOURCES - TYPE # INTERVAL TRN STR MFACT GROUP MEMBER S1 S2 - - WDM1 131 60 SAME 1.000E+00 EXTNL PREC 1 1 - WDM1 122 120 SAME 1.000E+00 EXTNL GATMP 1 1 - WDM1 41 1440 DIV 7.000E-01 EXTNL POTEV 1 1 - WDM1 42 1440 DIV 1.000E+00 EXTNL WIND 1 1 - WDM1 46 120 DIV 1.000E+00 EXTNL SOLRAD 1 1 - WDM1 125 1440 SAME 1.000E+00 EXTNL DEWTMP 1 1 - WDM1 135 1440 SAME 1.000E+00 EXTNL CLOUD 1 1 - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - IMPLND 1 IWATER SURO 1 1 2.500E+02 INFLOW IVOL 1 1 - IMPLND 1 SOLIDS SOSLD 1 1 3.000E+02 INFLOW ISED 1 1 - IMPLND 1 SOLIDS SOSLD 1 1 1.380E+03 INFLOW ISED 2 1 - IMPLND 1 SOLIDS SOSLD 1 1 1.320E+03 INFLOW ISED 3 1 - IMPLND 1 IWTGAS SOHT 1 1 3.000E+03 INFLOW IHEAT 1 1 - IMPLND 1 IWTGAS SODOXM 1 1 3.000E+03 INFLOW OXIF 1 1 - IMPLND 1 IWTGAS SOCO2M 1 1 3.000E+03 INFLOW PHIF 2 1 - IMPLND 1 IQUAL SOQUAL 1 1 3.000E+03 INFLOW OXIF 2 1 - RCHRES 4 ROFLOW ROVOL 1 1 1.000E+00 INFLOW IVOL 1 1 - RCHRES 4 ROFLOW ROCON 1 1 1.000E+00 INFLOW ICON 1 1 - RCHRES 4 ROFLOW ROHEAT 1 1 1.000E+00 INFLOW IHEAT 1 1 - RCHRES 4 ROFLOW ROSED 1 1 1.000E+00 INFLOW ISED 1 1 - RCHRES 4 ROFLOW ROSED 2 1 1.000E+00 INFLOW ISED 2 1 - RCHRES 4 ROFLOW ROSED 3 1 1.000E+00 INFLOW ISED 3 1 - RCHRES 4 ROFLOW RODQAL 1 1 1.000E+00 INFLOW IDQAL 1 1 - RCHRES 4 ROFLOW ROSQAL 1 1 1.000E+00 INFLOW ISQAL 1 1 - RCHRES 4 ROFLOW ROSQAL 2 1 1.000E+00 INFLOW ISQAL 2 1 - RCHRES 4 ROFLOW ROSQAL 3 1 1.000E+00 INFLOW ISQAL 3 1 - RCHRES 4 ROFLOW OXCF1 1 1 1.000E+00 INFLOW OXIF 1 1 - RCHRES 4 ROFLOW OXCF1 2 1 1.000E+00 INFLOW OXIF 2 1 - RCHRES 4 ROFLOW NUCF1 1 1 1.000E+00 INFLOW NUIF1 1 1 - RCHRES 4 ROFLOW NUCF1 2 1 1.000E+00 INFLOW NUIF1 2 1 - RCHRES 4 ROFLOW NUCF1 3 1 1.000E+00 INFLOW NUIF1 3 1 - RCHRES 4 ROFLOW NUCF1 4 1 1.000E+00 INFLOW NUIF1 4 1 - RCHRES 4 ROFLOW NUCF2 1 1 1.000E+00 INFLOW NUIF2 1 1 - RCHRES 4 ROFLOW NUCF2 2 1 1.000E+00 INFLOW NUIF2 2 1 - RCHRES 4 ROFLOW NUCF2 3 1 1.000E+00 INFLOW NUIF2 3 1 - RCHRES 4 ROFLOW NUCF2 1 2 1.000E+00 INFLOW NUIF2 1 2 - RCHRES 4 ROFLOW NUCF2 2 2 1.000E+00 INFLOW NUIF2 2 2 - RCHRES 4 ROFLOW NUCF2 3 2 1.000E+00 INFLOW NUIF2 3 2 - RCHRES 4 ROFLOW PKCF1 1 1 1.000E+00 INFLOW PKIF 1 1 - RCHRES 4 ROFLOW PKCF1 2 1 1.000E+00 INFLOW PKIF 2 1 - RCHRES 4 ROFLOW PKCF1 3 1 1.000E+00 INFLOW PKIF 3 1 - RCHRES 4 ROFLOW PKCF1 4 1 1.000E+00 INFLOW PKIF 4 1 - RCHRES 4 ROFLOW PKCF1 5 1 1.000E+00 INFLOW PKIF 5 1 - RCHRES 4 ROFLOW PHCF1 1 1 1.000E+00 INFLOW PHIF 1 1 - RCHRES 4 ROFLOW PHCF1 2 1 1.000E+00 INFLOW PHIF 2 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - OXRX DOX 1 1 1.000E+00 DISPLY 3 INPUT TIMSER 1 1 - GQUAL RSQAL 12 1 1.000E+00 GENER 2 INPUT ONE 1 1 - SEDTRN RSED 10 1 1.000E+00 GENER 2 INPUT TWO 1 1 - HYDR ROVOL 1 1 1.210E+01 PLTGEN 1 INPUT MEAN 2 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION DISPLY 3 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 5 OXRX DOX 1 1 1.000E+00 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION GENER 2 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 5 GQUAL RSQAL 12 1 1.000E+00 INPUT ONE 1 1 - RCHRES 5 SEDTRN RSED 10 1 1.000E+00 INPUT TWO 1 1 - - OUTPUT TIMESERIES - - TO OTHER OPERATIONS(NETWORK) - GROUP MEMBER S1 S2 MFACT TYPE # GROUP MEMBER S1 S2 - - OUTPUT TIMSER 1 1 1.100E+00 DISPLY 4 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION DISPLY 4 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - GENER 2 OUTPUT TIMSER 1 1 1.100E+00 INPUT TIMSER 1 1 - - - ++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ - - TIMESERIES USED BY OPERATION PLTGEN 1 - - INPUT TIMESERIES - - FROM OTHER OPERATIONS(NETWORK) - TYPE # GROUP MEMBER S1 S2 MFACT GROUP MEMBER S1 S2 - - RCHRES 1 HYDR ROVOL 1 1 1.210E+01 INPUT MEAN 1 1 - RCHRES 5 HYDR ROVOL 1 1 1.210E+01 INPUT MEAN 2 1 - - FINISHED PROCESSING BLOCKS CONTAINING TIME SERIES LINKAGES - ==================================================================================================================================== - - INTERPRETATION OF RUN DATA SET COMPLETE - - - COMMENCING EXECUTION - - - ************************************************************************************ - * * - * ERROR/WARNING ID: 344 21 * - * * - * DATE/TIME: 1976/ 8/13 5: 0 * - * * - * RCHRES: 2 * - * * - * Water temperature is above 66 C (150 F). In most cases, this indicates * - * an instability in advection. Try adding more definition in the FTABLE * - * for this reach. Or try changing the ADCALC activity flag (ADFG) to 2; * - * this will cause the advection to use the same weighting factors as are * - * used in the flow routing. * - * * - * Relevant values are : * - * * - * TW * - * 7.3767E+02 * - * * - ************************************************************************************ - - - - ************************************************************************************ - * * - * ERROR/WARNING ID: 344 21 * - * * - * DATE/TIME: 1976/ 5/ 9 18: 0 * - * * - * RCHRES: 3 * - * * - * Water temperature is above 66 C (150 F). In most cases, this indicates * - * an instability in advection. Try adding more definition in the FTABLE * - * for this reach. Or try changing the ADCALC activity flag (ADFG) to 2; * - * this will cause the advection to use the same weighting factors as are * - * used in the flow routing. * - * * - * Relevant values are : * - * * - * TW * - * 2.2736E+02 * - * * - ************************************************************************************ - - - - ************************************************************************************ - * * - * ERROR/WARNING ID: 344 21 * - * * - * DATE/TIME: 1976/ 5/28 3: 0 * - * * - * RCHRES: 3 * - * * - * Water temperature is above 66 C (150 F). In most cases, this indicates * - * an instability in advection. Try adding more definition in the FTABLE * - * for this reach. Or try changing the ADCALC activity flag (ADFG) to 2; * - * this will cause the advection to use the same weighting factors as are * - * used in the flow routing. * - * * - * Relevant values are : * - * * - * TW * - * 7.6714E+01 * - * * - ************************************************************************************ - - - - ************************************************************************************ - * * - * ERROR/WARNING ID: 344 21 * - * * - * DATE/TIME: 1976/ 6/ 4 3: 0 * - * * - * RCHRES: 3 * - * * - * Water temperature is above 66 C (150 F). In most cases, this indicates * - * an instability in advection. Try adding more definition in the FTABLE * - * for this reach. Or try changing the ADCALC activity flag (ADFG) to 2; * - * this will cause the advection to use the same weighting factors as are * - * used in the flow routing. * - * * - * Relevant values are : * - * * - * TW * - * 7.0752E+01 * - * * - ************************************************************************************ - - - - ************************************************************************************ - * * - * ERROR/WARNING ID: 344 21 * - * * - * DATE/TIME: 1976/ 8/13 15: 0 * - * * - * RCHRES: 4 * - * * - * Water temperature is above 66 C (150 F). In most cases, this indicates * - * an instability in advection. Try adding more definition in the FTABLE * - * for this reach. Or try changing the ADCALC activity flag (ADFG) to 2; * - * this will cause the advection to use the same weighting factors as are * - * used in the flow routing. * - * * - * Relevant values are : * - * * - * TW * - * 9.4452E+01 * - * * - ************************************************************************************ - - - - ************************************************************************************ - * * - * ERROR/WARNING ID: 344 21 * - * * - * DATE/TIME: 1976/ 8/18 23: 0 * - * * - * RCHRES: 5 * - * * - * Water temperature is above 66 C (150 F). In most cases, this indicates * - * an instability in advection. Try adding more definition in the FTABLE * - * for this reach. Or try changing the ADCALC activity flag (ADFG) to 2; * - * this will cause the advection to use the same weighting factors as are * - * used in the flow routing. * - * * - * Relevant values are : * - * * - * TW * - * 1.3503E+02 * - * * - ************************************************************************************ - - - End of Job diff --git a/tests/test10/HSPFresults/test10.log b/tests/test10/HSPFresults/test10.log deleted file mode 100644 index 4d683a0f..00000000 --- a/tests/test10/HSPFresults/test10.log +++ /dev/null @@ -1,9 +0,0 @@ -00:00:00.082 Main:StartToFile 2020-11-04 08:50:10 -00:00:00.082 Main:Begin Logging -00:00:00.083 WriteStatus:(LOGTOFILE test10.log) -00:00:00.083 Main:Pre: F90_ACTSCN (-1, 0, 100, 0, test10, 6) -00:00:00.550 Main:Post: F90_ACTSCN (-1, 0, 100, 0, test10, 6) -00:00:00.551 Main:Pre: F90_SIMSCN (0) -00:00:00.551 WriteStatus:(Progress Percent Off) -00:00:01.914 Main:Post: F90_SIMSCN (0) -00:00:01.915 WriteStatus:(EXIT) diff --git a/tests/test10/HSPFresults/test10.uci b/tests/test10/HSPFresults/test10.uci index b420489f..a9f4c060 100644 --- a/tests/test10/HSPFresults/test10.uci +++ b/tests/test10/HSPFresults/test10.uci @@ -17,6 +17,9 @@ MESSU 22 test10.ech 66 test10.d66 94 test10.p94 95 test10.p95 +BINO 81 test10P.hbn +BINO 82 test10I.hbn +BINO 83 test10R.hbn END FILES OPN SEQUENCE @@ -53,11 +56,17 @@ PERLND 1 4 4 4 4 12 END PRINT-INFO + BINARY-INFO +*** < PLS> Binary Output Flags PIVL PYR +*** x - x ATMP SNOW PWAT SED PST PWG PQAL MSTL PEST NITR PHOS TRAC + 1 2 2 2 2 2 1 12 + END BINARY-INFO + GEN-INFO - <-------Name-------> Unit-systems Printer *** - # - # t-series Engl Metr *** - in out *** - 1 BICKNELL FARM 1 1 1 0 + <-------Name-------> Unit-systems Printer BinaryOut *** + # - # t-series Engl Metr Engl Metr *** + in out *** + 1 BICKNELL FARM 1 1 1 0 81 0 END GEN-INFO *** Section SNOW *** @@ -182,11 +191,17 @@ IMPLND 1 4 4 4 4 4 12 END PRINT-INFO + BINARY-INFO +*** **** Binary-Output-flags **** PIVL PYR +*** x - x ATMP SNOW IWAT SLD IWG IQAL ********* + 1 2 2 2 2 2 1 12 + END BINARY-INFO + GEN-INFO - <-------Name-------> Unit-systems Printer *** - # - # t-series Engl Metr *** - in out *** - 1 DONIGIAN INDUSTRY 1 1 1 0 + <-------Name-------> Unit-systems Printer BinaryOut *** + # - # t-series Engl Metr Engl Metr *** + in out *** + 1 DONIGIAN INDUSTRY 1 1 1 0 82 0 END GEN-INFO *** Section SNOW *** @@ -304,15 +319,21 @@ RCHRES 5 4 4 4 4 4 4 4 4 4 4 12 END PRINT-INFO + BINARY-INFO +*** RCHRES Binary Output level flags +*** x - x HYDR ADCA CONS HEAT SED GQL OXRX NUTR PLNK PHCB PIVL PYR + 1 5 2 2 2 2 2 2 2 2 2 2 1 12 + END BINARY-INFO + GEN-INFO - RCHRES<-------Name------->Nexit Unit Systems Printer *** - # - # t-series Engl Metr LKFG *** - in out *** - 1 MEIER POND 2 1 1 1 0 1 - 2 OUTLET 1 1 1 1 0 - 3 SPILLWAY 1 1 1 1 0 - 4 UPPER KITTLE CREEK 1 1 1 1 0 - 5 LOWER KITTLE CREEK 1 1 1 1 0 + RCHRES<-------Name------->Nexit Unit Systems Printer BinaryOut *** + # - # t-series Engl Metr LKFG Engl Metr *** + in out *** + 1 MEIER POND 2 1 1 1 0 1 83 0 + 2 OUTLET 1 1 1 1 0 0 83 0 + 3 SPILLWAY 1 1 1 1 0 0 83 0 + 4 UPPER KITTLE CREEK 1 1 1 1 0 0 83 0 + 5 LOWER KITTLE CREEK 1 1 1 1 0 0 83 0 END GEN-INFO *** Section HYDR *** diff --git a/tests/test10/HSPFresults/test10I.hbn b/tests/test10/HSPFresults/test10I.hbn new file mode 100644 index 00000000..a4529a11 Binary files /dev/null and b/tests/test10/HSPFresults/test10I.hbn differ diff --git a/tests/test10/HSPFresults/test10P.hbn b/tests/test10/HSPFresults/test10P.hbn new file mode 100644 index 00000000..bfe0d3b0 Binary files /dev/null and b/tests/test10/HSPFresults/test10P.hbn differ diff --git a/tests/test10/HSPFresults/test10R.hbn b/tests/test10/HSPFresults/test10R.hbn new file mode 100644 index 00000000..1d4d5212 Binary files /dev/null and b/tests/test10/HSPFresults/test10R.hbn differ diff --git a/tests/test_report_conversion.html b/tests/test_report_conversion.html new file mode 100644 index 00000000..fe19c193 --- /dev/null +++ b/tests/test_report_conversion.html @@ -0,0 +1,1645 @@ +

CONVERSION TEST REPORT

+

C:\dev\HSPsquared\tests\test10

+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
IMPLND_IWATER_001_2
ConstituentMax DiffMatchNote
-RETS1.4156103134155273e-07
-SURS1.1175870895385742e-07
-PETADJ3.159046173095703e-06
-SUPY6.165355443954468e-07
-SURO5.103647708892822e-07
-PET1.8480932340025902e-09
-IMPEV4.452886059880257e-09
IMPLND_SOLIDS_001_2
ConstituentMax DiffMatchNote
-SLDS9.313225746154785e-09
-SOSLD3.725290298461914e-09
IMPLND_IWTGAS_001_2
ConstituentMax DiffMatchNote
-SOTMP7.62939453125e-06
-SODOX9.5367431640625e-07
-SOCO23.5762786865234375e-07
-SOHT0.5
-SODOXM1.646578311920166e-06
-SOCO2M3.1956005841493607e-08
IMPLND_IQUAL_001_2
ConstituentMax DiffMatchNote
-SQOCODNANAnot in h5
-SOQSPCODNANAnot in h5
-SOQOCCODNANAnot in h5
-SOQCCODNANAnot in h5
-SOQSCODNANAnot in h5
-SOQOCODNANAnot in h5
-SOQUALCODNANAnot in h5
PERLND_SNOW_001_2
ConstituentMax DiffMatchNote
-PACK3.516674041748047e-06
-PACKF3.248453140258789e-06
-PACKW2.60770320892334e-07
-PACKI1.430511474609375e-06
-PDEPTH1.3113021850585938e-05
-COVINX1.4901161193847656e-07
-NEGHTS2.980232238769531e-07
-XLNMLT1.0170042514801025e-06
-RDENPFnanX
-SKYCLR0.0
-SNOCOV6.496906280517578e-06
-DULL3.814697265625e-06
-ALBEDO5.960464477539063e-08
-PAKTMP2.6702880859375e-05
-DEWTMP0.0
-SNOTMP3.814697265625e-06
-PRECIPNANAnot in h5
-SNOWF2.9802322387695312e-08
-PRAIN6.705522537231445e-08
-SNOWE4.432674359122757e-06
-WYIELD1.2870877981185913e-06
-MELT2.644956111907959e-07
PERLND_PWATER_001_2
ConstituentMax DiffMatchNote
-PERS0.00133514404296875
-CEPS0.0001224968582391739
-SURS1.1893920600414276e-05
-UZS0.00014263391494750977
-IFWS2.2755004465579987e-05
-LZS0.0006866455078125
-AGWS0.0005435943603515625
-GWVS0.0005768537521362305
-INFFAC1.4901161193847656e-06
-PETADJ0.009999999776482582
-SUPY1.2870877981185913e-06
-SURO4.002235073130578e-06
-IFWO4.818139132112265e-07
-AGWO1.0952353477478027e-06
-PERO4.930305294692516e-06
-IGWI5.773443263024092e-06
-PET1.7499998648418114e-05
-CEPE1.7499998648418114e-05
-UZET2.9123621061444283e-06
-LZET8.183997124433517e-06
-AGWET1.4983932487666607e-05
-BASET0.0
-TAET1.7499998648418114e-05
-IFWI1.433282159268856e-05
-UZI1.8984079360961914e-05
-INFIL0.00011644978076219559
-PERC1.286913175135851e-06
-LZI6.725452840328217e-05
-AGWI5.196128040552139e-05
PERLND_PSTEMP_001_2
ConstituentMax DiffMatchNote
-AIRTNANAnot in h5
-SLTMP3.814697265625e-06
-ULTMP12.160799980163574X
-LGTMP60.57076644897461X
PERLND_PWTGAS_001_2
ConstituentMax DiffMatchNote
-SOTMP1.0000000150474662e+30X
-IOTMP3.1998939514160156X
-AOTMP60.58049011230469X
-SODOX1.0000000150474662e+30X
-SOCO21.0000000150474662e+30X
-IODOX0.0
-IOCO23.725290298461914e-09
-AODOX0.0
-AOCO23.725290298461914e-09
-SOHT0.816375732421875X
-IOHT480.54345703125X
-AOHT23777.792083740234X
-POHT23771.534729003906X
-SODOXM1.2868753401562572e-05
-SOCO2M2.542383299442008e-07
-IODOXM6.550690159201622e-07
-IOCO2M5.4590145737165585e-09
-AODOXM1.2409873306751251e-06
-AOCO2M1.2410964700393379e-08
-PODOXM1.3981014490127563e-05
-POCO2M2.647539076860994e-07
RCHRES_HYDR_001_2
ConstituentMax DiffMatchNote
-VOL0.0824127197265625
-DEP0.007266998291015625
-STAGENANAnot in h5
-AVDEPNANAnot in h5
-TWIDNANAnot in h5
-HRADNANAnot in h5
-SAREA0.004405021667480469
-AVVELNANAnot in h5
-AVSECTNANAnot in h5
-USTAR0.002726029109908268
-TAU1.8162558262702078e-05
-RO0.162872314453125X
-O10.004782676696777344
-O20.16086101531982422X
-IVOL0.0024653077125549316
-PRSUPY0.00026229023933410645
-VOLEV7.954426109790802e-06
-ROVOL0.011789321899414062
-OVOL10.00039505958557128906
-OVOL20.011643677949905396
-POTEVNANAnot in h5
RCHRES_CONS_001_2
ConstituentMax DiffMatchNote
-ALKALINITYCONCNANAnot in h5
-ALKALINITYICONNANAnot in h5
-ALKALINITYROCONNANAnot in h5
-ALKALINITYOCON1NANAnot in h5
-ALKALINITYOCON2NANAnot in h5
RCHRES_HTRCH_001_2
ConstituentMax DiffMatchNote
-AIRTMP0.15480804443359375X
-DEWTMPNANAnot in h5
-TW18.36562728881836X
-IHEAT142418248.25X
-HTEXCH499788061.5X
-ROHEAT54108560.0X
-OHEAT EXIT1NANAnot in h5
-OHEAT EXIT2NANAnot in h5
-QTOTALNANAnot in h5
-QSOLARNANAnot in h5
-QLONGWNANAnot in h5
-QEVAPNANAnot in h5
-QCONNANAnot in h5
-QPRECNANAnot in h5
-QBEDNANAnot in h5
RCHRES_SEDTRN_001_2
ConstituentMax DiffMatchNote
-SSEDSANDNANAnot in h5
-SSEDSILTNANAnot in h5
-SSEDCLAYNANAnot in h5
-SSEDTOTNANAnot in h5
-RSEDSUSPSANDNANAnot in h5
-RSEDSUSPSILTNANAnot in h5
-RSEDSUSPCLAYNANAnot in h5
-RSEDSUSPTOTNANAnot in h5
-RSEDBEDSANDNANAnot in h5
-RSEDBEDSILTNANAnot in h5
-RSEDBEDCLAYNANAnot in h5
-RSEDBEDTOTNANAnot in h5
-RSEDTOTSANDNANAnot in h5
-RSEDTOTSILTNANAnot in h5
-RSEDTOTCLAYNANAnot in h5
-RSEDTOTTOTNANAnot in h5
-BEDDEP9.5367431640625e-07
-ISEDSANDNANAnot in h5
-ISEDSILTNANAnot in h5
-ISEDCLAYNANAnot in h5
-ISEDTOTNANAnot in h5
-DEPSCOURSANDNANAnot in h5
-DEPSCOURSILTNANAnot in h5
-DEPSCOURCLAYNANAnot in h5
-DEPSCOURTOTNANAnot in h5
-ROSEDSANDNANAnot in h5
-ROSEDSILTNANAnot in h5
-ROSEDCLAYNANAnot in h5
-ROSEDTOTNANAnot in h5
-OSEDSANDEXIT1NANAnot in h5
-OSEDSILTEXIT1NANAnot in h5
-OSEDCLAYEXIT1NANAnot in h5
-OSEDTOTEXIT1NANAnot in h5
-OSEDSANDEXIT2NANAnot in h5
-OSEDSILTEXIT2NANAnot in h5
-OSEDCLAYEXIT2NANAnot in h5
-OSEDTOTEXIT2NANAnot in h5
RCHRES_GQUAL_001_2
ConstituentMax DiffMatchNote
-PESTICIDE B4DQALNANAnot in h5
-PESTICIDE B4SQALSUSPSANDNANAnot in h5
-PESTICIDE B4SQALSUSPSILTNANAnot in h5
-PESTICIDE B4SQALSUSPCLAYNANAnot in h5
-PESTICIDE B4SQALBEDSANDNANAnot in h5
-PESTICIDE B4SQALBEDSILTNANAnot in h5
-PESTICIDE B4SQALBEDCLAYNANAnot in h5
-PESTICIDE B4RDQALNANAnot in h5
-PESTICIDE B4RSQALSUSPSANDNANAnot in h5
-PESTICIDE B4RSQALSUSPSILTNANAnot in h5
-PESTICIDE B4RSQALSUSPCLAYNANAnot in h5
-PESTICIDE B4RSQALSUSPTOTNANAnot in h5
-PESTICIDE B4RSQALBEDSANDNANAnot in h5
-PESTICIDE B4RSQALBEDSILTNANAnot in h5
-PESTICIDE B4RSQALBEDCLAYNANAnot in h5
-PESTICIDE B4RSQALBEDTOTNANAnot in h5
-PESTICIDE B4RSQALTOTSANDNANAnot in h5
-PESTICIDE B4RSQALTOTSILTNANAnot in h5
-PESTICIDE B4RSQALTOTCLAYNANAnot in h5
-PESTICIDE B4RSQALTOTTOTNANAnot in h5
-PESTICIDE B4RRQALNANAnot in h5
-PESTICIDE B4IDQALNANAnot in h5
-PESTICIDE B4ISQALSANDNANAnot in h5
-PESTICIDE B4ISQALSILTNANAnot in h5
-PESTICIDE B4ISQALCLAYNANAnot in h5
-PESTICIDE B4ISQALTOTNANAnot in h5
-PESTICIDE B4TIQALNANAnot in h5
-PESTICIDE B4DDQALHYDROLNANAnot in h5
-PESTICIDE B4DDQALOXIDNANAnot in h5
-PESTICIDE B4DDQALPHOTOLNANAnot in h5
-PESTICIDE B4DDQALVOLATNANAnot in h5
-PESTICIDE B4DDQALBIODEGNANAnot in h5
-PESTICIDE B4DDQALGENNANAnot in h5
-PESTICIDE B4DDQALTOTNANAnot in h5
-PESTICIDE B4SQDECSUSPSANDNANAnot in h5
-PESTICIDE B4SQDECSUSPSILTNANAnot in h5
-PESTICIDE B4SQDECSUSPCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDSANDNANAnot in h5
-PESTICIDE B4SQDECBEDSILTNANAnot in h5
-PESTICIDE B4SQDECBEDCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDTOTNANAnot in h5
-PESTICIDE B4ADQALSUSPSANDNANAnot in h5
-PESTICIDE B4ADQALSUSPSILTNANAnot in h5
-PESTICIDE B4ADQALSUSPCLAYNANAnot in h5
-PESTICIDE B4ADQALBEDSANDNANAnot in h5
-PESTICIDE B4ADQALBEDSILTNANAnot in h5
-PESTICIDE B4ADQALBEDCLAYNANAnot in h5
-PESTICIDE B4ADQALTOTNANAnot in h5
-PESTICIDE B4DSQALSANDNANAnot in h5
-PESTICIDE B4DSQALSILTNANAnot in h5
-PESTICIDE B4DSQALCLAYNANAnot in h5
-PESTICIDE B4DSQALTOTNANAnot in h5
-PESTICIDE B4RODQALNANAnot in h5
-PESTICIDE B4ROSQALSANDNANAnot in h5
-PESTICIDE B4ROSQALSILTNANAnot in h5
-PESTICIDE B4ROSQALCLAYNANAnot in h5
-PESTICIDE B4ROSQALTOTNANAnot in h5
-PESTICIDE B4TROQALNANAnot in h5
-PESTICIDE B4ODQALEXIT1NANAnot in h5
-PESTICIDE B4OSQALSAND1NANAnot in h5
-PESTICIDE B4OSQALSILT1NANAnot in h5
-PESTICIDE B4OSQALCLAY1NANAnot in h5
-PESTICIDE B4OSQALTOT1NANAnot in h5
-PESTICIDE B4ODQALEXIT2NANAnot in h5
-PESTICIDE B4OSQALSAND2NANAnot in h5
-PESTICIDE B4OSQALSILT2NANAnot in h5
-PESTICIDE B4OSQALCLAY2NANAnot in h5
-PESTICIDE B4OSQALTOT2NANAnot in h5
RCHRES_OXRX_001_2
ConstituentMax DiffMatchNote
-DOXCONCNANAnot in h5
-DOXSTORNANAnot in h5
-DOXINNANAnot in h5
-DOXFLUXTOTNANAnot in h5
-DOXFLUXREAERNANAnot in h5
-DOXFLUXBODDECNANAnot in h5
-DOXFLUXBENTHALNANAnot in h5
-DOXFLUXNITRNANAnot in h5
-DOXFLUXPHYTONANAnot in h5
-DOXFLUXZOONANAnot in h5
-DOXFLUXBENTHICNANAnot in h5
-DOXOUTTOTNANAnot in h5
-DOXOUTEXIT1NANAnot in h5
-DOXOUTEXIT2NANAnot in h5
-BODCONCNANAnot in h5
-BODSTORNANAnot in h5
-BODINNANAnot in h5
-BODFLUXTOTNANAnot in h5
-BODFLUXBODDECNANAnot in h5
-BODFLUXBENTHALNANAnot in h5
-BODFLUXSINKNANAnot in h5
-BODFLUXDENITRNANAnot in h5
-BODFLUXPHYTONANAnot in h5
-BODFLUXZOONANAnot in h5
-BODFLUXBENTHICNANAnot in h5
-BODOUTTOTNANAnot in h5
-BODOUTEXIT1NANAnot in h5
-BODOUTEXIT2NANAnot in h5
RCHRES_NUTRX_001_2
ConstituentMax DiffMatchNote
-TAMCONCDISNANAnot in h5
-NH4CONCDISNANAnot in h5
-NH3CONCDISNANAnot in h5
-NH4CONCSUSPSANDNANAnot in h5
-NH4CONCSUSPSILTNANAnot in h5
-NH4CONCSUSPCLAYNANAnot in h5
-TAMSTORDISNANAnot in h5
-NH4STORDISNANAnot in h5
-NH3STORDISNANAnot in h5
-TAMINDISNANAnot in h5
-TAMINTOTNANAnot in h5
-TAMPROCFLUXTOTNANAnot in h5
-TAMPROCFLUXNITRNANAnot in h5
-TAMPROCFLUXVOLATNANAnot in h5
-TAMPROCFLUXBENTHALNANAnot in h5
-TAMPROCFLUXBODDECNANAnot in h5
-TAMPROCFLUXPHYTONANAnot in h5
-TAMPROCFLUXZOONANAnot in h5
-TAMPROCFLUXBENTHICNANAnot in h5
-TAMOUTDISNANAnot in h5
-TAMOUTTOTNANAnot in h5
-TAMOUTDISEXIT1NANAnot in h5
-TAMOUTDISEXIT2NANAnot in h5
-NO2CONCDISNANAnot in h5
-NO2STORNANAnot in h5
-NO2INTOTNANAnot in h5
-NO2PROCFLUXTOTNANAnot in h5
-NO2PROCFLUXNITNANAnot in h5
-NO2OUTTOTNANAnot in h5
-NO2OUTDISEXIT1NANAnot in h5
-NO2OUTDISEXIT2NANAnot in h5
-NO3CONCDISNANAnot in h5
-NO3STORNANAnot in h5
-NO3INTOTNANAnot in h5
-NO3PROCFLUXTOTNANAnot in h5
-NO3PROCFLUXNITRNANAnot in h5
-NO3PROCFLUXDENITRNANAnot in h5
-NO3PROCFLUXBODDECNANAnot in h5
-NO3PROCFLUXPHYTONANAnot in h5
-NO3PROCFLUXZOONANAnot in h5
-NO3PROCFLUXBENTHICNANAnot in h5
-NO3OUTTOTNANAnot in h5
-NO3OUTDISEXIT1NANAnot in h5
-NO3OUTDISEXIT2NANAnot in h5
-PO4CONCDISNANAnot in h5
-PO4STORDISNANAnot in h5
-PO4INDISNANAnot in h5
-PO4INTOTNANAnot in h5
-PO4PROCFLUXTOTNANAnot in h5
-PO4PROCFLUXBENTHALNANAnot in h5
-PO4PROCFLUXBODDECNANAnot in h5
-PO4PROCFLUXPHYTONANAnot in h5
-PO4PROCFLUXZOONANAnot in h5
-PO4PROCFLUXBENTHICNANAnot in h5
-PO4OUTDISNANAnot in h5
-PO4OUTTOTNANAnot in h5
-PO4OUTDISEXIT1NANAnot in h5
-PO4OUTDISEXIT2NANAnot in h5
RCHRES_PLANK_001_2
ConstituentMax DiffMatchNote
-PHYTONANAnot in h5
-PHYCLANANAnot in h5
-LIMPHYNANAnot in h5
-ZOONANAnot in h5
-BENAL1NANAnot in h5
-BALCLA1NANAnot in h5
-LIMBAL1NANAnot in h5
-NREFORGCONCNANAnot in h5
-PREFORGCONCNANAnot in h5
-CREFORGCONCNANAnot in h5
-NTOTORGCONCNANAnot in h5
-PTOTORGCONCNANAnot in h5
-CTOTORGCONCNANAnot in h5
-POTBODNANAnot in h5
-NTOTCONCNANAnot in h5
-PTOTCONCNANAnot in h5
-PHYTOINNANAnot in h5
-PHYTOOUTNANAnot in h5
-PHYTOOUTEXIT1NANAnot in h5
-PHYTOOUTEXIT2NANAnot in h5
-ZOOINNANAnot in h5
-ZOOOUTNANAnot in h5
-ZOOOUTEXIT1NANAnot in h5
-ZOOOUTEXIT2NANAnot in h5
-NREFORGINNANAnot in h5
-NREFORGOUTNANAnot in h5
-NREFORGOUTEXIT1NANAnot in h5
-NREFORGOUTEXIT2NANAnot in h5
-PREFORGINNANAnot in h5
-PREFORGOUTNANAnot in h5
-PREFORGOUTEXIT1NANAnot in h5
-PREFORGOUTEXIT2NANAnot in h5
-CREFORGINNANAnot in h5
-CREFORGOUTNANAnot in h5
-CREFORGOUTEXIT1NANAnot in h5
-CREFORGOUTEXIT2NANAnot in h5
-PHYTOTOTPROCFLUXNANAnot in h5
-PHYTOSINKNANAnot in h5
-PHYTOZOOPREDNANAnot in h5
-PHYTODEATHNANAnot in h5
-PHYTOGROWTHNANAnot in h5
-ZOOTOTPROCFLUXNANAnot in h5
-ZOOGROWTHNANAnot in h5
-ZOODEATHNANAnot in h5
-BENAL1NANAnot in h5
-BENTHICGROWTH1NANAnot in h5
-BENTHICDEATH1NANAnot in h5
-NREFORGTOTPROCFLUXNANAnot in h5
-NREFORGSINKNANAnot in h5
-NREFORGPHYTODEATHNANAnot in h5
-NREFORGZOODEATHNANAnot in h5
-NREFORGBENTHICDEATHNANAnot in h5
-PREFORGTOTPROCFLUXNANAnot in h5
-PREFORGSINKNANAnot in h5
-PREFORGPHYTODEATHNANAnot in h5
-PREFORGZOODEATHNANAnot in h5
-PREFORGBENTHICDEATHNANAnot in h5
-CREFORGTOTPROCFLUXNANAnot in h5
-CREFORGSINKNANAnot in h5
-CREFORGPHYTODEATHNANAnot in h5
-CREFORGZOODEATHNANAnot in h5
-CREFORGBENTHICDEATHNANAnot in h5
-NTOTORGINNANAnot in h5
-NTOTORGOUTNANAnot in h5
-NTOTORGOUTEXIT1NANAnot in h5
-NTOTORGOUTEXIT2NANAnot in h5
-PTOTORGINNANAnot in h5
-PTOTORGOUTNANAnot in h5
-PTOTORGOUTEXIT1NANAnot in h5
-PTOTORGOUTEXIT2NANAnot in h5
-CTOTORGINNANAnot in h5
-CTOTORGOUTNANAnot in h5
-CTOTORGOUTEXIT1NANAnot in h5
-CTOTORGOUTEXIT2NANAnot in h5
-NTOTINNANAnot in h5
-NTOTOUTNANAnot in h5
-NTOTOUTEXIT1NANAnot in h5
-NTOTOUTEXIT2NANAnot in h5
-PTOTINNANAnot in h5
-PTOTOUTNANAnot in h5
-PTOTOUTEXIT1NANAnot in h5
-PTOTOUTEXIT2NANAnot in h5
RCHRES_PHCARB_001_2
ConstituentMax DiffMatchNote
-TICCONCNANAnot in h5
-CO2CONCNANAnot in h5
-PHNANAnot in h5
-TICINNANAnot in h5
-TICOUTNANAnot in h5
-TICOUTEXIT1NANAnot in h5
-TICOUTEXIT2NANAnot in h5
-CO2INNANAnot in h5
-CO2OUTNANAnot in h5
-CO2OUTEXIT1NANAnot in h5
-CO2OUTEXIT2NANAnot in h5
-CO2TOTPROCFLUXNANAnot in h5
-CO2BODDNANAnot in h5
-CO2PHYTNANAnot in h5
-CO2ZOONANAnot in h5
-CO2BENTNANAnot in h5
-CO2BENTNANAnot in h5
-CO2INVANANAnot in h5
RCHRES_HYDR_002_2
ConstituentMax DiffMatchNote
-VOL124.02978993579745X
-DEP19.66168901324272X
-STAGENANAnot in h5
-AVDEPNANAnot in h5
-TWIDNANAnot in h5
-HRADNANAnot in h5
-SAREA12.167598322033882X
-AVVELNANAnot in h5
-AVSECTNANAnot in h5
-USTAR0.42124365337076597X
-TAU0.344452195093254X
-RO11.485855102539062X
-IVOL2.0215455889701843X
-PRSUPY0.6324578952044249X
-VOLEV0.014517487572447862X
-ROVOL0.9367459416389465X
-POTEVNANAnot in h5
RCHRES_CONS_002_2
ConstituentMax DiffMatchNote
-ALKALINITYCONCNANAnot in h5
-ALKALINITYICONNANAnot in h5
-ALKALINITYROCONNANAnot in h5
RCHRES_HTRCH_002_2
ConstituentMax DiffMatchNote
-AIRTMP0.15480804443359375X
-DEWTMPNANAnot in h5
-TW37.40068054199219X
-IHEAT117744174.0X
-HTEXCH104264778.75X
-ROHEAT91223512.0X
-QTOTALNANAnot in h5
-QSOLARNANAnot in h5
-QLONGWNANAnot in h5
-QEVAPNANAnot in h5
-QCONNANAnot in h5
-QPRECNANAnot in h5
-QBEDNANAnot in h5
RCHRES_SEDTRN_002_2
ConstituentMax DiffMatchNote
-SSEDSANDNANAnot in h5
-SSEDSILTNANAnot in h5
-SSEDCLAYNANAnot in h5
-SSEDTOTNANAnot in h5
-RSEDSUSPSANDNANAnot in h5
-RSEDSUSPSILTNANAnot in h5
-RSEDSUSPCLAYNANAnot in h5
-RSEDSUSPTOTNANAnot in h5
-RSEDBEDSANDNANAnot in h5
-RSEDBEDSILTNANAnot in h5
-RSEDBEDCLAYNANAnot in h5
-RSEDBEDTOTNANAnot in h5
-RSEDTOTSANDNANAnot in h5
-RSEDTOTSILTNANAnot in h5
-RSEDTOTCLAYNANAnot in h5
-RSEDTOTTOTNANAnot in h5
-BEDDEP1.5336849391460419X
-ISEDSANDNANAnot in h5
-ISEDSILTNANAnot in h5
-ISEDCLAYNANAnot in h5
-ISEDTOTNANAnot in h5
-DEPSCOURSANDNANAnot in h5
-DEPSCOURSILTNANAnot in h5
-DEPSCOURCLAYNANAnot in h5
-DEPSCOURTOTNANAnot in h5
-ROSEDSANDNANAnot in h5
-ROSEDSILTNANAnot in h5
-ROSEDCLAYNANAnot in h5
-ROSEDTOTNANAnot in h5
-OSEDSANDEXIT1NANAnot in h5
-OSEDSILTEXIT1NANAnot in h5
-OSEDCLAYEXIT1NANAnot in h5
-OSEDTOTEXIT1NANAnot in h5
RCHRES_GQUAL_002_2
ConstituentMax DiffMatchNote
-PESTICIDE B4DQALNANAnot in h5
-PESTICIDE B4SQALSUSPSANDNANAnot in h5
-PESTICIDE B4SQALSUSPSILTNANAnot in h5
-PESTICIDE B4SQALSUSPCLAYNANAnot in h5
-PESTICIDE B4SQALBEDSANDNANAnot in h5
-PESTICIDE B4SQALBEDSILTNANAnot in h5
-PESTICIDE B4SQALBEDCLAYNANAnot in h5
-PESTICIDE B4RDQALNANAnot in h5
-PESTICIDE B4RSQALSUSPSANDNANAnot in h5
-PESTICIDE B4RSQALSUSPSILTNANAnot in h5
-PESTICIDE B4RSQALSUSPCLAYNANAnot in h5
-PESTICIDE B4RSQALSUSPTOTNANAnot in h5
-PESTICIDE B4RSQALBEDSANDNANAnot in h5
-PESTICIDE B4RSQALBEDSILTNANAnot in h5
-PESTICIDE B4RSQALBEDCLAYNANAnot in h5
-PESTICIDE B4RSQALBEDTOTNANAnot in h5
-PESTICIDE B4RSQALTOTSANDNANAnot in h5
-PESTICIDE B4RSQALTOTSILTNANAnot in h5
-PESTICIDE B4RSQALTOTCLAYNANAnot in h5
-PESTICIDE B4RSQALTOTTOTNANAnot in h5
-PESTICIDE B4RRQALNANAnot in h5
-PESTICIDE B4IDQALNANAnot in h5
-PESTICIDE B4ISQALSANDNANAnot in h5
-PESTICIDE B4ISQALSILTNANAnot in h5
-PESTICIDE B4ISQALCLAYNANAnot in h5
-PESTICIDE B4ISQALTOTNANAnot in h5
-PESTICIDE B4TIQALNANAnot in h5
-PESTICIDE B4DDQALHYDROLNANAnot in h5
-PESTICIDE B4DDQALOXIDNANAnot in h5
-PESTICIDE B4DDQALPHOTOLNANAnot in h5
-PESTICIDE B4DDQALVOLATNANAnot in h5
-PESTICIDE B4DDQALBIODEGNANAnot in h5
-PESTICIDE B4DDQALGENNANAnot in h5
-PESTICIDE B4DDQALTOTNANAnot in h5
-PESTICIDE B4SQDECSUSPSANDNANAnot in h5
-PESTICIDE B4SQDECSUSPSILTNANAnot in h5
-PESTICIDE B4SQDECSUSPCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDSANDNANAnot in h5
-PESTICIDE B4SQDECBEDSILTNANAnot in h5
-PESTICIDE B4SQDECBEDCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDTOTNANAnot in h5
-PESTICIDE B4ADQALSUSPSANDNANAnot in h5
-PESTICIDE B4ADQALSUSPSILTNANAnot in h5
-PESTICIDE B4ADQALSUSPCLAYNANAnot in h5
-PESTICIDE B4ADQALBEDSANDNANAnot in h5
-PESTICIDE B4ADQALBEDSILTNANAnot in h5
-PESTICIDE B4ADQALBEDCLAYNANAnot in h5
-PESTICIDE B4ADQALTOTNANAnot in h5
-PESTICIDE B4DSQALSANDNANAnot in h5
-PESTICIDE B4DSQALSILTNANAnot in h5
-PESTICIDE B4DSQALCLAYNANAnot in h5
-PESTICIDE B4DSQALTOTNANAnot in h5
-PESTICIDE B4RODQALNANAnot in h5
-PESTICIDE B4ROSQALSANDNANAnot in h5
-PESTICIDE B4ROSQALSILTNANAnot in h5
-PESTICIDE B4ROSQALCLAYNANAnot in h5
-PESTICIDE B4ROSQALTOTNANAnot in h5
-PESTICIDE B4TROQALNANAnot in h5
RCHRES_OXRX_002_2
ConstituentMax DiffMatchNote
-DOXCONCNANAnot in h5
-DOXSTORNANAnot in h5
-DOXINNANAnot in h5
-DOXFLUXTOTNANAnot in h5
-DOXFLUXREAERNANAnot in h5
-DOXFLUXBODDECNANAnot in h5
-DOXFLUXBENTHALNANAnot in h5
-DOXFLUXNITRNANAnot in h5
-DOXFLUXPHYTONANAnot in h5
-DOXFLUXZOONANAnot in h5
-DOXFLUXBENTHICNANAnot in h5
-DOXOUTTOTNANAnot in h5
-BODCONCNANAnot in h5
-BODSTORNANAnot in h5
-BODINNANAnot in h5
-BODFLUXTOTNANAnot in h5
-BODFLUXBODDECNANAnot in h5
-BODFLUXBENTHALNANAnot in h5
-BODFLUXSINKNANAnot in h5
-BODFLUXDENITRNANAnot in h5
-BODFLUXPHYTONANAnot in h5
-BODFLUXZOONANAnot in h5
-BODFLUXBENTHICNANAnot in h5
-BODOUTTOTNANAnot in h5
RCHRES_NUTRX_002_2
ConstituentMax DiffMatchNote
-TAMCONCDISNANAnot in h5
-NH4CONCDISNANAnot in h5
-NH3CONCDISNANAnot in h5
-NH4CONCSUSPSANDNANAnot in h5
-NH4CONCSUSPSILTNANAnot in h5
-NH4CONCSUSPCLAYNANAnot in h5
-TAMSTORDISNANAnot in h5
-NH4STORDISNANAnot in h5
-NH3STORDISNANAnot in h5
-TAMINDISNANAnot in h5
-TAMINTOTNANAnot in h5
-TAMPROCFLUXTOTNANAnot in h5
-TAMPROCFLUXNITRNANAnot in h5
-TAMPROCFLUXVOLATNANAnot in h5
-TAMPROCFLUXBENTHALNANAnot in h5
-TAMPROCFLUXBODDECNANAnot in h5
-TAMPROCFLUXPHYTONANAnot in h5
-TAMPROCFLUXZOONANAnot in h5
-TAMPROCFLUXBENTHICNANAnot in h5
-TAMOUTDISNANAnot in h5
-TAMOUTTOTNANAnot in h5
-TAMOUTDISEXIT1NANAnot in h5
-NO2CONCDISNANAnot in h5
-NO2STORNANAnot in h5
-NO2INTOTNANAnot in h5
-NO2PROCFLUXTOTNANAnot in h5
-NO2PROCFLUXNITNANAnot in h5
-NO2OUTTOTNANAnot in h5
-NO3CONCDISNANAnot in h5
-NO3STORNANAnot in h5
-NO3INTOTNANAnot in h5
-NO3PROCFLUXTOTNANAnot in h5
-NO3PROCFLUXNITRNANAnot in h5
-NO3PROCFLUXDENITRNANAnot in h5
-NO3PROCFLUXBODDECNANAnot in h5
-NO3PROCFLUXPHYTONANAnot in h5
-NO3PROCFLUXZOONANAnot in h5
-NO3PROCFLUXBENTHICNANAnot in h5
-NO3OUTTOTNANAnot in h5
-PO4CONCDISNANAnot in h5
-PO4STORDISNANAnot in h5
-PO4INDISNANAnot in h5
-PO4INTOTNANAnot in h5
-PO4PROCFLUXTOTNANAnot in h5
-PO4PROCFLUXBENTHALNANAnot in h5
-PO4PROCFLUXBODDECNANAnot in h5
-PO4PROCFLUXPHYTONANAnot in h5
-PO4PROCFLUXZOONANAnot in h5
-PO4PROCFLUXBENTHICNANAnot in h5
-PO4OUTDISNANAnot in h5
-PO4OUTTOTNANAnot in h5
-PO4OUTDISEXIT1NANAnot in h5
RCHRES_PLANK_002_2
ConstituentMax DiffMatchNote
-PHYTONANAnot in h5
-PHYCLANANAnot in h5
-LIMPHYNANAnot in h5
-ZOONANAnot in h5
-BENAL1NANAnot in h5
-BALCLA1NANAnot in h5
-LIMBAL1NANAnot in h5
-NREFORGCONCNANAnot in h5
-PREFORGCONCNANAnot in h5
-CREFORGCONCNANAnot in h5
-NTOTORGCONCNANAnot in h5
-PTOTORGCONCNANAnot in h5
-CTOTORGCONCNANAnot in h5
-POTBODNANAnot in h5
-NTOTCONCNANAnot in h5
-PTOTCONCNANAnot in h5
-PHYTOINNANAnot in h5
-PHYTOOUTNANAnot in h5
-ZOOINNANAnot in h5
-ZOOOUTNANAnot in h5
-NREFORGINNANAnot in h5
-NREFORGOUTNANAnot in h5
-PREFORGINNANAnot in h5
-PREFORGOUTNANAnot in h5
-CREFORGINNANAnot in h5
-CREFORGOUTNANAnot in h5
-PHYTOTOTPROCFLUXNANAnot in h5
-PHYTOSINKNANAnot in h5
-PHYTOZOOPREDNANAnot in h5
-PHYTODEATHNANAnot in h5
-PHYTOGROWTHNANAnot in h5
-ZOOTOTPROCFLUXNANAnot in h5
-ZOOGROWTHNANAnot in h5
-ZOODEATHNANAnot in h5
-BENAL1NANAnot in h5
-BENTHICGROWTH1NANAnot in h5
-BENTHICDEATH1NANAnot in h5
-NREFORGTOTPROCFLUXNANAnot in h5
-NREFORGSINKNANAnot in h5
-NREFORGPHYTODEATHNANAnot in h5
-NREFORGZOODEATHNANAnot in h5
-NREFORGBENTHICDEATHNANAnot in h5
-PREFORGTOTPROCFLUXNANAnot in h5
-PREFORGSINKNANAnot in h5
-PREFORGPHYTODEATHNANAnot in h5
-PREFORGZOODEATHNANAnot in h5
-PREFORGBENTHICDEATHNANAnot in h5
-CREFORGTOTPROCFLUXNANAnot in h5
-CREFORGSINKNANAnot in h5
-CREFORGPHYTODEATHNANAnot in h5
-CREFORGZOODEATHNANAnot in h5
-CREFORGBENTHICDEATHNANAnot in h5
-NTOTORGINNANAnot in h5
-NTOTORGOUTNANAnot in h5
-PTOTORGINNANAnot in h5
-PTOTORGOUTNANAnot in h5
-CTOTORGINNANAnot in h5
-CTOTORGOUTNANAnot in h5
-NTOTINNANAnot in h5
-NTOTOUTNANAnot in h5
-PTOTINNANAnot in h5
-PTOTOUTNANAnot in h5
RCHRES_PHCARB_002_2
ConstituentMax DiffMatchNote
-TICCONCNANAnot in h5
-CO2CONCNANAnot in h5
-PHNANAnot in h5
-TICINNANAnot in h5
-TICOUTNANAnot in h5
-CO2INNANAnot in h5
-CO2OUTNANAnot in h5
-CO2TOTPROCFLUXNANAnot in h5
-CO2BODDNANAnot in h5
-CO2PHYTNANAnot in h5
-CO2ZOONANAnot in h5
-CO2BENTNANAnot in h5
-CO2BENTNANAnot in h5
-CO2INVANANAnot in h5
RCHRES_HYDR_003_2
ConstituentMax DiffMatchNote
-VOL124.03283881396055X
-DEP19.999576568603516X
-STAGENANAnot in h5
-AVDEPNANAnot in h5
-TWIDNANAnot in h5
-HRADNANAnot in h5
-SAREA12.169527523219585X
-AVVELNANAnot in h5
-AVSECTNANAnot in h5
-USTAR0.5060839815123472X
-TAU0.4970202159282451X
-RO10.382853507995605X
-IVOL2.4172273874282837X
-PRSUPY0.6333829283248633X
-VOLEV0.01463033352047205X
-ROVOL0.8445035517215729X
-POTEVNANAnot in h5
RCHRES_CONS_003_2
ConstituentMax DiffMatchNote
-ALKALINITYCONCNANAnot in h5
-ALKALINITYICONNANAnot in h5
-ALKALINITYROCONNANAnot in h5
RCHRES_HTRCH_003_2
ConstituentMax DiffMatchNote
-AIRTMP0.15480804443359375X
-DEWTMPNANAnot in h5
-TW37.40068054199219X
-IHEAT137792648.5X
-HTEXCH104513746.5X
-ROHEAT87263688.0X
-QTOTALNANAnot in h5
-QSOLARNANAnot in h5
-QLONGWNANAnot in h5
-QEVAPNANAnot in h5
-QCONNANAnot in h5
-QPRECNANAnot in h5
-QBEDNANAnot in h5
RCHRES_SEDTRN_003_2
ConstituentMax DiffMatchNote
-SSEDSANDNANAnot in h5
-SSEDSILTNANAnot in h5
-SSEDCLAYNANAnot in h5
-SSEDTOTNANAnot in h5
-RSEDSUSPSANDNANAnot in h5
-RSEDSUSPSILTNANAnot in h5
-RSEDSUSPCLAYNANAnot in h5
-RSEDSUSPTOTNANAnot in h5
-RSEDBEDSANDNANAnot in h5
-RSEDBEDSILTNANAnot in h5
-RSEDBEDCLAYNANAnot in h5
-RSEDBEDTOTNANAnot in h5
-RSEDTOTSANDNANAnot in h5
-RSEDTOTSILTNANAnot in h5
-RSEDTOTCLAYNANAnot in h5
-RSEDTOTTOTNANAnot in h5
-BEDDEP1.5336849391460419X
-ISEDSANDNANAnot in h5
-ISEDSILTNANAnot in h5
-ISEDCLAYNANAnot in h5
-ISEDTOTNANAnot in h5
-DEPSCOURSANDNANAnot in h5
-DEPSCOURSILTNANAnot in h5
-DEPSCOURCLAYNANAnot in h5
-DEPSCOURTOTNANAnot in h5
-ROSEDSANDNANAnot in h5
-ROSEDSILTNANAnot in h5
-ROSEDCLAYNANAnot in h5
-ROSEDTOTNANAnot in h5
-OSEDSANDEXIT1NANAnot in h5
-OSEDSILTEXIT1NANAnot in h5
-OSEDCLAYEXIT1NANAnot in h5
-OSEDTOTEXIT1NANAnot in h5
RCHRES_GQUAL_003_2
ConstituentMax DiffMatchNote
-PESTICIDE B4DQALNANAnot in h5
-PESTICIDE B4SQALSUSPSANDNANAnot in h5
-PESTICIDE B4SQALSUSPSILTNANAnot in h5
-PESTICIDE B4SQALSUSPCLAYNANAnot in h5
-PESTICIDE B4SQALBEDSANDNANAnot in h5
-PESTICIDE B4SQALBEDSILTNANAnot in h5
-PESTICIDE B4SQALBEDCLAYNANAnot in h5
-PESTICIDE B4RDQALNANAnot in h5
-PESTICIDE B4RSQALSUSPSANDNANAnot in h5
-PESTICIDE B4RSQALSUSPSILTNANAnot in h5
-PESTICIDE B4RSQALSUSPCLAYNANAnot in h5
-PESTICIDE B4RSQALSUSPTOTNANAnot in h5
-PESTICIDE B4RSQALBEDSANDNANAnot in h5
-PESTICIDE B4RSQALBEDSILTNANAnot in h5
-PESTICIDE B4RSQALBEDCLAYNANAnot in h5
-PESTICIDE B4RSQALBEDTOTNANAnot in h5
-PESTICIDE B4RSQALTOTSANDNANAnot in h5
-PESTICIDE B4RSQALTOTSILTNANAnot in h5
-PESTICIDE B4RSQALTOTCLAYNANAnot in h5
-PESTICIDE B4RSQALTOTTOTNANAnot in h5
-PESTICIDE B4RRQALNANAnot in h5
-PESTICIDE B4IDQALNANAnot in h5
-PESTICIDE B4ISQALSANDNANAnot in h5
-PESTICIDE B4ISQALSILTNANAnot in h5
-PESTICIDE B4ISQALCLAYNANAnot in h5
-PESTICIDE B4ISQALTOTNANAnot in h5
-PESTICIDE B4TIQALNANAnot in h5
-PESTICIDE B4DDQALHYDROLNANAnot in h5
-PESTICIDE B4DDQALOXIDNANAnot in h5
-PESTICIDE B4DDQALPHOTOLNANAnot in h5
-PESTICIDE B4DDQALVOLATNANAnot in h5
-PESTICIDE B4DDQALBIODEGNANAnot in h5
-PESTICIDE B4DDQALGENNANAnot in h5
-PESTICIDE B4DDQALTOTNANAnot in h5
-PESTICIDE B4SQDECSUSPSANDNANAnot in h5
-PESTICIDE B4SQDECSUSPSILTNANAnot in h5
-PESTICIDE B4SQDECSUSPCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDSANDNANAnot in h5
-PESTICIDE B4SQDECBEDSILTNANAnot in h5
-PESTICIDE B4SQDECBEDCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDTOTNANAnot in h5
-PESTICIDE B4ADQALSUSPSANDNANAnot in h5
-PESTICIDE B4ADQALSUSPSILTNANAnot in h5
-PESTICIDE B4ADQALSUSPCLAYNANAnot in h5
-PESTICIDE B4ADQALBEDSANDNANAnot in h5
-PESTICIDE B4ADQALBEDSILTNANAnot in h5
-PESTICIDE B4ADQALBEDCLAYNANAnot in h5
-PESTICIDE B4ADQALTOTNANAnot in h5
-PESTICIDE B4DSQALSANDNANAnot in h5
-PESTICIDE B4DSQALSILTNANAnot in h5
-PESTICIDE B4DSQALCLAYNANAnot in h5
-PESTICIDE B4DSQALTOTNANAnot in h5
-PESTICIDE B4RODQALNANAnot in h5
-PESTICIDE B4ROSQALSANDNANAnot in h5
-PESTICIDE B4ROSQALSILTNANAnot in h5
-PESTICIDE B4ROSQALCLAYNANAnot in h5
-PESTICIDE B4ROSQALTOTNANAnot in h5
-PESTICIDE B4TROQALNANAnot in h5
RCHRES_OXRX_003_2
ConstituentMax DiffMatchNote
-DOXCONCNANAnot in h5
-DOXSTORNANAnot in h5
-DOXINNANAnot in h5
-DOXFLUXTOTNANAnot in h5
-DOXFLUXREAERNANAnot in h5
-DOXFLUXBODDECNANAnot in h5
-DOXFLUXBENTHALNANAnot in h5
-DOXFLUXNITRNANAnot in h5
-DOXFLUXPHYTONANAnot in h5
-DOXFLUXZOONANAnot in h5
-DOXFLUXBENTHICNANAnot in h5
-DOXOUTTOTNANAnot in h5
-BODCONCNANAnot in h5
-BODSTORNANAnot in h5
-BODINNANAnot in h5
-BODFLUXTOTNANAnot in h5
-BODFLUXBODDECNANAnot in h5
-BODFLUXBENTHALNANAnot in h5
-BODFLUXSINKNANAnot in h5
-BODFLUXDENITRNANAnot in h5
-BODFLUXPHYTONANAnot in h5
-BODFLUXZOONANAnot in h5
-BODFLUXBENTHICNANAnot in h5
-BODOUTTOTNANAnot in h5
RCHRES_NUTRX_003_2
ConstituentMax DiffMatchNote
-TAMCONCDISNANAnot in h5
-NH4CONCDISNANAnot in h5
-NH3CONCDISNANAnot in h5
-NH4CONCSUSPSANDNANAnot in h5
-NH4CONCSUSPSILTNANAnot in h5
-NH4CONCSUSPCLAYNANAnot in h5
-TAMSTORDISNANAnot in h5
-NH4STORDISNANAnot in h5
-NH3STORDISNANAnot in h5
-TAMINDISNANAnot in h5
-TAMINTOTNANAnot in h5
-TAMPROCFLUXTOTNANAnot in h5
-TAMPROCFLUXNITRNANAnot in h5
-TAMPROCFLUXVOLATNANAnot in h5
-TAMPROCFLUXBENTHALNANAnot in h5
-TAMPROCFLUXBODDECNANAnot in h5
-TAMPROCFLUXPHYTONANAnot in h5
-TAMPROCFLUXZOONANAnot in h5
-TAMPROCFLUXBENTHICNANAnot in h5
-TAMOUTDISNANAnot in h5
-TAMOUTTOTNANAnot in h5
-TAMOUTDISEXIT1NANAnot in h5
-NO2CONCDISNANAnot in h5
-NO2STORNANAnot in h5
-NO2INTOTNANAnot in h5
-NO2PROCFLUXTOTNANAnot in h5
-NO2PROCFLUXNITNANAnot in h5
-NO2OUTTOTNANAnot in h5
-NO3CONCDISNANAnot in h5
-NO3STORNANAnot in h5
-NO3INTOTNANAnot in h5
-NO3PROCFLUXTOTNANAnot in h5
-NO3PROCFLUXNITRNANAnot in h5
-NO3PROCFLUXDENITRNANAnot in h5
-NO3PROCFLUXBODDECNANAnot in h5
-NO3PROCFLUXPHYTONANAnot in h5
-NO3PROCFLUXZOONANAnot in h5
-NO3PROCFLUXBENTHICNANAnot in h5
-NO3OUTTOTNANAnot in h5
-PO4CONCDISNANAnot in h5
-PO4STORDISNANAnot in h5
-PO4INDISNANAnot in h5
-PO4INTOTNANAnot in h5
-PO4PROCFLUXTOTNANAnot in h5
-PO4PROCFLUXBENTHALNANAnot in h5
-PO4PROCFLUXBODDECNANAnot in h5
-PO4PROCFLUXPHYTONANAnot in h5
-PO4PROCFLUXZOONANAnot in h5
-PO4PROCFLUXBENTHICNANAnot in h5
-PO4OUTDISNANAnot in h5
-PO4OUTTOTNANAnot in h5
-PO4OUTDISEXIT1NANAnot in h5
RCHRES_PLANK_003_2
ConstituentMax DiffMatchNote
-PHYTONANAnot in h5
-PHYCLANANAnot in h5
-LIMPHYNANAnot in h5
-ZOONANAnot in h5
-BENAL1NANAnot in h5
-BALCLA1NANAnot in h5
-LIMBAL1NANAnot in h5
-NREFORGCONCNANAnot in h5
-PREFORGCONCNANAnot in h5
-CREFORGCONCNANAnot in h5
-NTOTORGCONCNANAnot in h5
-PTOTORGCONCNANAnot in h5
-CTOTORGCONCNANAnot in h5
-POTBODNANAnot in h5
-NTOTCONCNANAnot in h5
-PTOTCONCNANAnot in h5
-PHYTOINNANAnot in h5
-PHYTOOUTNANAnot in h5
-ZOOINNANAnot in h5
-ZOOOUTNANAnot in h5
-NREFORGINNANAnot in h5
-NREFORGOUTNANAnot in h5
-PREFORGINNANAnot in h5
-PREFORGOUTNANAnot in h5
-CREFORGINNANAnot in h5
-CREFORGOUTNANAnot in h5
-PHYTOTOTPROCFLUXNANAnot in h5
-PHYTOSINKNANAnot in h5
-PHYTOZOOPREDNANAnot in h5
-PHYTODEATHNANAnot in h5
-PHYTOGROWTHNANAnot in h5
-ZOOTOTPROCFLUXNANAnot in h5
-ZOOGROWTHNANAnot in h5
-ZOODEATHNANAnot in h5
-BENAL1NANAnot in h5
-BENTHICGROWTH1NANAnot in h5
-BENTHICDEATH1NANAnot in h5
-NREFORGTOTPROCFLUXNANAnot in h5
-NREFORGSINKNANAnot in h5
-NREFORGPHYTODEATHNANAnot in h5
-NREFORGZOODEATHNANAnot in h5
-NREFORGBENTHICDEATHNANAnot in h5
-PREFORGTOTPROCFLUXNANAnot in h5
-PREFORGSINKNANAnot in h5
-PREFORGPHYTODEATHNANAnot in h5
-PREFORGZOODEATHNANAnot in h5
-PREFORGBENTHICDEATHNANAnot in h5
-CREFORGTOTPROCFLUXNANAnot in h5
-CREFORGSINKNANAnot in h5
-CREFORGPHYTODEATHNANAnot in h5
-CREFORGZOODEATHNANAnot in h5
-CREFORGBENTHICDEATHNANAnot in h5
-NTOTORGINNANAnot in h5
-NTOTORGOUTNANAnot in h5
-PTOTORGINNANAnot in h5
-PTOTORGOUTNANAnot in h5
-CTOTORGINNANAnot in h5
-CTOTORGOUTNANAnot in h5
-NTOTINNANAnot in h5
-NTOTOUTNANAnot in h5
-PTOTINNANAnot in h5
-PTOTOUTNANAnot in h5
RCHRES_PHCARB_003_2
ConstituentMax DiffMatchNote
-TICCONCNANAnot in h5
-CO2CONCNANAnot in h5
-PHNANAnot in h5
-TICINNANAnot in h5
-TICOUTNANAnot in h5
-CO2INNANAnot in h5
-CO2OUTNANAnot in h5
-CO2TOTPROCFLUXNANAnot in h5
-CO2BODDNANAnot in h5
-CO2PHYTNANAnot in h5
-CO2ZOONANAnot in h5
-CO2BENTNANAnot in h5
-CO2BENTNANAnot in h5
-CO2INVANANAnot in h5
RCHRES_HYDR_004_2
ConstituentMax DiffMatchNote
-VOL122.44352090358734X
-DEP19.165059566497803X
-STAGENANAnot in h5
-AVDEPNANAnot in h5
-TWIDNANAnot in h5
-HRADNANAnot in h5
-SAREA10.990119814872742X
-AVVELNANAnot in h5
-AVSECTNANAnot in h5
-USTAR0.3201453774818219X
-TAU0.19905331948044136X
-RO4.822874069213867X
-IVOL1.6074820756912231X
-PRSUPY0.6371300220489502X
-VOLEV0.013195656705647707X
-ROVOL0.24370503425598145X
-POTEVNANAnot in h5
RCHRES_CONS_004_2
ConstituentMax DiffMatchNote
-ALKALINITYCONCNANAnot in h5
-ALKALINITYICONNANAnot in h5
-ALKALINITYROCONNANAnot in h5
RCHRES_HTRCH_004_2
ConstituentMax DiffMatchNote
-AIRTMP26.87310218811035X
-DEWTMPNANAnot in h5
-TW121.77328491210938X
-IHEAT108595052.0X
-HTEXCH112929300.0X
-ROHEAT62059456.0X
-QTOTALNANAnot in h5
-QSOLARNANAnot in h5
-QLONGWNANAnot in h5
-QEVAPNANAnot in h5
-QCONNANAnot in h5
-QPRECNANAnot in h5
-QBEDNANAnot in h5
RCHRES_SEDTRN_004_2
ConstituentMax DiffMatchNote
-SSEDSANDNANAnot in h5
-SSEDSILTNANAnot in h5
-SSEDCLAYNANAnot in h5
-SSEDTOTNANAnot in h5
-RSEDSUSPSANDNANAnot in h5
-RSEDSUSPSILTNANAnot in h5
-RSEDSUSPCLAYNANAnot in h5
-RSEDSUSPTOTNANAnot in h5
-RSEDBEDSANDNANAnot in h5
-RSEDBEDSILTNANAnot in h5
-RSEDBEDCLAYNANAnot in h5
-RSEDBEDTOTNANAnot in h5
-RSEDTOTSANDNANAnot in h5
-RSEDTOTSILTNANAnot in h5
-RSEDTOTCLAYNANAnot in h5
-RSEDTOTTOTNANAnot in h5
-BEDDEP1.7761037051677704X
-ISEDSANDNANAnot in h5
-ISEDSILTNANAnot in h5
-ISEDCLAYNANAnot in h5
-ISEDTOTNANAnot in h5
-DEPSCOURSANDNANAnot in h5
-DEPSCOURSILTNANAnot in h5
-DEPSCOURCLAYNANAnot in h5
-DEPSCOURTOTNANAnot in h5
-ROSEDSANDNANAnot in h5
-ROSEDSILTNANAnot in h5
-ROSEDCLAYNANAnot in h5
-ROSEDTOTNANAnot in h5
-OSEDSANDEXIT1NANAnot in h5
-OSEDSILTEXIT1NANAnot in h5
-OSEDCLAYEXIT1NANAnot in h5
-OSEDTOTEXIT1NANAnot in h5
RCHRES_GQUAL_004_2
ConstituentMax DiffMatchNote
-PESTICIDE B4DQALNANAnot in h5
-PESTICIDE B4SQALSUSPSANDNANAnot in h5
-PESTICIDE B4SQALSUSPSILTNANAnot in h5
-PESTICIDE B4SQALSUSPCLAYNANAnot in h5
-PESTICIDE B4SQALBEDSANDNANAnot in h5
-PESTICIDE B4SQALBEDSILTNANAnot in h5
-PESTICIDE B4SQALBEDCLAYNANAnot in h5
-PESTICIDE B4RDQALNANAnot in h5
-PESTICIDE B4RSQALSUSPSANDNANAnot in h5
-PESTICIDE B4RSQALSUSPSILTNANAnot in h5
-PESTICIDE B4RSQALSUSPCLAYNANAnot in h5
-PESTICIDE B4RSQALSUSPTOTNANAnot in h5
-PESTICIDE B4RSQALBEDSANDNANAnot in h5
-PESTICIDE B4RSQALBEDSILTNANAnot in h5
-PESTICIDE B4RSQALBEDCLAYNANAnot in h5
-PESTICIDE B4RSQALBEDTOTNANAnot in h5
-PESTICIDE B4RSQALTOTSANDNANAnot in h5
-PESTICIDE B4RSQALTOTSILTNANAnot in h5
-PESTICIDE B4RSQALTOTCLAYNANAnot in h5
-PESTICIDE B4RSQALTOTTOTNANAnot in h5
-PESTICIDE B4RRQALNANAnot in h5
-PESTICIDE B4IDQALNANAnot in h5
-PESTICIDE B4ISQALSANDNANAnot in h5
-PESTICIDE B4ISQALSILTNANAnot in h5
-PESTICIDE B4ISQALCLAYNANAnot in h5
-PESTICIDE B4ISQALTOTNANAnot in h5
-PESTICIDE B4TIQALNANAnot in h5
-PESTICIDE B4DDQALHYDROLNANAnot in h5
-PESTICIDE B4DDQALOXIDNANAnot in h5
-PESTICIDE B4DDQALPHOTOLNANAnot in h5
-PESTICIDE B4DDQALVOLATNANAnot in h5
-PESTICIDE B4DDQALBIODEGNANAnot in h5
-PESTICIDE B4DDQALGENNANAnot in h5
-PESTICIDE B4DDQALTOTNANAnot in h5
-PESTICIDE B4SQDECSUSPSANDNANAnot in h5
-PESTICIDE B4SQDECSUSPSILTNANAnot in h5
-PESTICIDE B4SQDECSUSPCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDSANDNANAnot in h5
-PESTICIDE B4SQDECBEDSILTNANAnot in h5
-PESTICIDE B4SQDECBEDCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDTOTNANAnot in h5
-PESTICIDE B4ADQALSUSPSANDNANAnot in h5
-PESTICIDE B4ADQALSUSPSILTNANAnot in h5
-PESTICIDE B4ADQALSUSPCLAYNANAnot in h5
-PESTICIDE B4ADQALBEDSANDNANAnot in h5
-PESTICIDE B4ADQALBEDSILTNANAnot in h5
-PESTICIDE B4ADQALBEDCLAYNANAnot in h5
-PESTICIDE B4ADQALTOTNANAnot in h5
-PESTICIDE B4DSQALSANDNANAnot in h5
-PESTICIDE B4DSQALSILTNANAnot in h5
-PESTICIDE B4DSQALCLAYNANAnot in h5
-PESTICIDE B4DSQALTOTNANAnot in h5
-PESTICIDE B4RODQALNANAnot in h5
-PESTICIDE B4ROSQALSANDNANAnot in h5
-PESTICIDE B4ROSQALSILTNANAnot in h5
-PESTICIDE B4ROSQALCLAYNANAnot in h5
-PESTICIDE B4ROSQALTOTNANAnot in h5
-PESTICIDE B4TROQALNANAnot in h5
RCHRES_OXRX_004_2
ConstituentMax DiffMatchNote
-DOXCONCNANAnot in h5
-DOXSTORNANAnot in h5
-DOXINNANAnot in h5
-DOXFLUXTOTNANAnot in h5
-DOXFLUXREAERNANAnot in h5
-DOXFLUXBODDECNANAnot in h5
-DOXFLUXBENTHALNANAnot in h5
-DOXFLUXNITRNANAnot in h5
-DOXFLUXPHYTONANAnot in h5
-DOXFLUXZOONANAnot in h5
-DOXFLUXBENTHICNANAnot in h5
-DOXOUTTOTNANAnot in h5
-BODCONCNANAnot in h5
-BODSTORNANAnot in h5
-BODINNANAnot in h5
-BODFLUXTOTNANAnot in h5
-BODFLUXBODDECNANAnot in h5
-BODFLUXBENTHALNANAnot in h5
-BODFLUXSINKNANAnot in h5
-BODFLUXDENITRNANAnot in h5
-BODFLUXPHYTONANAnot in h5
-BODFLUXZOONANAnot in h5
-BODFLUXBENTHICNANAnot in h5
-BODOUTTOTNANAnot in h5
RCHRES_NUTRX_004_2
ConstituentMax DiffMatchNote
-TAMCONCDISNANAnot in h5
-NH4CONCDISNANAnot in h5
-NH3CONCDISNANAnot in h5
-NH4CONCSUSPSANDNANAnot in h5
-NH4CONCSUSPSILTNANAnot in h5
-NH4CONCSUSPCLAYNANAnot in h5
-TAMSTORDISNANAnot in h5
-NH4STORDISNANAnot in h5
-NH3STORDISNANAnot in h5
-TAMINDISNANAnot in h5
-TAMINTOTNANAnot in h5
-TAMPROCFLUXTOTNANAnot in h5
-TAMPROCFLUXNITRNANAnot in h5
-TAMPROCFLUXVOLATNANAnot in h5
-TAMPROCFLUXBENTHALNANAnot in h5
-TAMPROCFLUXBODDECNANAnot in h5
-TAMPROCFLUXPHYTONANAnot in h5
-TAMPROCFLUXZOONANAnot in h5
-TAMPROCFLUXBENTHICNANAnot in h5
-TAMOUTDISNANAnot in h5
-TAMOUTTOTNANAnot in h5
-TAMOUTDISEXIT1NANAnot in h5
-NO2CONCDISNANAnot in h5
-NO2STORNANAnot in h5
-NO2INTOTNANAnot in h5
-NO2PROCFLUXTOTNANAnot in h5
-NO2PROCFLUXNITNANAnot in h5
-NO2OUTTOTNANAnot in h5
-NO3CONCDISNANAnot in h5
-NO3STORNANAnot in h5
-NO3INTOTNANAnot in h5
-NO3PROCFLUXTOTNANAnot in h5
-NO3PROCFLUXNITRNANAnot in h5
-NO3PROCFLUXDENITRNANAnot in h5
-NO3PROCFLUXBODDECNANAnot in h5
-NO3PROCFLUXPHYTONANAnot in h5
-NO3PROCFLUXZOONANAnot in h5
-NO3PROCFLUXBENTHICNANAnot in h5
-NO3OUTTOTNANAnot in h5
-PO4CONCDISNANAnot in h5
-PO4STORDISNANAnot in h5
-PO4INDISNANAnot in h5
-PO4INTOTNANAnot in h5
-PO4PROCFLUXTOTNANAnot in h5
-PO4PROCFLUXBENTHALNANAnot in h5
-PO4PROCFLUXBODDECNANAnot in h5
-PO4PROCFLUXPHYTONANAnot in h5
-PO4PROCFLUXZOONANAnot in h5
-PO4PROCFLUXBENTHICNANAnot in h5
-PO4OUTDISNANAnot in h5
-PO4OUTTOTNANAnot in h5
-PO4OUTDISEXIT1NANAnot in h5
RCHRES_PLANK_004_2
ConstituentMax DiffMatchNote
-PHYTONANAnot in h5
-PHYCLANANAnot in h5
-LIMPHYNANAnot in h5
-ZOONANAnot in h5
-BENAL1NANAnot in h5
-BALCLA1NANAnot in h5
-LIMBAL1NANAnot in h5
-NREFORGCONCNANAnot in h5
-PREFORGCONCNANAnot in h5
-CREFORGCONCNANAnot in h5
-NTOTORGCONCNANAnot in h5
-PTOTORGCONCNANAnot in h5
-CTOTORGCONCNANAnot in h5
-POTBODNANAnot in h5
-NTOTCONCNANAnot in h5
-PTOTCONCNANAnot in h5
-PHYTOINNANAnot in h5
-PHYTOOUTNANAnot in h5
-ZOOINNANAnot in h5
-ZOOOUTNANAnot in h5
-NREFORGINNANAnot in h5
-NREFORGOUTNANAnot in h5
-PREFORGINNANAnot in h5
-PREFORGOUTNANAnot in h5
-CREFORGINNANAnot in h5
-CREFORGOUTNANAnot in h5
-PHYTOTOTPROCFLUXNANAnot in h5
-PHYTOSINKNANAnot in h5
-PHYTOZOOPREDNANAnot in h5
-PHYTODEATHNANAnot in h5
-PHYTOGROWTHNANAnot in h5
-ZOOTOTPROCFLUXNANAnot in h5
-ZOOGROWTHNANAnot in h5
-ZOODEATHNANAnot in h5
-BENAL1NANAnot in h5
-BENTHICGROWTH1NANAnot in h5
-BENTHICDEATH1NANAnot in h5
-NREFORGTOTPROCFLUXNANAnot in h5
-NREFORGSINKNANAnot in h5
-NREFORGPHYTODEATHNANAnot in h5
-NREFORGZOODEATHNANAnot in h5
-NREFORGBENTHICDEATHNANAnot in h5
-PREFORGTOTPROCFLUXNANAnot in h5
-PREFORGSINKNANAnot in h5
-PREFORGPHYTODEATHNANAnot in h5
-PREFORGZOODEATHNANAnot in h5
-PREFORGBENTHICDEATHNANAnot in h5
-CREFORGTOTPROCFLUXNANAnot in h5
-CREFORGSINKNANAnot in h5
-CREFORGPHYTODEATHNANAnot in h5
-CREFORGZOODEATHNANAnot in h5
-CREFORGBENTHICDEATHNANAnot in h5
-NTOTORGINNANAnot in h5
-NTOTORGOUTNANAnot in h5
-PTOTORGINNANAnot in h5
-PTOTORGOUTNANAnot in h5
-CTOTORGINNANAnot in h5
-CTOTORGOUTNANAnot in h5
-NTOTINNANAnot in h5
-NTOTOUTNANAnot in h5
-PTOTINNANAnot in h5
-PTOTOUTNANAnot in h5
RCHRES_PHCARB_004_2
ConstituentMax DiffMatchNote
-TICCONCNANAnot in h5
-CO2CONCNANAnot in h5
-PHNANAnot in h5
-TICINNANAnot in h5
-TICOUTNANAnot in h5
-CO2INNANAnot in h5
-CO2OUTNANAnot in h5
-CO2TOTPROCFLUXNANAnot in h5
-CO2BODDNANAnot in h5
-CO2PHYTNANAnot in h5
-CO2ZOONANAnot in h5
-CO2BENTNANAnot in h5
-CO2BENTNANAnot in h5
-CO2INVANANAnot in h5
RCHRES_HYDR_005_2
ConstituentMax DiffMatchNote
-VOL159.70544815063477X
-DEP19.211909472942352X
-STAGENANAnot in h5
-AVDEPNANAnot in h5
-TWIDNANAnot in h5
-HRADNANAnot in h5
-SAREA87.50627040863037X
-AVVELNANAnot in h5
-AVSECTNANAnot in h5
-USTAR0.4055572991783265X
-TAU0.3188151669860644X
-RO986.7782762646675X
-IVOL233.33911361545324X
-PRSUPY3.4058892554603517X
-VOLEV0.07830982562154531X
-ROVOL73.76893509924412X
-POTEVNANAnot in h5
RCHRES_CONS_005_2
ConstituentMax DiffMatchNote
-ALKALINITYCONCNANAnot in h5
-ALKALINITYICONNANAnot in h5
-ALKALINITYROCONNANAnot in h5
RCHRES_HTRCH_005_2
ConstituentMax DiffMatchNote
-AIRTMP26.87310218811035X
-DEWTMPNANAnot in h5
-TW42.25491714477539X
-IHEAT25579677696.0X
-HTEXCH11016123416.0X
-ROHEAT14491767365.0X
-QTOTALNANAnot in h5
-QSOLARNANAnot in h5
-QLONGWNANAnot in h5
-QEVAPNANAnot in h5
-QCONNANAnot in h5
-QPRECNANAnot in h5
-QBEDNANAnot in h5
RCHRES_SEDTRN_005_2
ConstituentMax DiffMatchNote
-SSEDSANDNANAnot in h5
-SSEDSILTNANAnot in h5
-SSEDCLAYNANAnot in h5
-SSEDTOTNANAnot in h5
-RSEDSUSPSANDNANAnot in h5
-RSEDSUSPSILTNANAnot in h5
-RSEDSUSPCLAYNANAnot in h5
-RSEDSUSPTOTNANAnot in h5
-RSEDBEDSANDNANAnot in h5
-RSEDBEDSILTNANAnot in h5
-RSEDBEDCLAYNANAnot in h5
-RSEDBEDTOTNANAnot in h5
-RSEDTOTSANDNANAnot in h5
-RSEDTOTSILTNANAnot in h5
-RSEDTOTCLAYNANAnot in h5
-RSEDTOTTOTNANAnot in h5
-BEDDEP1.0096848011016846X
-ISEDSANDNANAnot in h5
-ISEDSILTNANAnot in h5
-ISEDCLAYNANAnot in h5
-ISEDTOTNANAnot in h5
-DEPSCOURSANDNANAnot in h5
-DEPSCOURSILTNANAnot in h5
-DEPSCOURCLAYNANAnot in h5
-DEPSCOURTOTNANAnot in h5
-ROSEDSANDNANAnot in h5
-ROSEDSILTNANAnot in h5
-ROSEDCLAYNANAnot in h5
-ROSEDTOTNANAnot in h5
-OSEDSANDEXIT1NANAnot in h5
-OSEDSILTEXIT1NANAnot in h5
-OSEDCLAYEXIT1NANAnot in h5
-OSEDTOTEXIT1NANAnot in h5
RCHRES_GQUAL_005_2
ConstituentMax DiffMatchNote
-PESTICIDE B4DQALNANAnot in h5
-PESTICIDE B4SQALSUSPSANDNANAnot in h5
-PESTICIDE B4SQALSUSPSILTNANAnot in h5
-PESTICIDE B4SQALSUSPCLAYNANAnot in h5
-PESTICIDE B4SQALBEDSANDNANAnot in h5
-PESTICIDE B4SQALBEDSILTNANAnot in h5
-PESTICIDE B4SQALBEDCLAYNANAnot in h5
-PESTICIDE B4RDQALNANAnot in h5
-PESTICIDE B4RSQALSUSPSANDNANAnot in h5
-PESTICIDE B4RSQALSUSPSILTNANAnot in h5
-PESTICIDE B4RSQALSUSPCLAYNANAnot in h5
-PESTICIDE B4RSQALSUSPTOTNANAnot in h5
-PESTICIDE B4RSQALBEDSANDNANAnot in h5
-PESTICIDE B4RSQALBEDSILTNANAnot in h5
-PESTICIDE B4RSQALBEDCLAYNANAnot in h5
-PESTICIDE B4RSQALBEDTOTNANAnot in h5
-PESTICIDE B4RSQALTOTSANDNANAnot in h5
-PESTICIDE B4RSQALTOTSILTNANAnot in h5
-PESTICIDE B4RSQALTOTCLAYNANAnot in h5
-PESTICIDE B4RSQALTOTTOTNANAnot in h5
-PESTICIDE B4RRQALNANAnot in h5
-PESTICIDE B4IDQALNANAnot in h5
-PESTICIDE B4ISQALSANDNANAnot in h5
-PESTICIDE B4ISQALSILTNANAnot in h5
-PESTICIDE B4ISQALCLAYNANAnot in h5
-PESTICIDE B4ISQALTOTNANAnot in h5
-PESTICIDE B4TIQALNANAnot in h5
-PESTICIDE B4DDQALHYDROLNANAnot in h5
-PESTICIDE B4DDQALOXIDNANAnot in h5
-PESTICIDE B4DDQALPHOTOLNANAnot in h5
-PESTICIDE B4DDQALVOLATNANAnot in h5
-PESTICIDE B4DDQALBIODEGNANAnot in h5
-PESTICIDE B4DDQALGENNANAnot in h5
-PESTICIDE B4DDQALTOTNANAnot in h5
-PESTICIDE B4SQDECSUSPSANDNANAnot in h5
-PESTICIDE B4SQDECSUSPSILTNANAnot in h5
-PESTICIDE B4SQDECSUSPCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDSANDNANAnot in h5
-PESTICIDE B4SQDECBEDSILTNANAnot in h5
-PESTICIDE B4SQDECBEDCLAYNANAnot in h5
-PESTICIDE B4SQDECBEDTOTNANAnot in h5
-PESTICIDE B4ADQALSUSPSANDNANAnot in h5
-PESTICIDE B4ADQALSUSPSILTNANAnot in h5
-PESTICIDE B4ADQALSUSPCLAYNANAnot in h5
-PESTICIDE B4ADQALBEDSANDNANAnot in h5
-PESTICIDE B4ADQALBEDSILTNANAnot in h5
-PESTICIDE B4ADQALBEDCLAYNANAnot in h5
-PESTICIDE B4ADQALTOTNANAnot in h5
-PESTICIDE B4DSQALSANDNANAnot in h5
-PESTICIDE B4DSQALSILTNANAnot in h5
-PESTICIDE B4DSQALCLAYNANAnot in h5
-PESTICIDE B4DSQALTOTNANAnot in h5
-PESTICIDE B4RODQALNANAnot in h5
-PESTICIDE B4ROSQALSANDNANAnot in h5
-PESTICIDE B4ROSQALSILTNANAnot in h5
-PESTICIDE B4ROSQALCLAYNANAnot in h5
-PESTICIDE B4ROSQALTOTNANAnot in h5
-PESTICIDE B4TROQALNANAnot in h5
RCHRES_OXRX_005_2
ConstituentMax DiffMatchNote
-DOXCONCNANAnot in h5
-DOXSTORNANAnot in h5
-DOXINNANAnot in h5
-DOXFLUXTOTNANAnot in h5
-DOXFLUXREAERNANAnot in h5
-DOXFLUXBODDECNANAnot in h5
-DOXFLUXBENTHALNANAnot in h5
-DOXFLUXNITRNANAnot in h5
-DOXFLUXPHYTONANAnot in h5
-DOXFLUXZOONANAnot in h5
-DOXFLUXBENTHICNANAnot in h5
-DOXOUTTOTNANAnot in h5
-BODCONCNANAnot in h5
-BODSTORNANAnot in h5
-BODINNANAnot in h5
-BODFLUXTOTNANAnot in h5
-BODFLUXBODDECNANAnot in h5
-BODFLUXBENTHALNANAnot in h5
-BODFLUXSINKNANAnot in h5
-BODFLUXDENITRNANAnot in h5
-BODFLUXPHYTONANAnot in h5
-BODFLUXZOONANAnot in h5
-BODFLUXBENTHICNANAnot in h5
-BODOUTTOTNANAnot in h5
RCHRES_NUTRX_005_2
ConstituentMax DiffMatchNote
-TAMCONCDISNANAnot in h5
-NH4CONCDISNANAnot in h5
-NH3CONCDISNANAnot in h5
-NH4CONCSUSPSANDNANAnot in h5
-NH4CONCSUSPSILTNANAnot in h5
-NH4CONCSUSPCLAYNANAnot in h5
-TAMSTORDISNANAnot in h5
-NH4STORDISNANAnot in h5
-NH3STORDISNANAnot in h5
-TAMINDISNANAnot in h5
-TAMINTOTNANAnot in h5
-TAMPROCFLUXTOTNANAnot in h5
-TAMPROCFLUXNITRNANAnot in h5
-TAMPROCFLUXVOLATNANAnot in h5
-TAMPROCFLUXBENTHALNANAnot in h5
-TAMPROCFLUXBODDECNANAnot in h5
-TAMPROCFLUXPHYTONANAnot in h5
-TAMPROCFLUXZOONANAnot in h5
-TAMPROCFLUXBENTHICNANAnot in h5
-TAMOUTDISNANAnot in h5
-TAMOUTTOTNANAnot in h5
-TAMOUTDISEXIT1NANAnot in h5
-NO2CONCDISNANAnot in h5
-NO2STORNANAnot in h5
-NO2INTOTNANAnot in h5
-NO2PROCFLUXTOTNANAnot in h5
-NO2PROCFLUXNITNANAnot in h5
-NO2OUTTOTNANAnot in h5
-NO3CONCDISNANAnot in h5
-NO3STORNANAnot in h5
-NO3INTOTNANAnot in h5
-NO3PROCFLUXTOTNANAnot in h5
-NO3PROCFLUXNITRNANAnot in h5
-NO3PROCFLUXDENITRNANAnot in h5
-NO3PROCFLUXBODDECNANAnot in h5
-NO3PROCFLUXPHYTONANAnot in h5
-NO3PROCFLUXZOONANAnot in h5
-NO3PROCFLUXBENTHICNANAnot in h5
-NO3OUTTOTNANAnot in h5
-PO4CONCDISNANAnot in h5
-PO4STORDISNANAnot in h5
-PO4INDISNANAnot in h5
-PO4INTOTNANAnot in h5
-PO4PROCFLUXTOTNANAnot in h5
-PO4PROCFLUXBENTHALNANAnot in h5
-PO4PROCFLUXBODDECNANAnot in h5
-PO4PROCFLUXPHYTONANAnot in h5
-PO4PROCFLUXZOONANAnot in h5
-PO4PROCFLUXBENTHICNANAnot in h5
-PO4OUTDISNANAnot in h5
-PO4OUTTOTNANAnot in h5
-PO4OUTDISEXIT1NANAnot in h5
RCHRES_PLANK_005_2
ConstituentMax DiffMatchNote
-PHYTONANAnot in h5
-PHYCLANANAnot in h5
-LIMPHYNANAnot in h5
-ZOONANAnot in h5
-BENAL1NANAnot in h5
-BALCLA1NANAnot in h5
-LIMBAL1NANAnot in h5
-NREFORGCONCNANAnot in h5
-PREFORGCONCNANAnot in h5
-CREFORGCONCNANAnot in h5
-NTOTORGCONCNANAnot in h5
-PTOTORGCONCNANAnot in h5
-CTOTORGCONCNANAnot in h5
-POTBODNANAnot in h5
-NTOTCONCNANAnot in h5
-PTOTCONCNANAnot in h5
-PHYTOINNANAnot in h5
-PHYTOOUTNANAnot in h5
-ZOOINNANAnot in h5
-ZOOOUTNANAnot in h5
-NREFORGINNANAnot in h5
-NREFORGOUTNANAnot in h5
-PREFORGINNANAnot in h5
-PREFORGOUTNANAnot in h5
-CREFORGINNANAnot in h5
-CREFORGOUTNANAnot in h5
-PHYTOTOTPROCFLUXNANAnot in h5
-PHYTOSINKNANAnot in h5
-PHYTOZOOPREDNANAnot in h5
-PHYTODEATHNANAnot in h5
-PHYTOGROWTHNANAnot in h5
-ZOOTOTPROCFLUXNANAnot in h5
-ZOOGROWTHNANAnot in h5
-ZOODEATHNANAnot in h5
-BENAL1NANAnot in h5
-BENTHICGROWTH1NANAnot in h5
-BENTHICDEATH1NANAnot in h5
-NREFORGTOTPROCFLUXNANAnot in h5
-NREFORGSINKNANAnot in h5
-NREFORGPHYTODEATHNANAnot in h5
-NREFORGZOODEATHNANAnot in h5
-NREFORGBENTHICDEATHNANAnot in h5
-PREFORGTOTPROCFLUXNANAnot in h5
-PREFORGSINKNANAnot in h5
-PREFORGPHYTODEATHNANAnot in h5
-PREFORGZOODEATHNANAnot in h5
-PREFORGBENTHICDEATHNANAnot in h5
-CREFORGTOTPROCFLUXNANAnot in h5
-CREFORGSINKNANAnot in h5
-CREFORGPHYTODEATHNANAnot in h5
-CREFORGZOODEATHNANAnot in h5
-CREFORGBENTHICDEATHNANAnot in h5
-NTOTORGINNANAnot in h5
-NTOTORGOUTNANAnot in h5
-PTOTORGINNANAnot in h5
-PTOTORGOUTNANAnot in h5
-CTOTORGINNANAnot in h5
-CTOTORGOUTNANAnot in h5
-NTOTINNANAnot in h5
-NTOTOUTNANAnot in h5
-PTOTINNANAnot in h5
-PTOTOUTNANAnot in h5
RCHRES_PHCARB_005_2
ConstituentMax DiffMatchNote
-TICCONCNANAnot in h5
-CO2CONCNANAnot in h5
-PHNANAnot in h5
-TICINNANAnot in h5
-TICOUTNANAnot in h5
-CO2INNANAnot in h5
-CO2OUTNANAnot in h5
-CO2TOTPROCFLUXNANAnot in h5
-CO2BODDNANAnot in h5
-CO2PHYTNANAnot in h5
-CO2ZOONANAnot in h5
-CO2BENTNANAnot in h5
-CO2BENTNANAnot in h5
-CO2INVANANAnot in h5
+