From 69785989b84f2dc1d81033edf2d996c7b828c251 Mon Sep 17 00:00:00 2001 From: barronh Date: Wed, 14 Aug 2024 12:05:42 -0400 Subject: [PATCH] see changelog --- CHANGELOG.md | 29 + README.md | 25 - examples/maps/plot_mortality.py | 136 + examples/timeseries/plot_elpaso.py | 2 +- pyrsig/__init__.py | 30 +- pyrsig/bin.py | 50 + pyrsig/cmaq/__init__.py | 47 +- pyrsig/data/DescribeCoverage.csv | 4652 +++++++++++++++++++++++++--- pyrsig/xdr.py | 276 +- 9 files changed, 4653 insertions(+), 594 deletions(-) create mode 100644 CHANGELOG.md create mode 100644 examples/maps/plot_mortality.py create mode 100644 pyrsig/bin.py diff --git a/CHANGELOG.md b/CHANGELOG.md new file mode 100644 index 0000000..b0afa4a --- /dev/null +++ b/CHANGELOG.md @@ -0,0 +1,29 @@ +Change Log +========== + +Not all changes are listed, but notable changes are itemized for ease of review. + +* v0.9.0: Overhauled xdr for faster and clearer processing + Added bin format capability for population + Add robustness fixes for cmaq + Added updates to DescribeCoverage.csv +* v0.8.5: Added simple control over cache warning. +* v0.8.4: Added support for Subset 9.0 CMAQ and Grid 1.0 xdr formats. + Updated keys to rely on descriptions (via DescribeCoverage). + Added utilites for basic polygon/cmaq intersections for HMS. +* v0.8.3: Added xdr Polygon 1.0 format capability, added package + DescribeCoverage in data module and restructured utilities. +* v0.8.2: Added xdr CALIPSO 1.0 format capability. +* v0.8.1: Added xdr Point 1.0 format capability. +* v0.8.0: Restructuring module code and adding CMAQ pairing. +* v0.7.0: Added offline descriptions for review of space/time coverage. +* v0.7.0: Added TEMPO options for screening +* v0.6.0: Added latitude longitude grid pass thru support. +* v0.5.1: Added convenience function for opening many IOAPI files at once. +* v0.5.1: Updated TEMPO proxy naming. +* v0.4.6: Added support for legacy TLS servers (e.g, ofmpub and maple) +* v0.4.5: Updated TEMPO proxy naming +* v0.4.4: Adding pandora explicit support +* v0.4.3: updated to work with CMAQ EQUATES data (must exclude grid=False) +* v0.4.3: updated to support GDTYP=7 (equatorial mercator) +* v0.4.2: updated to support GDTYP=2 (equatorial mercator) diff --git a/README.md b/README.md index 4292028..3a6ab72 100644 --- a/README.md +++ b/README.md @@ -89,28 +89,3 @@ keys = rsigapi.keys(offline=False) # slow and likely to many options print(len(keys)) # 3875 ``` - -## Change Log - -Not all changes are listed, but notable changes are itemized for ease of review. - -* v0.8.5: Added simple control over cache warning. -* v0.8.4: Added support for Subset 9.0 CMAQ and Grid 1.0 xdr formats. - Updated keys to rely on descriptions (via DescribeCoverage). - Added utilites for basic polygon/cmaq intersections for HMS. -* v0.8.3: Added xdr Polygon 1.0 format capability, added package - DescribeCoverage in data module and restructured utilities. -* v0.8.2: Added xdr CALIPSO 1.0 format capability. -* v0.8.1: Added xdr Point 1.0 format capability. -* v0.8.0: Restructuring module code and adding CMAQ pairing. -* v0.7.0: Added offline descriptions for review of space/time coverage. -* v0.7.0: Added TEMPO options for screening -* v0.6.0: Added latitude longitude grid pass thru support. -* v0.5.1: Added convenience function for opening many IOAPI files at once. -* v0.5.1: Updated TEMPO proxy naming. -* v0.4.6: Added support for legacy TLS servers (e.g, ofmpub and maple) -* v0.4.5: Updated TEMPO proxy naming -* v0.4.4: Adding pandora explicit support -* v0.4.3: updated to work with CMAQ EQUATES data (must exclude grid=False) -* v0.4.3: updated to support GDTYP=7 (equatorial mercator) -* v0.4.2: updated to support GDTYP=2 (equatorial mercator) diff --git a/examples/maps/plot_mortality.py b/examples/maps/plot_mortality.py new file mode 100644 index 0000000..4e3d0ce --- /dev/null +++ b/examples/maps/plot_mortality.py @@ -0,0 +1,136 @@ +""" +Plot Smoke Polygons +=================== + +Get HMS Smoke from RSIG and create daily plots. +""" +import matplotlib.pyplot as plt +import numpy as np +import pandas as pd +import xarray as xr +from shapely import polygons +import geopandas as gpd +import pycno +import pyrsig + + +datakey = 'cmaq.equates.conus.aconc.PM25' +ckey = 'PM25' + +# %% +# Concentration Reponse Function Formulation +# ------------------------------------------ +# +# * Krewski 2009 PM25 +# * all-cause mortality risk 1.06 per 10 micrograms/m3 +# * 30+ year-old population +# * Simplifying Assumptions +# * Baseline mortality incidence is spatiall uniform +# * [GDB IHME](vizhub.healthdata.org/gbd-results) for 2019 in the US +# * all cause deaths = 2853165.03 +# * population = 329996155.19 +# * Age distribution is spatially unfiorm +# * Age distribution from the US Census ACSST5Y2020 +# * US population 30 years or older: 201686433 +# * US population total : 329824950 +beta = np.log(1.06) / 10 +y0 = 2853165.03 /329996155.19 +f_pop = 201686433 / 329824950 + + +bdates = pd.date_range('2019-01-01', '2019-12-31', freq='1d') +print('**WARNING**: using 1 day/month as representative of monthly average') +bdates = bdates[15::30] + + +# %% +# Retrieve Conc from RSIG (or cache) +# ---------------------------------- +dss = [] +for bdate in bdates: + ds = pyrsig.to_ioapi(datakey, bbox=(-180, 0, 0, 90), bdate=bdate) + dss.append(ds[[ckey]].mean(('TSTEP', 'LAY'), keep_attrs=True)) + +attrs = {k: v for k, v in ds.attrs.items()} +ds = xr.concat(dss, dim='TSTEP') +ds.attrs.update(attrs) +units = ds[ckey].units.strip() + +# %% +# Retrieve Pop from RSIG (or cache) +# --------------------------------- +# +# population available for pacific, gulf, and atlantic and is returned as a +# geopandas.GeoDataFrame. These populations are at the county scale, which +# limits the spatial resolution of the analysis to sizes of counties. +popdf = pyrsig.to_dataframe( + 'landuse.atlantic.population_iclus1', + bdate='2010-01-01T000000Z', edate='2090-01-01T235959Z' +) +popdf.crs = 4326 + +# %% +# Convert Conc to GeoDataFrame +# ---------------------------- +# +# Converting Conc to a GeoDataFrame for compatibility with population. +df = ds.mean('TSTEP').to_dataframe() + +# Create a GeoDataFrame in grid cell units +cell_off = np.array([[[-.5, -.5], [.5, -.5], [.5, .5], [-.5, .5]]]) +xy = df.reset_index()[['COL', 'ROW']].values[:, None, :] +geom = polygons(xy + cell_off) +cgdf = gpd.GeoDataFrame(df, geometry=geom, crs=ds.crs_proj4) + + +# %% +# Area Weight Conc at Population +# ------------------------------ +# +# Create area weighted concentrations at the population polygon level. +# 1. Create intersection +# 2. Calculate intersection fraction from each grid cell +# 3. Weight concentration by area +intxdf = gpd.overlay(cgdf.reset_index(), popdf.to_crs(cgdf.crs).reset_index()) +intxdf['intx_area'] = intxdf.geometry.area +intx_total_area = intxdf[['index', 'intx_area']].groupby('index').sum() +intxdf['overlapped_area'] = intx_total_area.loc[intxdf['index']].values +area_factor = intxdf['intx_area'] / intxdf['overlapped_area'] +# Calculate area weighted concentration as C and use 2010 population as P +intxdf[f'areawt_{ckey}'] = intxdf[ckey] * area_factor +finaldf = intxdf.groupby('index').agg( + C=(f'areawt_{ckey}', 'sum'), + P=('BC_2010POP', 'first'), +) + +# Convert to geodataframe pulling geometry from original pop dataframe +pgeom = popdf.loc[finaldf.index, 'geometry'] +finaldf = gpd.GeoDataFrame(finaldf, geometry=pgeom, crs=4326) + +F = finaldf['F'] = 1 - np.exp(-beta * finaldf['C']) +M = finaldf['M'] = y0 * finaldf['P'] * f_pop +finaldf['M_i'] = M * F +M_i = float(finaldf['M_i'].sum()) +P = float(finaldf['P'].sum()) +M = float(M.sum()) +C_p = float(finaldf.eval('C * P').sum() / P) + +# Now make the plot +gskw = dict(left=0.05, right=0.95) +fig, axx = plt.subplots(1, 2, figsize=(8, 4), gridspec_kw=gskw) +lkw = dict(label=f'{ckey} [{units}]') +finaldf.plot('C', ax=axx[0], legend=True, legend_kwds=lkw) +tprops = dict( + x=0.95, y=0.05, horizontalalignment='right', backgroundcolor='w' +) +tprops['transform'] = axx[0].transAxes +axx[0].text(s='$\\overline{C^p}$ = ' f'{C_p:.2f}', **tprops) +lkw = dict(label=f'Population [#]') +finaldf.plot('P', ax=axx[1], legend=True, legend_kwds=lkw) +tprops['transform'] = axx[1].transAxes +axx[1].text(s='$\\sum{P}$ = ' f'{P:.0f}', **tprops) +pycno.cno().drawstates(ax=axx) +fig.suptitle( + f'$M_i = f_a y_0 P_x F_x$ = {f_pop:.2f} * {y0:.5f} * P$_x$ * (1 - exp(-{beta:.6f} C$_x$)) = {M_i:.0f}' +) +fig.savefig(f'{ckey}_mortality.png') diff --git a/examples/timeseries/plot_elpaso.py b/examples/timeseries/plot_elpaso.py index 59d5e58..0365329 100644 --- a/examples/timeseries/plot_elpaso.py +++ b/examples/timeseries/plot_elpaso.py @@ -59,7 +59,7 @@ # Configure axes ax.set(ylabel='AirNow NO2 ppb', ylim=(0, 10)) -tax.set(ylim=(0.3e15, 4e15), ylabel='TropOMI NO2 molecules/cm$^2$') +tax.set(ylim=(0.3e15, 4e15), ylabel='TEMPO NO2 molecules/cm$^2$') plt.show() # Or save out figure diff --git a/pyrsig/__init__.py b/pyrsig/__init__.py index b72a5ee..bca1f7e 100644 --- a/pyrsig/__init__.py +++ b/pyrsig/__init__.py @@ -1,5 +1,5 @@ __all__ = ['RsigApi', 'RsigGui', 'open_ioapi', 'open_mfioapi', 'cmaq'] -__version__ = '0.8.5' +__version__ = '0.9.0' from . import cmaq from .cmaq import open_ioapi, open_mfioapi @@ -13,6 +13,12 @@ ) _nolonlats_prefixes = ('cmaq', 'regridded') _noregrid_prefixes = ('cmaq', 'regridded') +_shpxdrprefixes = ['hms.'] +_shpbinprefixes = [ + 'landuse.atlantic.population_iclus', + 'landuse.gulf.population_iclus', + 'landuse.pacific.population_iclus', +] def _actionf(msg, action, ErrorTyp=None): @@ -705,9 +711,13 @@ def to_dataframe( """ from . import xdr - assert backend in {'ascii', 'xdr'} - if key.startswith('hms.'): + from . import bin + assert backend in {'ascii', 'xdr', 'bin'} + if any([key.startswith(pfx) for pfx in _shpxdrprefixes]): backend = 'xdr' + elif any([key.startswith(pfx) for pfx in _shpbinprefixes]): + backend = 'bin' + outpath = self.get_file( backend, key=key, bdate=bdate, edate=edate, bbox=bbox, grid=False, verbose=verbose, corners=corners, @@ -715,8 +725,12 @@ def to_dataframe( ) if backend == 'ascii': df = pd.read_csv(outpath, delimiter='\t', na_values=[-9999., -999]) - else: + elif backend == 'xdr': df = xdr.from_xdrfile(outpath, na_values=[-9999., -999]) + elif backend == 'bin': + df = bin.from_binfile(outpath) + else: + raise KeyError(f'format {backend} unknown; use xdr, bin or ascii') if withmeta: metapath = self.get_file( @@ -1099,3 +1113,11 @@ def check(self, action='return'): _actionf('bdate is later than edate', action) return iswe & issn & isbe + + +# Add easy access defaults +_defapi = RsigApi() +descriptions = _defapi.descriptions +to_dataframe = _defapi.to_dataframe +to_ioapi = _defapi.to_ioapi +to_netcdf = _defapi.to_netcdf diff --git a/pyrsig/bin.py b/pyrsig/bin.py new file mode 100644 index 0000000..4595893 --- /dev/null +++ b/pyrsig/bin.py @@ -0,0 +1,50 @@ +__all__ = ['from_binfile'] + + +def from_binfile(path): + """ + Arguments + --------- + path : str + Path to binary file that has a first line + prefix shxn shpn dbfn + Where shxn is the length of the shx file + Where shpn is the length of the shp file + Where dbfn is the length of the shp file + + Returns + ------- + df : geopandas.GeoDataFrame + """ + import tempfile + import gzip + import geopandas as gpd + + if path.endswith('.gz'): + bf = gzip.open(path) + else: + bf = open(path, 'rb') + _l = bf.readline().decode().strip() + prefix, shxn, shpn, dbfn = _l.split() + shxn = int(shxn) + shpn = int(shpn) + dbfn = int(dbfn) + shxs = bf.tell() + shxe = shxs + shxn + shps = shxe + shpe = shps + shpn + dbfs = shpe + dbfe = dbfs + dbfn + with tempfile.TemporaryDirectory() as td: + filestem = f'{td}/{prefix}' + bf.seek(shxs, 0) + with open(filestem + '.shx', 'wb') as shxf: + shxf.write(bf.read(shxe - shxs)) + with open(filestem + '.shp', 'wb') as shpf: + shpf.write(bf.read(shpe - shps)) + with open(filestem + '.dbf', 'wb') as dbff: + dbff.write(bf.read(dbfe - dbfs)) + outdf = gpd.read_file(filestem + '.shp') + + outdf.crs = 4326 + return outdf diff --git a/pyrsig/cmaq/__init__.py b/pyrsig/cmaq/__init__.py index b800b6e..15a8385 100644 --- a/pyrsig/cmaq/__init__.py +++ b/pyrsig/cmaq/__init__.py @@ -125,7 +125,7 @@ def save_ioapi(ds, path, format='NETCDF3_CLASSIC', **kwds): return odds.to_netcdf(path, format=format, **kwds) -def open_ioapi(path, metapath=None, earth_radius=6370000.): +def open_ioapi(path, metapath=None, earth_radius=6370000., **kwds): """ Open an IOAPI file, add coordinate data, and optionally add RSIG metadata. @@ -138,6 +138,8 @@ def open_ioapi(path, metapath=None, earth_radius=6370000.): added as metadata global property. earth_radius : float Assumed radius of the earth. 6370000 is the WRF default. + kwds : mappable + Passed to xr.open_dataset Returns ------- @@ -145,8 +147,8 @@ def open_ioapi(path, metapath=None, earth_radius=6370000.): Dataset with IOAPI metadata """ import xarray as xr - - f = xr.open_dataset(path, engine='netcdf4') + kwds.setdefault('engine', 'netcdf4') + f = xr.open_dataset(path, **kwds) f = add_ioapi_meta( f, path=path, metapath=metapath, earth_radius=earth_radius ) @@ -176,24 +178,39 @@ def add_ioapi_meta(ds, metapath=None, earth_radius=6370000., path=''): import numpy as np import warnings f = ds - lvls = f.attrs['VGLVLS'] - tflag = f['TFLAG'].astype('i').values[:, 0, :] - yyyyjjj = tflag[:, 0] - yyyyjjj = np.where(yyyyjjj < 1, 1970001, yyyyjjj) - HHMMSS = tflag[:, 1] - tstrs = [] - for j, t in zip(yyyyjjj, HHMMSS): - tstrs.append(f'{j:07d}T{t:06d}') - try: + tflag = f['TFLAG'].astype('i').values[:, 0, :] + yyyyjjj = tflag[:, 0] + yyyyjjj = np.where(yyyyjjj < 1, 1970001, yyyyjjj) + HHMMSS = tflag[:, 1] + tstrs = [] + for j, t in zip(yyyyjjj, HHMMSS): + tstrs.append(f'{j:07d}T{t:06d}') + time = pd.to_datetime(tstrs, format='%Y%jT%H%M%S') f.coords['TSTEP'] = time except Exception: pass - f.coords['LAY'] = (lvls[:-1] + lvls[1:]) / 2. - f.coords['ROW'] = np.arange(f.attrs['NROWS']) + 0.5 - f.coords['COL'] = np.arange(f.attrs['NCOLS']) + 0.5 + if 'VGLVLS' in f.attrs: + lvls = f.attrs['VGLVLS'] + if len(lvls) > 1: + f.coords['LAY'] = (lvls[:-1] + lvls[1:]) / 2. + else: + f.coords['LAY'] = [np.mean(lvls)] + + nrs = [f.sizes.get('ROW', None), f.attrs.get('NROWS', None)] + for nr in nrs: + if nr is not None: + f.coords['ROW'] = np.arange(f.attrs['NROWS']) + 0.5 + break + + ncs = [f.sizes.get('COL', None), f.attrs.get('NCOLS', None)] + for nc in ncs: + if nc is not None: + f.coords['COL'] = np.arange(f.attrs['NCOLS']) + 0.5 + break + try: proj4str = get_proj4(f.attrs, earth_radius=earth_radius) f.attrs['crs_proj4'] = proj4str diff --git a/pyrsig/data/DescribeCoverage.csv b/pyrsig/data/DescribeCoverage.csv index 98af545..1d94b40 100644 --- a/pyrsig/data/DescribeCoverage.csv +++ b/pyrsig/data/DescribeCoverage.csv @@ -15,6 +15,7 @@ airnow2.ozone,ozone(ppb),UTC hourly mean surface measured ozone concentration in airnow2.no2,no2(ppb),UTC hourly mean surface measured nitrogen dioxide concentration in part-per-billion.,-157 21 -51 64,2003-01-02T00:00:00Z,PT1H,now,airnow2 airnow2.so2,so2(ppb),UTC hourly mean surface measured sulfur dioxide concentration in part-per-billion.,-157 21 -51 64,2003-01-02T00:00:00Z,PT1H,now,airnow2 airnow2.co,co(ppm),UTC hourly mean surface measured carbon monoxide concentration in part-per-million.,-157 21 -51 64,2003-01-02T00:00:00Z,PT1H,now,airnow2 +aqs.pams,pams(-),Photochemical Assessment Monitoring Stations (PAMS) site ids.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,aqs aqs.ozone,ozone(ppb),UTC hourly mean surface measured ozone concentration in part-per-billion.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,aqs aqs.ozone_8hour_average,ozone_8hour_average(ppb),Local hourly mean of preceeding 8 hours surface measured ozone concentration in part-per-billion.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,aqs aqs.ozone_daily_8hour_maximum,ozone_daily_8hour_maximum(ppb),Local daily maximum of 8 hour means surface measured ozone concentration in part-per-billion.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,aqs @@ -380,24 +381,3919 @@ calipso.l2_vfm.Land_Water_Mask,Land_Water_Mask(-),Land_Water_Mask,-180 -90 180 9 calipso.l2_vfm.Spacecraft_Position_X,Spacecraft_Position_X(km),Spacecraft_Position_X,-180 -90 180 90,2006-06-07T00:00:00Z,PT1H,2012-12-31T23:59:59Z,calipso calipso.l2_vfm.Spacecraft_Position_Y,Spacecraft_Position_Y(km),Spacecraft_Position_Y,-180 -90 180 90,2006-06-07T00:00:00Z,PT1H,2012-12-31T23:59:59Z,calipso calipso.l2_vfm.Spacecraft_Position_Z,Spacecraft_Position_Z(km),Spacecraft_Position_Z,-180 -90 180 90,2006-06-07T00:00:00Z,PT1H,2012-12-31T23:59:59Z,calipso -modis.mod7.Cloud_Mask,Cloud_Mask(-),"MODIS Cloud Mask, First Byte",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.K_Index,K_Index(K),K Index,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Lifted_Index,Lifted_Index(K),Lifted Index,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Scan_Start_Time,Scan_Start_Time(Seconds_since_1993-01-01),TAI Time at Start of Scan replicated across the swath,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Sensor_Azimuth,Sensor_Azimuth(deg),"Sensor Azimuth Angle, Cell to Sensor",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Sensor_Zenith,Sensor_Zenith(deg),"Sensor Zenith Angle, Cell to Sensor",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Skin_Temperature,Skin_Temperature(K),Skin Temperature,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Solar_Azimuth,Solar_Azimuth(deg),"Solar Azimuth Angle, Cell to Sun",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Solar_Zenith,Solar_Zenith(deg),"Solar Zenith Angle, Cell to Sun",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Surface_Elevation,Surface_Elevation(m),Surface Elevation,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Surface_Pressure,Surface_Pressure(hPa),Surface Pressure,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Total_Ozone,Total_Ozone(Dobson),Total Ozone Burden,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Total_Totals,Total_Totals(K),Total Totals,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Tropopause_Height,Tropopause_Height(hPa),Tropopause Height,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Water_Vapor,Water_Vapor(cm),Total Column Precipitable Water Vapor - IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Water_Vapor_Direct,Water_Vapor_Direct(cm),Total Column Precipitable Water Vapor - Direct IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Water_Vapor_High,Water_Vapor_High(cm),Precipitable Water Vapor High - IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod7.Water_Vapor_Low,Water_Vapor_Low(cm),Precipitable Water Vapor Low - IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +cmaq.amad.hemi.aerovis.ext_mie,ext_mie(1/km),Levels 0-35 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2006-01-01T00:00:00Z,PT1H,2006-12-31T23:59:59Z,cmaq +cmaq.amad.hemi.aerovis.ext_recon,ext_recon(1/km),Levels 0-35 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2006-01-01T00:00:00Z,PT1H,2006-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aod.aod,aod(-),Levels 0-1 of CMAQ modelled aerosol optical depth,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aacd,aacd(ppmV),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aalj,aalj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aalkj,aalkj(ug/m3),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.abnz1j,abnz1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.abnz2j,abnz2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.abnz3j,abnz3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.acaj,acaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.acli,acli(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aclj,aclj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aclk,aclk(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.acors,acors(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aeci,aeci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aecj,aecj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.afej,afej(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ah2oi,ah2oi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ah2oj,ah2oj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ah2ok,ah2ok(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aiso1j,aiso1j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aiso2j,aiso2j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aiso3j,aiso3j(ug/m3),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.akj,akj(ug/m3),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ald2,ald2(ppmV),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aldx,aldx(ppmV),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.amgj,amgj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.amnj,amnj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.anai,anai(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.anaj,anaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.anh4i,anh4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.anh4j,anh4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.anh4k,anh4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ano3i,ano3i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ano3j,ano3j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ano3k,ano3k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aolgaj,aolgaj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aolgbj,aolgbj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aorgcj,aorgcj(ug/m3),Levels 0-1 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aothri,aothri(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aothrj,aothrj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.apncomi,apncomi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.apncomj,apncomj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.apoci,apoci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.apocj,apocj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aseacat,aseacat(ug/m3),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.asij,asij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aso4i,aso4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aso4j,aso4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.aso4k,aso4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.asoil,asoil(ug/m3),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.asqtj,asqtj(ug/m3),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.atij,atij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.atol1j,atol1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.atol2j,atol2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.atol3j,atol3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.atrp1j,atrp1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.atrp2j,atrp2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.axyl1j,axyl1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.axyl2j,axyl2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.axyl3j,axyl3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.benzene,benzene(ppmV),Levels 0-1 of CMAQ modelled Benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.benzro2,benzro2(ppmV),Levels 0-1 of CMAQ modelled First generation SOA intermediate from benzene oxidation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.bnzhrxn,bnzhrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under low NOx conditions,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.bnznrxn,bnznrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under high NOx conditions,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.c2o3,c2o3(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cao2,cao2(ppmV),Levels 0-1 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cat1,cat1(ppmV),Levels 0-1 of CMAQ modelled Methyl-catechol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cl,cl(ppmV),Levels 0-1 of CMAQ modelled Chlorides,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cl2,cl2(ppmV),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.clo,clo(ppmV),Levels 0-1 of CMAQ modelled Hypoclorite,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.co,co(ppmV),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cres,cres(ppmV),Levels 0-1 of CMAQ modelled Cresol And Higher Molecular Weight Phenois,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.crn2,crn2(ppmV),Levels 0-1 of CMAQ modelled Chromium nitride,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.crno,crno(ppmV),Levels 0-1 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cro,cro(ppmV),Levels 0-1 of CMAQ modelled nitrocresol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cron,cron(ppmV),Levels 0-1 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.crpx,crpx(ppmV),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.cxo3,cxo3(ppmV),Levels 0-1 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.eth,eth(ppmV),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.etha,etha(ppmV),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.etoh,etoh(ppmV),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.facd,facd(ppmV),Levels 0-1 of CMAQ modelled Formic Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.fmcl,fmcl(ppmV),Levels 0-1 of CMAQ modelled Formyl Chloride,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.form,form(ppmV),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.h2o2,h2o2(ppmV),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.hcl,hcl(ppmV),Levels 0-1 of CMAQ modelled Hydrocloric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.hco3,hco3(ppmV),Levels 0-1 of CMAQ modelled Radical formed when formaldehyde reacts with HO2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.hno3,hno3(ppmV),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ho2,ho2(ppmV),Levels 0-1 of CMAQ modelled Hydroperoxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.hocl,hocl(ppmV),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.hono,hono(ppmV),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.iole,iole(ppmV),Levels 0-1 of CMAQ modelled Internal Olefins,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.isop,isop(ppmV),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.isoprxn,isoprxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ispd,ispd(ppmV),Levels 0-1 of CMAQ modelled Isoprene Product,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.meo2,meo2(ppmV),Levels 0-1 of CMAQ modelled Methyl Peroxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.meoh,meoh(ppmV),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.mepx,mepx(ppmV),Levels 0-1 of CMAQ modelled Methyl Hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.mgly,mgly(ppmV),Levels 0-1 of CMAQ modelled Methylglyoxal And Other Aeromatic Products,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.n2o5,n2o5(ppmV),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.nh3,nh3(ppmV),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.no,no(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.no2,no2(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.no3,no3(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ntr,ntr(ppmV),Levels 0-1 of CMAQ modelled Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.numacc,numacc(number/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.numatkn,numatkn(number/m3),Levels 0-1 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.numcor,numcor(number/m3),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.o,o(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O3(P) Electronic State,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.o1d,o1d(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O1(D) Electronic State,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.o3,o3(ppmV),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.oh,oh(ppmV),Levels 0-1 of CMAQ modelled Hydroxyl Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ole,ole(ppmV),Levels 0-1 of CMAQ modelled Terminal Olefin Carbon Bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.opan,opan(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.open,open(ppmV),Levels 0-1 of CMAQ modelled Aromatic Ring Opening Product,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.opo3,opo3(ppmV),Levels 0-1 of CMAQ modelled Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.pacd,pacd(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetic And Higher Peroxycarboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.pan,pan(ppmV),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.panx,panx(ppmV),Levels 0-1 of CMAQ modelled C3+ PANs,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.par,par(ppmV),Levels 0-1 of CMAQ modelled Paraffin Carbon Bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.pna,pna(ppmV),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.rooh,rooh(ppmV),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.ror,ror(ppmV),Levels 0-1 of CMAQ modelled Secondary Alkoxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sesq,sesq(ppmV),Levels 0-1 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sesqrxn,sesqrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from SESQ,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.so2,so2(ppmV),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.srfacc,srfacc(m2/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.srfatkn,srfatkn(m2/m3),Levels 0-1 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.srfcor,srfcor(m2/m3),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sulf,sulf(ppmV),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sulrxn,sulrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing aerosols from SULF,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_alk,sv_alk(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile alkanes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_bnz1,sv_bnz1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_bnz2,sv_bnz2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_iso1,sv_iso1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_iso2,sv_iso2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_sqt,sv_sqt(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from sesquiterpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_tol1,sv_tol1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_tol2,sv_tol2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_trp1,sv_trp1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_trp2,sv_trp2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_xyl1,sv_xyl1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.sv_xyl2,sv_xyl2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.terp,terp(ppmV),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.to2,to2(ppmV),Levels 0-1 of CMAQ modelled Toluene-Hydroxyl Radical Adduct,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.tol,tol(ppmV),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.tolhrxn,tolhrxn(ppmV),Levels 0-1 of CMAQ modelled tolhrxn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.tolnrxn,tolnrxn(ppmV),Levels 0-1 of CMAQ modelled tolnrxn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.tolro2,tolro2(ppmV),Levels 0-1 of CMAQ modelled tolro2?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.trprxn,trprxn(ppmV),Levels 0-1 of CMAQ modelled trprxn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.xo2,xo2(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical Operator,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.xo2n,xo2n(ppmV),Levels 0-1 of CMAQ modelled NO To Organic Nitrate Conversion From Alkylperoxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.xyl,xyl(ppmV),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.xylhrxn,xylhrxn(ppmV),Levels 0-1 of CMAQ modelled xylhrxn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.xylnrxn,xylnrxn(ppmV),Levels 0-1 of CMAQ modelled xylnrxn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aconc.xylro2,xylro2(ppmV),Levels 0-1 of CMAQ modelled xylro2?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.dgacc_dry,dgacc_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode Without Water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.dgacc_wet,dgacc_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode With Water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.dgatkn_dry,dgatkn_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode Without Water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.dgatkn_wet,dgatkn_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode With Water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.dgcor_dry,dgcor_dry(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter without water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.dgcor_wet,dgcor_wet(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter with water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.gamma_n2o5,gamma_n2o5(-),Levels 0-35 of CMAQ modelled N2O5 Heterogeneous reaction probability,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m2acc_wet,m2acc_wet(m2/m3),Levels 0-35 of CMAQ modelled Accumulation mode 2nd moment (wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m2atkn_wet,m2atkn_wet(m2/m3),Levels 0-35 of CMAQ modelled Aitken mode 2nd moment (wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m2cor_wet,m2cor_wet(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 2nd moment (wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m3acc_dry,m3acc_dry(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (dry),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m3acc_wet,m3acc_wet(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m3atkn_dry,m3atkn_dry(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (dry),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m3atkn_wet,m3atkn_wet(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m3cor_dry,m3cor_dry(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (dry),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.m3cor_wet,m3cor_wet(-),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.pm25ac,pm25ac(-),Levels 0-35 of CMAQ modelled Fine fraction of accumulation mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.pm25at,pm25at(-),Levels 0-35 of CMAQ modelled Fine fraction of Aitken mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.pm25co,pm25co(-),Levels 0-35 of CMAQ modelled Fine fraction of coarse mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.rh,rh(-),Levels 0-35 of CMAQ modelled Relative humiditity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.stdevacc,stdevacc(-),Levels 0-35 of CMAQ modelled Accumulation mode standard deviation (dry and wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.stdevatkn,stdevatkn(-),Levels 0-35 of CMAQ modelled Aitken mode standard deviation (dry and wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerodiam.stdevcor,stdevcor(-),Levels 0-35 of CMAQ modelled Coarse mode standard deviation (dry and wet),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerovis.dcv_mie,dcv_mie(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerovis.dcv_recon,dcv_recon(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerovis.ext_mie,ext_mie(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.aerovis.ext_recon,ext_recon(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.ald2,ald2(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol High Molecular Weight Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.anh4i,anh4i(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.anh4j,anh4j(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.anh4k,anh4k(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.ano3i,ano3i(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.ano3j,ano3j(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.ano3k,ano3k(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.aso4i,aso4i(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.aso4j,aso4j(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.aso4k,aso4k(micrograms/m**3),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.co,co(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.form,form(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.h2o2,h2o2(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Hydrogen peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.hno3,hno3(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.ho2,ho2(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Hydroperoxy Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.hono,hono(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrous acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.isop,isop(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.n2o5,n2o5(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrogen pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.nh3,nh3(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.no,no(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitric oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.no2,no2(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrogen dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.no3,no3(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.ntr,ntr(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Organic Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.o3,o3(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.oh,oh(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Hydroxyl radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.pan,pan(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Peroxyacyl nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.panx,panx(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol C3 and higher peroxyacyl nitrates,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.pna,pna(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Peroxynitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.sesq,sesq(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Sesquiterpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.so2,so2(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.terp,terp(ppmV),Levels 0-35 of CMAQ modelled CMAQ modeled Aerosol Terpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.conc.w_vel,w_vel(m/s),Levels 0-35 of CMAQ modelled CMAQ modeled Vertical component of wind velocity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_ald,vd_ald(cm/sec),Levels 0-1 of CMAQ modelled ald?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_cl2,vd_cl2(cm/sec),Levels 0-1 of CMAQ modelled cl2?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_co,vd_co(cm/sec),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_fmcl,vd_fmcl(cm/sec),Levels 0-1 of CMAQ modelled fmcl?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_gen_ald,vd_gen_ald(cm/sec),Levels 0-1 of CMAQ modelled gen_ald?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_h2o2,vd_h2o2(cm/sec),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_hcho,vd_hcho(cm/sec),Levels 0-1 of CMAQ modelled hcho?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_hcl,vd_hcl(cm/sec),Levels 0-1 of CMAQ modelled Hydrochloric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_hno3,vd_hno3(cm/sec),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_hocl,vd_hocl(cm/sec),Levels 0-1 of CMAQ modelled hocl?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_hono,vd_hono(cm/sec),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_methanol,vd_methanol(cm/sec),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_n2o5,vd_n2o5(cm/sec),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_nh3,vd_nh3(cm/sec),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_no,vd_no(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_no2,vd_no2(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_no3,vd_no3(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_o3,vd_o3(cm/sec),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_op,vd_op(cm/sec),Levels 0-1 of CMAQ modelled op?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_ora,vd_ora(cm/sec),Levels 0-1 of CMAQ modelled ora?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_paa,vd_paa(cm/sec),Levels 0-1 of CMAQ modelled paa?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_pan,vd_pan(cm/sec),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_so2,vd_so2(cm/sec),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vd_sulf,vd_sulf(cm/sec),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vmassc,vmassc(cm/sec),Levels 0-1 of CMAQ modelled vmassc?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vmassi,vmassi(cm/sec),Levels 0-1 of CMAQ modelled vmassi?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vmassj,vmassj(cm/sec),Levels 0-1 of CMAQ modelled vmassj?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vnumacc,vnumacc(cm/sec),Levels 0-1 of CMAQ modelled vnumacc?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vnumatkn,vnumatkn(cm/sec),Levels 0-1 of CMAQ modelled vnumatkn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vnumcor,vnumcor(cm/sec),Levels 0-1 of CMAQ modelled vnumcor?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vsrfacc,vsrfacc(cm/sec),Levels 0-1 of CMAQ modelled vsrfacc?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vsrfatkn,vsrfatkn(cm/sec),Levels 0-1 of CMAQ modelled vsrfatkn?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.depv.vsrfcor,vsrfcor(cm/sec),Levels 0-1 of CMAQ modelled vsrfcor?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol organic carbon Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol other carbon Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.crpx,crpx(kg/hectare),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.drydep.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.acrolein,acrolein(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of acrolein,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.ald2,ald2(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Acetaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.ald2_primary,ald2_primary(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Primary Acetaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.aldx,aldx(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Propionaldehyde and higher aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.benzene,benzene(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.butadiene13,butadiene13(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of butadiene13,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.ch4,ch4(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of methane,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.cl2,cl2(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of chlorine,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.co,co(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of carbon monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.eth,eth(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of ethene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.etha,etha(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of ethane,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.etoh,etoh(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Ethanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.form,form(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.form_primary,form_primary(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Formaldehyde primary,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.hcl,hcl(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Hydrogen chloride,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.hflux,hflux(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of hflux,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.hono,hono(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Nitrous acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.iole,iole(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Internal olefin carbon bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.isop,isop(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.meoh,meoh(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Methanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.naphthalene,naphthalene(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of naphthalene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.nh3,nh3(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.nh3_fert,nh3_fert(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Ammonia from fertilizer,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.no,no(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of nitric oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.no2,no2(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.nvol,nvol(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Nonvolatile Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.ole,ole(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Terminal olefin carbon bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pal,pal(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode aluminum,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.par,par(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Paraffin Carbon Bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pca,pca(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode calcium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pcl,pcl(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode chlorine,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pec,pec(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Elemental Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pfe,pfe(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode iron,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.ph2o,ph2o(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode particulate water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pk,pk(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode potassium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pmc,pmc(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Coarse mode primary particulate matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pmfine,pmfine(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode primary particulate matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pmg,pmg(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode magnesium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pmn,pmn(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode manganese,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pmothr,pmothr(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of fine mode primary particulate matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pna,pna(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode sodium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pncom,pncom(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode primary non-carbon organic matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pnh4,pnh4(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine particulate ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pno3,pno3(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.poc,poc(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode primary organic carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.psi,psi(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode silicon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pso4,pso4(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.pti,pti(g/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode titanium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.so2,so2(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode sulfur dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.sulf,sulf(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.terp,terp(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode terpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.tol,tol(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Fine mode Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.unk,unk(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Unknown,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.unr,unr(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Unreactive,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.voc_inv,voc_inv(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of volatile organic componds inv,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.emis.xyl,xyl(moles/s),Levels 0-1 of CMAQ modelled CMAQ modeled emissions of Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.ext.extinction,extinction(1/km),Levels 0-35 of CMAQ modelled Block extinction (reconstructed),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.dens,dens(kg/m3),Levels 0-35 of CMAQ modelled total density of air,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.densa_j,densa_j(kg/m2),Levels 0-35 of CMAQ modelled J weighted total air density,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.jacobf,jacobf(m),Levels 0-35 of CMAQ modelled total Jacobian at layer face,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.jacobm,jacobm(m),Levels 0-35 of CMAQ modelled total Jacobian at layer middle,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.pres,pres(Pa),Levels 0-35 of CMAQ modelled pressure,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.pv,pv(m^2*k/kg/s/10^6),Levels 0-35 of CMAQ modelled potential vorticity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.qc,qc(kg/kg),Levels 0-35 of CMAQ modelled cloud water mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.qg,qg(kg/kg),Levels 0-35 of CMAQ modelled graupel mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.qi,qi(kg/kg),Levels 0-35 of CMAQ modelled ice mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.qr,qr(kg/kg),Levels 0-35 of CMAQ modelled rain water mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.qs,qs(kg/kg),Levels 0-35 of CMAQ modelled snow mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.qv,qv(kg/kg),Levels 0-35 of CMAQ modelled water vapor mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.ta,ta(K),Levels 0-35 of CMAQ modelled air temperature,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.what_jd,what_jd(kg/m2),Levels 0-35 of CMAQ modelled J and Density weighted vertical contra-W,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.wwind,wwind(m/s),Levels 0-35 of CMAQ modelled true W component of wind,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.zf,zf(m),Levels 0-35 of CMAQ modelled full-layer height above ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro3d.zh,zh(m),Levels 0-35 of CMAQ modelled mid-layer height above ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.uhat_jd,uhat_jd(kg/(m*s)),Levels 0-35 of CMAQ modelled (contra_U*Jacobian*Density) at square pt,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.uwind,uwind(m/s),Levels 0-35 of CMAQ modelled U-comp. of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.vhat_jd,vhat_jd(kg/(m*s)),Levels 0-35 of CMAQ modelled (contra_V*Jacobian*Density) at triangle pt,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.vwind,vwind(m/s),Levels 0-35 of CMAQ modelled V-comp. of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.uwindc,uwindc(m/s),Levels 0-35 of CMAQ modelled U-comp. of true wind at west-east faces,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.vwindc,vwindc(m/s),Levels 0-35 of CMAQ modelled V-comp. of true wind at south-north faces,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metdot3d.wind,wind(m/s),Levels 0-35 of CMAQ modelled UVW 3D vector of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ALD2,ALD2(ppbV),Levels 0-1 of CMAQ modelled 1000.0*ALD2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ALDX,ALDX(ppbV),Levels 0-1 of CMAQ modelled 1000.0*ALDX[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.CO,CO(ppbV),Levels 0-1 of CMAQ modelled 1000.0*CO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ETH,ETH(ppbV),Levels 0-1 of CMAQ modelled 1000.0*ETH[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ETHA,ETHA(ppbV),Levels 0-1 of CMAQ modelled 1000.0*ETHA[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.FORM,FORM(ppbV),Levels 0-1 of CMAQ modelled 1000.0*FORM[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.H2O2,H2O2(ppbV),Levels 0-1 of CMAQ modelled 1000.0*H2O2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.HNO3,HNO3(ppbV),Levels 0-1 of CMAQ modelled 1000.0*HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.HNO3_UGM3,HNO3_UGM3(ug/m3),Levels 0-1 of CMAQ modelled 1000.0*(HNO3[1]*2.1756*DENS[3]),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.HONO,HONO(ppbV),Levels 0-1 of CMAQ modelled 1000.0*HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.HOX,HOX(ppbV),Levels 0-1 of CMAQ modelled 1000.0*(OH[1]+HO2[1]),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.IOLE,IOLE(ppbV),Levels 0-1 of CMAQ modelled 1000.0*IOLE[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ISOP,ISOP(ppbV),Levels 0-1 of CMAQ modelled 1000.0*ISOP[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.N2O5,N2O5(ppbV),Levels 0-1 of CMAQ modelled 1000.0*N2O5[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NH3,NH3(ppbV),Levels 0-1 of CMAQ modelled 1000.0*NH3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NH3_UGM3,NH3_UGM3(ug/m3),Levels 0-1 of CMAQ modelled 1000.0*(NH3[1]*0.5880*DENS[3]),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NHX,NHX(ug/m3),Levels 0-1 of CMAQ modelled 1000.0*(NH3[1]*0.5880*DENS[3])+ANH4I[1]+ANH4J[1]+ANH4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NO,NO(ppbV),Levels 0-1 of CMAQ modelled 1000.0*NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NO2,NO2(ppbV),Levels 0-1 of CMAQ modelled 1000.0*NO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANO3_PPB,ANO3_PPB(ppbV),Levels 0-1 of CMAQ modelled (ANO3I[1]+ANO3J[1]+ANO3K[1])/(DENS[3]*(62.0/28.97)),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NOY,NOY(ppbV),Levels 0-1 of CMAQ modelled 1000.0*(NO[1]+NO2[1]+NO3[1]+2*N2O5[1]+HONO[1]+HNO3[1]+PAN[1]+PANX[1]+PNA[1]+NTR[,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.NTR,NTR(ppbV),Levels 0-1 of CMAQ modelled 1000.0*NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.O3,O3(ppbV),Levels 0-1 of CMAQ modelled 1000.0*O3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.OLE,OLE(ppbV),Levels 0-1 of CMAQ modelled 1000.0*OLE[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PAR,PAR(ppbV),Levels 0-1 of CMAQ modelled 1000.0*PAR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PAN,PAN(ppbV),Levels 0-1 of CMAQ modelled 1000.0*PAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PANX,PANX(ppbV),Levels 0-1 of CMAQ modelled 1000.0*PANX[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.SO2,SO2(ppbV),Levels 0-1 of CMAQ modelled 1000.0*SO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.SO2_UGM3,SO2_UGM3(ug/m3),Levels 0-1 of CMAQ modelled 1000.0*(SO2[1]*2.2118*DENS[3]),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.SULF,SULF(ppbV),Levels 0-1 of CMAQ modelled 1000.0*SULF[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.TERP,TERP(ppbV),Levels 0-1 of CMAQ modelled 1000.0*TERP[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.TOL,TOL(ppbV),Levels 0-1 of CMAQ modelled 1000.0*TOL[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.VOC,VOC(ppbC),Levels 0-1 of CMAQ modelled 1000.0*(PAR[1]+2.0*ETH[1]+2.0*ETOH[1]+2.0*OLE[1]+7.0*TOL[1]+8.0*XYL[1]+FORM[1]+2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.XYL,XYL(ppbV),Levels 0-1 of CMAQ modelled 1000.0*XYL[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AFEJ,AFEJ(ug/m3),Levels 0-1 of CMAQ modelled AFEJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AALJ,AALJ(ug/m3),Levels 0-1 of CMAQ modelled AALJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ASIJ,ASIJ(ug/m3),Levels 0-1 of CMAQ modelled ASIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ATIJ,ATIJ(ug/m3),Levels 0-1 of CMAQ modelled ATIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ACAJ,ACAJ(ug/m3),Levels 0-1 of CMAQ modelled ACAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AMGJ,AMGJ(ug/m3),Levels 0-1 of CMAQ modelled AMGJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AKJ,AKJ(ug/m3),Levels 0-1 of CMAQ modelled AKJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AMNJ,AMNJ(ug/m3),Levels 0-1 of CMAQ modelled AMNJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ASOILJ,ASOILJ(ug/m3),Levels 0-1 of CMAQ modelled 2.20*AALJ[1]+2.49*ASIJ[1]+1.63*ACAJ[1]+2.42*AFEJ[1]+1.94*ATIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANAK,ANAK(ug/m3),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[1]+0.0626*ASOIL[1]+0.0023*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AMGK,AMGK(ug/m3),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[1]+0.0032*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AKK,AKK(ug/m3),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[1]+0.0242*ASOIL[1]+0.0176*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ACAK,ACAK(ug/m3),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[1]+0.0838*ASOIL[1]+0.0562*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ACLIJ,ACLIJ(ug/m3),Levels 0-1 of CMAQ modelled ACLI[1]+ACLJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AECIJ,AECIJ(ug/m3),Levels 0-1 of CMAQ modelled AECI[1]+AECJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANAIJ,ANAIJ(ug/m3),Levels 0-1 of CMAQ modelled ANAJ[1]+ANAI[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANO3IJ,ANO3IJ(ug/m3),Levels 0-1 of CMAQ modelled ANO3I[1]+ANO3J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANO3K,ANO3K(ug/m3),Levels 0-1 of CMAQ modelled ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANH4IJ,ANH4IJ(ug/m3),Levels 0-1 of CMAQ modelled ANH4I[1]+ANH4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANH4K,ANH4K(ug/m3),Levels 0-1 of CMAQ modelled ANH4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AOCIJ,AOCIJ(ugC/m3),Levels 0-1 of CMAQ modelled (AXYL1J[1]+AXYL2J[1]+AXYL3J[1])/2.0+(ATOL1J[1]+ATOL2J[1]+ATOL3J[1])/2.0+(ABNZ1J[,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AOMIJ,AOMIJ(ug/m3),Levels 0-1 of CMAQ modelled AXYL1J[1]+AXYL2J[1]+AXYL3J[1]+ATOL1J[1]+ATOL2J[1]+ATOL3J[1]+ABNZ1J[1]+ABNZ2J[1]+,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AORGAJ,AORGAJ(ug/m3),Levels 0-1 of CMAQ modelled AXYL1J[1]+AXYL2J[1]+AXYL3J[1]+ATOL1J[1]+ATOL2J[1]+ATOL3J[1]+ABNZ1J[1]+ABNZ2J[1]+,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AORGBJ,AORGBJ(ug/m3),Levels 0-1 of CMAQ modelled AISO1J[1]+AISO2J[1]+AISO3J[1]+ATRP1J[1]+ATRP2J[1]+ASQTJ[1]+AOLGBJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AORGCJ,AORGCJ(ug/m3),Levels 0-1 of CMAQ modelled AORGCJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.APOCIJ,APOCIJ(ugC/m3),Levels 0-1 of CMAQ modelled APOCI[1]+APOCJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.APOAIJ,APOAIJ(ug/m3),Levels 0-1 of CMAQ modelled APOCIJ[0]+APNCOMI[1]+APNCOMJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ASO4IJ,ASO4IJ(ug/m3),Levels 0-1 of CMAQ modelled ASO4I[1]+ASO4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ASO4K,ASO4K(ug/m3),Levels 0-1 of CMAQ modelled ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ATOTI,ATOTI(ug/m3),Levels 0-1 of CMAQ modelled ASO4I[1]+ANO3I[1]+ANH4I[1]+ANAI[1]+ACLI[1]+AECI[1]+APOCI[1]+APNCOMI[1]+AOTHRI[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ATOTJ,ATOTJ(ug/m3),Levels 0-1 of CMAQ modelled ASO4J[1]+ANO3J[1]+ANH4J[1]+ANAJ[1]+ACLJ[1]+AECJ[1]+AOMIJ[0]-(APOCI[1]+APNCOMI[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ATOTK,ATOTK(ug/m3),Levels 0-1 of CMAQ modelled ASOIL[1]+ACORS[1]+ASEACAT[1]+ACLK[1]+ASO4K[1]+ANO3K[1]+ANH4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMIJ,PMIJ(ug/m3),Levels 0-1 of CMAQ modelled ATOTI[0]+ATOTJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM10,PM10(ug/m3),Levels 0-1 of CMAQ modelled PMIJ[0]+ATOTK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AUNSPEC1IJ,AUNSPEC1IJ(ug/m3),Levels 0-1 of CMAQ modelled PMIJ[0]-(ASOILJ[0]+ANO3IJ[0]+ASO4IJ[0]+ANH4IJ[0]+AOCIJ[0]+AECIJ[0]+,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANCOMIJ,ANCOMIJ(ug/m3),Levels 0-1 of CMAQ modelled AOMIJ[0]-AOCIJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AUNSPEC2IJ,AUNSPEC2IJ(ug/m3),Levels 0-1 of CMAQ modelled AUNSPEC1IJ[0]-ANCOMIJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AOMOCRAT_PRI,AOMOCRAT_PRI(none),Levels 0-1 of CMAQ modelled APOAIJ[0]/APOCIJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AOMOCRAT_TOT,AOMOCRAT_TOT(none),Levels 0-1 of CMAQ modelled AOMIJ[0]/AOCIJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_CL,PM25_CL(ug/m3),Levels 0-1 of CMAQ modelled ACLI[1]*PM25AT[4]+ACLJ[1]*PM25AC[4]+ACLK[1]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_EC,PM25_EC(ug/m3),Levels 0-1 of CMAQ modelled AECI[1]*PM25AT[4]+AECJ[1]*PM25AC[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_NA,PM25_NA(ug/m3),Levels 0-1 of CMAQ modelled ANAI[1]*PM25AT[4]+ANAJ[1]*PM25AC[4]+ANAK[0]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_MG,PM25_MG(ug/m3),Levels 0-1 of CMAQ modelled AMGJ[1]*PM25AC[4]+AMGK[0]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_K,PM25_K(ug/m3),Levels 0-1 of CMAQ modelled AKJ[1]*PM25AC[4]+AKK[0]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_CA,PM25_CA(ug/m3),Levels 0-1 of CMAQ modelled ACAJ[1]*PM25AC[4]+ACAK[0]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_NH4,PM25_NH4(ug/m3),Levels 0-1 of CMAQ modelled ANH4I[1]*PM25AT[4]+ANH4J[1]*PM25AC[4]+ANH4K[1]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_NO3,PM25_NO3(ug/m3),Levels 0-1 of CMAQ modelled ANO3I[1]*PM25AT[4]+ANO3J[1]*PM25AC[4]+ANO3K[1]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_OC,PM25_OC(ugC/m3),Levels 0-1 of CMAQ modelled APOCI[1]*PM25AT[4]+(AOCIJ[0]-APOCI[1])*PM25AC[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_SOIL,PM25_SOIL(ug/m3),Levels 0-1 of CMAQ modelled ASOILJ[0]*PM25AC[4]+(ASOIL[1]+ACORS[1])*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_SO4,PM25_SO4(ug/m3),Levels 0-1 of CMAQ modelled ASO4I[1]*PM25AT[4]+ASO4J[1]*PM25AC[4]+ASO4K[1]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_TOT,PM25_TOT(ug/m3),Levels 0-1 of CMAQ modelled ATOTI[0]*PM25AT[4]+ATOTJ[0]*PM25AC[4]+ATOTK[0]*PM25CO[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_UNSPEC1,PM25_UNSPEC1(ug/m3),Levels 0-1 of CMAQ modelled PM25_TOT[0]-(PM25_CL[0]+PM25_EC[0]+PM25_NA[0]+PM25_NH4[0]+PM25_NO3[0]+PM25_OC[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMC_CL,PMC_CL(ug/m3),Levels 0-1 of CMAQ modelled ACLI[1]+ACLJ[1]+ACLK[1]-PM25_CL[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMC_NA,PMC_NA(ug/m3),Levels 0-1 of CMAQ modelled ANAIJ[0]+ANAK[0]*0.78-PM25_NA[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMC_NH4,PMC_NH4(ug/m3),Levels 0-1 of CMAQ modelled ANH4I[1]+ANH4J[1]+ANH4K[1]-PM25_NH4[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMC_NO3,PMC_NO3(ug/m3),Levels 0-1 of CMAQ modelled ANO3I[1]+ANO3J[1]+ANO3K[1]-PM25_NO3[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMC_SO4,PMC_SO4(ug/m3),Levels 0-1 of CMAQ modelled ASO4I[1]+ASO4J[1]+ASO4K[1]-PM25_SO4[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMC_TOT,PMC_TOT(ug/m3),Levels 0-1 of CMAQ modelled PM10[0]-PM25_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.TNO3,TNO3(ug/m3),Levels 0-1 of CMAQ modelled 2175.6*(HNO3[1]*DENS[3])+ANO3I[1]+ANO3J[1]+ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.DCV_Recon,DCV_Recon(deciview),Levels 0-1 of CMAQ modelled DCV_Recon[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.AIR_DENS,AIR_DENS(kg/m3),Levels 0-1 of CMAQ modelled DENS[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.RH,RH(%),Levels 0-1 of CMAQ modelled 100.00*RH[4],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.SFC_TMP,SFC_TMP(C),Levels 0-1 of CMAQ modelled (TEMP2[5]-273.15),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.SOL_RAD,SOL_RAD(W/m2),Levels 0-1 of CMAQ modelled RGRND[5],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.precip,precip(cm),Levels 0-1 of CMAQ modelled RN[5]+RC[5],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.WSPD10,WSPD10(m/s),Levels 0-1 of CMAQ modelled WSPD10[5],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.WDIR10,WDIR10(deg),Levels 0-1 of CMAQ modelled WDIR10[5],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.K,K(ppb^2),Levels 0-1 of CMAQ modelled exp(118.87-24084/TEMP2[5]-6.025*log(TEMP2[5])),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.P1,P1(-),Levels 0-1 of CMAQ modelled exp(8763/TEMP2[5]+19.12*log(TEMP2[5])-135.94),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.P2,P2(-),Levels 0-1 of CMAQ modelled exp(9969/TEMP2[5]+16.22*log(TEMP2[5])-122.65),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.P3,P3(-),Levels 0-1 of CMAQ modelled exp(13875/TEMP2[5]+24.46*log(TEMP2[5])-182.61),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.a,a(-),Levels 0-1 of CMAQ modelled 1-RH[0]/100,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.K_prime,K_prime(ppb^2),Levels 0-1 of CMAQ modelled (P1[0]-P2[0]*a[0]+(P3[0]*a[0]*a[0]))*(a[0]^1.75)*K[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.sqrt_Ki,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.pm.max_NO3_loss,max_NO3_loss(ug/m3),Levels 0-1 of CMAQ modelled 745.7/TEMP2[5]*sqrt_Ki[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_NO3_loss,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.pm.ANO3IJ_loss,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.pm.PM25_NH4_loss,PM25_NH4_loss(ug/m3),Levels 0-1 of CMAQ modelled PM25_NO3_loss[0]*(18/62),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.ANH4IJ_loss,ANH4IJ_loss(ug/m3),Levels 0-1 of CMAQ modelled ANO3IJ_loss[0]*(18/62),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PMIJ_FRM,PMIJ_FRM(ug/m3),Levels 0-1 of CMAQ modelled PMIJ[0]-(ANO3IJ_loss[0]+ANH4IJ_loss[0])+0.24*(ASO4IJ[0]+ANH4IJ[0]-ANH4IJ_loss[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.PM25_FRM,PM25_FRM(ug/m3),Levels 0-1 of CMAQ modelled PM25_TOT[0]-(PM25_NO3_loss[0]+PM25_NH4_loss[0])+0.24*(PM25_SO4[0]+PM25_NH4[0]-PM,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.Gamma1,Gamma1(-),Levels 0-1 of CMAQ modelled Gamma1[6],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.Gamma2,Gamma2(-),Levels 0-1 of CMAQ modelled Gamma2[6],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.Hp_L1,Hp_L1(mol/l),Levels 0-1 of CMAQ modelled MHpsl1[6],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm.Hp_L2,Hp_L2(mol/l),Levels 0-1 of CMAQ modelled MHpsl2[6],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.pm25.pm25,pm25(ug/m3),Levels 0-35 of CMAQ modelled particulate matter (aerosols) not more than 2.5 microns in diameter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.a25j,a25j(kg/ha),Levels 0-35 of CMAQ modelled Accumulation Mode Unspecified Anthropogenic Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aacd,aacd(kg/ha),Levels 0-35 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aalkj,aalkj(kg/ha),Levels 0-35 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.abnz1j,abnz1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.abnz2j,abnz2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.abnz3j,abnz3j(kg/ha),Levels 0-35 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aclj,aclj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aclk,aclk(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.acors,acors(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aeci,aeci(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aecj,aecj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aiso1j,aiso1j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from isoprene*,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aiso2j,aiso2j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aiso3j,aiso3j(kg/ha),Levels 0-35 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.ald2,ald2(kg/ha),Levels 0-35 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aldx,aldx(kg/ha),Levels 0-35 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.anaj,anaj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.anak,anak(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sodium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.anh4i,anh4i(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.anh4j,anh4j(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.anh4k,anh4k(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.ano3i,ano3i(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.ano3j,ano3j(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.ano3k,ano3k(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aolgaj,aolgaj(kg/ha),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aolgbj,aolgbj(kg/ha),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aorgcj,aorgcj(kg/ha),Levels 0-35 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aorgpai,aorgpai(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Primary Organic Mass Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aorgpaj,aorgpaj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Primary Organic Mass Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aso4i,aso4i(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aso4j,aso4j(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.aso4k,aso4k(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.asoil,asoil(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Soil,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.asqtj,asqtj(kg/ha),Levels 0-35 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.atol1j,atol1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.atol2j,atol2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.atol3j,atol3j(kg/ha),Levels 0-35 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.atrp1j,atrp1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.atrp2j,atrp2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.axyl1j,axyl1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.axyl2j,axyl2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.axyl3j,axyl3j(kg/ha),Levels 0-35 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.cl2,cl2(kg/ha),Levels 0-35 of CMAQ modelled cl2?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.co,co(kg/ha),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.facd,facd(kg/ha),Levels 0-35 of CMAQ modelled Formic Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.fmcl,fmcl(kg/ha),Levels 0-35 of CMAQ modelled fmcl?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.form,form(kg/ha),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.h2o2,h2o2(kg/ha),Levels 0-35 of CMAQ modelled Peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.hcl,hcl(kg/ha),Levels 0-35 of CMAQ modelled Hydrochloric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.hno3,hno3(kg/ha),Levels 0-35 of CMAQ modelled Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.hocl,hocl(kg/ha),Levels 0-35 of CMAQ modelled hocl?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.hono,hono(kg/ha),Levels 0-35 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.hplus,hplus(kg/ha),Levels 0-35 of CMAQ modelled hplus?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.meoh,meoh(kg/ha),Levels 0-35 of CMAQ modelled Methanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.mepx,mepx(kg/ha),Levels 0-35 of CMAQ modelled Methyl Hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.n2o5,n2o5(kg/ha),Levels 0-35 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.nh3,nh3(kg/ha),Levels 0-35 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.no2,no2(kg/ha),Levels 0-35 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.no3,no3(kg/ha),Levels 0-35 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.no,no(kg/ha),Levels 0-35 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.ntr,ntr(kg/ha),Levels 0-35 of CMAQ modelled Organic Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.o3,o3(kg/ha),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.pacd,pacd(kg/ha),Levels 0-35 of CMAQ modelled Peroxyacetic And Higher Peroxycarboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.pan,pan(kg/ha),Levels 0-35 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.panx,panx(kg/ha),Levels 0-35 of CMAQ modelled C3+ PANs,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.pna,pna(kg/ha),Levels 0-35 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.rooh,rooh(kg/ha),Levels 0-35 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.so2,so2(kg/ha),Levels 0-35 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep1.sulf,sulf(kg/ha),Levels 0-35 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.a25j,a25j(kg/ha),Levels 0-35 of CMAQ modelled Accumulation Mode Unspecified Anthropogenic Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aacd,aacd(kg/ha),Levels 0-35 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aalkj,aalkj(kg/ha),Levels 0-35 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.abnz1j,abnz1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.abnz2j,abnz2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.abnz3j,abnz3j(kg/ha),Levels 0-35 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aclj,aclj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aclk,aclk(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.acors,acors(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aeci,aeci(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aecj,aecj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aiso1j,aiso1j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from isoprene*,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aiso2j,aiso2j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aiso3j,aiso3j(kg/ha),Levels 0-35 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.ald2,ald2(kg/ha),Levels 0-35 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aldx,aldx(kg/ha),Levels 0-35 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.anaj,anaj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.anak,anak(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sodium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.anh4i,anh4i(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.anh4j,anh4j(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.anh4k,anh4k(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.ano3i,ano3i(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.ano3j,ano3j(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.ano3k,ano3k(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aolgaj,aolgaj(kg/ha),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aolgbj,aolgbj(kg/ha),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aorgcj,aorgcj(kg/ha),Levels 0-35 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aorgpai,aorgpai(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Primary Organic Mass Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aorgpaj,aorgpaj(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Primary Organic Mass Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aso4i,aso4i(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aso4j,aso4j(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.aso4k,aso4k(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.asoil,asoil(kg/ha),Levels 0-35 of CMAQ modelled Aerosol Soil,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.asqtj,asqtj(kg/ha),Levels 0-35 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.atol1j,atol1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.atol2j,atol2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.atol3j,atol3j(kg/ha),Levels 0-35 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.atrp1j,atrp1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.atrp2j,atrp2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.axyl1j,axyl1j(kg/ha),Levels 0-35 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.axyl2j,axyl2j(kg/ha),Levels 0-35 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.axyl3j,axyl3j(kg/ha),Levels 0-35 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.cl2,cl2(kg/ha),Levels 0-35 of CMAQ modelled cl2?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.cloud_bottom,cloud_bottom(layer),Levels 0-35 of CMAQ modelled layer containing bottom of cloud,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.co,co(kg/ha),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.facd,facd(kg/ha),Levels 0-35 of CMAQ modelled Formic Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.fmcl,fmcl(kg/ha),Levels 0-35 of CMAQ modelled fmcl,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.form,form(kg/ha),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.h2o2,h2o2(kg/ha),Levels 0-35 of CMAQ modelled Peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.hcl,hcl(kg/ha),Levels 0-35 of CMAQ modelled Hydrochloric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.hno3,hno3(kg/ha),Levels 0-35 of CMAQ modelled Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.hocl,hocl(kg/ha),Levels 0-35 of CMAQ modelled hocl?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.hono,hono(kg/ha),Levels 0-35 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.hplus,hplus(kg/ha),Levels 0-35 of CMAQ modelled hplus?,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.meoh,meoh(kg/ha),Levels 0-35 of CMAQ modelled Methanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.mepx,mepx(kg/ha),Levels 0-35 of CMAQ modelled Methyl Hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.n2o5,n2o5(kg/ha),Levels 0-35 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.nh3,nh3(kg/ha),Levels 0-35 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.no,no(kg/ha),Levels 0-35 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.no2,no2(kg/ha),Levels 0-35 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.no3,no3(kg/ha),Levels 0-35 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.np_cldfrac,np_cldfrac(-),Levels 0-35 of CMAQ modelled NP cloud fraction,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.np_cloudtop,np_cloudtop(layer-number),Levels 0-35 of CMAQ modelled layer containing top of NP cloud,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.ntr,ntr(kg/ha),Levels 0-35 of CMAQ modelled Organic Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.o3,o3(kg/ha),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.pacd,pacd(kg/ha),Levels 0-35 of CMAQ modelled Peroxyacetic And Higher Peroxycarboxylic Acids,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.pan,pan(kg/ha),Levels 0-35 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.panx,panx(kg/ha),Levels 0-35 of CMAQ modelled C3+ PANs,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.plcl,plcl(Pa),Levels 0-35 of CMAQ modelled pressure at lifting condensation level,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.pna,pna(kg/ha),Levels 0-35 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.pr_cldfrac,pr_cldfrac(-),Levels 0-35 of CMAQ modelled PR cloud fraction,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.pr_cloudtop,pr_cloudtop(layer),Levels 0-35 of CMAQ modelled layer containing top of PR cloud,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.rain_flag,rain_flag(1),Levels 0-35 of CMAQ modelled Rain-event flag,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.rooh,rooh(kg/ha),Levels 0-35 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.so2,so2(kg/ha),Levels 0-35 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.wetdep2.sulf,sulf(kg/ha),Levels 0-35 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.cfrac,cfrac(fraction),Levels 0-1 of CMAQ modelled total cloud fraction,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.cldb,cldb(m),Levels 0-1 of CMAQ modelled cloud bottom layer height (m),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.cldt,cldt(m),Levels 0-1 of CMAQ modelled cloud top layer height (m),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.glw,glw(watts/m**2),Levels 0-1 of CMAQ modelled longwave radiation at ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.gsw,gsw(watts/m**2),Levels 0-1 of CMAQ modelled solar radiation absorbed at ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.hfx,hfx(watts/m**2),Levels 0-1 of CMAQ modelled sensible heat flux,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.lai,lai(area/area),Levels 0-1 of CMAQ modelled leaf-area index,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.moli,moli(1/m),Levels 0-1 of CMAQ modelled inverse of Monin-Obukhov length,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.pbl,pbl(m),Levels 0-1 of CMAQ modelled PBL height,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.prsfc,prsfc(pascal),Levels 0-1 of CMAQ modelled surface pressure,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.q2,q2(kg/kg),Levels 0-1 of CMAQ modelled mixing ratio at 2 m,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.qfx,qfx(watts/m**2),Levels 0-1 of CMAQ modelled latent heat flux,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.radyni,radyni(m/s),Levels 0-1 of CMAQ modelled inverse of aerodynamic resistance,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.rc,rc(cm),Levels 0-1 of CMAQ modelled convective pcpn per met TSTEP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.rgrnd,rgrnd(watts/m**2),Levels 0-1 of CMAQ modelled solar rad reaching sfc,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.rn,rn(cm),Levels 0-1 of CMAQ modelled nonconvec. pcpn per met TSTEP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.rstomi,rstomi(m/s),Levels 0-1 of CMAQ modelled inverse of bulk stomatal resistance,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.seaice,seaice(fraction),Levels 0-1 of CMAQ modelled sea ice (fraction),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.sltyp,sltyp(category),Levels 0-1 of CMAQ modelled soil texture type by USDA category,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.snocov,snocov(decimal),Levels 0-1 of CMAQ modelled snow cover,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.soim1,soim1(m**3/m**3),Levels 0-1 of CMAQ modelled volumetric soil moisture in top cm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.soim2,soim2(m**3/m**3),Levels 0-1 of CMAQ modelled volumetric soil moisture in top m,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.soit1,soit1(k),Levels 0-1 of CMAQ modelled soil temperature in top cm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.soit2,soit2(k),Levels 0-1 of CMAQ modelled soil temperature in top m,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.temp2,temp2(k),Levels 0-1 of CMAQ modelled temperature at 2 m,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.tempg,tempg(k),Levels 0-1 of CMAQ modelled skin temperature at ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.ustar,ustar(m/s),Levels 0-1 of CMAQ modelled cell averaged friction velocity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.veg,veg(decimal),Levels 0-1 of CMAQ modelled vegetation coverage (decimal),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.wbar,wbar(g/m**3),Levels 0-1 of CMAQ modelled avg. liquid water content of cloud,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.wdir10,wdir10(degrees),Levels 0-1 of CMAQ modelled wind direction at 10 m,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.wr,wr(m),Levels 0-1 of CMAQ modelled canopy moisture content,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.wspd10,wspd10(m/s),Levels 0-1 of CMAQ modelled wind speed at 10 m,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.wstar,wstar(m/s),Levels 0-1 of CMAQ modelled convective velocity scale,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.metcro2d.zruf,zruf(m),Levels 0-1 of CMAQ modelled surface roughness length,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.noy.noy,noy(ppmV),Levels 0-35 of CMAQ modelled Total reactive nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w294,albedo_w294(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 294 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w303,albedo_w303(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 303 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w310,albedo_w310(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 310 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w316,albedo_w316(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 316 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w333,albedo_w333(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 333 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w381,albedo_w381(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 381 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.albedo_w607,albedo_w607(-),Levels 0-1 of CMAQ modelled surface albedo at the wavelength 607 nm,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.coszens,coszens(-),Levels 0-1 of CMAQ modelled cosine of solar zenith angle,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w294,etot_sfc_w294(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 294 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w303,etot_sfc_w303(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 303 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w310,etot_sfc_w310(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 310 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w316,etot_sfc_w316(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 316 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w333,etot_sfc_w333(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 333 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w381,etot_sfc_w381(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 381 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.etot_sfc_w607,etot_sfc_w607(watts/m**2),"Levels 0-1 of CMAQ modelled total downward irradiance at sfc, 607 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.jno2,jno2(1/min),Levels 0-1 of CMAQ modelled j-value for no2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.jo3o1d,jo3o1d(1/min),Levels 0-1 of CMAQ modelled j-value for o3o1d,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w294,tau_aero_w294(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 294 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w303,tau_aero_w303(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 303 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w310,tau_aero_w310(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 310 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w316,tau_aero_w316(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 316 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w333,tau_aero_w333(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 333 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w381,tau_aero_w381(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 381 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_aero_w607,tau_aero_w607(-),"Levels 0-1 of CMAQ modelled aerosol optical depth, 607 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w294,tauo3_top_w294(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 294 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w303,tauo3_top_w303(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 303 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w310,tauo3_top_w310(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 310 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w316,tauo3_top_w316(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 316 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w333,tauo3_top_w333(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 333 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w381,tauo3_top_w381(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 381 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tauo3_top_w607,tauo3_top_w607(-),"Levels 0-1 of CMAQ modelled optical depth of o3 above model domain, 607 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w294,tau_tot_w294(-),"Levels 0-1 of CMAQ modelled total optical depth, 294 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w303,tau_tot_w303(-),"Levels 0-1 of CMAQ modelled total optical depth, 303 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w310,tau_tot_w310(-),"Levels 0-1 of CMAQ modelled total optical depth, 310 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w316,tau_tot_w316(-),"Levels 0-1 of CMAQ modelled total optical depth, 316 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w333,tau_tot_w333(-),"Levels 0-1 of CMAQ modelled total optical depth, 333 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w381,tau_tot_w381(-),"Levels 0-1 of CMAQ modelled total optical depth, 381 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.tau_tot_w607,tau_tot_w607(-),"Levels 0-1 of CMAQ modelled total optical depth, 607 nm",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag1.toc,toc(du),Levels 0-1 of CMAQ modelled total ozone column,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.acrolein_saprc99,acrolein_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for acrolein_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.cl2_iupac04,cl2_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for c2cho_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.c2cho_saprc99,c2cho_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for ccho_r_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.ccho_r_saprc99,ccho_r_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for cl2_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.cooh_saprc99,cooh_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for cooh_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.fmcl_iupac04,fmcl_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for fmcl_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.h2o2_saprc99,h2o2_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for h2o2_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.hcho_m_saprc99,hcho_m_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hcho_m_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.hcho_r_saprc99,hcho_r_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hcho_r_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.hno3_iupac04,hno3_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hno3_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.ho2no2_iupac04,ho2no2_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for ho2no2_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.hocl_iupac04,hocl_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hocl_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.hono_iupac04,hono_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hono_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.mgly_iupac04,mgly_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for mgly_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.n2o5_iupac04,n2o5_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for n2o5_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.no2_saprc99,no2_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for no2_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.no3no2_saprc99,no3no2_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for no3no2_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.no3no_saprc99,no3no_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for no3no_saprc99,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.ntr_iupac04,ntr_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for ntr_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.o3_o1d_iupac04,o3_o1d_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for o3_o1d_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.o3_o3p_iupac04,o3_o3p_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for o3_o3p_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.pacd_cb05,pacd_cb05(1/min),Levels 0-35 of CMAQ modelled photolysis rates for pacd_cb05,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.photdiag2.pan_iupac04,pan_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for pan_iupac04,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.soilinp.ptype,ptype(integer),Levels 0-1 of CMAQ modelled no emission pulse type,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.soilinp.pulsedate,pulsedate(yyyyddd),Levels 0-1 of CMAQ modelled cmaq starting date for no emission pulse,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.soilinp.pulsetime,pulsetime(hhmmss),Levels 0-1 of CMAQ modelled cmaq starting time for no emission pulse,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.soilinp.rainfall01,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall02,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall03,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall04,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall05,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall06,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall07,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall08,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall09,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall10,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall11,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall12,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall13,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall14,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall15,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall16,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall17,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall18,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall19,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall20,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall21,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall22,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall23,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.soilinp.rainfall24,,,-180 -90 180 90,,,now,cmaq +cmaq.amad.conus.b3gts_s.ald2,ald2(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Acetaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.aldx,aldx(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Propionaldehyde and higher aldehydes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.co,co(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.eth,eth(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Ethene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.etha,etha(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Ethane,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.etoh,etoh(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Ethanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.form,form(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.iole,iole(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Internal olefin carbon bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.isop,isop(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.meoh,meoh(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Methanol,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.no,no(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Nitrogen Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.ole,ole(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Terminal olefin carbon bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.par,par(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Paraffin carbon bond,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.sesq,sesq(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Sesquiterpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.b3gts_s.terp,terp(gm/s),Levels 0-1 of CMAQ modelled CMAQ modeled biogenic emissions of Terpene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.media.Gamma1,Gamma1(-),Levels 0-1 of CMAQ modelled NH4+/H+ in Soil layer 1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.media.Gamma2,Gamma2(-),Levels 0-1 of CMAQ modelled NH4+/H+ in Soil layer 2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.media.MHpsl1,MHpsl1(mol/l),Levels 0-1 of CMAQ modelled Molar H+ in Soil layer 1,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.media.MHpsl2,MHpsl2(mol/l),Levels 0-1 of CMAQ modelled Molar H+ in Soil layer 2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.amad.conus.ltngdiag.no,no(mol/s),Levels 0-35 of CMAQ modelled hourly average NO produced from lightning,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.cdc.conus.aconc.o3,o3(ppmV),Levels 0-1 of CMAQ modelled Ozone.,-180 -90 180 90,2007-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.cdc.conus.pm25.pm25,pm25(ug/m3),Levels 0-1 of CMAQ modelled Particulate matter (aerosols) not more than 2.5 microns in diameter.,-180 -90 180 90,2007-01-01T00:00:00Z,PT1H,2012-12-31T23:59:59Z,cmaq +cmaq.cdc.east.aconc.o3,o3(ppmV),Levels 0-1 of CMAQ modelled Ozone.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2006-12-31T23:59:59Z,cmaq +cmaq.cdc.east.pm25.pm25,pm25(ug/m3),Levels 0-1 of CMAQ modelled Particulate matter (aerosols) not more than 2.5 microns in diameter.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2006-12-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aacd,aacd(ppmV),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aalj,aalj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aalkj,aalkj(ug/m3),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.abnz1j,abnz1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.abnz2j,abnz2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.abnz3j,abnz3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.acaj,acaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.acli,acli(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aclj,aclj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aclk,aclk(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.acors,acors(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aeci,aeci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aecj,aecj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.afej,afej(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ah2oi,ah2oi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ah2oj,ah2oj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ah2ok,ah2ok(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aiso1j,aiso1j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aiso2j,aiso2j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aiso3j,aiso3j(ug/m3),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.akj,akj(ug/m3),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ald2,ald2(ppmV),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aldx,aldx(ppmV),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.amgj,amgj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.amnj,amnj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.anai,anai(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.anaj,anaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.anh4i,anh4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.anh4j,anh4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.anh4k,anh4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ano3i,ano3i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ano3j,ano3j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ano3k,ano3k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aolgaj,aolgaj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aolgbj,aolgbj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aorgcj,aorgcj(ug/m3),Levels 0-1 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aothri,aothri(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aothrj,aothrj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.apncomi,apncomi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.apncomj,apncomj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.apoci,apoci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.apocj,apocj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aseacat,aseacat(ug/m3),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.asij,asij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aso4i,aso4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aso4j,aso4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.aso4k,aso4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.asoil,asoil(ug/m3),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.asqtj,asqtj(ug/m3),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.atij,atij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.atol1j,atol1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.atol2j,atol2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.atol3j,atol3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.atrp1j,atrp1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.atrp2j,atrp2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.axyl1j,axyl1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.axyl2j,axyl2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.axyl3j,axyl3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.benzene,benzene(ppmV),Levels 0-1 of CMAQ modelled Benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.benzro2,benzro2(ppmV),Levels 0-1 of CMAQ modelled First generation SOA intermediate from benzene oxidation,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.bnzhrxn,bnzhrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under low NOx conditions,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.bnznrxn,bnznrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under high NOx conditions,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.c2o3,c2o3(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cao2,cao2(ppmV),Levels 0-1 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cat1,cat1(ppmV),Levels 0-1 of CMAQ modelled Methyl-catechol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cl,cl(ppmV),Levels 0-1 of CMAQ modelled Chlorides,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cl2,cl2(ppmV),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.clo,clo(ppmV),Levels 0-1 of CMAQ modelled Hypoclorite,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.co,co(ppmV),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cres,cres(ppmV),Levels 0-1 of CMAQ modelled Cresol And Higher Molecular Weight Phenois,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.crn2,crn2(ppmV),Levels 0-1 of CMAQ modelled Chromium nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.crno,crno(ppmV),Levels 0-1 of CMAQ modelled Alkoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cro,cro(ppmV),Levels 0-1 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cron,cron(ppmV),Levels 0-1 of CMAQ modelled nitrocresol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.crpx,crpx(ppmV),Levels 0-1 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.cxo3,cxo3(ppmV),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.eth,eth(ppmV),Levels 0-1 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.etha,etha(ppmV),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.etoh,etoh(ppmV),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.facd,facd(ppmV),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.fmcl,fmcl(ppmV),Levels 0-1 of CMAQ modelled Formic Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.form,form(ppmV),Levels 0-1 of CMAQ modelled Formyl Chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.h2o2,h2o2(ppmV),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.hcl,hcl(ppmV),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.hco3,hco3(ppmV),Levels 0-1 of CMAQ modelled Hydrocloric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.hno3,hno3(ppmV),Levels 0-1 of CMAQ modelled Radical formed when formaldehyde reacts with HO2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ho2,ho2(ppmV),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.hocl,hocl(ppmV),Levels 0-1 of CMAQ modelled Hydroperoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.hono,hono(ppmV),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.iole,iole(ppmV),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.isop,isop(ppmV),Levels 0-1 of CMAQ modelled Internal Olefins,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.isoprxn,isoprxn(ppmV),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ispd,ispd(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.meo2,meo2(ppmV),Levels 0-1 of CMAQ modelled Isoprene Product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.meoh,meoh(ppmV),Levels 0-1 of CMAQ modelled Methyl Peroxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.mepx,mepx(ppmV),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.mgly,mgly(ppmV),Levels 0-1 of CMAQ modelled Methyl Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.n2o5,n2o5(ppmV),Levels 0-1 of CMAQ modelled Methylglyoxal And Other Aeromatic Products,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.nh3,nh3(ppmV),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.no,no(ppmV),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.no2,no2(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.no3,no3(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ntr,ntr(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.numacc,numacc(number/m3),Levels 0-1 of CMAQ modelled Nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.numatkn,numatkn(number/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.numcor,numcor(number/m3),Levels 0-1 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.o,o(ppmV),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.o1d,o1d(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O3(P) Electronic State,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.o3,o3(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O1(D) Electronic State,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.oh,oh(ppmV),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ole,ole(ppmV),Levels 0-1 of CMAQ modelled Hydroxyl Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.opan,opan(ppmV),Levels 0-1 of CMAQ modelled Terminal Olefin Carbon Bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.open,open(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.opo3,opo3(ppmV),Levels 0-1 of CMAQ modelled Aromatic Ring Opening Product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.pacd,pacd(ppmV),Levels 0-1 of CMAQ modelled Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.pan,pan(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetic And Higher Peroxycarboxylic Acids,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.panx,panx(ppmV),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.par,par(ppmV),Levels 0-1 of CMAQ modelled C3+ PANs,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.pna,pna(ppmV),Levels 0-1 of CMAQ modelled Paraffin Carbon Bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.rooh,rooh(ppmV),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.ror,ror(ppmV),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sesq,sesq(ppmV),Levels 0-1 of CMAQ modelled Secondary Alkoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sesqrxn,sesqrxn(ppmV),Levels 0-1 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.so2,so2(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from SESQ,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.srfacc,srfacc(m2/m3),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.srfatkn,srfatkn(m2/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.srfcor,srfcor(m2/m3),Levels 0-1 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sulf,sulf(ppmV),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sulrxn,sulrxn(ppmV),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_alk,sv_alk(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing aerosols from SULF,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_bnz1,sv_bnz1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_bnz2,sv_bnz2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_iso1,sv_iso1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_iso2,sv_iso2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_sqt,sv_sqt(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_tol1,sv_tol1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from sesquiterpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_tol2,sv_tol2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_trp1,sv_trp1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_trp2,sv_trp2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_xyl1,sv_xyl1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.sv_xyl2,sv_xyl2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.terp,terp(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.to2,to2(ppmV),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.tol,tol(ppmV),Levels 0-1 of CMAQ modelled Toluene-Hydroxyl Radical Adduct,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.tolhrxn,tolhrxn(ppmV),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.tolnrxn,tolnrxn(ppmV),Levels 0-1 of CMAQ modelled tolhrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.tolro2,tolro2(ppmV),Levels 0-1 of CMAQ modelled tolnrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.trprxn,trprxn(ppmV),Levels 0-1 of CMAQ modelled tolro2?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.xo2,xo2(ppmV),Levels 0-1 of CMAQ modelled trprxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.xo2n,xo2n(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical Operator,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.xyl,xyl(ppmV),Levels 0-1 of CMAQ modelled NO To Organic Nitrate Conversion From Alkylperoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.xylhrxn,xylhrxn(ppmV),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.xylnrxn,xylnrxn(ppmV),Levels 0-1 of CMAQ modelled xylhrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aconc.xylro2,xylro2(ppmV),Levels 0-1 of CMAQ modelled xylnrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.dgacc_dry,dgacc_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode Without Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.dgacc_wet,dgacc_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode With Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.dgatkn_dry,dgatkn_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode Without Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.dgatkn_wet,dgatkn_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode With Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.dgcor_dry,dgcor_dry(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter without water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.dgcor_wet,dgcor_wet(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter with water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.gamma_n2o5,gamma_n2o5(-),Levels 0-35 of CMAQ modelled N2O5 Heterogeneous reaction probability,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m2acc_wet,m2acc_wet(m2/m3),Levels 0-35 of CMAQ modelled Accumulation mode 2nd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m2atkn_wet,m2atkn_wet(m2/m3),Levels 0-35 of CMAQ modelled Aitken mode 2nd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m2cor_wet,m2cor_wet(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 2nd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m3acc_dry,m3acc_dry(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (dry),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m3acc_wet,m3acc_wet(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m3atkn_dry,m3atkn_dry(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (dry),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m3atkn_wet,m3atkn_wet(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m3cor_dry,m3cor_dry(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (dry),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.m3cor_wet,m3cor_wet(-),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.pm25ac,pm25ac(-),Levels 0-35 of CMAQ modelled Fine fraction of accumulation mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.pm25at,pm25at(-),Levels 0-35 of CMAQ modelled Fine fraction of Aitken mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.pm25co,pm25co(-),Levels 0-35 of CMAQ modelled Fine fraction of coarse mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.rh,rh(-),Levels 0-35 of CMAQ modelled Relative humiditity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.stdevacc,stdevacc(-),Levels 0-35 of CMAQ modelled Accumulation mode standard deviation (dry and wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.stdevatkn,stdevatkn(-),Levels 0-35 of CMAQ modelled Aitken mode standard deviation (dry and wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerodiam.stdevcor,stdevcor(-),Levels 0-35 of CMAQ modelled Coarse mode standard deviation (dry and wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerovis.dcv_mie,dcv_mie(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerovis.dcv_recon,dcv_recon(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerovis.ext_mie,ext_mie(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.aerovis.ext_recon,ext_recon(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aalj,aalj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aalkj,aalkj(ug/m3),Levels 0-35 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.abnz1j,abnz1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.abnz2j,abnz2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.abnz3j,abnz3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.acaj,acaj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol CA? Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.acli,acli(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aclj,aclj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aclk,aclk(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.acors,acors(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aeci,aeci(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aecj,aecj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.afej,afej(ug/m3),Levels 0-35 of CMAQ modelled Aerosol ? Elemental Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ah2oi,ah2oi(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ah2oj,ah2oj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ah2ok,ah2ok(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aiso1j,aiso1j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aiso2j,aiso2j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aiso3j,aiso3j(ug/m3),Levels 0-35 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.akj,akj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol ? Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ald2,ald2(ppmv),Levels 0-35 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aldx,aldx(ppmv),Levels 0-35 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.amgj,amgj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol MG? Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.amnj,amnj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol MN? Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.anai,anai(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.anaj,anaj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.anh4i,anh4i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.anh4j,anh4j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.anh4k,anh4k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ano3i,ano3i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ano3j,ano3j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ano3k,ano3k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aolgaj,aolgaj(ug/m3),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aolgbj,aolgbj(ug/m3),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aorgcj,aorgcj(ug/m3),Levels 0-35 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aothri,aothri(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aothrj,aothrj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.apncomi,apncomi(ug/m3),Levels 0-35 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.apncomj,apncomj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.apoci,apoci(ug/m3),Levels 0-35 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.apocj,apocj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aseacat,aseacat(ug/m3),Levels 0-35 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.asij,asij(ug/m3),Levels 0-35 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aso4i,aso4i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aso4j,aso4j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.aso4k,aso4k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.asoil,asoil(ug/m3),Levels 0-35 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.asqtj,asqtj(ug/m3),Levels 0-35 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.atij,atij(ug/m3),Levels 0-35 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.atol1j,atol1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.atol2j,atol2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.atol3j,atol3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.atrp1j,atrp1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.atrp2j,atrp2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.axyl1j,axyl1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.axyl2j,axyl2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.axyl3j,axyl3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.benzene,benzene(ppmv),Levels 0-35 of CMAQ modelled benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.c2o3,c2o3(ppmv),Levels 0-35 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.cao2,cao2(ppmv),Levels 0-35 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.co,co(ppmv),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.crn2,crn2(ppmv),Levels 0-35 of CMAQ modelled Chromium nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.crno,crno(ppmv),Levels 0-35 of CMAQ modelled Alkoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.cro,cro(ppmv),Levels 0-35 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.cron,cron(ppmv),Levels 0-35 of CMAQ modelled nitrocresol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.crpx,crpx(ppmv),Levels 0-35 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.cxo3,cxo3(ppmv),Levels 0-35 of CMAQ modelled CRPX?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.eth,eth(ppmv),Levels 0-35 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.etha,etha(ppmv),Levels 0-35 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.etoh,etoh(ppmv),Levels 0-35 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.form,form(ppmv),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.h2o2,h2o2(ppmv),Levels 0-35 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.hco3,hco3(ppmv),Levels 0-35 of CMAQ modelled hco3,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.hno3,hno3(ppmv),Levels 0-35 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ho2,ho2(ppmv),Levels 0-35 of CMAQ modelled Hydroperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.hono,hono(ppmv),Levels 0-35 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.iole,iole(ppmv),Levels 0-35 of CMAQ modelled Internal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.isop,isop(ppmv),Levels 0-35 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.meo2,meo2(ppmv),Levels 0-35 of CMAQ modelled Methylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.n2o5,n2o5(ppmv),Levels 0-35 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.nh3,nh3(ppmv),Levels 0-35 of CMAQ modelled ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.no2,no2(ppmv),Levels 0-35 of CMAQ modelled nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.no3,no3(ppmv),Levels 0-35 of CMAQ modelled nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.no,no(ppmv),Levels 0-35 of CMAQ modelled nitric oxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ntr,ntr(ppmv),Levels 0-35 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.numacc,numacc(number/m3),Levels 0-35 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.numatkn,numatkn(number/m3),Levels 0-35 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.numcor,numcor(number/m3),Levels 0-35 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.o3,o3(ppmv),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.oh,oh(ppmv),Levels 0-35 of CMAQ modelled Hydroxyl radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ole,ole(ppmv),Levels 0-35 of CMAQ modelled Terminal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.opan,opan(ppmv),Levels 0-35 of CMAQ modelled opan,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.opo3,opo3(ppmv),Levels 0-35 of CMAQ modelled Peroxyacyl radical from oxidation of OPEN,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.pan,pan(ppmv),Levels 0-35 of CMAQ modelled Peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.panx,panx(ppmv),Levels 0-35 of CMAQ modelled C3 and higher peroxyacyl nitrates,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.par,par(ppmv),Levels 0-35 of CMAQ modelled Paraffin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.pna,pna(ppmv),Levels 0-35 of CMAQ modelled Peroxynitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.rooh,rooh(ppmv),Levels 0-35 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.ror,ror(ppmv),Levels 0-35 of CMAQ modelled Secondary alkoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.sesq,sesq(ppmv),Levels 0-35 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.so2,so2(ppmv),Levels 0-35 of CMAQ modelled Sulfur dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.srfacc,srfacc(m2/m3),Levels 0-35 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.srfatkn,srfatkn(m2/m3),Levels 0-35 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.srfcor,srfcor(m2/m3),Levels 0-35 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.sulf,sulf(ppmv),Levels 0-35 of CMAQ modelled Sulfuric acid gas,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.terp,terp(ppmv),Levels 0-35 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.to2,to2(ppmv),Levels 0-35 of CMAQ modelled Tolene-hydroxyl radical adduct,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.tol,tol(ppmv),Levels 0-35 of CMAQ modelled Toluene and other monoalkyl aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.w_vel,w_vel(m/s),Levels 0-35 of CMAQ modelled Vertical component of wind velocity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.xo2,xo2(ppmv),Levels 0-35 of CMAQ modelled NO-to-NO2 conversion from alkylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.xo2n,xo2n(ppmv),Levels 0-35 of CMAQ modelled NO-to-nitrate conversion from alkylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.conc.xyl,xyl(ppmv),Levels 0-35 of CMAQ modelled Xylene and other polyalkyl aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_ald,vd_ald(cm/sec),Levels 0-1 of CMAQ modelled ald?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_cl2,vd_cl2(cm/sec),Levels 0-1 of CMAQ modelled cl2?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_co,vd_co(cm/sec),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_fmcl,vd_fmcl(cm/sec),Levels 0-1 of CMAQ modelled fmcl?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_gen_ald,vd_gen_ald(cm/sec),Levels 0-1 of CMAQ modelled gen_ald?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_h2o2,vd_h2o2(cm/sec),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_hcho,vd_hcho(cm/sec),Levels 0-1 of CMAQ modelled hcho?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_hcl,vd_hcl(cm/sec),Levels 0-1 of CMAQ modelled Hydrochloric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_hno3,vd_hno3(cm/sec),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_hocl,vd_hocl(cm/sec),Levels 0-1 of CMAQ modelled hocl?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_hono,vd_hono(cm/sec),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_methanol,vd_methanol(cm/sec),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_n2o5,vd_n2o5(cm/sec),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_nh3,vd_nh3(cm/sec),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_no,vd_no(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_no2,vd_no2(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_no3,vd_no3(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_o3,vd_o3(cm/sec),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_op,vd_op(cm/sec),Levels 0-1 of CMAQ modelled op?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_ora,vd_ora(cm/sec),Levels 0-1 of CMAQ modelled ora?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_paa,vd_paa(cm/sec),Levels 0-1 of CMAQ modelled paa?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_pan,vd_pan(cm/sec),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_so2,vd_so2(cm/sec),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vd_sulf,vd_sulf(cm/sec),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vmassc,vmassc(cm/sec),Levels 0-1 of CMAQ modelled vmassc?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vmassi,vmassi(cm/sec),Levels 0-1 of CMAQ modelled vmassi?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vmassj,vmassj(cm/sec),Levels 0-1 of CMAQ modelled vmassj?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vnumacc,vnumacc(cm/sec),Levels 0-1 of CMAQ modelled vnumacc?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vnumatkn,vnumatkn(cm/sec),Levels 0-1 of CMAQ modelled vnumatkn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vnumcor,vnumcor(cm/sec),Levels 0-1 of CMAQ modelled vnumcor?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vsrfacc,vsrfacc(cm/sec),Levels 0-1 of CMAQ modelled vsrfacc?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vsrfatkn,vsrfatkn(cm/sec),Levels 0-1 of CMAQ modelled vsrfatkn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.depv.vsrfcor,vsrfcor(cm/sec),Levels 0-1 of CMAQ modelled vsrfcor?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol other carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.crpx,crpx(kg/hectare),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.drydep.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.acrolein,acrolein(g/s),Levels 0-1 of CMAQ modelled acrolein,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.ald2,ald2(g/s),Levels 0-1 of CMAQ modelled Acetaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.ald2_primary,ald2_primary(g/s),Levels 0-1 of CMAQ modelled ald2_primary,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.aldx,aldx(g/s),Levels 0-1 of CMAQ modelled Propionaldehyde and higher aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.benzene,benzene(g/s),Levels 0-1 of CMAQ modelled benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.butadiene13,butadiene13(g/s),Levels 0-1 of CMAQ modelled butadiene13,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.ch4,ch4(g/s),Levels 0-1 of CMAQ modelled methane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.cl2,cl2(g/s),Levels 0-1 of CMAQ modelled chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.co,co(g/s),Levels 0-1 of CMAQ modelled carbon monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.eth,eth(g/s),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.etha,etha(g/s),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.etoh,etoh(g/s),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.form,form(g/s),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.form_primary,form_primary(g/s),Levels 0-1 of CMAQ modelled Formaldehyde primary,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.hcl,hcl(g/s),Levels 0-1 of CMAQ modelled Hydrogen chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.hono,hono(g/s),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.iole,iole(g/s),Levels 0-1 of CMAQ modelled Internal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.isop,isop(g/s),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.meoh,meoh(g/s),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.naphthalene,naphthalene(g/s),Levels 0-1 of CMAQ modelled naphthalene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.nh3,nh3(moles/s),Levels 0-1 of CMAQ modelled ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.nh3_fert,nh3_fert(moles/s),Levels 0-1 of CMAQ modelled ammonia from fertilizers,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.no,no(moles/s),Levels 0-1 of CMAQ modelled nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.no2,no2(moles/s),Levels 0-1 of CMAQ modelled nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.nvol,nvol(moles/s),Levels 0-1 of CMAQ modelled Nonvolatile Carbon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.ole,ole(moles/s),Levels 0-1 of CMAQ modelled Terminal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pal,pal(moles/s),Levels 0-1 of CMAQ modelled Fine mode aluminum,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.par,par(moles/s),Levels 0-1 of CMAQ modelled Paraffin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pca,pca(moles/s),Levels 0-1 of CMAQ modelled fine mode calcium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pcl,pcl(moles/s),Levels 0-1 of CMAQ modelled fine mode chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pec,pec(moles/s),Levels 0-1 of CMAQ modelled fine mode elemental carbon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pfe,pfe(moles/s),Levels 0-1 of CMAQ modelled fine mode iron,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.ph2o,ph2o(moles/s),Levels 0-1 of CMAQ modelled Fine mode particulate water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pk,pk(moles/s),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pmc,pmc(moles/s),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pmfine,pmfine(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pmg,pmg(moles/s),Levels 0-1 of CMAQ modelled Fine mode magnesium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pmn,pmn(moles/s),Levels 0-1 of CMAQ modelled Fine mode manganese,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pmothr,pmothr(moles/s),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pna,pna(moles/s),Levels 0-1 of CMAQ modelled Fine mode sodium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pncom,pncom(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary non-carbon organic matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pnh4,pnh4(moles/s),Levels 0-1 of CMAQ modelled Fine particulate ammonium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pno3,pno3(moles/s),Levels 0-1 of CMAQ modelled Fine mode nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.poc,poc(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary organic carbon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.psi,psi(moles/s),Levels 0-1 of CMAQ modelled Fine mode silicon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pso4,pso4(moles/s),Levels 0-1 of CMAQ modelled Fine mode sulfate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.pti,pti(moles/s),Levels 0-1 of CMAQ modelled Fine mode titanium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.so2,so2(moles/s),Levels 0-1 of CMAQ modelled Fine mode sulfate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.sulf,sulf(moles/s),Levels 0-1 of CMAQ modelled sulfate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.terp,terp(moles/s),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.tol,tol(moles/s),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.unk,unk(moles/s),Levels 0-1 of CMAQ modelled Unknown,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.unr,unr(moles/s),Levels 0-1 of CMAQ modelled Unreactive,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.voc_inv,voc_inv(moles/s),Levels 0-1 of CMAQ modelled volatile organic componds inv,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.emis.xyl,xyl(moles/s),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.metcro3d.dens,dens(Pa),Levels 0-35 of CMAQ modelled Base state pressure,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.pm25.pm25,pm25(ug/m3),Levels 0-35 of CMAQ modelled particulate matter (aerosols) not more than 2.5 microns in diameter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Higher carboxylic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol potassium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol soil-derived,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Carbon monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.hplus,hplus(kg/hectare),Levels 0-1 of CMAQ modelled Hydronium ion,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.pna,pna(kg/hectare),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep1.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Higher carboxylic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol potassium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol soil-derived,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.cld_trans,cld_trans(-),Levels 0-1 of CMAQ modelled total cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.cloud_bottom,cloud_bottom(layer-number),"Levels 0-1 of CMAQ modelled layer containing bottom of cloud, or missing = -9999.9",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Carbon monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.hplus,hplus(kg/hectare),Levels 0-1 of CMAQ modelled Hydronium ion,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.np_cldfrac,np_cldfrac(-),Levels 0-1 of CMAQ modelled Non-precipitating cloud fraction,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.np_cloudtop,np_cloudtop(layer-number),Levels 0-1 of CMAQ modelled Model layer containing top of non-precipitating cloud,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.np_trans,np_trans(-),Levels 0-1 of CMAQ modelled Non-precipitating cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.plcl,plcl(pa ),Levels 0-1 of CMAQ modelled Pressure at lifting condensation level,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.pna,pna(kg/hectare),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.pr_cldfrac,pr_cldfrac(-),Levels 0-1 of CMAQ modelled Precipitating cloud fraction,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.pr_cloudtop,pr_cloudtop(layer-number),Levels 0-1 of CMAQ modelled Precipitating cloud top layer number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.pr_trans,pr_trans(-),Levels 0-1 of CMAQ modelled Precipitating cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.rain_flag,rain_flag(1 or 0),Levels 0-1 of CMAQ modelled Rain flag 1 is raining 0 is not raining,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.res_trans,res_trans(-),Levels 0-1 of CMAQ modelled Resolved cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.wetdep2.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.metcro2d.rainc,rainc(mm),Levels 0-1 of CMAQ modelled Accumulated total cumulus precipitation,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.metcro2d.rainnc,rainnc(mm),Levels 0-1 of CMAQ modelled Accumulated total grid scale precipitation,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.noy.noy,noy(ppmV),Levels 0-35 of CMAQ modelled Total reactive nitrogen,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w294,albedo_w294(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 294 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w303,albedo_w303(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 303 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w310,albedo_w310(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 310 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w316,albedo_w316(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 316 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w333,albedo_w333(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 333 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w381,albedo_w381(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 381 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.albedo_w607,albedo_w607(-),Levels 0-1 of CMAQ modelled Surface Albedo at the wavelength 607 nm,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.coszens,coszens(-),Levels 0-1 of CMAQ modelled Cosine of Solar Zenith Angle,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w294,etot_sfc_w294(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 294 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w303,etot_sfc_w303(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 303 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w310,etot_sfc_w310(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 310 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w316,etot_sfc_w316(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 316 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w333,etot_sfc_w333(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 333 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w381,etot_sfc_w381(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 381 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.etot_sfc_w607,etot_sfc_w607(W/m2),"Levels 0-1 of CMAQ modelled Total Downward Irradiance at sfc, 607 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.jno2,jno2(1/min),Levels 0-1 of CMAQ modelled J-value for NO2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.jo3o1d,jo3o1d(1/min),Levels 0-1 of CMAQ modelled J-value for O3O1D,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w294,tau_aero_w294(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 294 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w303,tau_aero_w303(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 303 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w310,tau_aero_w310(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 310 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w316,tau_aero_w316(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 316 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w333,tau_aero_w333(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 333 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w381,tau_aero_w381(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 381 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_aero_w607,tau_aero_w607(-),"Levels 0-1 of CMAQ modelled Aerosol Optical Depth, 607 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w294,tauo3_top_w294(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 294 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w303,tauo3_top_w303(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 303 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w310,tauo3_top_w310(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 310 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w316,tauo3_top_w316(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 316 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w333,tauo3_top_w333(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 333 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w381,tauo3_top_w381(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 381 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tauo3_top_w607,tauo3_top_w607(-),"Levels 0-1 of CMAQ modelled Optical Depth of O3 above model domain, 607 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w294,tau_tot_w294(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 294 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w303,tau_tot_w303(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 303 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w310,tau_tot_w310(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 310 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w316,tau_tot_w316(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 316 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w333,tau_tot_w333(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 333 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w381,tau_tot_w381(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 381 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.tau_tot_w607,tau_tot_w607(-),"Levels 0-1 of CMAQ modelled Total Optical Depth, 607 nm",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag1.toc,toc(DU),Levels 0-1 of CMAQ modelled Total Ozone Column,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.acrolein_saprc99,acrolein_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for acrolein_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.c2cho_saprc99,c2cho_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for c2cho_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.ccho_r_saprc99,ccho_r_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for ccho_r_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.cl2_iupac04,cl2_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for cl2_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.cooh_saprc99,cooh_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for cooh_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.fmcl_iupac04,fmcl_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for fmcl_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.h2o2_saprc99,h2o2_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for h2o2_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.hcho_m_saprc99,hcho_m_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hcho_m_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.hcho_r_saprc99,hcho_r_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hcho_r_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.hno3_iupac04,hno3_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hno3_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.ho2no2_iupac04,ho2no2_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for ho2no2_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.hocl_iupac04,hocl_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hocl_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.hono_iupac04,hono_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for hono_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.mgly_iupac04,mgly_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for mgly_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.n2o5_iupac04,n2o5_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for n2o5_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.no2_saprc99,no2_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for no2_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.no3no2_saprc99,no3no2_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for no3no2_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.no3no_saprc99,no3no_saprc99(1/min),Levels 0-35 of CMAQ modelled photolysis rates for no3no_saprc99,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.ntr_iupac04,ntr_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for ntr_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.o3_o1d_iupac04,o3_o1d_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for o3_o1d_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.o3_o3p_iupac04,o3_o3p_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for o3_o3p_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.pacd_cb05,pacd_cb05(1/min),Levels 0-35 of CMAQ modelled photolysis rates for pacd_cb05,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.photdiag2.pan_iupac04,pan_iupac04(1/min),Levels 0-35 of CMAQ modelled photolysis rates for pan_iupac04,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.soilinp.ptype,ptype(integer),Levels 0-1 of CMAQ modelled no emission pulse type,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.soilinp.pulsedate,pulsedate(yyyyddd),Levels 0-1 of CMAQ modelled cmaq starting date for no emission pulse,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.soilinp.pulsetime,pulsetime(hhmmss),Levels 0-1 of CMAQ modelled cmaq starting time for no emission pulse,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.soilinp.rainfall01,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall02,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall03,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall04,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall05,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall06,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall07,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall08,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall09,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall10,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall11,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall12,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall13,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall14,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall15,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall16,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall17,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall18,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall19,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall20,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall21,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall22,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall23,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.soilinp.rainfall24,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.conus.ssemis.acaj,acaj(g/s),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.aclj,aclj(g/s),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.aclk,aclk(g/s),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.ah2oj,ah2oj(g/s),Levels 0-1 of CMAQ modelled Aerosol Water Vapor Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.ah2ok,ah2ok(g/s),Levels 0-1 of CMAQ modelled Aerosol Water Vapor Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.akj,akj(g/s),Levels 0-1 of CMAQ modelled Aerosol Potassium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.amgj,amgj(g/s),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.anaj,anaj(g/s),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.aseacat,aseacat(g/s),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.aso4j,aso4j(g/s),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.aso4k,aso4k(g/s),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.numacc,numacc(number/s),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.numcor,numcor(number/s),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.srfacc,srfacc(m2/s),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.conus.ssemis.srfcor,srfcor(m2/s),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aacd,aacd(ppmV),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aalj,aalj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aalkj,aalkj(ug/m3),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.abnz1j,abnz1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.abnz2j,abnz2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.abnz3j,abnz3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.acaj,acaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.acli,acli(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aclj,aclj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aclk,aclk(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.acors,acors(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aeci,aeci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aecj,aecj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.afej,afej(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ah2oi,ah2oi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ah2oj,ah2oj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ah2ok,ah2ok(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aiso1j,aiso1j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aiso2j,aiso2j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aiso3j,aiso3j(ug/m3),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.akj,akj(ug/m3),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ald2,ald2(ppmV),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aldx,aldx(ppmV),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.amgj,amgj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.amnj,amnj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.anai,anai(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.anaj,anaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.anh4i,anh4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.anh4j,anh4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.anh4k,anh4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ano3i,ano3i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ano3j,ano3j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ano3k,ano3k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aolgaj,aolgaj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aolgbj,aolgbj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aorgcj,aorgcj(ug/m3),Levels 0-1 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aothri,aothri(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aothrj,aothrj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.apncomi,apncomi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.apncomj,apncomj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.apoci,apoci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.apocj,apocj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aseacat,aseacat(ug/m3),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.asij,asij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aso4i,aso4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aso4j,aso4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.aso4k,aso4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.asoil,asoil(ug/m3),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.asqtj,asqtj(ug/m3),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.atij,atij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.atol1j,atol1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.atol2j,atol2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.atol3j,atol3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.atrp1j,atrp1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.atrp2j,atrp2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.axyl1j,axyl1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.axyl2j,axyl2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.axyl3j,axyl3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.benzene,benzene(ppmV),Levels 0-1 of CMAQ modelled Benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.benzro2,benzro2(ppmV),Levels 0-1 of CMAQ modelled First generation SOA intermediate from benzene oxidation,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.bnzhrxn,bnzhrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under low NOx conditions,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.bnznrxn,bnznrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under high NOx conditions,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.c2o3,c2o3(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cao2,cao2(ppmV),Levels 0-1 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cat1,cat1(ppmV),Levels 0-1 of CMAQ modelled Methyl-catechol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cl,cl(ppmV),Levels 0-1 of CMAQ modelled Chlorides,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cl2,cl2(ppmV),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.clo,clo(ppmV),Levels 0-1 of CMAQ modelled Hypoclorite,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.co,co(ppmV),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cres,cres(ppmV),Levels 0-1 of CMAQ modelled Cresol And Higher Molecular Weight Phenois,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.crn2,crn2(ppmV),Levels 0-1 of CMAQ modelled Chromium nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.crno,crno(ppmV),Levels 0-1 of CMAQ modelled Alkoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cro,cro(ppmV),Levels 0-1 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cron,cron(ppmV),Levels 0-1 of CMAQ modelled nitrocresol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.crpx,crpx(ppmV),Levels 0-1 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.cxo3,cxo3(ppmV),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.eth,eth(ppmV),Levels 0-1 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.etha,etha(ppmV),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.etoh,etoh(ppmV),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.facd,facd(ppmV),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.fmcl,fmcl(ppmV),Levels 0-1 of CMAQ modelled Formic Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.form,form(ppmV),Levels 0-1 of CMAQ modelled Formyl Chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.h2o2,h2o2(ppmV),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.hcl,hcl(ppmV),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.hco3,hco3(ppmV),Levels 0-1 of CMAQ modelled Hydrocloric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.hno3,hno3(ppmV),Levels 0-1 of CMAQ modelled Radical formed when formaldehyde reacts with HO2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ho2,ho2(ppmV),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.hocl,hocl(ppmV),Levels 0-1 of CMAQ modelled Hydroperoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.hono,hono(ppmV),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.iole,iole(ppmV),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.isop,isop(ppmV),Levels 0-1 of CMAQ modelled Internal Olefins,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.isoprxn,isoprxn(ppmV),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ispd,ispd(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.meo2,meo2(ppmV),Levels 0-1 of CMAQ modelled Isoprene Product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.meoh,meoh(ppmV),Levels 0-1 of CMAQ modelled Methyl Peroxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.mepx,mepx(ppmV),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.mgly,mgly(ppmV),Levels 0-1 of CMAQ modelled Methyl Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.n2o5,n2o5(ppmV),Levels 0-1 of CMAQ modelled Methylglyoxal And Other Aeromatic Products,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.nh3,nh3(ppmV),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.no,no(ppmV),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.no2,no2(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.no3,no3(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ntr,ntr(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.numacc,numacc(number/m3),Levels 0-1 of CMAQ modelled Nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.numatkn,numatkn(number/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.numcor,numcor(number/m3),Levels 0-1 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.o,o(ppmV),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.o1d,o1d(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O3(P) Electronic State,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.o3,o3(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O1(D) Electronic State,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.oh,oh(ppmV),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ole,ole(ppmV),Levels 0-1 of CMAQ modelled Hydroxyl Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.opan,opan(ppmV),Levels 0-1 of CMAQ modelled Terminal Olefin Carbon Bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.open,open(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.opo3,opo3(ppmV),Levels 0-1 of CMAQ modelled Aromatic Ring Opening Product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.pacd,pacd(ppmV),Levels 0-1 of CMAQ modelled Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.pan,pan(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetic And Higher Peroxycarboxylic Acids,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.panx,panx(ppmV),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.par,par(ppmV),Levels 0-1 of CMAQ modelled C3+ PANs,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.pna,pna(ppmV),Levels 0-1 of CMAQ modelled Paraffin Carbon Bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.rooh,rooh(ppmV),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.ror,ror(ppmV),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sesq,sesq(ppmV),Levels 0-1 of CMAQ modelled Secondary Alkoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sesqrxn,sesqrxn(ppmV),Levels 0-1 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.so2,so2(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from SESQ,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.srfacc,srfacc(m2/m3),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.srfatkn,srfatkn(m2/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.srfcor,srfcor(m2/m3),Levels 0-1 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sulf,sulf(ppmV),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sulrxn,sulrxn(ppmV),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_alk,sv_alk(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing aerosols from SULF,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_bnz1,sv_bnz1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_bnz2,sv_bnz2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_iso1,sv_iso1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_iso2,sv_iso2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_sqt,sv_sqt(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_tol1,sv_tol1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from sesquiterpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_tol2,sv_tol2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_trp1,sv_trp1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_trp2,sv_trp2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_xyl1,sv_xyl1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.sv_xyl2,sv_xyl2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene1,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.terp,terp(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene2,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.to2,to2(ppmV),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.tol,tol(ppmV),Levels 0-1 of CMAQ modelled Toluene-Hydroxyl Radical Adduct,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.tolhrxn,tolhrxn(ppmV),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.tolnrxn,tolnrxn(ppmV),Levels 0-1 of CMAQ modelled tolhrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.tolro2,tolro2(ppmV),Levels 0-1 of CMAQ modelled tolnrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.trprxn,trprxn(ppmV),Levels 0-1 of CMAQ modelled tolro2?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.xo2,xo2(ppmV),Levels 0-1 of CMAQ modelled trprxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.xo2n,xo2n(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical Operator,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.xyl,xyl(ppmV),Levels 0-1 of CMAQ modelled NO To Organic Nitrate Conversion From Alkylperoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.xylhrxn,xylhrxn(ppmV),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.xylnrxn,xylnrxn(ppmV),Levels 0-1 of CMAQ modelled xylhrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aconc.xylro2,xylro2(ppmV),Levels 0-1 of CMAQ modelled xylnrxn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.dgacc_dry,dgacc_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode Without Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.dgacc_wet,dgacc_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode With Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.dgatkn_dry,dgatkn_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode Without Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.dgatkn_wet,dgatkn_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode With Water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.dgcor_dry,dgcor_dry(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter without water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.dgcor_wet,dgcor_wet(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter with water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.gamma_n2o5,gamma_n2o5(-),Levels 0-35 of CMAQ modelled N2O5 Heterogeneous reaction probability,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m2acc_wet,m2acc_wet(m2/m3),Levels 0-35 of CMAQ modelled Accumulation mode 2nd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m2atkn_wet,m2atkn_wet(m2/m3),Levels 0-35 of CMAQ modelled Aitken mode 2nd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m2cor_wet,m2cor_wet(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 2nd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m3acc_dry,m3acc_dry(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (dry),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m3acc_wet,m3acc_wet(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m3atkn_dry,m3atkn_dry(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (dry),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m3atkn_wet,m3atkn_wet(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m3cor_dry,m3cor_dry(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (dry),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.m3cor_wet,m3cor_wet(-),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.pm25ac,pm25ac(-),Levels 0-35 of CMAQ modelled Fine fraction of accumulation mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.pm25at,pm25at(-),Levels 0-35 of CMAQ modelled Fine fraction of Aitken mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.pm25co,pm25co(-),Levels 0-35 of CMAQ modelled Fine fraction of coarse mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.rh,rh(-),Levels 0-35 of CMAQ modelled Relative humiditity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.stdevacc,stdevacc(-),Levels 0-35 of CMAQ modelled Accumulation mode standard deviation (dry and wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.stdevatkn,stdevatkn(-),Levels 0-35 of CMAQ modelled Aitken mode standard deviation (dry and wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerodiam.stdevcor,stdevcor(-),Levels 0-35 of CMAQ modelled Coarse mode standard deviation (dry and wet),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerovis.dcv_mie,dcv_mie(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerovis.dcv_recon,dcv_recon(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerovis.ext_mie,ext_mie(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.aerovis.ext_recon,ext_recon(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aalj,aalj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aalkj,aalkj(ug/m3),Levels 0-35 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.abnz1j,abnz1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.abnz2j,abnz2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.abnz3j,abnz3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.acaj,acaj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol CA? Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.acli,acli(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aclj,aclj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aclk,aclk(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.acors,acors(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aeci,aeci(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aecj,aecj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.afej,afej(ug/m3),Levels 0-35 of CMAQ modelled Aerosol ? Elemental Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ah2oi,ah2oi(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ah2oj,ah2oj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ah2ok,ah2ok(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aiso1j,aiso1j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aiso2j,aiso2j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aiso3j,aiso3j(ug/m3),Levels 0-35 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.akj,akj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol ? Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ald2,ald2(ppmv),Levels 0-35 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aldx,aldx(ppmv),Levels 0-35 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.amgj,amgj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol MG? Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.amnj,amnj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol MN? Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.anai,anai(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.anaj,anaj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.anh4i,anh4i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.anh4j,anh4j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.anh4k,anh4k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ano3i,ano3i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ano3j,ano3j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ano3k,ano3k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aolgaj,aolgaj(ug/m3),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aolgbj,aolgbj(ug/m3),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aorgcj,aorgcj(ug/m3),Levels 0-35 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aothri,aothri(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aothrj,aothrj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.apncomi,apncomi(ug/m3),Levels 0-35 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.apncomj,apncomj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.apoci,apoci(ug/m3),Levels 0-35 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.apocj,apocj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aseacat,aseacat(ug/m3),Levels 0-35 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.asij,asij(ug/m3),Levels 0-35 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aso4i,aso4i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aso4j,aso4j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.aso4k,aso4k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.asoil,asoil(ug/m3),Levels 0-35 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.asqtj,asqtj(ug/m3),Levels 0-35 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.atij,atij(ug/m3),Levels 0-35 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.atol1j,atol1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.atol2j,atol2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.atol3j,atol3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.atrp1j,atrp1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.atrp2j,atrp2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.axyl1j,axyl1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.axyl2j,axyl2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.axyl3j,axyl3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.benzene,benzene(ppmv),Levels 0-35 of CMAQ modelled benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.c2o3,c2o3(ppmv),Levels 0-35 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.cao2,cao2(ppmv),Levels 0-35 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.co,co(ppmv),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.crn2,crn2(ppmv),Levels 0-35 of CMAQ modelled Chromium nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.crno,crno(ppmv),Levels 0-35 of CMAQ modelled Alkoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.cro,cro(ppmv),Levels 0-35 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.cron,cron(ppmv),Levels 0-35 of CMAQ modelled nitrocresol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.crpx,crpx(ppmv),Levels 0-35 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.cxo3,cxo3(ppmv),Levels 0-35 of CMAQ modelled CRPX?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.eth,eth(ppmv),Levels 0-35 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.etha,etha(ppmv),Levels 0-35 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.etoh,etoh(ppmv),Levels 0-35 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.form,form(ppmv),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.h2o2,h2o2(ppmv),Levels 0-35 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.hco3,hco3(ppmv),Levels 0-35 of CMAQ modelled hco3,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.hno3,hno3(ppmv),Levels 0-35 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ho2,ho2(ppmv),Levels 0-35 of CMAQ modelled Hydroperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.hono,hono(ppmv),Levels 0-35 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.iole,iole(ppmv),Levels 0-35 of CMAQ modelled Internal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.isop,isop(ppmv),Levels 0-35 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.meo2,meo2(ppmv),Levels 0-35 of CMAQ modelled Methylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.n2o5,n2o5(ppmv),Levels 0-35 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.nh3,nh3(ppmv),Levels 0-35 of CMAQ modelled ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.no2,no2(ppmv),Levels 0-35 of CMAQ modelled nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.no3,no3(ppmv),Levels 0-35 of CMAQ modelled nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.no,no(ppmv),Levels 0-35 of CMAQ modelled nitric oxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ntr,ntr(ppmv),Levels 0-35 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.numacc,numacc(number/m3),Levels 0-35 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.numatkn,numatkn(number/m3),Levels 0-35 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.numcor,numcor(number/m3),Levels 0-35 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.o3,o3(ppmv),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.oh,oh(ppmv),Levels 0-35 of CMAQ modelled Hydroxyl radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ole,ole(ppmv),Levels 0-35 of CMAQ modelled Terminal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.opan,opan(ppmv),Levels 0-35 of CMAQ modelled opan,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.opo3,opo3(ppmv),Levels 0-35 of CMAQ modelled Peroxyacyl radical from oxidation of OPEN,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.pan,pan(ppmv),Levels 0-35 of CMAQ modelled Peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.panx,panx(ppmv),Levels 0-35 of CMAQ modelled C3 and higher peroxyacyl nitrates,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.par,par(ppmv),Levels 0-35 of CMAQ modelled Paraffin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.pna,pna(ppmv),Levels 0-35 of CMAQ modelled Peroxynitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.rooh,rooh(ppmv),Levels 0-35 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.ror,ror(ppmv),Levels 0-35 of CMAQ modelled Secondary alkoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.sesq,sesq(ppmv),Levels 0-35 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.so2,so2(ppmv),Levels 0-35 of CMAQ modelled Sulfur dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.srfacc,srfacc(m2/m3),Levels 0-35 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.srfatkn,srfatkn(m2/m3),Levels 0-35 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.srfcor,srfcor(m2/m3),Levels 0-35 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.sulf,sulf(ppmv),Levels 0-35 of CMAQ modelled Sulfuric acid gas,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.terp,terp(ppmv),Levels 0-35 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.to2,to2(ppmv),Levels 0-35 of CMAQ modelled Tolene-hydroxyl radical adduct,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.tol,tol(ppmv),Levels 0-35 of CMAQ modelled Toluene and other monoalkyl aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.w_vel,w_vel(m/s),Levels 0-35 of CMAQ modelled Vertical component of wind velocity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.xo2,xo2(ppmv),Levels 0-35 of CMAQ modelled NO-to-NO2 conversion from alkylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.xo2n,xo2n(ppmv),Levels 0-35 of CMAQ modelled NO-to-nitrate conversion from alkylperoxy radical,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.conc.xyl,xyl(ppmv),Levels 0-35 of CMAQ modelled Xylene and other polyalkyl aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_ald,vd_ald(cm/sec),Levels 0-1 of CMAQ modelled ald?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_cl2,vd_cl2(cm/sec),Levels 0-1 of CMAQ modelled cl2?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_co,vd_co(cm/sec),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_fmcl,vd_fmcl(cm/sec),Levels 0-1 of CMAQ modelled fmcl?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_gen_ald,vd_gen_ald(cm/sec),Levels 0-1 of CMAQ modelled gen_ald?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_h2o2,vd_h2o2(cm/sec),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_hcho,vd_hcho(cm/sec),Levels 0-1 of CMAQ modelled hcho?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_hcl,vd_hcl(cm/sec),Levels 0-1 of CMAQ modelled Hydrochloric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_hno3,vd_hno3(cm/sec),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_hocl,vd_hocl(cm/sec),Levels 0-1 of CMAQ modelled hocl?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_hono,vd_hono(cm/sec),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_methanol,vd_methanol(cm/sec),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_n2o5,vd_n2o5(cm/sec),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_nh3,vd_nh3(cm/sec),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_no,vd_no(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_no2,vd_no2(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_no3,vd_no3(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_o3,vd_o3(cm/sec),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_op,vd_op(cm/sec),Levels 0-1 of CMAQ modelled op?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_ora,vd_ora(cm/sec),Levels 0-1 of CMAQ modelled ora?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_paa,vd_paa(cm/sec),Levels 0-1 of CMAQ modelled paa?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_pan,vd_pan(cm/sec),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_so2,vd_so2(cm/sec),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vd_sulf,vd_sulf(cm/sec),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vmassc,vmassc(cm/sec),Levels 0-1 of CMAQ modelled vmassc?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vmassi,vmassi(cm/sec),Levels 0-1 of CMAQ modelled vmassi?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vmassj,vmassj(cm/sec),Levels 0-1 of CMAQ modelled vmassj?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vnumacc,vnumacc(cm/sec),Levels 0-1 of CMAQ modelled vnumacc?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vnumatkn,vnumatkn(cm/sec),Levels 0-1 of CMAQ modelled vnumatkn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vnumcor,vnumcor(cm/sec),Levels 0-1 of CMAQ modelled vnumcor?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vsrfacc,vsrfacc(cm/sec),Levels 0-1 of CMAQ modelled vsrfacc?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vsrfatkn,vsrfatkn(cm/sec),Levels 0-1 of CMAQ modelled vsrfatkn?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.depv.vsrfcor,vsrfcor(cm/sec),Levels 0-1 of CMAQ modelled vsrfcor?,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol other carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.crpx,crpx(kg/hectare),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.drydep.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.acrolein,acrolein(g/s),Levels 0-1 of CMAQ modelled acrolein,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.ald2,ald2(g/s),Levels 0-1 of CMAQ modelled Acetaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.ald2_primary,ald2_primary(g/s),Levels 0-1 of CMAQ modelled ald2_primary,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.aldx,aldx(g/s),Levels 0-1 of CMAQ modelled Propionaldehyde and higher aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.benzene,benzene(g/s),Levels 0-1 of CMAQ modelled benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.butadiene13,butadiene13(g/s),Levels 0-1 of CMAQ modelled butadiene13,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.ch4,ch4(g/s),Levels 0-1 of CMAQ modelled methane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.cl2,cl2(g/s),Levels 0-1 of CMAQ modelled chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.co,co(g/s),Levels 0-1 of CMAQ modelled carbon monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.eth,eth(g/s),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.etha,etha(g/s),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.etoh,etoh(g/s),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.form,form(g/s),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.form_primary,form_primary(g/s),Levels 0-1 of CMAQ modelled Formaldehyde primary,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.hcl,hcl(g/s),Levels 0-1 of CMAQ modelled Hydrogen chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.hono,hono(g/s),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.iole,iole(g/s),Levels 0-1 of CMAQ modelled Internal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.isop,isop(g/s),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.meoh,meoh(g/s),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.naphthalene,naphthalene(g/s),Levels 0-1 of CMAQ modelled naphthalene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.nh3,nh3(moles/s),Levels 0-1 of CMAQ modelled ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.nh3_fert,nh3_fert(moles/s),Levels 0-1 of CMAQ modelled ammonia from fertilizers,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.no,no(moles/s),Levels 0-1 of CMAQ modelled nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.no2,no2(moles/s),Levels 0-1 of CMAQ modelled nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.nvol,nvol(moles/s),Levels 0-1 of CMAQ modelled Nonvolatile Carbon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.ole,ole(moles/s),Levels 0-1 of CMAQ modelled Terminal olefin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pal,pal(moles/s),Levels 0-1 of CMAQ modelled Fine mode aluminum,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.par,par(moles/s),Levels 0-1 of CMAQ modelled Paraffin carbon bond,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pca,pca(moles/s),Levels 0-1 of CMAQ modelled fine mode calcium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pcl,pcl(moles/s),Levels 0-1 of CMAQ modelled fine mode chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pec,pec(moles/s),Levels 0-1 of CMAQ modelled fine mode elemental carbon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pfe,pfe(moles/s),Levels 0-1 of CMAQ modelled fine mode iron,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.ph2o,ph2o(moles/s),Levels 0-1 of CMAQ modelled Fine mode particulate water,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pk,pk(moles/s),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pmc,pmc(moles/s),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pmfine,pmfine(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pmg,pmg(moles/s),Levels 0-1 of CMAQ modelled Fine mode magnesium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pmn,pmn(moles/s),Levels 0-1 of CMAQ modelled Fine mode manganese,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pmothr,pmothr(moles/s),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pna,pna(moles/s),Levels 0-1 of CMAQ modelled Fine mode sodium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pncom,pncom(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary non-carbon organic matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pnh4,pnh4(moles/s),Levels 0-1 of CMAQ modelled Fine particulate ammonium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pno3,pno3(moles/s),Levels 0-1 of CMAQ modelled Fine mode nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.poc,poc(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary organic carbon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.psi,psi(moles/s),Levels 0-1 of CMAQ modelled Fine mode silicon,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pso4,pso4(moles/s),Levels 0-1 of CMAQ modelled Fine mode sulfate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.pti,pti(moles/s),Levels 0-1 of CMAQ modelled Fine mode titanium,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.so2,so2(moles/s),Levels 0-1 of CMAQ modelled Fine mode sulfate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.sulf,sulf(moles/s),Levels 0-1 of CMAQ modelled sulfate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.terp,terp(moles/s),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.tol,tol(moles/s),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.unk,unk(moles/s),Levels 0-1 of CMAQ modelled Unknown,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.unr,unr(moles/s),Levels 0-1 of CMAQ modelled Unreactive,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.voc_inv,voc_inv(moles/s),Levels 0-1 of CMAQ modelled volatile organic componds inv,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.emis.xyl,xyl(moles/s),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.metcro3d.dens,dens(Pa),Levels 0-35 of CMAQ modelled Base state pressure,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.pm25.pm25,pm25(ug/m3),Levels 0-35 of CMAQ modelled particulate matter (aerosols) not more than 2.5 microns in diameter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Higher carboxylic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol potassium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol soil-derived,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Carbon monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.hplus,hplus(kg/hectare),Levels 0-1 of CMAQ modelled Hydronium ion,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.pna,pna(kg/hectare),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep1.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Higher carboxylic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol aluminum Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol potassium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Silicon Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol soil-derived,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled chlorine,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.cld_trans,cld_trans(-),Levels 0-1 of CMAQ modelled total cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.cloud_bottom,cloud_bottom(layer-number),"Levels 0-1 of CMAQ modelled layer containing bottom of cloud, or missing = -9999.9",-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Carbon monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.hplus,hplus(kg/hectare),Levels 0-1 of CMAQ modelled Hydronium ion,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.np_cldfrac,np_cldfrac(-),Levels 0-1 of CMAQ modelled Non-precipitating cloud fraction,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.np_cloudtop,np_cloudtop(layer-number),Levels 0-1 of CMAQ modelled Model layer containing top of non-precipitating cloud,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.np_trans,np_trans(-),Levels 0-1 of CMAQ modelled Non-precipitating cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.plcl,plcl(pa ),Levels 0-1 of CMAQ modelled Pressure at lifting condensation level,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.pna,pna(kg/hectare),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.pr_cldfrac,pr_cldfrac(-),Levels 0-1 of CMAQ modelled Precipitating cloud fraction,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.pr_cloudtop,pr_cloudtop(layer-number),Levels 0-1 of CMAQ modelled Precipitating cloud top layer number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.pr_trans,pr_trans(-),Levels 0-1 of CMAQ modelled Precipitating cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.rain_flag,rain_flag(1 or 0),Levels 0-1 of CMAQ modelled Rain flag 1 is raining 0 is not raining,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.res_trans,res_trans(-),Levels 0-1 of CMAQ modelled Resolved cloud transmissivity,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.wetdep2.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.metcro2d.rainc,rainc(mm),Levels 0-1 of CMAQ modelled Accumulated total cumulus precipitation,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.metcro2d.rainnc,rainnc(mm),Levels 0-1 of CMAQ modelled Accumulated total grid scale precipitation,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.noy.noy,noy(ppmV),Levels 0-35 of CMAQ modelled Total reactive nitrogen,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.soilinp.ptype,ptype(integer),Levels 0-1 of CMAQ modelled no emission pulse type,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.soilinp.pulsedate,pulsedate(yyyyddd),Levels 0-1 of CMAQ modelled cmaq starting date for no emission pulse,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.soilinp.pulsetime,pulsetime(hhmmss),Levels 0-1 of CMAQ modelled cmaq starting time for no emission pulse,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.soilinp.rainfall01,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall02,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall03,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall04,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall05,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall06,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall07,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall08,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall09,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall10,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall11,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall12,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall13,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall14,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall15,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall16,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall17,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall18,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall19,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall20,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall21,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall22,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall23,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.soilinp.rainfall24,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.east.ssemis.acaj,acaj(g/s),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.aclj,aclj(g/s),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.aclk,aclk(g/s),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.ah2oj,ah2oj(g/s),Levels 0-1 of CMAQ modelled Aerosol Water Vapor Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.ah2ok,ah2ok(g/s),Levels 0-1 of CMAQ modelled Aerosol Water Vapor Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.akj,akj(g/s),Levels 0-1 of CMAQ modelled Aerosol Potassium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.amgj,amgj(g/s),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.anaj,anaj(g/s),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.aseacat,aseacat(g/s),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.aso4j,aso4j(g/s),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.aso4k,aso4k(g/s),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.numacc,numacc(number/s),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.numcor,numcor(number/s),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.srfacc,srfacc(m2/s),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.east.ssemis.srfcor,srfcor(m2/s),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-01T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aacd,aacd(ppmV),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aalj,aalj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aalkj,aalkj(ug/m3),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.abnz1j,abnz1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.abnz2j,abnz2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.abnz3j,abnz3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.acaj,acaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.acli,acli(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aclj,aclj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aclk,aclk(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.acors,acors(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aeci,aeci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aecj,aecj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.afej,afej(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ah2oi,ah2oi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ah2oj,ah2oj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ah2ok,ah2ok(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aiso1j,aiso1j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aiso2j,aiso2j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aiso3j,aiso3j(ug/m3),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.akj,akj(ug/m3),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ald2,ald2(ppmV),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aldx,aldx(ppmV),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.amgj,amgj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.amnj,amnj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.anai,anai(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.anaj,anaj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.anh4i,anh4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.anh4j,anh4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.anh4k,anh4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ano3i,ano3i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ano3j,ano3j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ano3k,ano3k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aolgaj,aolgaj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aolgbj,aolgbj(ug/m3),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aorgcj,aorgcj(ug/m3),Levels 0-1 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aothri,aothri(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aothrj,aothrj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.apncomi,apncomi(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.apncomj,apncomj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.apoci,apoci(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.apocj,apocj(ug/m3),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aseacat,aseacat(ug/m3),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.asij,asij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aso4i,aso4i(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aso4j,aso4j(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.aso4k,aso4k(ug/m3),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.asoil,asoil(ug/m3),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.asqtj,asqtj(ug/m3),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.atij,atij(ug/m3),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.atol1j,atol1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.atol2j,atol2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.atol3j,atol3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.atrp1j,atrp1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.atrp2j,atrp2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.axyl1j,axyl1j(ug/m3),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.axyl2j,axyl2j(ug/m3),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.axyl3j,axyl3j(ug/m3),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.benzene,benzene(ppmV),Levels 0-1 of CMAQ modelled Benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.benzro2,benzro2(ppmV),Levels 0-1 of CMAQ modelled First generation SOA intermediate from benzene oxidation,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.bnzhrxn,bnzhrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under low NOx conditions,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.bnznrxn,bnznrxn(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from BENZENE under high NOx conditions,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.c2o3,c2o3(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cao2,cao2(ppmV),Levels 0-1 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cat1,cat1(ppmV),Levels 0-1 of CMAQ modelled Methyl-catechol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cl,cl(ppmV),Levels 0-1 of CMAQ modelled Chlorides,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cl2,cl2(ppmV),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.clo,clo(ppmV),Levels 0-1 of CMAQ modelled Hypoclorite,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.co,co(ppmV),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cres,cres(ppmV),Levels 0-1 of CMAQ modelled Cresol And Higher Molecular Weight Phenois,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.crn2,crn2(ppmV),Levels 0-1 of CMAQ modelled Chromium nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.crno,crno(ppmV),Levels 0-1 of CMAQ modelled Alkoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cro,cro(ppmV),Levels 0-1 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cron,cron(ppmV),Levels 0-1 of CMAQ modelled nitrocresol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.crpx,crpx(ppmV),Levels 0-1 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.cxo3,cxo3(ppmV),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.eth,eth(ppmV),Levels 0-1 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.etha,etha(ppmV),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.etoh,etoh(ppmV),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.facd,facd(ppmV),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.fmcl,fmcl(ppmV),Levels 0-1 of CMAQ modelled Formic Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.form,form(ppmV),Levels 0-1 of CMAQ modelled Formyl Chloride,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.h2o2,h2o2(ppmV),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.hcl,hcl(ppmV),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.hco3,hco3(ppmV),Levels 0-1 of CMAQ modelled Hydrocloric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.hno3,hno3(ppmV),Levels 0-1 of CMAQ modelled Radical formed when formaldehyde reacts with HO2,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ho2,ho2(ppmV),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.hocl,hocl(ppmV),Levels 0-1 of CMAQ modelled Hydroperoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.hono,hono(ppmV),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.iole,iole(ppmV),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.isop,isop(ppmV),Levels 0-1 of CMAQ modelled Internal Olefins,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.isoprxn,isoprxn(ppmV),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ispd,ispd(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from ISOP,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.meo2,meo2(ppmV),Levels 0-1 of CMAQ modelled Isoprene Product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.meoh,meoh(ppmV),Levels 0-1 of CMAQ modelled Methyl Peroxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.mepx,mepx(ppmV),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.mgly,mgly(ppmV),Levels 0-1 of CMAQ modelled Methyl Hydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.n2o5,n2o5(ppmV),Levels 0-1 of CMAQ modelled Methylglyoxal And Other Aeromatic Products,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.nh3,nh3(ppmV),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.no,no(ppmV),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.no2,no2(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.no3,no3(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ntr,ntr(ppmV),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.numacc,numacc(number/m3),Levels 0-1 of CMAQ modelled Nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.numatkn,numatkn(number/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.numcor,numcor(number/m3),Levels 0-1 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.o,o(ppmV),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.o1d,o1d(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O3(P) Electronic State,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.o3,o3(ppmV),Levels 0-1 of CMAQ modelled Oxygen Atom In The O1(D) Electronic State,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.oh,oh(ppmV),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ole,ole(ppmV),Levels 0-1 of CMAQ modelled Hydroxyl Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.opan,opan(ppmV),Levels 0-1 of CMAQ modelled Terminal Olefin Carbon Bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.open,open(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.opo3,opo3(ppmV),Levels 0-1 of CMAQ modelled Aromatic Ring Opening Product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.pacd,pacd(ppmV),Levels 0-1 of CMAQ modelled Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.pan,pan(ppmV),Levels 0-1 of CMAQ modelled Peroxyacetic And Higher Peroxycarboxylic Acids,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.panx,panx(ppmV),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.par,par(ppmV),Levels 0-1 of CMAQ modelled C3+ PANs,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.pna,pna(ppmV),Levels 0-1 of CMAQ modelled Paraffin Carbon Bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.rooh,rooh(ppmV),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.ror,ror(ppmV),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sesq,sesq(ppmV),Levels 0-1 of CMAQ modelled Secondary Alkoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sesqrxn,sesqrxn(ppmV),Levels 0-1 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.so2,so2(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing SOA from SESQ,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.srfacc,srfacc(m2/m3),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.srfatkn,srfatkn(m2/m3),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.srfcor,srfcor(m2/m3),Levels 0-1 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sulf,sulf(ppmV),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sulrxn,sulrxn(ppmV),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_alk,sv_alk(ppmV),Levels 0-1 of CMAQ modelled Counter species for computing aerosols from SULF,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_bnz1,sv_bnz1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile alkanes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_bnz2,sv_bnz2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene1,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_iso1,sv_iso1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from benzene2,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_iso2,sv_iso2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene1,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_sqt,sv_sqt(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from isoprene2,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_tol1,sv_tol1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from sesquiterpene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_tol2,sv_tol2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene1,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_trp1,sv_trp1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Toluene2,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_trp2,sv_trp2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene1,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_xyl1,sv_xyl1(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Terpene2,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.sv_xyl2,sv_xyl2(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene1,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.terp,terp(ppmV),Levels 0-1 of CMAQ modelled Semi-volatile SOA from Xylene2,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.to2,to2(ppmV),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.tol,tol(ppmV),Levels 0-1 of CMAQ modelled Toluene-Hydroxyl Radical Adduct,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.tolhrxn,tolhrxn(ppmV),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.tolnrxn,tolnrxn(ppmV),Levels 0-1 of CMAQ modelled tolhrxn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.tolro2,tolro2(ppmV),Levels 0-1 of CMAQ modelled tolnrxn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.trprxn,trprxn(ppmV),Levels 0-1 of CMAQ modelled tolro2?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.xo2,xo2(ppmV),Levels 0-1 of CMAQ modelled trprxn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.xo2n,xo2n(ppmV),Levels 0-1 of CMAQ modelled Peroxy Radical Operator,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.xyl,xyl(ppmV),Levels 0-1 of CMAQ modelled NO To Organic Nitrate Conversion From Alkylperoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.xylhrxn,xylhrxn(ppmV),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.xylnrxn,xylnrxn(ppmV),Levels 0-1 of CMAQ modelled xylhrxn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aconc.xylro2,xylro2(ppmV),Levels 0-1 of CMAQ modelled xylnrxn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.dgacc_dry,dgacc_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode Without Water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.dgacc_wet,dgacc_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Accumulation Mode With Water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.dgatkn_dry,dgatkn_dry(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode Without Water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.dgatkn_wet,dgatkn_wet(ug/m3),Levels 0-35 of CMAQ modelled Geometric Diameter Of Aitken Mode With Water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.dgcor_dry,dgcor_dry(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter without water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.dgcor_wet,dgcor_wet(ug/m3),Levels 0-35 of CMAQ modelled Coarse mode mean diameter with water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.gamma_n2o5,gamma_n2o5(-),Levels 0-35 of CMAQ modelled N2O5 Heterogeneous reaction probability,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m2acc_wet,m2acc_wet(m2/m3),Levels 0-35 of CMAQ modelled Accumulation mode 2nd moment (wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m2atkn_wet,m2atkn_wet(m2/m3),Levels 0-35 of CMAQ modelled Aitken mode 2nd moment (wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m2cor_wet,m2cor_wet(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 2nd moment (wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m3acc_dry,m3acc_dry(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (dry),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m3acc_wet,m3acc_wet(m3/m3),Levels 0-35 of CMAQ modelled Accumulation mode 3rd moment (wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m3atkn_dry,m3atkn_dry(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (dry),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m3atkn_wet,m3atkn_wet(m3/m3),Levels 0-35 of CMAQ modelled Aitken mode 3rd moment (wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m3cor_dry,m3cor_dry(m3/m3),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (dry),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.m3cor_wet,m3cor_wet(-),Levels 0-35 of CMAQ modelled Coarse mode 3rd moment (wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.pm25ac,pm25ac(-),Levels 0-35 of CMAQ modelled Fine fraction of accumulation mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.pm25at,pm25at(-),Levels 0-35 of CMAQ modelled Fine fraction of Aitken mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.pm25co,pm25co(-),Levels 0-35 of CMAQ modelled Fine fraction of coarse mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.rh,rh(-),Levels 0-35 of CMAQ modelled Relative humiditity,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.stdevacc,stdevacc(-),Levels 0-35 of CMAQ modelled Accumulation mode standard deviation (dry and wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.stdevatkn,stdevatkn(-),Levels 0-35 of CMAQ modelled Aitken mode standard deviation (dry and wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerodiam.stdevcor,stdevcor(-),Levels 0-35 of CMAQ modelled Coarse mode standard deviation (dry and wet),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerovis.dcv_mie,dcv_mie(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerovis.dcv_recon,dcv_recon(deciview),Levels 0-1 of CMAQ modelled hourly visual range,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerovis.ext_mie,ext_mie(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.aerovis.ext_recon,ext_recon(1/km),Levels 0-1 of CMAQ modelled hourly extinction coefficient,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aalj,aalj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aalkj,aalkj(ug/m3),Levels 0-35 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.abnz1j,abnz1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.abnz2j,abnz2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.abnz3j,abnz3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.acaj,acaj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol CA? Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.acli,acli(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aclj,aclj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aclk,aclk(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.acors,acors(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aeci,aeci(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aecj,aecj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.afej,afej(ug/m3),Levels 0-35 of CMAQ modelled Aerosol ? Elemental Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ah2oi,ah2oi(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ah2oj,ah2oj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ah2ok,ah2ok(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Water Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aiso1j,aiso1j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aiso2j,aiso2j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aiso3j,aiso3j(ug/m3),Levels 0-35 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.akj,akj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol ? Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ald2,ald2(ppmv),Levels 0-35 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aldx,aldx(ppmv),Levels 0-35 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.amgj,amgj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol MG? Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.amnj,amnj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol MN? Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.anai,anai(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sodium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.anaj,anaj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.anh4i,anh4i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.anh4j,anh4j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.anh4k,anh4k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ano3i,ano3i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ano3j,ano3j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ano3k,ano3k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aolgaj,aolgaj(ug/m3),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aolgbj,aolgbj(ug/m3),Levels 0-35 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aorgcj,aorgcj(ug/m3),Levels 0-35 of CMAQ modelled SOA from in-cloud oxidation of dialdehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aothri,aothri(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Other Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aothrj,aothrj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Other Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.apncomi,apncomi(ug/m3),Levels 0-35 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.apncomj,apncomj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.apoci,apoci(ug/m3),Levels 0-35 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.apocj,apocj(ug/m3),Levels 0-35 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aseacat,aseacat(ug/m3),Levels 0-35 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.asij,asij(ug/m3),Levels 0-35 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aso4i,aso4i(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aso4j,aso4j(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.aso4k,aso4k(ug/m3),Levels 0-35 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.asoil,asoil(ug/m3),Levels 0-35 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.asqtj,asqtj(ug/m3),Levels 0-35 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.atij,atij(ug/m3),Levels 0-35 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.atol1j,atol1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.atol2j,atol2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.atol3j,atol3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.atrp1j,atrp1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.atrp2j,atrp2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.axyl1j,axyl1j(ug/m3),Levels 0-35 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.axyl2j,axyl2j(ug/m3),Levels 0-35 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.axyl3j,axyl3j(ug/m3),Levels 0-35 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.benzene,benzene(ppmv),Levels 0-35 of CMAQ modelled benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.c2o3,c2o3(ppmv),Levels 0-35 of CMAQ modelled Peroxy Radical from Methyl-catechol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.cao2,cao2(ppmv),Levels 0-35 of CMAQ modelled Acetyl Peroxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.co,co(ppmv),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.crn2,crn2(ppmv),Levels 0-35 of CMAQ modelled Chromium nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.crno,crno(ppmv),Levels 0-35 of CMAQ modelled Alkoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.cro,cro(ppmv),Levels 0-35 of CMAQ modelled Methylphenoxy Radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.cron,cron(ppmv),Levels 0-35 of CMAQ modelled nitrocresol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.crpx,crpx(ppmv),Levels 0-35 of CMAQ modelled C3+ Peroxyacetyl Radicals,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.cxo3,cxo3(ppmv),Levels 0-35 of CMAQ modelled CRPX?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.eth,eth(ppmv),Levels 0-35 of CMAQ modelled Higher acylperoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.etha,etha(ppmv),Levels 0-35 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.etoh,etoh(ppmv),Levels 0-35 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.form,form(ppmv),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.h2o2,h2o2(ppmv),Levels 0-35 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.hco3,hco3(ppmv),Levels 0-35 of CMAQ modelled hco3,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.hno3,hno3(ppmv),Levels 0-35 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ho2,ho2(ppmv),Levels 0-35 of CMAQ modelled Hydroperoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.hono,hono(ppmv),Levels 0-35 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.iole,iole(ppmv),Levels 0-35 of CMAQ modelled Internal olefin carbon bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.isop,isop(ppmv),Levels 0-35 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.meo2,meo2(ppmv),Levels 0-35 of CMAQ modelled Methylperoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.n2o5,n2o5(ppmv),Levels 0-35 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.nh3,nh3(ppmv),Levels 0-35 of CMAQ modelled ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.no2,no2(ppmv),Levels 0-35 of CMAQ modelled nitrogen dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.no3,no3(ppmv),Levels 0-35 of CMAQ modelled nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.no,no(ppmv),Levels 0-35 of CMAQ modelled nitric oxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ntr,ntr(ppmv),Levels 0-35 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.numacc,numacc(number/m3),Levels 0-35 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.numatkn,numatkn(number/m3),Levels 0-35 of CMAQ modelled Aitken Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.numcor,numcor(number/m3),Levels 0-35 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.o3,o3(ppmv),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.oh,oh(ppmv),Levels 0-35 of CMAQ modelled Hydroxyl radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ole,ole(ppmv),Levels 0-35 of CMAQ modelled Terminal olefin carbon bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.opan,opan(ppmv),Levels 0-35 of CMAQ modelled opan,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.opo3,opo3(ppmv),Levels 0-35 of CMAQ modelled Peroxyacyl radical from oxidation of OPEN,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.pan,pan(ppmv),Levels 0-35 of CMAQ modelled Peroxyacyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.panx,panx(ppmv),Levels 0-35 of CMAQ modelled C3 and higher peroxyacyl nitrates,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.par,par(ppmv),Levels 0-35 of CMAQ modelled Paraffin carbon bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.pna,pna(ppmv),Levels 0-35 of CMAQ modelled Peroxynitric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.rooh,rooh(ppmv),Levels 0-35 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.ror,ror(ppmv),Levels 0-35 of CMAQ modelled Secondary alkoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.sesq,sesq(ppmv),Levels 0-35 of CMAQ modelled Sesquiterpene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.so2,so2(ppmv),Levels 0-35 of CMAQ modelled Sulfur dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.srfacc,srfacc(m2/m3),Levels 0-35 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.srfatkn,srfatkn(m2/m3),Levels 0-35 of CMAQ modelled Aitken Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.srfcor,srfcor(m2/m3),Levels 0-35 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.sulf,sulf(ppmv),Levels 0-35 of CMAQ modelled Sulfuric acid gas,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.terp,terp(ppmv),Levels 0-35 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.to2,to2(ppmv),Levels 0-35 of CMAQ modelled Tolene-hydroxyl radical adduct,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.tol,tol(ppmv),Levels 0-35 of CMAQ modelled Toluene and other monoalkyl aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.w_vel,w_vel(m/s),Levels 0-35 of CMAQ modelled Vertical component of wind velocity,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.xo2,xo2(ppmv),Levels 0-35 of CMAQ modelled NO-to-NO2 conversion from alkylperoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.xo2n,xo2n(ppmv),Levels 0-35 of CMAQ modelled NO-to-nitrate conversion from alkylperoxy radical,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.conc.xyl,xyl(ppmv),Levels 0-35 of CMAQ modelled Xylene and other polyalkyl aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_ald,vd_ald(cm/sec),Levels 0-1 of CMAQ modelled ald?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_cl2,vd_cl2(cm/sec),Levels 0-1 of CMAQ modelled cl2?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_co,vd_co(cm/sec),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_fmcl,vd_fmcl(cm/sec),Levels 0-1 of CMAQ modelled fmcl?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_gen_ald,vd_gen_ald(cm/sec),Levels 0-1 of CMAQ modelled gen_ald?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_h2o2,vd_h2o2(cm/sec),Levels 0-1 of CMAQ modelled Peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_hcho,vd_hcho(cm/sec),Levels 0-1 of CMAQ modelled hcho?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_hcl,vd_hcl(cm/sec),Levels 0-1 of CMAQ modelled Hydrochloric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_hno3,vd_hno3(cm/sec),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_hocl,vd_hocl(cm/sec),Levels 0-1 of CMAQ modelled hocl?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_hono,vd_hono(cm/sec),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_methanol,vd_methanol(cm/sec),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_n2o5,vd_n2o5(cm/sec),Levels 0-1 of CMAQ modelled Dinitrate Pentoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_nh3,vd_nh3(cm/sec),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_no,vd_no(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Oxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_no2,vd_no2(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_no3,vd_no3(cm/sec),Levels 0-1 of CMAQ modelled Nitrogen Trioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_o3,vd_o3(cm/sec),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_op,vd_op(cm/sec),Levels 0-1 of CMAQ modelled op?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_ora,vd_ora(cm/sec),Levels 0-1 of CMAQ modelled ora?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_paa,vd_paa(cm/sec),Levels 0-1 of CMAQ modelled paa?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_pan,vd_pan(cm/sec),Levels 0-1 of CMAQ modelled Peroxy Acetyl Nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_so2,vd_so2(cm/sec),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vd_sulf,vd_sulf(cm/sec),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vmassc,vmassc(cm/sec),Levels 0-1 of CMAQ modelled vmassc?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vmassi,vmassi(cm/sec),Levels 0-1 of CMAQ modelled vmassi?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vmassj,vmassj(cm/sec),Levels 0-1 of CMAQ modelled vmassj?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vnumacc,vnumacc(cm/sec),Levels 0-1 of CMAQ modelled vnumacc?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vnumatkn,vnumatkn(cm/sec),Levels 0-1 of CMAQ modelled vnumatkn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vnumcor,vnumcor(cm/sec),Levels 0-1 of CMAQ modelled vnumcor?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vsrfacc,vsrfacc(cm/sec),Levels 0-1 of CMAQ modelled vsrfacc?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vsrfatkn,vsrfatkn(cm/sec),Levels 0-1 of CMAQ modelled vsrfatkn?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.depv.vsrfcor,vsrfcor(cm/sec),Levels 0-1 of CMAQ modelled vsrfcor?,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Acetic And Higher Carboxylic Acids,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Aluminum Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chlorine Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Course Mode Anthropogenic Mass,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Elemental Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled High Melecular Weight Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol organic carbon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol other carbon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic matter Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol particle oxidation catalysts Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol silicon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coase Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol coarse mode soil-derived mass,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Elemental Chlorine,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.crpx,crpx(kg/hectare),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Nitro-cresol from hydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled Higher organic peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.drydep.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.acrolein,acrolein(g/s),Levels 0-1 of CMAQ modelled acrolein,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.ald2,ald2(g/s),Levels 0-1 of CMAQ modelled Acetaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.ald2_primary,ald2_primary(g/s),Levels 0-1 of CMAQ modelled ald2_primary,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.aldx,aldx(g/s),Levels 0-1 of CMAQ modelled Propionaldehyde and higher aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.benzene,benzene(g/s),Levels 0-1 of CMAQ modelled benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.butadiene13,butadiene13(g/s),Levels 0-1 of CMAQ modelled butadiene13,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.ch4,ch4(g/s),Levels 0-1 of CMAQ modelled methane,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.cl2,cl2(g/s),Levels 0-1 of CMAQ modelled chlorine,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.co,co(g/s),Levels 0-1 of CMAQ modelled carbon monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.eth,eth(g/s),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.etha,etha(g/s),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.etoh,etoh(g/s),Levels 0-1 of CMAQ modelled Ethanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.form,form(g/s),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.form_primary,form_primary(g/s),Levels 0-1 of CMAQ modelled Formaldehyde primary,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.hcl,hcl(g/s),Levels 0-1 of CMAQ modelled Hydrogen chloride,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.hono,hono(g/s),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.iole,iole(g/s),Levels 0-1 of CMAQ modelled Internal olefin carbon bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.isop,isop(g/s),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.meoh,meoh(g/s),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.naphthalene,naphthalene(g/s),Levels 0-1 of CMAQ modelled naphthalene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.nh3,nh3(moles/s),Levels 0-1 of CMAQ modelled ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.nh3_fert,nh3_fert(moles/s),Levels 0-1 of CMAQ modelled ammonia from fertilizers,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.no,no(moles/s),Levels 0-1 of CMAQ modelled nitrogen monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.no2,no2(moles/s),Levels 0-1 of CMAQ modelled nitrogen dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.nvol,nvol(moles/s),Levels 0-1 of CMAQ modelled Nonvolatile Carbon,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.ole,ole(moles/s),Levels 0-1 of CMAQ modelled Terminal olefin carbon bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pal,pal(moles/s),Levels 0-1 of CMAQ modelled Fine mode aluminum,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.par,par(moles/s),Levels 0-1 of CMAQ modelled Paraffin carbon bond,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pca,pca(moles/s),Levels 0-1 of CMAQ modelled fine mode calcium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pcl,pcl(moles/s),Levels 0-1 of CMAQ modelled fine mode chlorine,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pec,pec(moles/s),Levels 0-1 of CMAQ modelled fine mode elemental carbon,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pfe,pfe(moles/s),Levels 0-1 of CMAQ modelled fine mode iron,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.ph2o,ph2o(moles/s),Levels 0-1 of CMAQ modelled Fine mode particulate water,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pk,pk(moles/s),Levels 0-1 of CMAQ modelled Fine mode potassium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pmc,pmc(moles/s),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pmfine,pmfine(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pmg,pmg(moles/s),Levels 0-1 of CMAQ modelled Fine mode magnesium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pmn,pmn(moles/s),Levels 0-1 of CMAQ modelled Fine mode manganese,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pmothr,pmothr(moles/s),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pna,pna(moles/s),Levels 0-1 of CMAQ modelled Fine mode sodium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pncom,pncom(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary non-carbon organic matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pnh4,pnh4(moles/s),Levels 0-1 of CMAQ modelled Fine particulate ammonium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pno3,pno3(moles/s),Levels 0-1 of CMAQ modelled Fine mode nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.poc,poc(moles/s),Levels 0-1 of CMAQ modelled Fine mode primary organic carbon,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.psi,psi(moles/s),Levels 0-1 of CMAQ modelled Fine mode silicon,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pso4,pso4(moles/s),Levels 0-1 of CMAQ modelled Fine mode sulfate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.pti,pti(moles/s),Levels 0-1 of CMAQ modelled Fine mode titanium,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.so2,so2(moles/s),Levels 0-1 of CMAQ modelled Fine mode sulfate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.sulf,sulf(moles/s),Levels 0-1 of CMAQ modelled sulfate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.terp,terp(moles/s),Levels 0-1 of CMAQ modelled Terpene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.tol,tol(moles/s),Levels 0-1 of CMAQ modelled Toluene And Other Monoalkyl Aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.unk,unk(moles/s),Levels 0-1 of CMAQ modelled Unknown,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.unr,unr(moles/s),Levels 0-1 of CMAQ modelled Unreactive,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.voc_inv,voc_inv(moles/s),Levels 0-1 of CMAQ modelled volatile organic componds inv,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.emis.xyl,xyl(moles/s),Levels 0-1 of CMAQ modelled Xylene And Other Polyalkyl Aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.metcro3d.dens,dens(Pa),Levels 0-35 of CMAQ modelled Base state pressure,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.pm25.pm25,pm25(ug/m3),Levels 0-35 of CMAQ modelled particulate matter (aerosols) not more than 2.5 microns in diameter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Higher carboxylic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol aluminum Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol potassium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Silicon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol soil-derived,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled Chlorine,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Carbon monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.hplus,hplus(kg/hectare),Levels 0-1 of CMAQ modelled Hydronium ion,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.pna,pna(kg/hectare),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep1.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aacd,aacd(kg/hectare),Levels 0-1 of CMAQ modelled Higher carboxylic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aalj,aalj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol aluminum Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aalkj,aalkj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from alkanes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.abnz1j,abnz1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.abnz2j,abnz2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from benzene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.abnz3j,abnz3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from benzene (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.acaj,acaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aclj,aclj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aclk,aclk(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.acors,acors(kg/hectare),Levels 0-1 of CMAQ modelled Coarse mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aeci,aeci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aecj,aecj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Elemental Carbon Mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.afej,afej(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Iron Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aiso1j,aiso1j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aiso2j,aiso2j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aiso3j,aiso3j(kg/hectare),Levels 0-1 of CMAQ modelled Acid-enhanced SOA from isoprene,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.akj,akj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol potassium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.ald2,ald2(kg/hectare),Levels 0-1 of CMAQ modelled High Molecular Weight Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aldx,aldx(kg/hectare),Levels 0-1 of CMAQ modelled C3+ Aldehydes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.amgj,amgj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.amnj,amnj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Manganese Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.anaj,anaj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.anh4i,anh4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.anh4j,anh4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.anh4k,anh4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Ammonium Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.ano3i,ano3i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.ano3j,ano3j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.ano3k,ano3k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Nitrate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aolgaj,aolgaj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile anthropogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aolgbj,aolgbj(kg/hectare),Levels 0-1 of CMAQ modelled Oligomers from semi-volatile biogenic SOA species,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aorgcj,aorgcj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aothrj,aothrj(kg/hectare),Levels 0-1 of CMAQ modelled Unspeciated fine mode primary particulate matter,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.apncomi,apncomi(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.apncomj,apncomj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary non-carbon organic mass Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.apoci,apoci(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.apocj,apocj(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol primary organic carbon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aseacat,aseacat(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.asij,asij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Silicon Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aso4i,aso4i(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Aitken Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aso4j,aso4j(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.aso4k,aso4k(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.asoil,asoil(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol soil-derived,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.asqtj,asqtj(kg/hectare),Levels 0-1 of CMAQ modelled SOA from sesquiterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.atij,atij(kg/hectare),Levels 0-1 of CMAQ modelled Aerosol titanium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.atol1j,atol1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.atol2j,atol2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from mono-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.atol3j,atol3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from mono-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.atrp1j,atrp1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.atrp2j,atrp2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from monoterpenes,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.axyl1j,axyl1j(kg/hectare),Levels 0-1 of CMAQ modelled Low-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.axyl2j,axyl2j(kg/hectare),Levels 0-1 of CMAQ modelled High-volatility SOA from poly-substituted aromatics,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.axyl3j,axyl3j(kg/hectare),Levels 0-1 of CMAQ modelled Non-volatile SOA from poly-substituted aromatics (low-NOx),-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.cl2,cl2(kg/hectare),Levels 0-1 of CMAQ modelled chlorine,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.cld_trans,cld_trans(-),Levels 0-1 of CMAQ modelled total cloud transmissivity,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.cloud_bottom,cloud_bottom(layer-number),"Levels 0-1 of CMAQ modelled layer containing bottom of cloud, or missing = -9999.9",-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.co,co(kg/hectare),Levels 0-1 of CMAQ modelled Carbon monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.facd,facd(kg/hectare),Levels 0-1 of CMAQ modelled Formic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.fmcl,fmcl(kg/hectare),Levels 0-1 of CMAQ modelled Formyl chloride,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.form,form(kg/hectare),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.h2o2,h2o2(kg/hectare),Levels 0-1 of CMAQ modelled Hydrogen peroxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.hcl,hcl(kg/hectare),Levels 0-1 of CMAQ modelled Hydrochloric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.hno3,hno3(kg/hectare),Levels 0-1 of CMAQ modelled Nitric acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.hocl,hocl(kg/hectare),Levels 0-1 of CMAQ modelled Hypochlorous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.hono,hono(kg/hectare),Levels 0-1 of CMAQ modelled Nitrous acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.hplus,hplus(kg/hectare),Levels 0-1 of CMAQ modelled Hydronium ion,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.meoh,meoh(kg/hectare),Levels 0-1 of CMAQ modelled Methanol,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.mepx,mepx(kg/hectare),Levels 0-1 of CMAQ modelled Methylhydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.n2o5,n2o5(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen pentoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.nh3,nh3(kg/hectare),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.no,no(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen monoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.no2,no2(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.no3,no3(kg/hectare),Levels 0-1 of CMAQ modelled Nitrogen trioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.np_cldfrac,np_cldfrac(-),Levels 0-1 of CMAQ modelled Non-precipitating cloud fraction,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.np_cloudtop,np_cloudtop(layer-number),Levels 0-1 of CMAQ modelled Model layer containing top of non-precipitating cloud,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.np_trans,np_trans(-),Levels 0-1 of CMAQ modelled Non-precipitating cloud transmissivity,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.ntr,ntr(kg/hectare),Levels 0-1 of CMAQ modelled Organic nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.o3,o3(kg/hectare),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.opan,opan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate from Peroxy radical from Aromatic ring opening product,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.pacd,pacd(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetic acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.pan,pan(kg/hectare),Levels 0-1 of CMAQ modelled Peroxyacetyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.panx,panx(kg/hectare),Levels 0-1 of CMAQ modelled Higher peroxyacyl nitrate,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.plcl,plcl(pa ),Levels 0-1 of CMAQ modelled Pressure at lifting condensation level,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.pna,pna(kg/hectare),Levels 0-1 of CMAQ modelled Peroxynitric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.pr_cldfrac,pr_cldfrac(-),Levels 0-1 of CMAQ modelled Precipitating cloud fraction,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.pr_cloudtop,pr_cloudtop(layer-number),Levels 0-1 of CMAQ modelled Precipitating cloud top layer number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.pr_trans,pr_trans(-),Levels 0-1 of CMAQ modelled Precipitating cloud transmissivity,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.rain_flag,rain_flag(1 or 0),Levels 0-1 of CMAQ modelled Rain flag 1 is raining 0 is not raining,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.res_trans,res_trans(-),Levels 0-1 of CMAQ modelled Resolved cloud transmissivity,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.rooh,rooh(kg/hectare),Levels 0-1 of CMAQ modelled C2+ Organic Hydroperoxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.so2,so2(kg/hectare),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.wetdep2.sulf,sulf(kg/hectare),Levels 0-1 of CMAQ modelled Sulfuric Acid,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.metcro2d.rainc,rainc(mm),Levels 0-1 of CMAQ modelled Accumulated total cumulus precipitation,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.metcro2d.rainnc,rainnc(mm),Levels 0-1 of CMAQ modelled Accumulated total grid scale precipitation,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.noy.noy,noy(ppmV),Levels 0-35 of CMAQ modelled Total reactive nitrogen,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.soilinp.ptype,ptype(integer),Levels 0-1 of CMAQ modelled no emission pulse type,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.soilinp.pulsedate,pulsedate(yyyyddd),Levels 0-1 of CMAQ modelled cmaq starting date for no emission pulse,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.soilinp.pulsetime,pulsetime(hhmmss),Levels 0-1 of CMAQ modelled cmaq starting time for no emission pulse,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.soilinp.rainfall01,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall02,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall03,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall04,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall05,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall06,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall07,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall08,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall09,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall10,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall11,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall12,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall13,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall14,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall15,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall16,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall17,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall18,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall19,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall20,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall21,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall22,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall23,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.soilinp.rainfall24,,,-180 -90 180 90,,,now,cmaq +cmaq.discover.md.ssemis.acaj,acaj(g/s),Levels 0-1 of CMAQ modelled Aerosol Calcium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.aclj,aclj(g/s),Levels 0-1 of CMAQ modelled Aerosol Chloride Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.aclk,aclk(g/s),Levels 0-1 of CMAQ modelled Aerosol Chloride Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.ah2oj,ah2oj(g/s),Levels 0-1 of CMAQ modelled Aerosol Water Vapor Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.ah2ok,ah2ok(g/s),Levels 0-1 of CMAQ modelled Aerosol Water Vapor Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.akj,akj(g/s),Levels 0-1 of CMAQ modelled Aerosol Potassium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.amgj,amgj(g/s),Levels 0-1 of CMAQ modelled Aerosol Magnesium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.anaj,anaj(g/s),Levels 0-1 of CMAQ modelled Aerosol Sodium Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.aseacat,aseacat(g/s),Levels 0-1 of CMAQ modelled Aerosol sea salt,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.aso4j,aso4j(g/s),Levels 0-1 of CMAQ modelled Aerosol Sulfate Accumulation Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.aso4k,aso4k(g/s),Levels 0-1 of CMAQ modelled Aerosol Sulfate Coarse Mode,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.numacc,numacc(number/s),Levels 0-1 of CMAQ modelled Accumulation Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.numcor,numcor(number/s),Levels 0-1 of CMAQ modelled Coarse Mode Number,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.srfacc,srfacc(m2/s),Levels 0-1 of CMAQ modelled Accumulation Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.discover.md.ssemis.srfcor,srfcor(m2/s),Levels 0-1 of CMAQ modelled Coarse Mode Surface Area,-180 -90 180 90,2011-07-02T00:00:00Z,PT1H,2011-07-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.ANAK_D,ANAK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[1]+0.0626*ASOIL[1]+0.0023*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.ANAK_W,ANAK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[2]+0.0626*ASOIL[2]+0.0023*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.ACAK_D,ACAK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[1]+0.0838*ASOIL[1]+0.0562*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.ACAK_W,ACAK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[2]+0.0838*ASOIL[2]+0.0562*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.AKK_D,AKK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[1]+0.0242*ASOIL[1]+0.0176*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.AKK_W,AKK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[2]+0.0242*ASOIL[2]+0.0176*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.AMGK_D,AMGK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[1]+0.0032*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.AMGK_W,AMGK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[2]+0.0032*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NO2,DDEP_NO2(kg/ha),Levels 0-1 of CMAQ modelled NO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_NO2,WDEP_NO2(kg/ha),Levels 0-1 of CMAQ modelled NO2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NO,DDEP_NO(kg/ha),Levels 0-1 of CMAQ modelled NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_NO,WDEP_NO(kg/ha),Levels 0-1 of CMAQ modelled NO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_FORM,DDEP_FORM(kg/ha),Levels 0-1 of CMAQ modelled FORM[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_FORM,WDEP_FORM(kg/ha),Levels 0-1 of CMAQ modelled FORM[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_H2O2,DDEP_H2O2(kg/ha),Levels 0-1 of CMAQ modelled H2O2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_H2O2,WDEP_H2O2(kg/ha),Levels 0-1 of CMAQ modelled H2O2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_N2O5,DDEP_N2O5(kg/ha),Levels 0-1 of CMAQ modelled N2O5[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_N2O5,WDEP_N2O5(kg/ha),Levels 0-1 of CMAQ modelled N2O5[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_HONO,DDEP_HONO(kg/ha),Levels 0-1 of CMAQ modelled HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_HONO,WDEP_HONO(kg/ha),Levels 0-1 of CMAQ modelled HONO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_HNO3,DDEP_HNO3(kg/ha),Levels 0-1 of CMAQ modelled HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_HNO3,WDEP_HNO3(kg/ha),Levels 0-1 of CMAQ modelled HNO3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANO3IJ,DDEP_ANO3IJ(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[1] + ANO3J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANO3K,DDEP_ANO3K(kg/ha),Levels 0-1 of CMAQ modelled ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_ANO3IJK,WDEP_ANO3IJK(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[2] + ANO3J[2] + ANO3K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_TNO3,DDEP_TNO3(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[1] + ANO3J[1] + ANO3K[1] + 0.984*HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_TNO3,WDEP_TNO3(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[2] + ANO3J[2] + ANO3K[2] + 0.984*HNO3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NTR,DDEP_NTR(kg/ha),Levels 0-1 of CMAQ modelled NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_NTR,WDEP_NTR(kg/ha),Levels 0-1 of CMAQ modelled NTR[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_PANT,DDEP_PANT(kg/ha),Levels 0-1 of CMAQ modelled PAN[1] + PANX[1] + OPAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_PANT,WDEP_PANT(kg/ha),Levels 0-1 of CMAQ modelled PAN[2] + PANX[2] + OPAN[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3,DDEP_NH3(kg/ha),Levels 0-1 of CMAQ modelled NH3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Nat,DDEP_NH3_Nat(kg/ha),Levels 0-1 of CMAQ modelled NH3_Nat[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Ag,DDEP_NH3_Ag(kg/ha),Levels 0-1 of CMAQ modelled NH3_Ag[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Wat,DDEP_NH3_Wat(kg/ha),Levels 0-1 of CMAQ modelled NH3_Wat[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Emis,DDEP_NH3_Emis(kg/ha),Levels 0-1 of CMAQ modelled NH3_Emis[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Dep,DDEP_NH3_Dep(kg/ha),Levels 0-1 of CMAQ modelled NH3_Dep[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Stom,DDEP_NH3_Stom(kg/ha),Levels 0-1 of CMAQ modelled NH3_Stom[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Cut,DDEP_NH3_Cut(kg/ha),Levels 0-1 of CMAQ modelled NH3_Cut[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NH3_Soil,DDEP_NH3_Soil(kg/ha),Levels 0-1 of CMAQ modelled NH3_Soil[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_NH3,WDEP_NH3(kg/ha),Levels 0-1 of CMAQ modelled NH3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANH4IJ,DDEP_ANH4IJ(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[1] + ANH4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANH4K,DDEP_ANH4K(kg/ha),Levels 0-1 of CMAQ modelled ANH4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_ANH4IJK,WDEP_ANH4IJK(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[2] + ANH4J[2] + ANH4K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_NHX,DDEP_NHX(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[1] + ANH4J[1] + ANH4K[1] + 1.059*NH3_Dep[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_NHX,WDEP_NHX(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[2] + ANH4J[2] + ANH4K[2] + 1.059*NH3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_SO2,DDEP_SO2(kg/ha),Levels 0-1 of CMAQ modelled SO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ASO4IJ,DDEP_ASO4IJ(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[1] + ASO4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ASO4K,DDEP_ASO4K(kg/ha),Levels 0-1 of CMAQ modelled ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_ASO4IJK,WDEP_ASO4IJK(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[2] + ASO4J[2] + ASO4K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_TSO4,WDEP_TSO4(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[2] + ASO4J[2] + ASO4K[2] + 1.5*SO2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_AECIJ,DDEP_AECIJ(kg/ha),Levels 0-1 of CMAQ modelled AECI[1] +AECJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_AOCIJ,DDEP_AOCIJ(kg/ha),Levels 0-1 of CMAQ modelled (AXYL1J[1]+AXYL2J[1]+AXYL3J[1])/2.0+(ATOL1J[1]+ATOL2J[1]+ATOL3J[1])/2.0+(ABNZ1J[,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_SSSO4J,DDEP_SSSO4J(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_SSSO4K,DDEP_SSSO4K(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_SSSO4JK,WDEP_SSSO4JK(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAJ[2] + 0.19579876*ANAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANAJ,DDEP_ANAJ(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANAK,DDEP_ANAK(kg/ha),Levels 0-1 of CMAQ modelled ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ANAJK,DDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[1] + ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_ANAJK,WDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[2] + ANAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TDEP_ANAJK,TDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled DDEP_ANAJK[0] + WDEP_ANAJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ACLJ,DDEP_ACLJ(kg/ha),Levels 0-1 of CMAQ modelled ACLJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ACLK,DDEP_ACLK(kg/ha),Levels 0-1 of CMAQ modelled ACLK[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ACLJK,DDEP_ACLJK(kg/ha),Levels 0-1 of CMAQ modelled ACLJ[1] + ACLK[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_TCL,WDEP_TCL(kg/ha),Levels 0-1 of CMAQ modelled 0.972*HCL[2] + ACLJ[2] + ACLK[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TDEP_CL,TDEP_CL(kg/ha),Levels 0-1 of CMAQ modelled DDEP_ACLJK[0] + WDEP_TCL[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_CAJ,DDEP_CAJ(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_CAJ,WDEP_CAJ(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_CAJK,DDEP_CAJK(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[1]+ACAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_CAJK,WDEP_CAJK(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[2]+ACAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TDEP_CA,TDEP_CA(kg/ha),Levels 0-1 of CMAQ modelled DDEP_CAJK[0]+WDEP_CAJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_FEJ,DDEP_FEJ(kg/ha),Levels 0-1 of CMAQ modelled AFEJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_FEJ,WDEP_FEJ(kg/ha),Levels 0-1 of CMAQ modelled AFEJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_ALJ,DDEP_ALJ(kg/ha),Levels 0-1 of CMAQ modelled AALJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_ALJ,WDEP_ALJ(kg/ha),Levels 0-1 of CMAQ modelled AALJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_SIJ,DDEP_SIJ(kg/ha),Levels 0-1 of CMAQ modelled ASIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_SIJ,WDEP_SIJ(kg/ha),Levels 0-1 of CMAQ modelled ASIJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_TIJ,DDEP_TIJ(kg/ha),Levels 0-1 of CMAQ modelled ATIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_TIJ,WDEP_TIJ(kg/ha),Levels 0-1 of CMAQ modelled ATIJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_MGJ,DDEP_MGJ(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_MGJ,WDEP_MGJ(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_MGJK,DDEP_MGJK(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[1]+AMGK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_MGJK,WDEP_MGJK(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[2]+AMGK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TDEP_MG,TDEP_MG(kg/ha),Levels 0-1 of CMAQ modelled DDEP_MGJK[0]+WDEP_MGJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_KJ,DDEP_KJ(kg/ha),Levels 0-1 of CMAQ modelled AKJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_KJ,WDEP_KJ(kg/ha),Levels 0-1 of CMAQ modelled AKJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_KJK,DDEP_KJK(kg/ha),Levels 0-1 of CMAQ modelled AKJ[1]+AKK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_KJK,WDEP_KJK(kg/ha),Levels 0-1 of CMAQ modelled AKJ[2]+AKK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TDEP_K,TDEP_K(kg/ha),Levels 0-1 of CMAQ modelled DDEP_KJK[0]+WDEP_KJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_MNJ,DDEP_MNJ(kg/ha),Levels 0-1 of CMAQ modelled AMNJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_MNJ,WDEP_MNJ(kg/ha),Levels 0-1 of CMAQ modelled AMNJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DDEP_O3,DDEP_O3(kg/ha),Levels 0-1 of CMAQ modelled O3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_O3,WDEP_O3(kg/ha),Levels 0-1 of CMAQ modelled O3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WDEP_PNA,WDEP_PNA(kg/ha),Levels 0-1 of CMAQ modelled PNA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.RT,RT(cm),Levels 0-1 of CMAQ modelled RN[3] + RC[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_NOX,DD_OXN_NOX(kg/ha),Levels 0-1 of CMAQ modelled 0.30435*NO2[1] + 0.46667*NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_NOX,WD_OXN_NOX(kg/ha),Levels 0-1 of CMAQ modelled 0.30435*NO2[2] + 0.46667*NO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_TNO3,DD_OXN_TNO3(kg/ha),Levels 0-1 of CMAQ modelled 0.22222*HNO3[1] + 0.22581*ANO3I[1] + 0.22581*ANO3J[1] + 0.22581*ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_TNO3,WD_OXN_TNO3(kg/ha),Levels 0-1 of CMAQ modelled 0.22581*WDEP_TNO3[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_PANT,DD_OXN_PANT(kg/ha),Levels 0-1 of CMAQ modelled 0.11570*PAN[1] + 0.11570*PANX[1] + 0.11570*OPAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_PANT,WD_OXN_PANT(kg/ha),Levels 0-1 of CMAQ modelled 0.11570*PAN[2] + 0.11570*PANX[2] + 0.11570*OPAN[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_ORGN,DD_OXN_ORGN(kg/ha),Levels 0-1 of CMAQ modelled 0.10770*NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_ORGN,WD_OXN_ORGN(kg/ha),Levels 0-1 of CMAQ modelled 0.10770*NTR[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_OTHR,DD_OXN_OTHR(kg/ha),Levels 0-1 of CMAQ modelled 0.25926*N2O5[1] + 0.29787*HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_OTHR,WD_OXN_OTHR(kg/ha),Levels 0-1 of CMAQ modelled 0.25926*N2O5[2] + 0.29787*HONO[2] + 0.177720*PNA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_TOT,DD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_OXN_NOX[0] + DD_OXN_TNO3[0] + DD_OXN_PANT[0] + DD_OXN_ORGN[0] + DD_OXN_OTHR[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_TOT,WD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled WD_OXN_NOX[0] + WD_OXN_TNO3[0] + WD_OXN_PANT[0] + WD_OXN_ORGN[0] + WD_OXN_OTHR[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_OXN_TOT,TD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_OXN_TOT[0] + WD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_OXN_TOTMEQ,DD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*DD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_OXN_TOTMEQ,WD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*WD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_OXN_TOTMEQ,TD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_OXN_TOTMEQ[0] + WD_OXN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_REDN_TOT,DD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.7777*DDEP_NHX[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_REDN_TOT,WD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.7777*WDEP_NHX[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_REDN_TOT,TD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_REDN_TOT[0] + WD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_REDN_TOTMEQ,DD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*DD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_REDN_TOTMEQ,WD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*WD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_REDN_TOTMEQ,TD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_REDN_TOTMEQ[0] + WD_REDN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_N_TOT,TD_N_TOT(kg/ha),Levels 0-1 of CMAQ modelled TD_OXN_TOT[0] + TD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_N_TOTMEQ,TD_N_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled TD_OXN_TOTMEQ[0] + TD_REDN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_S_TOT,DD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.5*SO2[1] + 0.33333*ASO4I[1] + 0.33333*ASO4J[1] + 0.33333*ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_S_TOT,WD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*WDEP_TSO4[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_S_TOT,TD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_S_TOT[0] + WD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_S_TOTMEQ,DD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*DD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_S_TOTMEQ,WD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*WD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_S_TOTMEQ,TD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_S_TOTMEQ[0] + WD_S_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_S_SeaS,DD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*DDEP_SSSO4J[0] + 0.33333*DDEP_SSSO4K[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_S_SeaS,WD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*WDEP_SSSO4JK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_S_SeaS,TD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled DD_S_SeaS[0] + WD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.DD_S_SeaSMEQ,DD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*DD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.WD_S_SeaSMEQ,WD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*WD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.adep.TD_S_SeaSMEQ,TD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_S_SeaSMEQ[0] + WD_S_SeaSMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.ANAK_D,ANAK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[1]+0.0626*ASOIL[1]+0.0023*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.ANAK_W,ANAK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[2]+0.0626*ASOIL[2]+0.0023*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.ACAK_D,ACAK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[1]+0.0838*ASOIL[1]+0.0562*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.ACAK_W,ACAK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[2]+0.0838*ASOIL[2]+0.0562*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.AKK_D,AKK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[1]+0.0242*ASOIL[1]+0.0176*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.AKK_W,AKK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[2]+0.0242*ASOIL[2]+0.0176*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.AMGK_D,AMGK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[1]+0.0032*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.AMGK_W,AMGK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[2]+0.0032*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NO2,DDEP_NO2(kg/ha),Levels 0-1 of CMAQ modelled NO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_NO2,WDEP_NO2(kg/ha),Levels 0-1 of CMAQ modelled NO2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NO,DDEP_NO(kg/ha),Levels 0-1 of CMAQ modelled NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_NO,WDEP_NO(kg/ha),Levels 0-1 of CMAQ modelled NO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_FORM,DDEP_FORM(kg/ha),Levels 0-1 of CMAQ modelled FORM[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_FORM,WDEP_FORM(kg/ha),Levels 0-1 of CMAQ modelled FORM[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_H2O2,DDEP_H2O2(kg/ha),Levels 0-1 of CMAQ modelled H2O2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_H2O2,WDEP_H2O2(kg/ha),Levels 0-1 of CMAQ modelled H2O2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_N2O5,DDEP_N2O5(kg/ha),Levels 0-1 of CMAQ modelled N2O5[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_N2O5,WDEP_N2O5(kg/ha),Levels 0-1 of CMAQ modelled N2O5[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_HONO,DDEP_HONO(kg/ha),Levels 0-1 of CMAQ modelled HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_HONO,WDEP_HONO(kg/ha),Levels 0-1 of CMAQ modelled HONO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_HNO3,DDEP_HNO3(kg/ha),Levels 0-1 of CMAQ modelled HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_HNO3,WDEP_HNO3(kg/ha),Levels 0-1 of CMAQ modelled HNO3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANO3IJ,DDEP_ANO3IJ(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[1] + ANO3J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANO3K,DDEP_ANO3K(kg/ha),Levels 0-1 of CMAQ modelled ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_ANO3IJK,WDEP_ANO3IJK(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[2] + ANO3J[2] + ANO3K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_TNO3,DDEP_TNO3(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[1] + ANO3J[1] + ANO3K[1] + 0.984*HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_TNO3,WDEP_TNO3(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[2] + ANO3J[2] + ANO3K[2] + 0.984*HNO3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NTR,DDEP_NTR(kg/ha),Levels 0-1 of CMAQ modelled NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_NTR,WDEP_NTR(kg/ha),Levels 0-1 of CMAQ modelled NTR[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_PANT,DDEP_PANT(kg/ha),Levels 0-1 of CMAQ modelled PAN[1] + PANX[1] + OPAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_PANT,WDEP_PANT(kg/ha),Levels 0-1 of CMAQ modelled PAN[2] + PANX[2] + OPAN[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3,DDEP_NH3(kg/ha),Levels 0-1 of CMAQ modelled NH3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Nat,DDEP_NH3_Nat(kg/ha),Levels 0-1 of CMAQ modelled NH3_Nat[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Ag,DDEP_NH3_Ag(kg/ha),Levels 0-1 of CMAQ modelled NH3_Ag[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Wat,DDEP_NH3_Wat(kg/ha),Levels 0-1 of CMAQ modelled NH3_Wat[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Emis,DDEP_NH3_Emis(kg/ha),Levels 0-1 of CMAQ modelled NH3_Emis[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Dep,DDEP_NH3_Dep(kg/ha),Levels 0-1 of CMAQ modelled NH3_Dep[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Stom,DDEP_NH3_Stom(kg/ha),Levels 0-1 of CMAQ modelled NH3_Stom[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Cut,DDEP_NH3_Cut(kg/ha),Levels 0-1 of CMAQ modelled NH3_Cut[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NH3_Soil,DDEP_NH3_Soil(kg/ha),Levels 0-1 of CMAQ modelled NH3_Soil[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_NH3,WDEP_NH3(kg/ha),Levels 0-1 of CMAQ modelled NH3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANH4IJ,DDEP_ANH4IJ(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[1] + ANH4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANH4K,DDEP_ANH4K(kg/ha),Levels 0-1 of CMAQ modelled ANH4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_ANH4IJK,WDEP_ANH4IJK(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[2] + ANH4J[2] + ANH4K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_NHX,DDEP_NHX(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[1] + ANH4J[1] + ANH4K[1] + 1.059*NH3_Dep[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_NHX,WDEP_NHX(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[2] + ANH4J[2] + ANH4K[2] + 1.059*NH3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_SO2,DDEP_SO2(kg/ha),Levels 0-1 of CMAQ modelled SO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ASO4IJ,DDEP_ASO4IJ(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[1] + ASO4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ASO4K,DDEP_ASO4K(kg/ha),Levels 0-1 of CMAQ modelled ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_ASO4IJK,WDEP_ASO4IJK(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[2] + ASO4J[2] + ASO4K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_TSO4,WDEP_TSO4(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[2] + ASO4J[2] + ASO4K[2] + 1.5*SO2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_AECIJ,DDEP_AECIJ(kg/ha),Levels 0-1 of CMAQ modelled AECI[1] +AECJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_AOCIJ,DDEP_AOCIJ(kg/ha),Levels 0-1 of CMAQ modelled (AXYL1J[1]+AXYL2J[1]+AXYL3J[1])/2.0+(ATOL1J[1]+ATOL2J[1]+ATOL3J[1])/2.0+(ABNZ1J[,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_SSSO4J,DDEP_SSSO4J(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_SSSO4K,DDEP_SSSO4K(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_SSSO4JK,WDEP_SSSO4JK(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAJ[2] + 0.19579876*ANAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANAJ,DDEP_ANAJ(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANAK,DDEP_ANAK(kg/ha),Levels 0-1 of CMAQ modelled ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ANAJK,DDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[1] + ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_ANAJK,WDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[2] + ANAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TDEP_ANAJK,TDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled DDEP_ANAJK[0] + WDEP_ANAJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ACLJ,DDEP_ACLJ(kg/ha),Levels 0-1 of CMAQ modelled ACLJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ACLK,DDEP_ACLK(kg/ha),Levels 0-1 of CMAQ modelled ACLK[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ACLJK,DDEP_ACLJK(kg/ha),Levels 0-1 of CMAQ modelled ACLJ[1] + ACLK[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_TCL,WDEP_TCL(kg/ha),Levels 0-1 of CMAQ modelled 0.972*HCL[2] + ACLJ[2] + ACLK[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TDEP_CL,TDEP_CL(kg/ha),Levels 0-1 of CMAQ modelled DDEP_ACLJK[0] + WDEP_TCL[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_CAJ,DDEP_CAJ(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_CAJ,WDEP_CAJ(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_CAJK,DDEP_CAJK(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[1]+ACAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_CAJK,WDEP_CAJK(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[2]+ACAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TDEP_CA,TDEP_CA(kg/ha),Levels 0-1 of CMAQ modelled DDEP_CAJK[0]+WDEP_CAJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_FEJ,DDEP_FEJ(kg/ha),Levels 0-1 of CMAQ modelled AFEJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_FEJ,WDEP_FEJ(kg/ha),Levels 0-1 of CMAQ modelled AFEJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_ALJ,DDEP_ALJ(kg/ha),Levels 0-1 of CMAQ modelled AALJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_ALJ,WDEP_ALJ(kg/ha),Levels 0-1 of CMAQ modelled AALJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_SIJ,DDEP_SIJ(kg/ha),Levels 0-1 of CMAQ modelled ASIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_SIJ,WDEP_SIJ(kg/ha),Levels 0-1 of CMAQ modelled ASIJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_TIJ,DDEP_TIJ(kg/ha),Levels 0-1 of CMAQ modelled ATIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_TIJ,WDEP_TIJ(kg/ha),Levels 0-1 of CMAQ modelled ATIJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_MGJ,DDEP_MGJ(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_MGJ,WDEP_MGJ(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_MGJK,DDEP_MGJK(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[1]+AMGK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_MGJK,WDEP_MGJK(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[2]+AMGK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TDEP_MG,TDEP_MG(kg/ha),Levels 0-1 of CMAQ modelled DDEP_MGJK[0]+WDEP_MGJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_KJ,DDEP_KJ(kg/ha),Levels 0-1 of CMAQ modelled AKJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_KJ,WDEP_KJ(kg/ha),Levels 0-1 of CMAQ modelled AKJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_KJK,DDEP_KJK(kg/ha),Levels 0-1 of CMAQ modelled AKJ[1]+AKK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_KJK,WDEP_KJK(kg/ha),Levels 0-1 of CMAQ modelled AKJ[2]+AKK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TDEP_K,TDEP_K(kg/ha),Levels 0-1 of CMAQ modelled DDEP_KJK[0]+WDEP_KJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_MNJ,DDEP_MNJ(kg/ha),Levels 0-1 of CMAQ modelled AMNJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_MNJ,WDEP_MNJ(kg/ha),Levels 0-1 of CMAQ modelled AMNJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DDEP_O3,DDEP_O3(kg/ha),Levels 0-1 of CMAQ modelled O3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_O3,WDEP_O3(kg/ha),Levels 0-1 of CMAQ modelled O3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WDEP_PNA,WDEP_PNA(kg/ha),Levels 0-1 of CMAQ modelled PNA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.RT,RT(cm),Levels 0-1 of CMAQ modelled RN[3] + RC[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_NOX,DD_OXN_NOX(kg/ha),Levels 0-1 of CMAQ modelled 0.30435*NO2[1] + 0.46667*NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_NOX,WD_OXN_NOX(kg/ha),Levels 0-1 of CMAQ modelled 0.30435*NO2[2] + 0.46667*NO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_TNO3,DD_OXN_TNO3(kg/ha),Levels 0-1 of CMAQ modelled 0.22222*HNO3[1] + 0.22581*ANO3I[1] + 0.22581*ANO3J[1] + 0.22581*ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_TNO3,WD_OXN_TNO3(kg/ha),Levels 0-1 of CMAQ modelled 0.22581*WDEP_TNO3[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_PANT,DD_OXN_PANT(kg/ha),Levels 0-1 of CMAQ modelled 0.11570*PAN[1] + 0.11570*PANX[1] + 0.11570*OPAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_PANT,WD_OXN_PANT(kg/ha),Levels 0-1 of CMAQ modelled 0.11570*PAN[2] + 0.11570*PANX[2] + 0.11570*OPAN[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_ORGN,DD_OXN_ORGN(kg/ha),Levels 0-1 of CMAQ modelled 0.10770*NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_ORGN,WD_OXN_ORGN(kg/ha),Levels 0-1 of CMAQ modelled 0.10770*NTR[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_OTHR,DD_OXN_OTHR(kg/ha),Levels 0-1 of CMAQ modelled 0.25926*N2O5[1] + 0.29787*HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_OTHR,WD_OXN_OTHR(kg/ha),Levels 0-1 of CMAQ modelled 0.25926*N2O5[2] + 0.29787*HONO[2] + 0.177720*PNA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_TOT,DD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_OXN_NOX[0] + DD_OXN_TNO3[0] + DD_OXN_PANT[0] + DD_OXN_ORGN[0] + DD_OXN_OTHR[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_TOT,WD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled WD_OXN_NOX[0] + WD_OXN_TNO3[0] + WD_OXN_PANT[0] + WD_OXN_ORGN[0] + WD_OXN_OTHR[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_OXN_TOT,TD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_OXN_TOT[0] + WD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_OXN_TOTMEQ,DD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*DD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_OXN_TOTMEQ,WD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*WD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_OXN_TOTMEQ,TD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_OXN_TOTMEQ[0] + WD_OXN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_REDN_TOT,DD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.7777*DDEP_NHX[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_REDN_TOT,WD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.7777*WDEP_NHX[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_REDN_TOT,TD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_REDN_TOT[0] + WD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_REDN_TOTMEQ,DD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*DD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_REDN_TOTMEQ,WD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*WD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_REDN_TOTMEQ,TD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_REDN_TOTMEQ[0] + WD_REDN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_N_TOT,TD_N_TOT(kg/ha),Levels 0-1 of CMAQ modelled TD_OXN_TOT[0] + TD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_N_TOTMEQ,TD_N_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled TD_OXN_TOTMEQ[0] + TD_REDN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_S_TOT,DD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.5*SO2[1] + 0.33333*ASO4I[1] + 0.33333*ASO4J[1] + 0.33333*ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_S_TOT,WD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*WDEP_TSO4[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_S_TOT,TD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_S_TOT[0] + WD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_S_TOTMEQ,DD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*DD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_S_TOTMEQ,WD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*WD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_S_TOTMEQ,TD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_S_TOTMEQ[0] + WD_S_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_S_SeaS,DD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*DDEP_SSSO4J[0] + 0.33333*DDEP_SSSO4K[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_S_SeaS,WD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*WDEP_SSSO4JK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_S_SeaS,TD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled DD_S_SeaS[0] + WD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.DD_S_SeaSMEQ,DD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*DD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.WD_S_SeaSMEQ,WD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*WD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.mdep.TD_S_SeaSMEQ,TD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_S_SeaSMEQ[0] + WD_S_SeaSMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.ANAK_D,ANAK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[1]+0.0626*ASOIL[1]+0.0023*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.ANAK_W,ANAK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.8373*ASEACAT[2]+0.0626*ASOIL[2]+0.0023*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.ACAK_D,ACAK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[1]+0.0838*ASOIL[1]+0.0562*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.ACAK_W,ACAK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0320*ASEACAT[2]+0.0838*ASOIL[2]+0.0562*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.AKK_D,AKK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[1]+0.0242*ASOIL[1]+0.0176*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.AKK_W,AKK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0310*ASEACAT[2]+0.0242*ASOIL[2]+0.0176*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.AMGK_D,AMGK_D(kg/ha),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[1]+0.0032*ACORS[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.AMGK_W,AMGK_W(kg/ha),Levels 0-1 of CMAQ modelled 0.0997*ASEACAT[2]+0.0032*ACORS[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NO2,DDEP_NO2(kg/ha),Levels 0-1 of CMAQ modelled NO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_NO2,WDEP_NO2(kg/ha),Levels 0-1 of CMAQ modelled NO2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NO,DDEP_NO(kg/ha),Levels 0-1 of CMAQ modelled NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_NO,WDEP_NO(kg/ha),Levels 0-1 of CMAQ modelled NO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_FORM,DDEP_FORM(kg/ha),Levels 0-1 of CMAQ modelled FORM[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_FORM,WDEP_FORM(kg/ha),Levels 0-1 of CMAQ modelled FORM[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_H2O2,DDEP_H2O2(kg/ha),Levels 0-1 of CMAQ modelled H2O2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_H2O2,WDEP_H2O2(kg/ha),Levels 0-1 of CMAQ modelled H2O2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_N2O5,DDEP_N2O5(kg/ha),Levels 0-1 of CMAQ modelled N2O5[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_N2O5,WDEP_N2O5(kg/ha),Levels 0-1 of CMAQ modelled N2O5[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_HONO,DDEP_HONO(kg/ha),Levels 0-1 of CMAQ modelled HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_HONO,WDEP_HONO(kg/ha),Levels 0-1 of CMAQ modelled HONO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_HNO3,DDEP_HNO3(kg/ha),Levels 0-1 of CMAQ modelled HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_HNO3,WDEP_HNO3(kg/ha),Levels 0-1 of CMAQ modelled HNO3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANO3IJ,DDEP_ANO3IJ(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[1] + ANO3J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANO3K,DDEP_ANO3K(kg/ha),Levels 0-1 of CMAQ modelled ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_ANO3IJK,WDEP_ANO3IJK(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[2] + ANO3J[2] + ANO3K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_TNO3,DDEP_TNO3(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[1] + ANO3J[1] + ANO3K[1] + 0.984*HNO3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_TNO3,WDEP_TNO3(kg/ha),Levels 0-1 of CMAQ modelled ANO3I[2] + ANO3J[2] + ANO3K[2] + 0.984*HNO3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NTR,DDEP_NTR(kg/ha),Levels 0-1 of CMAQ modelled NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_NTR,WDEP_NTR(kg/ha),Levels 0-1 of CMAQ modelled NTR[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_PANT,DDEP_PANT(kg/ha),Levels 0-1 of CMAQ modelled PAN[1] + PANX[1] + OPAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_PANT,WDEP_PANT(kg/ha),Levels 0-1 of CMAQ modelled PAN[2] + PANX[2] + OPAN[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3,DDEP_NH3(kg/ha),Levels 0-1 of CMAQ modelled NH3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Nat,DDEP_NH3_Nat(kg/ha),Levels 0-1 of CMAQ modelled NH3_Nat[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Ag,DDEP_NH3_Ag(kg/ha),Levels 0-1 of CMAQ modelled NH3_Ag[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Wat,DDEP_NH3_Wat(kg/ha),Levels 0-1 of CMAQ modelled NH3_Wat[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Emis,DDEP_NH3_Emis(kg/ha),Levels 0-1 of CMAQ modelled NH3_Emis[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Dep,DDEP_NH3_Dep(kg/ha),Levels 0-1 of CMAQ modelled NH3_Dep[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Stom,DDEP_NH3_Stom(kg/ha),Levels 0-1 of CMAQ modelled NH3_Stom[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Cut,DDEP_NH3_Cut(kg/ha),Levels 0-1 of CMAQ modelled NH3_Cut[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NH3_Soil,DDEP_NH3_Soil(kg/ha),Levels 0-1 of CMAQ modelled NH3_Soil[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_NH3,WDEP_NH3(kg/ha),Levels 0-1 of CMAQ modelled NH3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANH4IJ,DDEP_ANH4IJ(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[1] + ANH4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANH4K,DDEP_ANH4K(kg/ha),Levels 0-1 of CMAQ modelled ANH4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_ANH4IJK,WDEP_ANH4IJK(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[2] + ANH4J[2] + ANH4K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_NHX,DDEP_NHX(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[1] + ANH4J[1] + ANH4K[1] + 1.059*NH3_Dep[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_NHX,WDEP_NHX(kg/ha),Levels 0-1 of CMAQ modelled ANH4I[2] + ANH4J[2] + ANH4K[2] + 1.059*NH3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_SO2,DDEP_SO2(kg/ha),Levels 0-1 of CMAQ modelled SO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ASO4IJ,DDEP_ASO4IJ(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[1] + ASO4J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ASO4K,DDEP_ASO4K(kg/ha),Levels 0-1 of CMAQ modelled ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_ASO4IJK,WDEP_ASO4IJK(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[2] + ASO4J[2] + ASO4K[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_TSO4,WDEP_TSO4(kg/ha),Levels 0-1 of CMAQ modelled ASO4I[2] + ASO4J[2] + ASO4K[2] + 1.5*SO2[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_AECIJ,DDEP_AECIJ(kg/ha),Levels 0-1 of CMAQ modelled AECI[1] +AECJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_AOCIJ,DDEP_AOCIJ(kg/ha),Levels 0-1 of CMAQ modelled (AXYL1J[1]+AXYL2J[1]+AXYL3J[1])/2.0+(ATOL1J[1]+ATOL2J[1]+ATOL3J[1])/2.0+(ABNZ1J[,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_SSSO4J,DDEP_SSSO4J(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_SSSO4K,DDEP_SSSO4K(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_SSSO4JK,WDEP_SSSO4JK(kg/ha),Levels 0-1 of CMAQ modelled 0.19579876*ANAJ[2] + 0.19579876*ANAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANAJ,DDEP_ANAJ(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANAK,DDEP_ANAK(kg/ha),Levels 0-1 of CMAQ modelled ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ANAJK,DDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[1] + ANAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_ANAJK,WDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled ANAJ[2] + ANAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TDEP_ANAJK,TDEP_ANAJK(kg/ha),Levels 0-1 of CMAQ modelled DDEP_ANAJK[0] + WDEP_ANAJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ACLJ,DDEP_ACLJ(kg/ha),Levels 0-1 of CMAQ modelled ACLJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ACLK,DDEP_ACLK(kg/ha),Levels 0-1 of CMAQ modelled ACLK[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ACLJK,DDEP_ACLJK(kg/ha),Levels 0-1 of CMAQ modelled ACLJ[1] + ACLK[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_TCL,WDEP_TCL(kg/ha),Levels 0-1 of CMAQ modelled 0.972*HCL[2] + ACLJ[2] + ACLK[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TDEP_CL,TDEP_CL(kg/ha),Levels 0-1 of CMAQ modelled DDEP_ACLJK[0] + WDEP_TCL[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_CAJ,DDEP_CAJ(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_CAJ,WDEP_CAJ(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_CAJK,DDEP_CAJK(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[1]+ACAK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_CAJK,WDEP_CAJK(kg/ha),Levels 0-1 of CMAQ modelled ACAJ[2]+ACAK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TDEP_CA,TDEP_CA(kg/ha),Levels 0-1 of CMAQ modelled DDEP_CAJK[0]+WDEP_CAJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_FEJ,DDEP_FEJ(kg/ha),Levels 0-1 of CMAQ modelled AFEJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_FEJ,WDEP_FEJ(kg/ha),Levels 0-1 of CMAQ modelled AFEJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_ALJ,DDEP_ALJ(kg/ha),Levels 0-1 of CMAQ modelled AALJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_ALJ,WDEP_ALJ(kg/ha),Levels 0-1 of CMAQ modelled AALJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_SIJ,DDEP_SIJ(kg/ha),Levels 0-1 of CMAQ modelled ASIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_SIJ,WDEP_SIJ(kg/ha),Levels 0-1 of CMAQ modelled ASIJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_TIJ,DDEP_TIJ(kg/ha),Levels 0-1 of CMAQ modelled ATIJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_TIJ,WDEP_TIJ(kg/ha),Levels 0-1 of CMAQ modelled ATIJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_MGJ,DDEP_MGJ(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_MGJ,WDEP_MGJ(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_MGJK,DDEP_MGJK(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[1]+AMGK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_MGJK,WDEP_MGJK(kg/ha),Levels 0-1 of CMAQ modelled AMGJ[2]+AMGK_W[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TDEP_MG,TDEP_MG(kg/ha),Levels 0-1 of CMAQ modelled DDEP_MGJK[0]+WDEP_MGJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_KJ,DDEP_KJ(kg/ha),Levels 0-1 of CMAQ modelled AKJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_KJ,WDEP_KJ(kg/ha),Levels 0-1 of CMAQ modelled AKJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_KJK,DDEP_KJK(kg/ha),Levels 0-1 of CMAQ modelled AKJ[1]+AKK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_KJK,WDEP_KJK(kg/ha),Levels 0-1 of CMAQ modelled AKJ[2]+AKK_D[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TDEP_K,TDEP_K(kg/ha),Levels 0-1 of CMAQ modelled DDEP_KJK[0]+WDEP_KJK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_MNJ,DDEP_MNJ(kg/ha),Levels 0-1 of CMAQ modelled AMNJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_MNJ,WDEP_MNJ(kg/ha),Levels 0-1 of CMAQ modelled AMNJ[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DDEP_O3,DDEP_O3(kg/ha),Levels 0-1 of CMAQ modelled O3[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_O3,WDEP_O3(kg/ha),Levels 0-1 of CMAQ modelled O3[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WDEP_PNA,WDEP_PNA(kg/ha),Levels 0-1 of CMAQ modelled PNA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.RT,RT(cm),Levels 0-1 of CMAQ modelled RN[3] + RC[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_NOX,DD_OXN_NOX(kg/ha),Levels 0-1 of CMAQ modelled 0.30435*NO2[1] + 0.46667*NO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_NOX,WD_OXN_NOX(kg/ha),Levels 0-1 of CMAQ modelled 0.30435*NO2[2] + 0.46667*NO[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_TNO3,DD_OXN_TNO3(kg/ha),Levels 0-1 of CMAQ modelled 0.22222*HNO3[1] + 0.22581*ANO3I[1] + 0.22581*ANO3J[1] + 0.22581*ANO3K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_TNO3,WD_OXN_TNO3(kg/ha),Levels 0-1 of CMAQ modelled 0.22581*WDEP_TNO3[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_PANT,DD_OXN_PANT(kg/ha),Levels 0-1 of CMAQ modelled 0.11570*PAN[1] + 0.11570*PANX[1] + 0.11570*OPAN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_PANT,WD_OXN_PANT(kg/ha),Levels 0-1 of CMAQ modelled 0.11570*PAN[2] + 0.11570*PANX[2] + 0.11570*OPAN[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_ORGN,DD_OXN_ORGN(kg/ha),Levels 0-1 of CMAQ modelled 0.10770*NTR[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_ORGN,WD_OXN_ORGN(kg/ha),Levels 0-1 of CMAQ modelled 0.10770*NTR[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_OTHR,DD_OXN_OTHR(kg/ha),Levels 0-1 of CMAQ modelled 0.25926*N2O5[1] + 0.29787*HONO[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_OTHR,WD_OXN_OTHR(kg/ha),Levels 0-1 of CMAQ modelled 0.25926*N2O5[2] + 0.29787*HONO[2] + 0.177720*PNA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_TOT,DD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_OXN_NOX[0] + DD_OXN_TNO3[0] + DD_OXN_PANT[0] + DD_OXN_ORGN[0] + DD_OXN_OTHR[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_TOT,WD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled WD_OXN_NOX[0] + WD_OXN_TNO3[0] + WD_OXN_PANT[0] + WD_OXN_ORGN[0] + WD_OXN_OTHR[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_OXN_TOT,TD_OXN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_OXN_TOT[0] + WD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_OXN_TOTMEQ,DD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*DD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_OXN_TOTMEQ,WD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*WD_OXN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_OXN_TOTMEQ,TD_OXN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_OXN_TOTMEQ[0] + WD_OXN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_REDN_TOT,DD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.7777*DDEP_NHX[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_REDN_TOT,WD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.7777*WDEP_NHX[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_REDN_TOT,TD_REDN_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_REDN_TOT[0] + WD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_REDN_TOTMEQ,DD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*DD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_REDN_TOTMEQ,WD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 7.14*WD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_REDN_TOTMEQ,TD_REDN_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_REDN_TOTMEQ[0] + WD_REDN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_N_TOT,TD_N_TOT(kg/ha),Levels 0-1 of CMAQ modelled TD_OXN_TOT[0] + TD_REDN_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_N_TOTMEQ,TD_N_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled TD_OXN_TOTMEQ[0] + TD_REDN_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_S_TOT,DD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.5*SO2[1] + 0.33333*ASO4I[1] + 0.33333*ASO4J[1] + 0.33333*ASO4K[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_S_TOT,WD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*WDEP_TSO4[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_S_TOT,TD_S_TOT(kg/ha),Levels 0-1 of CMAQ modelled DD_S_TOT[0] + WD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_S_TOTMEQ,DD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*DD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_S_TOTMEQ,WD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*WD_S_TOT[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_S_TOTMEQ,TD_S_TOTMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_S_TOTMEQ[0] + WD_S_TOTMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_S_SeaS,DD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*DDEP_SSSO4J[0] + 0.33333*DDEP_SSSO4K[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_S_SeaS,WD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled 0.33333*WDEP_SSSO4JK[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_S_SeaS,TD_S_SeaS(kg/ha),Levels 0-1 of CMAQ modelled DD_S_SeaS[0] + WD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.DD_S_SeaSMEQ,DD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*DD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.WD_S_SeaSMEQ,WD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled 6.24*WD_S_SeaS[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.wdt.conus.ddep.TD_S_SeaSMEQ,TD_S_SeaSMEQ(meq/m2),Levels 0-1 of CMAQ modelled DD_S_SeaSMEQ[0] + WD_S_SeaSMEQ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2025-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_AL,PMF_AL(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Aluminum,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_CA,PMF_CA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Calcium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_CA,PMC_CA(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Calcium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_CL,PMF_CL(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Chloride,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_EC,PMF_EC(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Elemental Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.AFEJ,AFEJ(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Iron\tPMF_FE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_HPLUS,PMF_HPLUS(umol_m-3),Levels 0-1 of CMAQ modelled Fine Particle Hydronium Ion,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.AIR_DENS,AIR_DENS(kg_m-3),Levels 0-1 of CMAQ modelled Air Density,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_K,PMF_K(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Potassium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_K,PMC_K(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Potassium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.ALD2,ALD2(ppbV),Levels 0-1 of CMAQ modelled Acetaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_MG,PMC_MG(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Magnesium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_MG,PMF_MG(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Magnesium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_MN,PMF_MN(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Manganese,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_NA,PMF_NA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Sodium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_NA,PMC_NA(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Sodium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_NCOM,PMF_NCOM(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Non-Carbon Organic Mass (OM - OC),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_NH4,PMF_NH4(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_NH4,PMC_NH4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_NO3,PMC_NO3(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_NO3,PMF_NO3(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_NO3_PPB,PMF_NO3_PPB(ppbV),Levels 0-1 of CMAQ modelled Fine Particle Nitrate (mixing ratio),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_OC,PMF_OC(ugC_m-3),Levels 0-1 of CMAQ modelled Fine Particle Organic Carbon (C only),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_OM,PMF_OM(ug_m-3),"Levels 0-1 of CMAQ modelled Fine Particle Organic Matter (C,H,O,N, etc)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_OMOC,PMF_OMOC(ug_ug-1),Levels 0-1 of CMAQ modelled Fine Particle OM/OC Ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_CLDGLY,PMF_CLDGLY(ug_m-3),Levels 0-1 of CMAQ modelled Glyoxal and methylglyoxal SOA produced in cloud water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_POC,PMF_POC(ugC_m-3),Levels 0-1 of CMAQ modelled Fine Particle Primary Organic Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_POA,PMF_POA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Primary Organic Matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_SI,PMF_SI(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Silicon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_SO4,PMC_SO4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_SO4,PMF_SO4(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_SOC,PMF_SOC(ugC_m-3),Levels 0-1 of CMAQ modelled Fine Particle Secondary Organic Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_SOIL_IMPV,PMF_SOIL_IMPV(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Lumped Crustal Species calculated with IMPROVE method,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_SOA,PMF_SOA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Secondary Organic Matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_TI,PMF_TI(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Titanium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM_MASS,PM_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Total Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMAIT_MASS,PMAIT_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Aitken Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMC_MASS,PMC_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMACC_MASS,PMACC_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Accumulation Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_MASS,PMF_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.BENZENE,BENZENE(ppbV),Levels 0-1 of CMAQ modelled Benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.CO,CO(ppbV),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.ETH,ETH(ppbV),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.ETHA,ETHA(ppbV),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.FORM,FORM(ppbV),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.H2O2,H2O2(ppbV),Levels 0-1 of CMAQ modelled Hydrogen Peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.HNO3,HNO3(ppbV),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.HNO3_UGM3,HNO3_UGM3(ug_m-3),Levels 0-1 of CMAQ modelled Nitric Acid (concentration),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.HONO,HONO(ppbV),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.HOX,HOX(ppbV),Levels 0-1 of CMAQ modelled Hydroxyl Radical (OH) + Hydroperoxy Radical (HO2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.ISOP,ISOP(ppbV),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.N2O5,N2O5(ppbV),Levels 0-1 of CMAQ modelled Dinitrogen Pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NH3,NH3(ppbV),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NH3_UGM3,NH3_UGM3(ug_m-3),Levels 0-1 of CMAQ modelled Ammonia (concentration),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NHX,NHX(ug_m-3),Levels 0-1 of CMAQ modelled Inorganic Nitrogen (ammonia gas plus particulate ammonium),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NO,NO(ppbV),Levels 0-1 of CMAQ modelled Nitric Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NO2,NO2(ppbV),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NOX,NOX(ppbV),Levels 0-1 of CMAQ modelled Nitrogen Oxides (NO + NO2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NOY,NOY(ppbV),Levels 0-1 of CMAQ modelled Total Reative Nitrogen (NO + NO2 + HNO3 + PAN + other organic nitrates),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.NTR,NTR(ppbV),Levels 0-1 of CMAQ modelled Monofunctional Organic Nitrates (NTR1) + Multifunctional Organic Nitrates (NTR2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.O3,O3(ppbV),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.OH,OH(ppbV),Levels 0-1 of CMAQ modelled Hydroxyl Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PANS,PANS(ppbV),Levels 0-1 of CMAQ modelled Peroxyacylnitrate (PAN) + peroxyacylnitrates with 3 or morecarbons (PANX) + pero,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PBLH,PBLH(m),Levels 0-1 of CMAQ modelled Planetary Boundary Layer Height,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM1,PM1(ug_m-3),Levels 0-1 of CMAQ modelled PM1 (sharp 1 micrometer cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM10,PM10(ug_m-3),Levels 0-1 of CMAQ modelled Particulate Matter up to 10 micrometers in Size,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_CA,PM25_CA(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Calcium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_CL,PM25_CL(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Chloride (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_EC,PM25_EC(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Elemental Carbon (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_FRM,PM25_FRM(ug_m-3),Levels 0-1 of CMAQ modelled FRM Equivalent PM2.5 (computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_HP,PM25_HP(ug_m-3),Levels 0-1 of CMAQ modelled Hydronium Ion (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_K,PM25_K(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Potassium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_MG,PM25_MG(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Magnesium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_NA,PM25_NA(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Sodium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_NH4,PM25_NH4(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Ammonium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_NO3,PM25_NO3(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Nitrate (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_OC,PM25_OC(ugC_m-3),Levels 0-1 of CMAQ modelled PM2.5 Organic Carbon (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_OM,PM25_OM(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Organic Matter (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_SO4,PM25_SO4(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Sulfate (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_SOIL,PM25_SOIL(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Lumped Crustal Species (sharp cutoff computed using modeled size distribut,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25,PM25(ug_m-3),Levels 0-1 of CMAQ modelled Total PM2.5 (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25_UNSPEC1,PM25_UNSPEC1(ug_m-3),Levels 0-1 of CMAQ modelled Other PM2.5 Species (Total - (CL+EC+NA+NH4+NO3+OC+SOIL+SO4))\t,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25to10_CL,PM25to10_CL(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Chlorine (Total CL - PM25_CL),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25to10_NA,PM25to10_NA(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Sodium (Total NA - PM25_NA),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25to10_NH4,PM25to10_NH4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Ammonium (Total NH4 - PM25_NH4),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25to10_NO3,PM25to10_NO3(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Nitrate (Total Particle NO3 - PM25_NO3),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25to10_SO4,PM25to10_SO4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Sulfate (Total Particle SO4 - PM25_SO4),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PM25to10,PM25to10(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Particulate Matter (Total PM - PM25_TOT),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.PMF_FRM,PMF_FRM(ug_m-3),Levels 0-1 of CMAQ modelled FRM Equivalent Particulate Matter (Fine Mode),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.precip,precip(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.RH,RH(%),Levels 0-1 of CMAQ modelled Relative Humidity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.SFC_TMP,SFC_TMP(C),Levels 0-1 of CMAQ modelled Surface Temperature,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.SO2,SO2(ppbV),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.SO2_UGM3,SO2_UGM3(ug_m-3),Levels 0-1 of CMAQ modelled Sulfur Dioxide (concentration),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.SOL_RAD,SOL_RAD(W_m-2),Levels 0-1 of CMAQ modelled Solar Radiation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.TERP,TERP(ppbV),Levels 0-1 of CMAQ modelled Monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.TNO3,TNO3(ug_m-3),Levels 0-1 of CMAQ modelled Total Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.TOL,TOL(ppbV),Levels 0-1 of CMAQ modelled Toluene and Other Monoalkyl Aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.WDIR10,WDIR10(deg),Levels 0-1 of CMAQ modelled 10-m Wind Speed,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.WSPD10,WSPD10(m_s-1),Levels 0-1 of CMAQ modelled 10-m Wind Direction,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.aconc.XYL,XYL(ppbV),Levels 0-1 of CMAQ modelled Xylene and Other Polyalkyl Aromatics except Naphthalene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.AIR_DENS,AIR_DENS(kg_m-3),Levels 0-44 of CMAQ modelled Air Density,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PRES,PRES(Pa),Levels 0-44 of CMAQ modelled PRES[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.TEMP,TEMP(K),Levels 0-44 of CMAQ modelled TA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.QV,QV(kg_kg-1),Levels 0-44 of CMAQ modelled QV[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.ZH,ZH(m),Levels 0-44 of CMAQ modelled ZH[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.ZF,ZF(m),Levels 0-44 of CMAQ modelled ZF[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.CO,CO(ppbV),Levels 0-44 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.FORM,FORM(ppbV),Levels 0-44 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.NH3,NH3(ppbV),Levels 0-44 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.NO2,NO2(ppbV),Levels 0-44 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.O3,O3(ppbV),Levels 0-44 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.O3PV,O3PV(ppbV),Levels 0-44 of CMAQ modelled Ozone PV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.SO2,SO2(ppbV),Levels 0-44 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_SOIL_IMPV,PMF_SOIL_IMPV(ug_m-3),Levels 0-44 of CMAQ modelled Fine Particle Lumped Crustal Species calculated with IMPROVE method,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_EC,PMF_EC(ug_m-3),Levels 0-44 of CMAQ modelled Fine Particle Elemental Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_NO3,PMF_NO3(ug_m-3),Levels 0-44 of CMAQ modelled Fine Particle Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_NH4,PMF_NH4(ug_m-3),Levels 0-44 of CMAQ modelled Fine Particle Ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_SO4,PMF_SO4(ug_m-3),Levels 0-44 of CMAQ modelled Fine Particle Sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_OC,PMF_OC(ugC_m-3),Levels 0-44 of CMAQ modelled Fine Particle Organic Carbon (C only),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_OM,PMF_OM(ug_m-3),"Levels 0-44 of CMAQ modelled Fine Particle Organic Matter (C,H,O,N, etc)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.conc.PMF_MASS,PMF_MASS(ug_m-3),Levels 0-44 of CMAQ modelled Fine Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ACET,ACET(moles/s),Levels 0-44 of CMAQ modelled Model species ACET,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ACROLEIN,ACROLEIN(moles/s),Levels 0-44 of CMAQ modelled Model species ACROLEIN,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ALD2,ALD2(moles/s),Levels 0-44 of CMAQ modelled Model species ALD2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ALD2_PRIMARY,ALD2_PRIMARY(moles/s),Levels 0-44 of CMAQ modelled Model species ALD2_PRIMARY,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ALDX,ALDX(moles/s),Levels 0-44 of CMAQ modelled Model species ALDX,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.BENZ,BENZ(moles/s),Levels 0-44 of CMAQ modelled Model species BENZ,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.BUTADIENE13,BUTADIENE13(moles/s),Levels 0-44 of CMAQ modelled Model species BUTADIENE13,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.CH4,CH4(moles/s),Levels 0-44 of CMAQ modelled Model species CH4,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.CH4_INV,CH4_INV(g/s),Levels 0-44 of CMAQ modelled Model species CH4_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.CL2,CL2(moles/s),Levels 0-44 of CMAQ modelled Model species CL2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.CO,CO(moles/s),Levels 0-44 of CMAQ modelled Model species CO,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.CO2_INV,CO2_INV(g/s),Levels 0-44 of CMAQ modelled Model species CO2_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ETH,ETH(moles/s),Levels 0-44 of CMAQ modelled Model species ETH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ETHA,ETHA(moles/s),Levels 0-44 of CMAQ modelled Model species ETHA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ETHY,ETHY(moles/s),Levels 0-44 of CMAQ modelled Model species ETHY,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ETOH,ETOH(moles/s),Levels 0-44 of CMAQ modelled Model species ETOH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.FORM,FORM(moles/s),Levels 0-44 of CMAQ modelled Model species FORM,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.FORM_PRIMARY,FORM_PRIMARY(moles/s),Levels 0-44 of CMAQ modelled Model species FORM_PRIMARY,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.HCL,HCL(moles/s),Levels 0-44 of CMAQ modelled Model species HCL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.HONO,HONO(moles/s),Levels 0-44 of CMAQ modelled Model species HONO,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.IOLE,IOLE(moles/s),Levels 0-44 of CMAQ modelled Model species IOLE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.ISOP,ISOP(moles/s),Levels 0-44 of CMAQ modelled Model species ISOP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.IVOC,IVOC(moles/s),Levels 0-44 of CMAQ modelled Model species IVOC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.KET,KET(moles/s),Levels 0-44 of CMAQ modelled Model species KET,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.MEOH,MEOH(moles/s),Levels 0-44 of CMAQ modelled Model species MEOH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.N2O_INV,N2O_INV(g/s),Levels 0-44 of CMAQ modelled Model species N2O_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.NAPH,NAPH(moles/s),Levels 0-44 of CMAQ modelled Model species NAPH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.NH3,NH3(moles/s),Levels 0-44 of CMAQ modelled Model species NH3,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.NH3_FERT,NH3_FERT(moles/s),Levels 0-44 of CMAQ modelled Model species NH3_FERT,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.NO,NO(moles/s),Levels 0-44 of CMAQ modelled Model species NO,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.NO2,NO2(moles/s),Levels 0-44 of CMAQ modelled Model species NO2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.NVOL,NVOL(moles/s),Levels 0-44 of CMAQ modelled Model species NVOL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.OLE,OLE(moles/s),Levels 0-44 of CMAQ modelled Model species OLE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PAL,PAL(g/s),Levels 0-44 of CMAQ modelled Model species PAL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PAR,PAR(moles/s),Levels 0-44 of CMAQ modelled Model species PAR,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PCA,PCA(g/s),Levels 0-44 of CMAQ modelled Model species PCA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PCL,PCL(g/s),Levels 0-44 of CMAQ modelled Model species PCL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PEC,PEC(g/s),Levels 0-44 of CMAQ modelled Model species PEC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PFE,PFE(g/s),Levels 0-44 of CMAQ modelled Model species PFE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PH2O,PH2O(g/s),Levels 0-44 of CMAQ modelled Model species PH2O,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PK,PK(g/s),Levels 0-44 of CMAQ modelled Model species PK,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PMC,PMC(g/s),Levels 0-44 of CMAQ modelled Model species PMC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PMG,PMG(g/s),Levels 0-44 of CMAQ modelled Model species PMG,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PMN,PMN(g/s),Levels 0-44 of CMAQ modelled Model species PMN,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PMOTHR,PMOTHR(g/s),Levels 0-44 of CMAQ modelled Model species PMOTHR,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PNA,PNA(g/s),Levels 0-44 of CMAQ modelled Model species PNA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PNCOM,PNCOM(g/s),Levels 0-44 of CMAQ modelled Model species PNCOM,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PNH4,PNH4(g/s),Levels 0-44 of CMAQ modelled Model species PNH4,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PNO3,PNO3(g/s),Levels 0-44 of CMAQ modelled Model species PNO3,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.POC,POC(g/s),Levels 0-44 of CMAQ modelled Model species POC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PRPA,PRPA(moles/s),Levels 0-44 of CMAQ modelled Model species PRPA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PSI,PSI(g/s),Levels 0-44 of CMAQ modelled Model species PSI,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PSO4,PSO4(g/s),Levels 0-44 of CMAQ modelled Model species PSO4,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.PTI,PTI(g/s),Levels 0-44 of CMAQ modelled Model species PTI,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.SO2,SO2(moles/s),Levels 0-44 of CMAQ modelled Model species SO2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.SOAALK,SOAALK(moles/s),Levels 0-44 of CMAQ modelled Model species SOAALK,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.SULF,SULF(moles/s),Levels 0-44 of CMAQ modelled Model species SULF,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.TERP,TERP(moles/s),Levels 0-44 of CMAQ modelled Model species TERP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.TOG_INV,TOG_INV(g/s),Levels 0-44 of CMAQ modelled Model species TOG_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.TOL,TOL(moles/s),Levels 0-44 of CMAQ modelled Model species TOL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.UNK,UNK(moles/s),Levels 0-44 of CMAQ modelled Model species UNK,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.UNR,UNR(moles/s),Levels 0-44 of CMAQ modelled Model species UNR,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.VOC_INV,VOC_INV(g/s),Levels 0-44 of CMAQ modelled Model species VOC_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.emis.XYLMN,XYLMN(moles/s),Levels 0-44 of CMAQ modelled Model species XYLMN,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.JACOBF,JACOBF(m),Levels 0-44 of CMAQ modelled Jacobian at layer face scaled by MSFX2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.JACOBM,JACOBM(m),Levels 0-44 of CMAQ modelled Jacobian at layer middle scaled by MSFX2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.DENSA_J,DENSA_J(kg_m-2),Levels 0-44 of CMAQ modelled J-weighted air density (dry) scaled by MSFX2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.WHAT_JD,WHAT_JD(kg_m-1_s-1),Levels 0-44 of CMAQ modelled J- and density weighted vert contravariant-W,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.TA,TA(K),Levels 0-44 of CMAQ modelled air temperature,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.QV,QV(kg_kg-1),Levels 0-44 of CMAQ modelled water vapor mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.PRES,PRES(Pa),Levels 0-44 of CMAQ modelled pressure,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.DENS,DENS(kg_m-3),Levels 0-44 of CMAQ modelled density of air (dry),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.ZH,ZH(m),Levels 0-44 of CMAQ modelled mid-layer height above ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.ZF,ZF(m),Levels 0-44 of CMAQ modelled full-layer height above ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.PV,PV(m2_K_kg-1_s-1),Levels 0-44 of CMAQ modelled Potential vorticity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.QC,QC(kg_kg-1),Levels 0-44 of CMAQ modelled Cloud water mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.QR,QR(kg_kg-1),Levels 0-44 of CMAQ modelled Rain water mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.QI,QI(kg_kg-1),Levels 0-44 of CMAQ modelled Ice mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.QS,QS(kg_kg-1),Levels 0-44 of CMAQ modelled Snow mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metcro3d.QG,QG(kg_kg-1),Levels 0-44 of CMAQ modelled Graupel mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metdot3d.UWIND,UWIND(m_s-1),Levels 0-44 of CMAQ modelled U-comp. of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metdot3d.VWIND,VWIND(m_s-1),Levels 0-44 of CMAQ modelled V-comp. of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.metdot3d.WIND,WIND(m_s-1),"Levels 0-44 of CMAQ modelled U,V-comp. of true wind at dot point",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.RT,RT(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DD_OXN_NOX,DD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WD_OXN_NOX,WD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DD_OXN_TNO3,DD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WD_OXN_TNO3,WD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DD_OXN_PANT,DD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WD_OXN_PANT,WD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DD_OXN_ORGN,DD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WD_OXN_ORGN,WD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DD_OXN_OTHR,DD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WD_OXN_OTHR,WD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DRYDEP_OXN,DRYDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WETDEP_OXN,WETDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.TOTDEP_OXN,TOTDEP_OXN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Oxidized Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DRYDEP_REDN,DRYDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WETDEP_REDN,WETDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.TOTDEP_REDN,TOTDEP_REDN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Reduced Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DRYDEP_N,DRYDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WETDEP_N,WETDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.TOTDEP_N,TOTDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.DRYDEP_S,DRYDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.WETDEP_S,WETDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.dep.TOTDEP_S,TOTDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.NO2_COLUMN,NO2_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled NO2_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.CO_COLUMN,CO_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled CO_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.SO2_COLUMN,SO2_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled SO2_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.HCHO_COLUMN,HCHO_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled HCHO_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.O3_COLUMN,O3_COLUMN(DU),Levels 0-1 of CMAQ modelled TROPO_O3_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.JNO2,JNO2(min-1),Levels 0-1 of CMAQ modelled JNO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.hemi.integrated.AOD550,AOD550(-),Levels 0-1 of CMAQ modelled AOD_W550_ANGST[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AIR_DENS,AIR_DENS(kg_m-3),Levels 0-1 of CMAQ modelled Air Density,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.RH,RH(%),Levels 0-1 of CMAQ modelled Relative Humidity,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.SFC_TMP,SFC_TMP(C),Levels 0-1 of CMAQ modelled Surface Temperature,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PBLH,PBLH(m),Levels 0-1 of CMAQ modelled Planetary Boundary Layer Height,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.SOL_RAD,SOL_RAD(W_m-2),Levels 0-1 of CMAQ modelled Solar Radiation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.precip,precip(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.WSPD10,WSPD10(m_s-1),Levels 0-1 of CMAQ modelled 10-m Wind Direction,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.WDIR10,WDIR10(deg),Levels 0-1 of CMAQ modelled 10-m Wind Speed,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ALD2,ALD2(ppbV),Levels 0-1 of CMAQ modelled Acetaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.BENZENE,BENZENE(ppbV),Levels 0-1 of CMAQ modelled Benzene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.CO,CO(ppbV),Levels 0-1 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ETH,ETH(ppbV),Levels 0-1 of CMAQ modelled Ethene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ETHA,ETHA(ppbV),Levels 0-1 of CMAQ modelled Ethane,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.FORM,FORM(ppbV),Levels 0-1 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.H2O2,H2O2(ppbV),Levels 0-1 of CMAQ modelled Hydrogen Peroxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.HNO3,HNO3(ppbV),Levels 0-1 of CMAQ modelled Nitric Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.HNO3_UGM3,HNO3_UGM3(ug_m-3),Levels 0-1 of CMAQ modelled Nitric Acid (concentration),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.HONO,HONO(ppbV),Levels 0-1 of CMAQ modelled Nitrous Acid,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.HOX,HOX(ppbV),Levels 0-1 of CMAQ modelled Hydroxyl Radical (OH) + Hydroperoxy Radical (HO2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.OH,OH(ppbV),Levels 0-1 of CMAQ modelled Hydroxyl Radical,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ISOP,ISOP(ppbV),Levels 0-1 of CMAQ modelled Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.N2O5,N2O5(ppbV),Levels 0-1 of CMAQ modelled Dinitrogen Pentoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NH3,NH3(ppbV),Levels 0-1 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NH3_UGM3,NH3_UGM3(ug_m-3),Levels 0-1 of CMAQ modelled Ammonia (concentration),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NHX,NHX(ug_m-3),Levels 0-1 of CMAQ modelled Inorganic Nitrogen (ammonia gas plus particulate ammonium),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NO,NO(ppbV),Levels 0-1 of CMAQ modelled Nitric Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NO2,NO2(ppbV),Levels 0-1 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NOX,NOX(ppbV),Levels 0-1 of CMAQ modelled Nitrogen Oxides (NO + NO2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_NO3_PPB,PMF_NO3_PPB(ppbV),Levels 0-1 of CMAQ modelled Fine Particle Nitrate (mixing ratio),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NTR,NTR(ppbV),Levels 0-1 of CMAQ modelled Monofunctional Organic Nitrates (NTR1) + Multifunctional Organic Nitrates (NTR2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PANS,PANS(ppbV),Levels 0-1 of CMAQ modelled Peroxyacylnitrate (PAN) + peroxyacylnitrates with 3 or morecarbons (PANX) + pero,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.NOY,NOY(ppbV),Levels 0-1 of CMAQ modelled Total Reative Nitrogen (NO + NO2 + HNO3 + PAN + other organic nitrates),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.O3,O3(ppbV),Levels 0-1 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.SO2,SO2(ppbV),Levels 0-1 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.SO2_UGM3,SO2_UGM3(ug_m-3),Levels 0-1 of CMAQ modelled Sulfur Dioxide (concentration),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.TERP,TERP(ppbV),Levels 0-1 of CMAQ modelled Monoterpenes,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.TOL,TOL(ppbV),Levels 0-1 of CMAQ modelled Toluene and Other Monoalkyl Aromatics,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.XYL,XYL(ppbV),Levels 0-1 of CMAQ modelled Xylene and Other Polyalkyl Aromatics except Naphthalene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AFEJ,AFEJ(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Iron\tPMF_FE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_AL,PMF_AL(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Aluminum,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_SI,PMF_SI(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Silicon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_TI,PMF_TI(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Titanium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_CA,PMF_CA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Calcium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_MG,PMF_MG(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Magnesium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_K,PMF_K(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Potassium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_MN,PMF_MN(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Manganese,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_SOIL_IMPV,PMF_SOIL_IMPV(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Lumped Crustal Species calculated with IMPROVE method,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_HPLUS,PMF_HPLUS(umol_m-3),Levels 0-1 of CMAQ modelled Fine Particle Hydronium Ion,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_NA,PMC_NA(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Sodium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_MG,PMC_MG(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Magnesium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_K,PMC_K(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Potassium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_CA,PMC_CA(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Calcium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_CL,PMF_CL(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Chloride,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_EC,PMF_EC(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Elemental Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_NA,PMF_NA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Sodium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_NO3,PMF_NO3(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_NO3,PMC_NO3(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.TNO3,TNO3(ug_m-3),Levels 0-1 of CMAQ modelled Total Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_NH4,PMF_NH4(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_NH4,PMC_NH4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_SO4,PMF_SO4(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_SO4,PMC_SO4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.APOCI,APOCI(ugC_m-3),Levels 0-1 of CMAQ modelled ALVPO1I[1]/1.39 + ASVPO1I[1]/1.32 + ASVPO2I[1]/1.26 +APOCI[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.APOCJ,APOCJ(ugC_m-3),Levels 0-1 of CMAQ modelled ALVPO1J[1]/1.39 + ASVPO1J[1]/1.32 + ASVPO2J[1]/1.26 +ASVPO3J[1]/1.21 + AIVPO1J[,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_POC,PMF_POC(ugC_m-3),Levels 0-1 of CMAQ modelled Fine Particle Primary Organic Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.APOMI,APOMI(ug_m-3),Levels 0-1 of CMAQ modelled ALVPO1I[1] + ASVPO1I[1] + ASVPO2I[1] + APOCI[1] +APNCOMI[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.APOMJ,APOMJ(ug_m-3),Levels 0-1 of CMAQ modelled ALVPO1J[1] + ASVPO1J[1] + ASVPO2J[1] + APOCJ[1] +ASVPO3J[1] + AIVPO1J[1] +,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_POA,PMF_POA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Primary Organic Matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ASOCI,ASOCI(ugC_m-3),Levels 0-1 of CMAQ modelled ALVOO1I[1]/2.27 + ALVOO2I[1]/2.06 +ASVOO1I[1]/1.88 + ASVOO2I[1]/1.73,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ASOCJ,ASOCJ(ugC_m-3),Levels 0-1 of CMAQ modelled AISO1J[1]/2.20 + AISO2J[1]/2.23 + AISO3J[1]/2.80 +AMT1J[1]/1.67 + AMT2J[1]/,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_SOC,PMF_SOC(ugC_m-3),Levels 0-1 of CMAQ modelled Fine Particle Secondary Organic Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ASOMI,ASOMI(ug_m-3),Levels 0-1 of CMAQ modelled ALVOO1I[1] + ALVOO2I[1] + ASVOO1I[1] + ASVOO2I[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.ASOMJ,ASOMJ(ug_m-3),Levels 0-1 of CMAQ modelled +AISO1J[1]+ AISO2J[1] + AISO3J[1] +AMT1J[1] + AMT2J[1] + AMT3,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_SOA,PMF_SOA(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Secondary Organic Matter,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AOCI,AOCI(ugC_m-3),Levels 0-1 of CMAQ modelled APOCI[0] + ASOCI[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AOCJ,AOCJ(ugC_m-3),Levels 0-1 of CMAQ modelled APOCJ[0] + ASOCJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_OC,PMF_OC(ugC_m-3),Levels 0-1 of CMAQ modelled Fine Particle Organic Carbon (C only),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AOMI,AOMI(ug_m-3),Levels 0-1 of CMAQ modelled APOMI[0] + ASOMI[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AOMJ,AOMJ(ug_m-3),Levels 0-1 of CMAQ modelled APOMJ[0] + ASOMJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_OM,PMF_OM(ug_m-3),"Levels 0-1 of CMAQ modelled Fine Particle Organic Matter (C,H,O,N, etc)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AORGAJ,AORGAJ(ug_m-3),Levels 0-1 of CMAQ modelled AAVB1J[1]+AAVB2J[1]+AAVB3J[1]+AAVB4J[1]+AOLGAJ[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AORGBJ,AORGBJ(ug_m-3),Levels 0-1 of CMAQ modelled AISO1J[1] + AISO2J[1] + AISO3J[1] +AMT1J[1] + AMT2J[1] + AMT3J[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_CLDGLY,PMF_CLDGLY(ug_m-3),Levels 0-1 of CMAQ modelled Glyoxal and methylglyoxal SOA produced in cloud water,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_OMOC,PMF_OMOC(ug_ug-1),Levels 0-1 of CMAQ modelled Fine Particle OM/OC Ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMAIT_MASS,PMAIT_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Aitken Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMACC_MASS,PMACC_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Accumulation Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMC_MASS,PMC_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_MASS,PMF_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM_MASS,PM_MASS(ug_m-3),Levels 0-1 of CMAQ modelled Total Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AUNSPEC1IJ,AUNSPEC1IJ(ug_m-3),Levels 0-1 of CMAQ modelled ATOTIJ[0] - (ASOILJ[0] + ANO3IJ[0] + ASO4IJ[0] + ANH4IJ[0] +AOCIJ[0] + AECIJ[0,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMF_NCOM,PMF_NCOM(ug_m-3),Levels 0-1 of CMAQ modelled Fine Particle Non-Carbon Organic Mass (OM - OC),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.AUNSPEC2IJ,AUNSPEC2IJ(ug_m-3),Levels 0-1 of CMAQ modelled AUNSPEC1IJ[0] - ANCOMIJ[0],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMAMS_CL,PMAMS_CL(ug_m-3),Levels 0-1 of CMAQ modelled ACLI[1]*AMSAT[3]+ACLJ[1]*AMSAC[3]+ACLK[1]*AMSCO[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMAMS_NH4,PMAMS_NH4(ug_m-3),Levels 0-1 of CMAQ modelled ANH4I[1]*AMSAT[3]+ANH4J[1]*AMSAC[3]+ANH4K[1]*AMSCO[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMAMS_NO3,PMAMS_NO3(ug_m-3),Levels 0-1 of CMAQ modelled ANO3I[1]*AMSAT[3]+ANO3J[1]*AMSAC[3]+ANO3K[1]*AMSCO[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMAMS_OM,PMAMS_OM(ugC_m-3),Levels 0-1 of CMAQ modelled AOMI[0]*AMSAT[3]+AOMJ[0]*AMSAC[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PMAMS_SO4,PMAMS_SO4(ug_m-3),Levels 0-1 of CMAQ modelled ASO4I[1]*AMSAT[3]+ASO4J[1]*AMSAC[3]+ASO4K[1]*AMSCO[3],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM1,PM1(ug_m-3),Levels 0-1 of CMAQ modelled PM1 (sharp 1 micrometer cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_HP,PM25_HP(ug_m-3),Levels 0-1 of CMAQ modelled Hydronium Ion (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_CL,PM25_CL(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Chloride (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_EC,PM25_EC(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Elemental Carbon (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_NA,PM25_NA(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Sodium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_MG,PM25_MG(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Magnesium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_K,PM25_K(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Potassium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_CA,PM25_CA(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Calcium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_NH4,PM25_NH4(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Ammonium (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_NO3,PM25_NO3(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Nitrate (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_OC,PM25_OC(ugC_m-3),Levels 0-1 of CMAQ modelled PM2.5 Organic Carbon (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_OM,PM25_OM(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Organic Matter (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_SOIL,PM25_SOIL(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Lumped Crustal Species (sharp cutoff computed using modeled size distribut,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_SO4,PM25_SO4(ug_m-3),Levels 0-1 of CMAQ modelled PM2.5 Sulfate (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25,PM25(ug_m-3),Levels 0-1 of CMAQ modelled Total PM2.5 (sharp cutoff computed using modeled size distribution),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25_UNSPEC1,PM25_UNSPEC1(ug_m-3),Levels 0-1 of CMAQ modelled Other PM2.5 Species (Total - (CL+EC+NA+NH4+NO3+OC+SOIL+SO4))\t,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM10,PM10(ug_m-3),Levels 0-1 of CMAQ modelled Particulate Matter up to 10 micrometers in Size,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25to10_CL,PM25to10_CL(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Chlorine (Total CL - PM25_CL),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25to10_NA,PM25to10_NA(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Sodium (Total NA - PM25_NA),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25to10_NH4,PM25to10_NH4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Ammonium (Total NH4 - PM25_NH4),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25to10_NO3,PM25to10_NO3(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Nitrate (Total Particle NO3 - PM25_NO3),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25to10_SO4,PM25to10_SO4(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Sulfate (Total Particle SO4 - PM25_SO4),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.aconc.PM25to10,PM25to10(ug_m-3),Levels 0-1 of CMAQ modelled Coarse Mode Particulate Matter (Total PM - PM25_TOT),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.AIR_DENS,AIR_DENS(kg_m-3),Levels 0-35 of CMAQ modelled Air Density,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PRES,PRES(Pa),Levels 0-35 of CMAQ modelled PRES[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.TEMP,TEMP(K),Levels 0-35 of CMAQ modelled TA[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.QV,QV(kg_kg-1),Levels 0-35 of CMAQ modelled QV[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.ZH,ZH(m),Levels 0-35 of CMAQ modelled ZH[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.ZF,ZF(m),Levels 0-35 of CMAQ modelled ZF[2],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.CO,CO(ppbV),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.FORM,FORM(ppbV),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.NH3,NH3(ppbV),Levels 0-35 of CMAQ modelled Ammonia,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.NO,NO(ppbV),Levels 0-35 of CMAQ modelled Nitric Oxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.NO2,NO2(ppbV),Levels 0-35 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.O3,O3(ppbV),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.SO2,SO2(ppbV),Levels 0-35 of CMAQ modelled Sulfur Dioxide,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.ISOP,ISOP(ppbV),Levels 0-35 of CMAQ modelled Isoprene,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.GLY,GLY(ppbV),Levels 0-35 of CMAQ modelled 1000.0*GLY[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_NO3_PPB,PMF_NO3_PPB(ppbV),Levels 0-35 of CMAQ modelled Fine Particle Nitrate (mixing ratio),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.NTR,NTR(ppbV),Levels 0-35 of CMAQ modelled Monofunctional Organic Nitrates (NTR1) + Multifunctional Organic Nitrates (NTR2),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PANS,PANS(ppbV),Levels 0-35 of CMAQ modelled Peroxyacylnitrate (PAN) + peroxyacylnitrates with 3 or morecarbons (PANX) + pero,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.NOY,NOY(ppbV),Levels 0-35 of CMAQ modelled Total Reative Nitrogen (NO + NO2 + HNO3 + PAN + other organic nitrates),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_SOIL_IMPV,PMF_SOIL_IMPV(ug_m-3),Levels 0-35 of CMAQ modelled Fine Particle Lumped Crustal Species calculated with IMPROVE method,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_EC,PMF_EC(ug_m-3),Levels 0-35 of CMAQ modelled Fine Particle Elemental Carbon,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_NO3,PMF_NO3(ug_m-3),Levels 0-35 of CMAQ modelled Fine Particle Nitrate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_NH4,PMF_NH4(ug_m-3),Levels 0-35 of CMAQ modelled Fine Particle Ammonium,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_SO4,PMF_SO4(ug_m-3),Levels 0-35 of CMAQ modelled Fine Particle Sulfate,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_OC,PMF_OC(ugC_m-3),Levels 0-35 of CMAQ modelled Fine Particle Organic Carbon (C only),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_OM,PMF_OM(ug_m-3),"Levels 0-35 of CMAQ modelled Fine Particle Organic Matter (C,H,O,N, etc)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.conc.PMF_MASS,PMF_MASS(ug_m-3),Levels 0-35 of CMAQ modelled Fine Particle Mass,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ACET,ACET(moles/s),Levels 0-1 of CMAQ modelled Model species ACET,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ACROLEIN,ACROLEIN(moles/s),Levels 0-1 of CMAQ modelled Model species ACROLEIN,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ALD2,ALD2(moles/s),Levels 0-1 of CMAQ modelled Model species ALD2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ALD2_PRIMARY,ALD2_PRIMARY(moles/s),Levels 0-1 of CMAQ modelled Model species ALD2_PRIMARY,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ALDX,ALDX(moles/s),Levels 0-1 of CMAQ modelled Model species ALDX,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.BENZ,BENZ(moles/s),Levels 0-1 of CMAQ modelled Model species BENZ,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.BUTADIENE13,BUTADIENE13(moles/s),Levels 0-1 of CMAQ modelled Model species BUTADIENE13,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.CH4,CH4(moles/s),Levels 0-1 of CMAQ modelled Model species CH4,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.CH4_INV,CH4_INV(g/s),Levels 0-1 of CMAQ modelled Model species CH4_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.CL2,CL2(moles/s),Levels 0-1 of CMAQ modelled Model species CL2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.CO,CO(moles/s),Levels 0-1 of CMAQ modelled Model species CO,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.CO2_INV,CO2_INV(g/s),Levels 0-1 of CMAQ modelled Model species CO2_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ETH,ETH(moles/s),Levels 0-1 of CMAQ modelled Model species ETH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ETHA,ETHA(moles/s),Levels 0-1 of CMAQ modelled Model species ETHA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ETHY,ETHY(moles/s),Levels 0-1 of CMAQ modelled Model species ETHY,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ETOH,ETOH(moles/s),Levels 0-1 of CMAQ modelled Model species ETOH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.FORM,FORM(moles/s),Levels 0-1 of CMAQ modelled Model species FORM,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.FORM_PRIMARY,FORM_PRIMARY(moles/s),Levels 0-1 of CMAQ modelled Model species FORM_PRIMARY,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.HCL,HCL(moles/s),Levels 0-1 of CMAQ modelled Model species HCL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.HONO,HONO(moles/s),Levels 0-1 of CMAQ modelled Model species HONO,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.IOLE,IOLE(moles/s),Levels 0-1 of CMAQ modelled Model species IOLE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.ISOP,ISOP(moles/s),Levels 0-1 of CMAQ modelled Model species ISOP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.IVOC,IVOC(moles/s),Levels 0-1 of CMAQ modelled Model species IVOC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.KET,KET(moles/s),Levels 0-1 of CMAQ modelled Model species KET,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.MEOH,MEOH(moles/s),Levels 0-1 of CMAQ modelled Model species MEOH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.N2O_INV,N2O_INV(g/s),Levels 0-1 of CMAQ modelled Model species N2O_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.NAPH,NAPH(moles/s),Levels 0-1 of CMAQ modelled Model species NAPH,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.NH3,NH3(moles/s),Levels 0-1 of CMAQ modelled Model species NH3,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.NH3_FERT,NH3_FERT(moles/s),Levels 0-1 of CMAQ modelled Model species NH3_FERT,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.NO,NO(moles/s),Levels 0-1 of CMAQ modelled Model species NO,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.NO2,NO2(moles/s),Levels 0-1 of CMAQ modelled Model species NO2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.NVOL,NVOL(moles/s),Levels 0-1 of CMAQ modelled Model species NVOL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.OLE,OLE(moles/s),Levels 0-1 of CMAQ modelled Model species OLE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PAL,PAL(g/s),Levels 0-1 of CMAQ modelled Model species PAL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PAR,PAR(moles/s),Levels 0-1 of CMAQ modelled Model species PAR,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PCA,PCA(g/s),Levels 0-1 of CMAQ modelled Model species PCA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PCL,PCL(g/s),Levels 0-1 of CMAQ modelled Model species PCL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PEC,PEC(g/s),Levels 0-1 of CMAQ modelled Model species PEC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PFE,PFE(g/s),Levels 0-1 of CMAQ modelled Model species PFE,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PH2O,PH2O(g/s),Levels 0-1 of CMAQ modelled Model species PH2O,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PK,PK(g/s),Levels 0-1 of CMAQ modelled Model species PK,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PMC,PMC(g/s),Levels 0-1 of CMAQ modelled Model species PMC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PMG,PMG(g/s),Levels 0-1 of CMAQ modelled Model species PMG,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PMN,PMN(g/s),Levels 0-1 of CMAQ modelled Model species PMN,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PMOTHR,PMOTHR(g/s),Levels 0-1 of CMAQ modelled Model species PMOTHR,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PNA,PNA(g/s),Levels 0-1 of CMAQ modelled Model species PNA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PNCOM,PNCOM(g/s),Levels 0-1 of CMAQ modelled Model species PNCOM,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PNH4,PNH4(g/s),Levels 0-1 of CMAQ modelled Model species PNH4,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PNO3,PNO3(g/s),Levels 0-1 of CMAQ modelled Model species PNO3,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.POC,POC(g/s),Levels 0-1 of CMAQ modelled Model species POC,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PRPA,PRPA(moles/s),Levels 0-1 of CMAQ modelled Model species PRPA,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PSI,PSI(g/s),Levels 0-1 of CMAQ modelled Model species PSI,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PSO4,PSO4(g/s),Levels 0-1 of CMAQ modelled Model species PSO4,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.PTI,PTI(g/s),Levels 0-1 of CMAQ modelled Model species PTI,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.SO2,SO2(moles/s),Levels 0-1 of CMAQ modelled Model species SO2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.SOAALK,SOAALK(moles/s),Levels 0-1 of CMAQ modelled Model species SOAALK,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.SULF,SULF(moles/s),Levels 0-1 of CMAQ modelled Model species SULF,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.TERP,TERP(moles/s),Levels 0-1 of CMAQ modelled Model species TERP,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.TOG_INV,TOG_INV(g/s),Levels 0-1 of CMAQ modelled Model species TOG_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.TOL,TOL(moles/s),Levels 0-1 of CMAQ modelled Model species TOL,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.UNK,UNK(moles/s),Levels 0-1 of CMAQ modelled Model species UNK,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.UNR,UNR(moles/s),Levels 0-1 of CMAQ modelled Model species UNR,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.VOC_INV,VOC_INV(g/s),Levels 0-1 of CMAQ modelled Model species VOC_INV,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.emis.XYLMN,XYLMN(moles/s),Levels 0-1 of CMAQ modelled Model species XYLMN,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_O3MAX8,DAILY_O3MAX8(ppbV),Levels 0-1 of CMAQ modelled Local daily 8-hour maximum ozone.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_O3,DAILY_O3(ppbV),Levels 0-1 of CMAQ modelled Local daily average ozone.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_CO,DAILY_CO(ppbV),Levels 0-1 of CMAQ modelled Local daily average carbon monoxide.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_NO,DAILY_NO(ppbV),Levels 0-1 of CMAQ modelled Local daily average nitrogen oxide.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_NO2,DAILY_NO2(ppbV),Levels 0-1 of CMAQ modelled Local daily average nitrogen dioxide.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_SO2,DAILY_SO2(ppbV),Levels 0-1 of CMAQ modelled Local daily average sulfur dioxide.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_CH2O,DAILY_CH2O(ppbV),Levels 0-1 of CMAQ modelled Local daily average formaldehyde.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM10,DAILY_PM10(ug/m3),Levels 0-1 of CMAQ modelled Local daily average particulate matter up to 10 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM25,DAILY_PM25(ug/m3),Levels 0-1 of CMAQ modelled Local daily average particulate matter up to 10 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM25_SO4,DAILY_PM25_SO4(ug/m3),Levels 0-1 of CMAQ modelled Local daily average sulfate particulate matter up to 2.5 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM25_NO3,DAILY_PM25_NO3(ug/m3),Levels 0-1 of CMAQ modelled Local daily average nitrate particulate matter up to 2.5 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM25_NH4,DAILY_PM25_NH4(ug/m3),Levels 0-1 of CMAQ modelled Local daily average ammonium particulate matter up to 2.5 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM25_OC,DAILY_PM25_OC(ug/m3),Levels 0-1 of CMAQ modelled Local daily average organic carbon particulate matter up to 2.5 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.lstaconc.DAILY_PM25_EC,DAILY_PM25_EC(ug/m3),Levels 0-1 of CMAQ modelled Local daily average elemental carbon particulate matter up to 2.5 micrometers in size.,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.JACOBF,JACOBF(m),Levels 0-35 of CMAQ modelled Jacobian at layer face scaled by MSFX2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.JACOBM,JACOBM(m),Levels 0-35 of CMAQ modelled Jacobian at layer middle scaled by MSFX2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.DENSA_J,DENSA_J(kg_m-2),Levels 0-35 of CMAQ modelled J-weighted air density (dry) scaled by MSFX2,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.WHAT_JD,WHAT_JD(kg_m-1_s-1),Levels 0-35 of CMAQ modelled J- and density weighted vert contravariant-W,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.TA,TA(K),Levels 0-35 of CMAQ modelled air temperature,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.QV,QV(kg_kg-1),Levels 0-35 of CMAQ modelled water vapor mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.PRES,PRES(Pa),Levels 0-35 of CMAQ modelled pressure,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.DENS,DENS(kg_m-3),Levels 0-35 of CMAQ modelled density of air (dry),-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.ZH,ZH(m),Levels 0-35 of CMAQ modelled mid-layer height above ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.ZF,ZF(m),Levels 0-35 of CMAQ modelled full-layer height above ground,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.QC,QC(kg_kg-1),Levels 0-35 of CMAQ modelled Cloud water mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.QR,QR(kg_kg-1),Levels 0-35 of CMAQ modelled Rain water mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.QI,QI(kg_kg-1),Levels 0-35 of CMAQ modelled Ice mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.QS,QS(kg_kg-1),Levels 0-35 of CMAQ modelled Snow mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metcro3d.QG,QG(kg_kg-1),Levels 0-35 of CMAQ modelled Graupel mixing ratio,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metdot3d.UWIND,UWIND(m_s-1),Levels 0-35 of CMAQ modelled U-comp. of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metdot3d.VWIND,VWIND(m_s-1),Levels 0-35 of CMAQ modelled V-comp. of true wind at dot point,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.metdot3d.WIND,WIND(m_s-1),"Levels 0-35 of CMAQ modelled U,V-comp. of true wind at dot point",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.RT,RT(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DD_OXN_NOX,DD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WD_OXN_NOX,WD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DD_OXN_TNO3,DD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WD_OXN_TNO3,WD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DD_OXN_PANT,DD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WD_OXN_PANT,WD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DD_OXN_ORGN,DD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WD_OXN_ORGN,WD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DD_OXN_OTHR,DD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WD_OXN_OTHR,WD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DRYDEP_OXN,DRYDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WETDEP_OXN,WETDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.TOTDEP_OXN,TOTDEP_OXN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Oxidized Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DRYDEP_REDN,DRYDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WETDEP_REDN,WETDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.TOTDEP_REDN,TOTDEP_REDN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Reduced Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DRYDEP_N,DRYDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WETDEP_N,WETDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.TOTDEP_N,TOTDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.DRYDEP_S,DRYDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.WETDEP_S,WETDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.adep.TOTDEP_S,TOTDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.RT,RT(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DD_OXN_NOX,DD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WD_OXN_NOX,WD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DD_OXN_TNO3,DD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WD_OXN_TNO3,WD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DD_OXN_PANT,DD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WD_OXN_PANT,WD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DD_OXN_ORGN,DD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WD_OXN_ORGN,WD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DD_OXN_OTHR,DD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WD_OXN_OTHR,WD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DRYDEP_OXN,DRYDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WETDEP_OXN,WETDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.TOTDEP_OXN,TOTDEP_OXN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Oxidized Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DRYDEP_REDN,DRYDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WETDEP_REDN,WETDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.TOTDEP_REDN,TOTDEP_REDN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Reduced Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DRYDEP_N,DRYDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WETDEP_N,WETDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.TOTDEP_N,TOTDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.DRYDEP_S,DRYDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.WETDEP_S,WETDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.mdep.TOTDEP_S,TOTDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.RT,RT(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DD_OXN_NOX,DD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WD_OXN_NOX,WD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DD_OXN_TNO3,DD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WD_OXN_TNO3,WD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DD_OXN_PANT,DD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WD_OXN_PANT,WD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DD_OXN_ORGN,DD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WD_OXN_ORGN,WD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DD_OXN_OTHR,DD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WD_OXN_OTHR,WD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DRYDEP_OXN,DRYDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WETDEP_OXN,WETDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.TOTDEP_OXN,TOTDEP_OXN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Oxidized Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DRYDEP_REDN,DRYDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WETDEP_REDN,WETDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.TOTDEP_REDN,TOTDEP_REDN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Reduced Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DRYDEP_N,DRYDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WETDEP_N,WETDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.TOTDEP_N,TOTDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.DRYDEP_S,DRYDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.WETDEP_S,WETDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.ddep.TOTDEP_S,TOTDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.RT,RT(cm),Levels 0-1 of CMAQ modelled Precipitation,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DD_OXN_NOX,DD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WD_OXN_NOX,WD_OXN_NOX(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of NOX (NO, NO2)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DD_OXN_TNO3,DD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WD_OXN_TNO3,WD_OXN_TNO3(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Total Nitrate (HNO3, NO3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DD_OXN_PANT,DD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WD_OXN_PANT,WD_OXN_PANT(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Depostion of PANs (PAN, PANX, OPAN)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DD_OXN_ORGN,DD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WD_OXN_ORGN,WD_OXN_ORGN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Organic N (NTR1, NTR2, INTR)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DD_OXN_OTHR,DD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WD_OXN_OTHR,WD_OXN_OTHR(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Other Oxidized N (N2O5, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DRYDEP_OXN,DRYDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WETDEP_OXN,WETDEP_OXN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Oxidized Nitrogen (NOX, TNO3, PANs, Org N, N205, HONO, PNA)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.TOTDEP_OXN,TOTDEP_OXN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Oxidized Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DRYDEP_REDN,DRYDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Dry Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WETDEP_REDN,WETDEP_REDN(kgN_ha-1),"Levels 0-1 of CMAQ modelled Wet Deposition of Reduced Nitorgen (NH4, NH3)",-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.TOTDEP_REDN,TOTDEP_REDN(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Reduced Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DRYDEP_N,DRYDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WETDEP_N,WETDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.TOTDEP_N,TOTDEP_N(kgN_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Nitrogen,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.DRYDEP_S,DRYDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Dry Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.WETDEP_S,WETDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Wet Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.dep.TOTDEP_S,TOTDEP_S(kgS_ha-1),Levels 0-1 of CMAQ modelled Total (Dry + Wet) Deposition of Sulfur,-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.NO2_COLUMN,NO2_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled NO2_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.CO_COLUMN,CO_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled CO_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.SO2_COLUMN,SO2_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled SO2_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.HCHO_COLUMN,HCHO_COLUMN(petamolec_cm-2),Levels 0-1 of CMAQ modelled HCHO_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.O3_COLUMN,O3_COLUMN(DU),Levels 0-1 of CMAQ modelled TROPO_O3_COLUMN[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.JNO2,JNO2(min-1),Levels 0-1 of CMAQ modelled JNO2[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.equates.conus.integrated.AOD550,AOD550(-),Levels 0-1 of CMAQ modelled AOD_W550_ANGST[1],-180 -90 180 90,2002-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,cmaq +cmaq.listos.lis.conc.CO,CO(ppbV),Levels 0-35 of CMAQ modelled Carbon Monoxide,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.conc.FORM,FORM(ppbV),Levels 0-35 of CMAQ modelled Formaldehyde,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.conc.NO2,NO2(ppbV),Levels 0-35 of CMAQ modelled Nitrogen Dioxide,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.conc.O3,O3(ppbV),Levels 0-35 of CMAQ modelled Ozone,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.conc.PAN,PAN(ppbV),Levels 0-35 of CMAQ modelled Instantaneous molar mixing ratio peroxyacyl nitrates,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.conc.W_VEL,W_VEL(m_s-1),Levels 0-35 of CMAQ modelled Derived vertical velocity component,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.JACOBF,JACOBF(m),Levels 0-35 of CMAQ modelled Jacobian at layer face scaled by MSFX2,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.JACOBM,JACOBM(m),Levels 0-35 of CMAQ modelled Jacobian at layer middle scaled by MSFX2,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.DENSA_J,DENSA_J(kg_m-2),Levels 0-35 of CMAQ modelled J-weighted air density (dry) scaled by MSFX2,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.WHAT_JD,WHAT_JD(kg_m-1_s-1),Levels 0-35 of CMAQ modelled J- and density weighted vert contravariant-W,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.TA,TA(K),Levels 0-35 of CMAQ modelled air temperature,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.QV,QV(kg_kg-1),Levels 0-35 of CMAQ modelled water vapor mixing ratio,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.PRES,PRES(Pa),Levels 0-35 of CMAQ modelled pressure,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.DENS,DENS(kg_m-3),Levels 0-35 of CMAQ modelled density of air (dry),-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.ZH,ZH(m),Levels 0-35 of CMAQ modelled mid-layer height above ground,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.ZF,ZF(m),Levels 0-35 of CMAQ modelled full-layer height above ground,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.QC,QC(kg_kg-1),Levels 0-35 of CMAQ modelled Cloud water mixing ratio,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.QR,QR(kg_kg-1),Levels 0-35 of CMAQ modelled Rain water mixing ratio,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.QI,QI(kg_kg-1),Levels 0-35 of CMAQ modelled Ice mixing ratio,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.QS,QS(kg_kg-1),Levels 0-35 of CMAQ modelled Snow mixing ratio,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.QG,QG(kg_kg-1),Levels 0-35 of CMAQ modelled Graupel mixing ratio,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metcro3d.WWIND,WWIND(m_s-1),Levels 0-35 of CMAQ modelled Vertical component of wind velocity,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metdot3d.UWIND,UWIND(m_s-1),Levels 0-36 of CMAQ modelled U-comp. of true wind at dot point,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metdot3d.VWIND,VWIND(m_s-1),Levels 0-36 of CMAQ modelled V-comp. of true wind at dot point,-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq +cmaq.listos.lis.metdot3d.WIND,WIND(m_s-1),"Levels 0-36 of CMAQ modelled U,V-comp. of true wind at dot point",-180 -90 180 90,2018-07-01T00:00:00Z,PT1H,2018-08-31T23:59:59Z,cmaq modis.mod4.AOD_550_Dark_Target_Deep_Blue_Combined,AOD_550_Dark_Target_Deep_Blue_Combined(-),"Combined Dark Target, Deep Blue AOT at 0.55 micron for land and ocean.",-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod4.AOD_550_Dark_Target_Deep_Blue_Combined_Algorithm_Flag,AOD_550_Dark_Target_Deep_Blue_Combined_Algorithm_Flag(-),"Combined Dark Target, Deep Blue AOT at 0.55 micron Algorithm Flag (0=Dark Target, 1=Deep Blue, 2=Mixed)",-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod4.AOD_550_Dark_Target_Deep_Blue_Combined_QA_Flag,AOD_550_Dark_Target_Deep_Blue_Combined_QA_Flag(-),"Combined Dark Target, Deep Blue Aerosol Confidence Flag (0= No Confidence (or fill), 1= Marginal, 2= Good, 3= Very Good)",-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis @@ -439,7 +4335,7 @@ modis.mod4.Topographic_Altitude_Land,Topographic_Altitude_Land(km),Averaged topo modis.mod4.Wind_Speed_Ncep_Ocean,Wind_Speed_Ncep_Ocean(m/s),Wind Speed based on NCEP reanalysis for Ocean,-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod43k.Aerosol_Cloud_Fraction_Land,Aerosol_Cloud_Fraction_Land(-),Cloud fraction from Land aerosol cloud mask from retrieved and overcast pixels not including cirrus mask,-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod43k.Aerosol_Cloud_Fraction_Ocean,Aerosol_Cloud_Fraction_Ocean(-),Cloud fraction from land aerosol cloud mask from retrieved and overcast pixels not including cirrus mask,-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis -modis.mod43k.Aerosol_Type_Land,Aerosol_Type_Land(-),"Aerosol Type: 1 = continental, 2 = moderate absorption fine, 3 = strong bbsorption fine, 4 = weak absorption fine, 5 = dust coarse",-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis +modis.mod43k.Aerosol_Type_Land,Aerosol_Type_Land(-),"Aerosol Type: 1 = continental, 2 = moderate absorption fine, 3 = strong absorption fine, 4 = weak absorption fine, 5 = dust coarse",-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod43k.Angstrom_Exponent_1_Ocean,Angstrom_Exponent_1_Ocean(-),Calculated angstrom exponent for 0.55 vs 0.86 microns for average solution,-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod43k.Angstrom_Exponent_2_Ocean,Angstrom_Exponent_2_Ocean(-),Calculated angstrom exponent for 0.86 vs 2.13 microns for average solution,-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis modis.mod43k.Corrected_Optical_Depth_Land_wav2p1,Corrected_Optical_Depth_Land_wav2p1(-),Retrieved AOT at 2.13 microns,-180 -90 180 90,2001-01-01T00:00:00Z,PT1H,2017-12-31T23:59:59Z,modis @@ -478,9 +4374,9 @@ modis.mod6.Cloud_Phase_Infrared,Cloud_Phase_Infrared(-),Cloud Phase from 8.5 and modis.mod6.Cloud_Phase_Infrared_Day,Cloud_Phase_Infrared_Day(-),"Cloud Phase from 8.5 and 11 um Bands, Day Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Phase_Infrared_Night,Cloud_Phase_Infrared_Night(-),"Cloud Phase from 8.5 and 11 um Bands, Night Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Height,Cloud_Top_Height(m),Geopotential Height at Retrieved Cloud Top Pressure Level (rounded to nearest 50m),-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod6.Cloud_Top_Height_Nadir,Cloud_Top_Height_Nadir(m),Geopotential Height at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles <=32 Degrees (rounded to nearest 50m),-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod6.Cloud_Top_Height_Nadir_Day,Cloud_Top_Height_Nadir_Day(m),"Geopotential Height at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles <=32 Degrees, Day Data Only (rounded to nearest 50m)",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod6.Cloud_Top_Height_Nadir_Night,Cloud_Top_Height_Nadir_Night(m),"Geopotential Height at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles <=32 Degrees, Night Data Only (rounded to nearest 50m)",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod6.Cloud_Top_Height_Nadir,Cloud_Top_Height_Nadir(m),Geopotential Height at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles not more than 32 Degrees (rounded to nearest 50m),-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod6.Cloud_Top_Height_Nadir_Day,Cloud_Top_Height_Nadir_Day(m),"Geopotential Height at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles not more than 32 Degrees, Day Data Only (rounded to nearest 50m)",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod6.Cloud_Top_Height_Nadir_Night,Cloud_Top_Height_Nadir_Night(m),"Geopotential Height at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles not more than 32 Degrees, Night Data Only (rounded to nearest 50m)",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Pressure,Cloud_Top_Pressure(hPa),Cloud Top Pressure Level (rounded to nearest 5 hPa),-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Pressure_Day,Cloud_Top_Pressure_Day(hPa),"Cloud Top Pressure Level, Day Data Only (rounded to nearest 5 hPa)",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Pressure_Infrared,Cloud_Top_Pressure_Infrared(hPa),Cloud Top Pressure from IR Window Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis @@ -492,7 +4388,7 @@ modis.mod6.Cloud_Top_Temperature,Cloud_Top_Temperature(K),Temperature from Ancil modis.mod6.Cloud_Top_Temperature_Day,Cloud_Top_Temperature_Day(K),"Temperature from Ancillary Data at Retrieved Cloud Top Pressure Level, Day Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Temperature_Nadir,Cloud_Top_Temperature_Nadir(K),Temperature from Ancillary Data at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles not more than 32 Degrees,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Temperature_Nadir_Day,Cloud_Top_Temperature_Nadir_Day(K),"Temperature from Ancillary Data at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles not more than 32 Degrees, Day Data Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis -modis.mod6.Cloud_Top_Temperature_Nadir_Night,Cloud_Top_Temperature_Nadir_Night(K),"Temperature from Ancillary Data at Retrieved Cloud Top Pressure Level for Sensor Z enith (View) Angles not more than 32 Degrees, NightData Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod6.Cloud_Top_Temperature_Nadir_Night,Cloud_Top_Temperature_Nadir_Night(K),"Temperature from Ancillary Data at Retrieved Cloud Top Pressure Level for Sensor Zenith (View) Angles not more than 32 Degrees, NightData Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Cloud_Top_Temperature_Night,Cloud_Top_Temperature_Night(K),"Temperature from Ancillary Data at Retrieved Cloud Top Pressure Level, Night Only",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Radiance_Variance,Radiance_Variance(W/m2/sr/micron),Band 31 Radiance Standard Deviation,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Scan_Start_Time,Scan_Start_Time(Seconds_since_1993-01-01),TAI Time at Start of Scan replicated across the swath,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis @@ -511,6 +4407,24 @@ modis.mod6.Solar_Zenith_Night,Solar_Zenith_Night(deg),"Sensor Zenith Angle, Cell modis.mod6.Surface_Pressure,Surface_Pressure(hPa),Surface Pressure from Ancillary Data,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Surface_Temperature,Surface_Temperature(K),Surface Temperature from Ancillary Data,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis modis.mod6.Tropopause_Height,Tropopause_Height(hPa),Tropopause Height from Ancillary Data,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Cloud_Mask,Cloud_Mask(-),"MODIS Cloud Mask, First Byte",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.K_Index,K_Index(K),K Index,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Lifted_Index,Lifted_Index(K),Lifted Index,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Scan_Start_Time,Scan_Start_Time(Seconds_since_1993-01-01),TAI Time at Start of Scan replicated across the swath,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Sensor_Azimuth,Sensor_Azimuth(deg),"Sensor Azimuth Angle, Cell to Sensor",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Sensor_Zenith,Sensor_Zenith(deg),"Sensor Zenith Angle, Cell to Sensor",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Skin_Temperature,Skin_Temperature(K),Skin Temperature,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Solar_Azimuth,Solar_Azimuth(deg),"Solar Azimuth Angle, Cell to Sun",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Solar_Zenith,Solar_Zenith(deg),"Solar Zenith Angle, Cell to Sun",-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Surface_Elevation,Surface_Elevation(m),Surface Elevation,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Surface_Pressure,Surface_Pressure(hPa),Surface Pressure,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Total_Ozone,Total_Ozone(Dobson),Total Ozone Burden,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Total_Totals,Total_Totals(K),Total Totals,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Tropopause_Height,Tropopause_Height(hPa),Tropopause Height,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Water_Vapor,Water_Vapor(cm),Total Column Precipitable Water Vapor - IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Water_Vapor_Direct,Water_Vapor_Direct(cm),Total Column Precipitable Water Vapor - Direct IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Water_Vapor_High,Water_Vapor_High(cm),Precipitable Water Vapor High - IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis +modis.mod7.Water_Vapor_Low,Water_Vapor_Low(cm),Precipitable Water Vapor Low - IR Retrieval,-180 -90 180 90,2001-08-01T00:00:00Z,PT1H,2017-08-31T23:59:59Z,modis nesdis.pm25,pm25(ug/m3),UTC hourly mean surface satellite-derived particulate matter (aerosols) 2.5 microns or smaller in diameter in micrograms per cubic meter.,-121 25 -72 50,2007-01-01T00:00:00Z,PT1H,2013-12-31T23:59:59Z,nesdis nesdis.ch4,ch4(metric_tons),UTC hourly mean surface satellite-derived methane in metric tons.,-121 25 -72 50,2007-01-01T00:00:00Z,PT1H,2007-12-31T23:59:59Z,nesdis nesdis.co2,co2(metric_tons),UTC hourly mean surface satellite-derived carbon dioxide in metric tons.,-121 25 -72 50,2007-01-01T00:00:00Z,PT1H,2007-12-31T23:59:59Z,nesdis @@ -1168,367 +5082,6 @@ pandora.L2_rnvssp1_8.direct_nitrogen_dioxide_air_mass_factor_uncertainty,direct_ pandora.L2_rnvssp1_8.diffuse_correction,,,-180 -90 180 90,,,now,pandora pandora.L2_rnvssp1_8.stratospheric_nitrogen_dioxide,stratospheric_nitrogen_dioxide(molecules/cm2),Climatological nitrogen dioxide stratospheric column amount,-125 20 -60 50,2016-01-01T00:00:00Z,PT1H,now,pandora pandora.L2_rnvssp1_8.stratospheric_nitrogen_dioxide_uncertainty,stratospheric_nitrogen_dioxide_uncertainty(molecules/cm2),Uncertainty of climatological nitrogen dioxide stratospheric column amount,-125 20 -60 50,2016-01-01T00:00:00Z,PT1H,now,pandora -viirsnoaa.jrraod.AngsExp1,AngsExp1(-),Angstrom exponent for M4 vs M7 over ocean.,-180 -90 180 90,2017-08-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.jrraod.AngsExp2,AngsExp2(-),Angstrom exponent for M7 vs M10 over ocean.,-180 -90 180 90,2017-08-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.jrraod.AOD550,AOD550(-),Aerosol optical depth at 550 nm.,-180 -90 180 90,2017-08-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.ivaot.angexp,angexp(-),Angstrom exponent.,-180 -90 180 90,2013-06-15T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.ivaot.aotSlant550,aotSlant550(-),Aerosol optical thickness at 550 nm.,-180 -90 180 90,2013-06-15T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.ivaot.faot550,faot550(-),Aerosol optical thickness slant at 550 nm.,-180 -90 180 90,2013-06-15T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_412nm,AerosolOpticalDepth_at_412nm(-),Aerosol optical thickness at 412 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_445nm,AerosolOpticalDepth_at_445nm(-),Aerosol optical thickness at 445 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_488nm,AerosolOpticalDepth_at_488nm(-),Aerosol optical thickness at 488 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_550nm,AerosolOpticalDepth_at_550nm(-),Aerosol optical thickness at 550 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_555nm,AerosolOpticalDepth_at_555nm(-),Aerosol optical thickness at 555 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_672nm,AerosolOpticalDepth_at_672nm(-),Aerosol optical thickness at 672 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_746nm,AerosolOpticalDepth_at_746nm(-),Aerosol optical thickness at 746 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_865nm,AerosolOpticalDepth_at_865nm(-),Aerosol optical thickness at 865 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_1240nm,AerosolOpticalDepth_at_1240nm(-),Aerosol optical thickness at 1240 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_1610nm,AerosolOpticalDepth_at_1610nm(-),Aerosol optical thickness at 1610 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AerosolOpticalDepth_at_2250nm,AerosolOpticalDepth_at_2250nm(-),Aerosol optical thickness at 2250 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.AngstromExponent,AngstromExponent(-),Angstrom exponent.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vaooo.SmallModeFraction,SmallModeFraction(%),Small mode fraction.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa -viirsnoaa.vocco.Chlorophyll_a,Chlorophyll_a(mg/m3),Chlorophyll-a concentration.,-180 -90 180 90,2010-09-06T00:00:00Z,PT1H,now,viirsnoaa -tropomi.nrti.no2.nitrogendioxide_tropospheric_column,nitrogendioxide_tropospheric_column(molecules/cm2),Tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_tropospheric_column_precision,nitrogendioxide_tropospheric_column_precision(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_tropospheric_column_precision_kernel,nitrogendioxide_tropospheric_column_precision_kernel(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_stratospheric_column,nitrogendioxide_stratospheric_column(molecules/cm2),Stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_stratospheric_column_precision,nitrogendioxide_stratospheric_column_precision(molecules/cm2),Precision of the stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_total_column,nitrogendioxide_total_column(molecules/cm2),Total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_total_column_precision,nitrogendioxide_total_column_precision(molecules/cm2),Precision of the total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.nitrogendioxide_total_column_precision_kernel,nitrogendioxide_total_column_precision_kernel(molecules/cm2),Precision of the total vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.air_mass_factor_troposphere,air_mass_factor_troposphere(-),Tropospheric air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.air_mass_factor_total,air_mass_factor_total(-),Total air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.solar_azimuth_angle,solar_azimuth_angle(deg),"Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.solar_zenith_angle,solar_zenith_angle(deg),Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.viewing_azimuth_angle,viewing_azimuth_angle(deg),"Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.viewing_zenith_angle,viewing_zenith_angle(deg),Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.surface_pressure,surface_pressure(hPa),Air pressure at the surface.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.surface_classification,surface_classification(-),Flag indicating land/water and further surface classifications for the ground pixel. USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html),-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.surface_albedo,surface_albedo(-),Surface albedo in the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.surface_albedo_nitrogendioxide_window,surface_albedo_nitrogendioxide_window(-),Surface albedo in the NO2 fit window.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.cloud_fraction_crb,cloud_fraction_crb(-),Effective cloud fraction from the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.cloud_fraction_crb_nitrogendioxide_window,cloud_fraction_crb_nitrogendioxide_window(-),Cloud fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.cloud_radiance_fraction_nitrogendioxide_window,cloud_radiance_fraction_nitrogendioxide_window(-),Cloud radiance fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.qa_value,,,-180 -90 180 90,,,now,tropomi -tropomi.nrti.no2.eastward_wind,eastward_wind(m/s),Eastward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.northward_wind,northward_wind(m/s),Northward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.o22cld_cloud_height_crb,o22cld_cloud_height_crb(m),Height of cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.fresco_cloud_pressure_crb,fresco_cloud_pressure_crb(hPa),Air presswure at cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.air_mass_factor_cloudy,air_mass_factor_cloudy(-),Air mass factor for the cloud-covered part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.no2.air_mass_factor_clear,air_mass_factor_clear(-),Air mass factor for the cloud-free part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.hcho.formaldehyde_tropospheric_vertical_column,formaldehyde_tropospheric_vertical_column(molecules/cm2),Tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.hcho.formaldehyde_tropospheric_vertical_column_precision,formaldehyde_tropospheric_vertical_column_precision(molecules/cm2),Precision of the tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.hcho.qa_value,qa_value(-),Total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.co.carbonmonoxide_total_column,carbonmonoxide_total_column(molecules/cm2),Precision of total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.co.carbonmonoxide_total_column_precision,carbonmonoxide_total_column_precision(molecules/cm2),Total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.co.water_total_column,water_total_column(molecules/cm2),Precision of total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.co.water_total_column_precision,water_total_column_precision(molecules/cm2),Column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.co.qa_value,qa_value(-),Precision of the column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.ch4.methane_mixing_ratio,methane_mixing_ratio(-),Bias corrected column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.ch4.methane_mixing_ratio_precision,methane_mixing_ratio_precision(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.ch4.methane_mixing_ratio_bias_corrected,methane_mixing_ratio_bias_corrected(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.nrti.ch4.qa_value,qa_value(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_tropospheric_column,nitrogendioxide_tropospheric_column(molecules/cm2),Tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_tropospheric_column_precision,nitrogendioxide_tropospheric_column_precision(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_tropospheric_column_precision_kernel,nitrogendioxide_tropospheric_column_precision_kernel(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_stratospheric_column,nitrogendioxide_stratospheric_column(molecules/cm2),Stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_stratospheric_column_precision,nitrogendioxide_stratospheric_column_precision(molecules/cm2),Precision of the stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_total_column,nitrogendioxide_total_column(molecules/cm2),Total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_total_column_precision,nitrogendioxide_total_column_precision(molecules/cm2),Precision of the total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.nitrogendioxide_total_column_precision_kernel,nitrogendioxide_total_column_precision_kernel(molecules/cm2),Precision of the total vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.air_mass_factor_troposphere,air_mass_factor_troposphere(-),Tropospheric air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.air_mass_factor_total,air_mass_factor_total(-),Total air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.solar_azimuth_angle,solar_azimuth_angle(deg),"Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.solar_zenith_angle,solar_zenith_angle(deg),Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.viewing_azimuth_angle,viewing_azimuth_angle(deg),"Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.viewing_zenith_angle,viewing_zenith_angle(deg),Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.surface_pressure,surface_pressure(hPa),Air pressure at the surface.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.surface_classification,surface_classification(-),Flag indicating land/water and further surface classifications for the ground pixel. USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html),-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.surface_albedo,surface_albedo(-),Surface albedo in the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.surface_albedo_nitrogendioxide_window,surface_albedo_nitrogendioxide_window(-),Surface albedo in the NO2 fit window.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.cloud_fraction_crb,cloud_fraction_crb(-),Effective cloud fraction from the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.cloud_fraction_crb_nitrogendioxide_window,cloud_fraction_crb_nitrogendioxide_window(-),Cloud fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.cloud_radiance_fraction_nitrogendioxide_window,cloud_radiance_fraction_nitrogendioxide_window(-),Cloud radiance fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.qa_value,,,-180 -90 180 90,,,now,tropomi -tropomi.offl.no2.eastward_wind,eastward_wind(m/s),Eastward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.northward_wind,northward_wind(m/s),Northward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.o22cld_cloud_height_crb,o22cld_cloud_height_crb(m),Height of cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.fresco_cloud_pressure_crb,fresco_cloud_pressure_crb(hPa),Air presswure at cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.air_mass_factor_cloudy,air_mass_factor_cloudy(-),Air mass factor for the cloud-covered part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.no2.air_mass_factor_clear,air_mass_factor_clear(-),Air mass factor for the cloud-free part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.hcho.formaldehyde_tropospheric_vertical_column,formaldehyde_tropospheric_vertical_column(molecules/cm2),Tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.hcho.formaldehyde_tropospheric_vertical_column_precision,formaldehyde_tropospheric_vertical_column_precision(molecules/cm2),Precision of the tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.hcho.qa_value,qa_value(-),Total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.co.carbonmonoxide_total_column,carbonmonoxide_total_column(molecules/cm2),Precision of total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.co.carbonmonoxide_total_column_precision,carbonmonoxide_total_column_precision(molecules/cm2),Total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.co.water_total_column,water_total_column(molecules/cm2),Precision of total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.co.water_total_column_precision,water_total_column_precision(molecules/cm2),Column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.co.qa_value,qa_value(-),Precision of the column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.ch4.methane_mixing_ratio,methane_mixing_ratio(-),Bias corrected column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.ch4.methane_mixing_ratio_precision,methane_mixing_ratio_precision(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.ch4.methane_mixing_ratio_bias_corrected,methane_mixing_ratio_bias_corrected(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.offl.ch4.qa_value,qa_value(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_tropospheric_column,nitrogendioxide_tropospheric_column(molecules/cm2),Tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_tropospheric_column_precision,nitrogendioxide_tropospheric_column_precision(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_tropospheric_column_precision_kernel,nitrogendioxide_tropospheric_column_precision_kernel(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_stratospheric_column,nitrogendioxide_stratospheric_column(molecules/cm2),Stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_stratospheric_column_precision,nitrogendioxide_stratospheric_column_precision(molecules/cm2),Precision of the stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_total_column,nitrogendioxide_total_column(molecules/cm2),Total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_total_column_precision,nitrogendioxide_total_column_precision(molecules/cm2),Precision of the total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.nitrogendioxide_total_column_precision_kernel,nitrogendioxide_total_column_precision_kernel(molecules/cm2),Precision of the total vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.air_mass_factor_troposphere,air_mass_factor_troposphere(-),Tropospheric air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.air_mass_factor_total,air_mass_factor_total(-),Total air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.solar_azimuth_angle,solar_azimuth_angle(deg),"Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.solar_zenith_angle,solar_zenith_angle(deg),Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.viewing_azimuth_angle,viewing_azimuth_angle(deg),"Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.viewing_zenith_angle,viewing_zenith_angle(deg),Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.surface_pressure,surface_pressure(hPa),Air pressure at the surface.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.surface_classification,surface_classification(-),Flag indicating land/water and further surface classifications for the ground pixel. USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html),-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.surface_albedo,surface_albedo(-),Surface albedo in the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.surface_albedo_nitrogendioxide_window,surface_albedo_nitrogendioxide_window(-),Surface albedo in the NO2 fit window.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.cloud_fraction_crb,cloud_fraction_crb(-),Effective cloud fraction from the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.cloud_fraction_crb_nitrogendioxide_window,cloud_fraction_crb_nitrogendioxide_window(-),Cloud fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.cloud_radiance_fraction_nitrogendioxide_window,cloud_radiance_fraction_nitrogendioxide_window(-),Cloud radiance fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.qa_value,,,-180 -90 180 90,,,now,tropomi -tropomi.rpro.no2.eastward_wind,eastward_wind(m/s),Eastward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.northward_wind,northward_wind(m/s),Northward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.o22cld_cloud_height_crb,o22cld_cloud_height_crb(m),Height of cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.fresco_cloud_pressure_crb,fresco_cloud_pressure_crb(hPa),Air presswure at cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.air_mass_factor_cloudy,air_mass_factor_cloudy(-),Air mass factor for the cloud-covered part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.no2.air_mass_factor_clear,air_mass_factor_clear(-),Air mass factor for the cloud-free part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.hcho.formaldehyde_tropospheric_vertical_column,formaldehyde_tropospheric_vertical_column(molecules/cm2),Tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.hcho.formaldehyde_tropospheric_vertical_column_precision,formaldehyde_tropospheric_vertical_column_precision(molecules/cm2),Precision of the tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.hcho.qa_value,qa_value(-),Total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.co.carbonmonoxide_total_column,carbonmonoxide_total_column(molecules/cm2),Precision of total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.co.carbonmonoxide_total_column_precision,carbonmonoxide_total_column_precision(molecules/cm2),Total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.co.water_total_column,water_total_column(molecules/cm2),Precision of total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.co.water_total_column_precision,water_total_column_precision(molecules/cm2),Column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.co.qa_value,qa_value(-),Precision of the column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.ch4.methane_mixing_ratio,methane_mixing_ratio(-),Bias corrected column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.ch4.methane_mixing_ratio_precision,methane_mixing_ratio_precision(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.ch4.methane_mixing_ratio_bias_corrected,methane_mixing_ratio_bias_corrected(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tropomi.rpro.ch4.qa_value,qa_value(-),,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi -tempo.l2.no2.solar_zenith_angle,l2.no2.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.solar_azimuth_angle,l2.no2.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.viewing_zenith_angle,l2.no2.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.viewing_azimuth_angle,l2.no2.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.relative_azimuth_angle,l2.no2.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.vertical_column_total,l2.no2.vertical_column_total(molecules/cm2),Nitrogen dioxide vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.vertical_column_total_uncertainty,l2.no2.vertical_column_total_uncertainty(molecules/cm2),Nitrogen dioxide vertical column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.vertical_column_troposphere,l2.no2.vertical_column_troposphere(molecules/cm2),Troposphere nitrogen dioxide vertical column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.vertical_column_troposphere_uncertainty,l2.no2.vertical_column_troposphere_uncertainty(molecules/cm2),Troposphere nitrogen dioxide vertical column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.vertical_column_stratosphere,l2.no2.vertical_column_stratosphere(molecules/cm2),Stratosphere nitrogen dioxide vertical column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.fitted_slant_column,l2.no2.fitted_slant_column(molecules/cm2),Nitrogen dioxide fitted slant column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.fitted_slant_column_uncertainty,l2.no2.fitted_slant_column_uncertainty(molecules/cm2),Nitrogen dioxide fitted slant column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.snow_ice_fraction,l2.no2.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.terrain_height,l2.no2.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.ground_pixel_quality_flag,l2.no2.ground_pixel_quality_flag(-),shallow_ocean land shallow_inland_water shoreline intermittent_water deep_inland_water continental_shelf_ocean deep_ocean land_water_error sun_glint_possibility solar_eclipse_possibility water evergreen_needleleaf_forest evergreen_broadleaf_forest deciduous_needleleaf_forest deciduous_broadleaf_forest mixed_forest closed_shrublands open_shrublands woody_savannas savannas grasslands permanent_wetlands croplands urban_and_built_up cropland_natural_vegetation_mosaic snow_and_ice barren_or_sparsely_vegetated unclassified fill_value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.tropopause_pressure,l2.no2.tropopause_pressure(hPa),Tropopause pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.surface_pressure,l2.no2.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.albedo,l2.no2.albedo(-),Surface albedo.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.amf_total,l2.no2.amf_total(-),Total nitrogen dioxide air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.amf_diagnostic_flag,l2.no2.amf_diagnostic_flag(-),geometric_AMF glint snow_correction no_cloud_pressure adjusted_surface_pressure adjusted_cloud_pressure no_albedo no_cloud_fraction no_gas_profile no_scattering_weights AMF_disabled.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.eff_cloud_fraction,l2.no2.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.amf_cloud_fraction,l2.no2.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.amf_cloud_pressure,l2.no2.amf_cloud_pressure(-),Cloud pressure for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.amf_troposphere,l2.no2.amf_troposphere(-),Nitrogen dioxide tropospheric air mass factor.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.amf_stratosphere,l2.no2.amf_stratosphere(-),Nitrogen dioxide stratospheric air mass factor.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.fit_rms_residual,l2.no2.fit_rms_residual(-),Radiance fit RMS residual.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.no2.fit_convergence_flag,l2.no2.fit_convergence_flag(-),failed maxiter_exceeded suspect good.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.solar_zenith_angle,l2.hcho.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.solar_azimuth_angle,l2.hcho.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.viewing_zenith_angle,l2.hcho.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.viewing_azimuth_angle,l2.hcho.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.relative_azimuth_angle,l2.hcho.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.vertical_column,l2.hcho.vertical_column(molecules/cm2),Formaldehyde vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.vertical_column_uncertainty,l2.hcho.vertical_column_uncertainty(molecules/cm2),Formaldehyde vertical column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.fitted_slant_column,l2.hcho.fitted_slant_column(molecules/cm2),Formaldehyde fitted slant column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.fitted_slant_column_uncertainty,l2.hcho.fitted_slant_column_uncertainty(molecules/cm2),Formaldehyde fitted slant column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.snow_ice_fraction,l2.hcho.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.terrain_height,l2.hcho.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.ground_pixel_quality_flag,l2.hcho.ground_pixel_quality_flag(-),shallow_ocean land shallow_inland_water shoreline intermittent_water deep_inland_water continental_shelf_ocean deep_ocean land_water_error sun_glint_possibility solar_eclipse_possibility water evergreen_needleleaf_forest evergreen_broadleaf_forest deciduous_needleleaf_forest deciduous_broadleaf_forest mixed_forest closed_shrublands open_shrublands woody_savannas savannas grasslands permanent_wetlands croplands urban_and_built_up cropland_natural_vegetation_mosaic snow_and_ice barren_or_sparsely_vegetated unclassified fill_value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.surface_pressure,l2.hcho.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.albedo,l2.hcho.albedo(-),Surface albedo.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.amf,l2.hcho.amf(-),Total formaldehyde air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.amf_diagnostic_flag,l2.hcho.amf_diagnostic_flag(-),Geometric_AMF glint snow_correction no_cloud_pressure adjusted_surface_pressure adjusted_cloud_pressure no_albedo no_cloud_fraction no_gas_profile no_scattering_weights AMF_disabled.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.eff_cloud_fraction,l2.hcho.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.amf_cloud_fraction,l2.hcho.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.amf_cloud_pressure,l2.hcho.amf_cloud_pressure(-),Cloud pressure for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.fit_rms_residual,l2.hcho.fit_rms_residual(-),Radiance fit RMS residual.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.hcho.fit_convergence_flag,l2.hcho.fit_convergence_flag(-),failed maxiter_exceeded suspect good.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.solar_zenith_angle,l2.o3tot.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.solar_azimuth_angle,l2.o3tot.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.viewing_zenith_angle,l2.o3tot.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.viewing_azimuth_angle,l2.o3tot.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.relative_azimuth_angle,l2.o3tot.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.terrain_height,l2.o3tot.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.column_amount_o3,l2.o3tot.column_amount_o3(DU),Best total ozone solution.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.radiative_cloud_frac,l2.o3tot.radiative_cloud_frac(-),Cloud radiance fraction = fc*Ic331/Im331.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.fc,l2.o3tot.fc(-),Effective cloud fraction (mixed LER model).,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.o3_below_cloud,l2.o3tot.o3_below_cloud(-),"Ozone below fractional cloud"".",-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.uv_aerosol_index,l2.o3tot.uv_aerosol_index(-),UV aerosol index.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.cloud_pressure,l2.o3tot.cloud_pressure(hPa),Effective cloud pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.terrain_pressure,l2.o3tot.terrain_pressure(hPa),Terrain pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.surface_reflectivity_at_331nm,l2.o3tot.surface_reflectivity_at_331nm(-),Effective surface reflectivity at 331 nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.surface_reflectivity_at_360nm,l2.o3tot.surface_reflectivity_at_360nm(-),Effective surface reflectivity at 360 nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.step1_o3,l2.o3tot.step1_o3(DU),Step 1 ozone solution.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.step2_o3,l2.o3tot.step2_o3(DU),Step 2 ozone solution.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.quality_flag,l2.o3tot.quality_flag(-),Quality_flags.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.so2_index,l2.o3tot.so2_index(-),SO2 index.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.ground_pixel_quality_flag,l2.o3tot.ground_pixel_quality_flag(-),Ground pixel quality flag.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.lut_wavelength,l2.o3tot.lut_wavelength(nm),Lookup table wavelength.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.algorithm_flags,l2.o3tot.algorithm_flags(-),Algorithm_flags.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.radiance_bpix_flag_accepted,l2.o3tot.radiance_bpix_flag_accepted(-),Radiance bad pixel flag accepted.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.o3tot.cal_adjustment,l2.o3tot.cal_adjustment(-),Calibration adjustment.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.solar_zenith_angle,l2.cldo4.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.solar_azimuth_angle,l2.cldo4.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.viewing_zenith_angle,l2.cldo4.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.viewing_azimuth_angle,l2.cldo4.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.relative_azimuth_angle,l2.cldo4.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.CloudRadianceFraction440,l2.cldo4.CloudRadianceFraction440(-),Cloud radiance fraction at 440nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.CloudRadianceFraction466,l2.cldo4.CloudRadianceFraction466(-),Cloud radiance fraction at 466nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.cloud_fraction,l2.cldo4.cloud_fraction(-),Effective cloud fraction at 466nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.cloud_pressure,l2.cldo4.cloud_pressure(hPa),Optical centroid pressure for cloud.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.processing_quality_flag,l2.cldo4.processing_quality_flag(-),0_error_geoloc_or_angles 1_warn_466nm_crf_invalid 2_warn_ocp_repaced for_small_ecf 3_error_input_psurf_albedo 4_warn_ocp_replaced_for_snowice 5_warn_ocp_scd_iteration_exceeds_max 6_error_scd_negative_or_bad 7_info_440nm_rad_or_irr_error 8_error_466nm_rad_or_irr_error 9_warn_ecf_beyond_normal_range 10_info_pscene_SurfaceLER_TerrainP_invalid 11_info_pscene_SceneLER_SceneP_invalid 12_error_ecf_calc_skipped 13_error_ocp_calc_skipped 14_warning_ocp_beyond_normal_range 15_info_pscene_calc_skipped 16-29_unused_set_to_zero (4-byte only) 30-31_reserved_set_to_zero (4-byte only).,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.fit_convergence_flag,l2.cldo4.fit_convergence_flag(-),failed maxiter_exceeded suspect good.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.fit_rms_residual,l2.cldo4.fit_rms_residual(-),Radiance fit RMS residual.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.GLER440,l2.cldo4.GLER440(-),440nm surface reflectivity used in calculation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.GLER466,l2.cldo4.GLER466(-),466nm surface reflectivity used in calculation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.SCD_MainDataQualityFlags,l2.cldo4.SCD_MainDataQualityFlags(-),"Main data quality flags for fitted_slant_column: 0=normal, 1=suspicious, 2=bad.",-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.SceneLER440,l2.cldo4.SceneLER440(hPa),LER at 440nm calculated at ScenePressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.SceneLER466,l2.cldo4.SceneLER466(hPa),LER at 466nm calculated at ScenePressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.ScenePressure,l2.cldo4.ScenePressure(hPa),Scene pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.surface_pressure,l2.cldo4.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.ground_pixel_quality_flag,l2.cldo4.ground_pixel_quality_flag(-),shallow_ocean land shallow_inland_water shoreline intermittent_water deep_inland_water continental_shelf_ocean deep_ocean land_water_error sun_glint_possibility solar_eclipse_possibility water evergreen_needleleaf_forest evergreen_broadleaf_forest deciduous_needleleaf_forest deciduous_broadleaf_forest mixed_forest closed_shrublands open_shrublands woody_savannas savannas grasslands permanent_wetlands croplands urban_and_built_up cropland_natural_vegetation_mosaic snow_and_ice barren_or_sparsely_vegetated unclassified fill_value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.snow_ice_fraction,l2.cldo4.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.terrain_height,l2.cldo4.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.fitted_slant_column,l2.cldo4.fitted_slant_column(molecules2/cm5),Collision induced oxygen complex fitted slant column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l2.cldo4.fitted_slant_column_uncertainty,l2.cldo4.fitted_slant_column_uncertainty(molecules2/cm5),Collision induced oxygen complex fitted slant column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.surface_pressure,l3.no2.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.terrain_height,l3.no2.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.snow_ice_fraction,l3.no2.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.fitted_slant_column,l3.no2.fitted_slant_column(molecules2/cm5),Collision induced oxygen complex fitted slant column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.fitted_slant_column_uncertainty,l3.no2.fitted_slant_column_uncertainty(molecules2/cm5),Collision induced oxygen complex fitted slant column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.albedo,l3.no2.albedo(-),Surface albedo.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.tropopause_pressure,l3.no2.tropopause_pressure(hPa),Tropopause pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.amf_total,l3.no2.amf_total(-),Total nitrogen dioxide air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.eff_cloud_fraction,l3.no2.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.amf_cloud_fraction,l3.no2.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.amf_troposphere,l3.no2.amf_troposphere(-),Nitrogen dioxide tropospheric air mass factor.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.amf_cloud_pressure,l3.no2.amf_cloud_pressure(hPa),Cloud pressure for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.amf_troposphere,l3.no2.amf_troposphere(-),Nitrogen dioxide tropospheric air mass factor.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.no2.amf_stratosphere,l3.no2.amf_stratosphere(-),Nitrogen dioxide stratospheric air mass factor.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.solar_zenith_angle,l3.hcho.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.viewing_zenith_angle,l3.hcho.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.relative_azimuth_angle,l3.hcho.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.vertical_column,l3.hcho.vertical_column(molecules/cm2),Formaldehyde vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.vertical_column_uncertainty,l3.hcho.vertical_column_uncertainty(molecules/cm2),Formaldehyde vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.main_data_quality_flag,l3.hcho.main_data_quality_flag(-),normal suspicious bad.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.surface_pressure,l3.hcho.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.terrain_height,l3.hcho.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.snow_ice_fraction,l3.hcho.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.fitted_slant_column,l3.hcho.fitted_slant_column(molecules/cm2),Formaldehyde fitted slant column.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.fitted_slant_column_uncertainty,l3.hcho.fitted_slant_column_uncertainty(molecules/cm2),Formaldehyde fitted slant column uncertainty.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.albedo,l3.hcho.albedo(-),Surface albedo.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.amf,l3.hcho.amf(-),Total formaldehyde air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.eff_cloud_fraction,l3.hcho.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.amf_cloud_fraction,l3.hcho.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.amf_cloud_pressure,l3.hcho.amf_cloud_pressure(hPa),Cloud pressure for AMF computation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.weights,l3.hcho.weights(km2),Sum of Level 2 pixel overlap areas.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.num_vertical_column_total_samples,l3.hcho.num_vertical_column_total_samples(-),Number of Level 2 pixel values contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.min_vertical_column_total_sample,l3.hcho.min_vertical_column_total_sample(molecules/cm2),Smallest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.hcho.max_vertical_column_total_sample,l3.hcho.max_vertical_column_total_sample(molecules/cm2),Largest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.solar_zenith_angle,l3.o3tot.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.viewing_zenith_angle,l3.o3tot.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.relative_azimuth_angle,l3.o3tot.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.terrain_height,l3.o3tot.terrain_height(m),Terrain height.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.column_amount_o3,l3.o3tot.column_amount_o3(DU),Best total ozone solution.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.radiative_cloud_frac,l3.o3tot.radiative_cloud_frac(-),Cloud radiance fraction = fc*Ic331/Im331.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.fc,l3.o3tot.fc(-),Effective cloud fraction (mixed LER model).,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.o3_below_cloud,l3.o3tot.o3_below_cloud(DU),Ozone below fractional cloud.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.so2l_index,l3.o3tot.so2l_index(-),SO2 index.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.uv_aerosol_index,l3.o3tot.uv_aerosol_index(-),UV aerosol index.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.so2_index,l3.o3tot.so2_index(-),SO2 index.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.uv_aerosol_index,l3.o3tot.uv_aerosol_index(-),UV aerosol index.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.num_column_samples,l3.o3tot.num_column_samples(-),Number of Level 2 pixel values contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.min_column_samples,l3.o3tot.min_column_samples(DU),Smallest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.max_column_samples,l3.o3tot.max_column_samples(DU),Largest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.cloud_pressures,l3.o3tot.cloud_pressures(hPa),Effective cloud pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.terrain_pressures,l3.o3tot.terrain_pressures(hPa),Terrain pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.o3tot.weight,l3.o3tot.weight(km2),Sum of Level 2 pixel overlap areas.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.solar_zenith_angle,l3.cldo4.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.viewing_zenith_angle,l3.cldo4.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.relative_azimuth_angle,l3.cldo4.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.cloud_pressure,l3.cldo4.cloud_pressure(hPa),Optical centroid pressure for cloud.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.cloud_fraction,l3.cldo4.cloud_fraction(-),Effective cloud fraction at 466nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.CloudRadianceFraction440,l3.cldo4.CloudRadianceFraction440(-),Cloud radiance fraction at 440nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.CloudRadianceFraction466,l3.cldo4.CloudRadianceFraction466(-),Cloud radiance fraction at 466nm.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.surface_pressure,l3.cldo4.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.weight,l3.cldo4.weight(km2),Sum of Level 2 pixel overlap areas.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.GLER440,l3.cldo4.GLER440(-),440nm surface reflectivity used in calculation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.l3.cldo4.GLER466,l3.cldo4.GLER466(-),466nm surface reflectivity used in calculation.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.solar_zenith_angle,proxy_l2.hcho.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.solar_azimuth_angle,proxy_l2.hcho.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.viewing_zenith_angle,proxy_l2.hcho.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.viewing_azimuth_angle,proxy_l2.hcho.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.relative_azimuth_angle,proxy_l2.hcho.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.vertical_column,proxy_l2.hcho.vertical_column(molecules/cm2),Vertical column amount of HCHO.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.vertical_column_uncertainty,proxy_l2.hcho.vertical_column_uncertainty(molecules/cm2),Formaldehyde vertical column uncertainty,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.fit_convergence_flag,proxy_l2.hcho.fit_convergence_flag(-),Radiance fit convergence flag,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.fit_rms_residual,proxy_l2.hcho.fit_rms_residual(-),Radiance fit RMS residual,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.albedo,proxy_l2.hcho.albedo(-),Surface albedo from model truth,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.amf_cloud_fraction,proxy_l2.hcho.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.amf_cloud_pressure,proxy_l2.hcho.amf_cloud_pressure(hPa),Cloud pressure for AMF computation,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.amf_diagnostic_flag,proxy_l2.hcho.amf_diagnostic_flag(-),Formaldehyde air mass factor diagnostic flag,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.amf,proxy_l2.hcho.amf(-),Formaldehyde air mass factor,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.amf_uncertainty,proxy_l2.hcho.amf_uncertainty(-),Formaldehyde air mass factor uncertainty,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.fitted_slant_column,proxy_l2.hcho.fitted_slant_column(molecules/cm2),Formaldehyde fitted slant column,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.fitted_slant_column_uncertainty,proxy_l2.hcho.fitted_slant_column_uncertainty(molecules/cm2),Formaldehyde fitted slant column uncertainty,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.ground_pixel_quality_flag,proxy_l2.hcho.ground_pixel_quality_flag(-),Surface type code,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.reference_sector_correction,proxy_l2.hcho.reference_sector_correction(molecules/cm2),Reference sector correction,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.surface_pressure,proxy_l2.hcho.surface_pressure(hPa),Surface pressure,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.terrain_height,proxy_l2.hcho.terrain_height(m),Terrain height,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.hcho.snow_ice_fraction,proxy_l2.hcho.snow_ice_fraction(-),Snow/ice fraction,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.solar_zenith_angle,proxy_l2.no2.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.solar_azimuth_angle,proxy_l2.no2.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.viewing_zenith_angle,proxy_l2.no2.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.viewing_azimuth_angle,proxy_l2.no2.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.relative_azimuth_angle,proxy_l2.no2.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.vertical_column_stratosphere,proxy_l2.no2.vertical_column_stratosphere(molecules/cm2),Vertical column amount of NO2 in the stratosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.vertical_column_troposphere,proxy_l2.no2.vertical_column_troposphere(molecules/cm2),Vertical column amount of NO2 in the tropoosphere.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.vertical_column_total,proxy_l2.no2.vertical_column_total(molecules/cm2),Nitrogen dioxide fitted slant column,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.vertical_column_total_uncertainty,proxy_l2.no2.vertical_column_total_uncertainty(molecules/cm2),Nitrogen dioxide fitted slant column uncertainty,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.fit_convergence_flag,proxy_l2.no2.fit_convergence_flag(-),Radiance fit convergence flag,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.fit_rms_residual,proxy_l2.no2.fit_rms_residual(-),Radiance fit RMS residual,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.albedo,proxy_l2.no2.albedo(-),Surface albedo from model truth,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_cloud_fraction,proxy_l2.no2.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_cloud_pressure,proxy_l2.no2.amf_cloud_pressure(-),Cloud pressure for AMF computation,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_diagnostic_flag,proxy_l2.no2.amf_diagnostic_flag(-),AMF diagnostic flag,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_stratosphere,proxy_l2.no2.amf_stratosphere(-),Air mass factor (AMF) in the stratosphere,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_troposphere,proxy_l2.no2.amf_troposphere(-),Air mass factor (AMF) in the troposphere,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_total,proxy_l2.no2.amf_total(-),Air mass factor (AMF) total,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.amf_total_uncertainty,proxy_l2.no2.amf_total_uncertainty(-),Air mass factor (AMF) uncertainty,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.fitted_slant_column,proxy_l2.no2.fitted_slant_column(-),Surface type code,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.fitted_slant_column_uncertainty,proxy_l2.no2.fitted_slant_column_uncertainty(hPa),Surface pressure,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.ground_pixel_quality_flag,proxy_l2.no2.ground_pixel_quality_flag(m),Terrain height,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.surface_pressure,proxy_l2.no2.surface_pressure(hPa),Tropopause pressure,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.terrain_height,proxy_l2.no2.terrain_height(molecules/cm2),Nitrogen dioxide vertical column,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.tropopause_pressure,proxy_l2.no2.tropopause_pressure(molecules/cm2),Nitrogen dioxide vertical column uncertainty,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.no2.snow_ice_fraction,proxy_l2.no2.snow_ice_fraction(-),Snow/ice fraction,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.solar_zenith_angle,proxy_l2.o3p.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.solar_azimuth_angle,proxy_l2.o3p.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.viewing_zenith_angle,proxy_l2.o3p.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.viewing_azimuth_angle,proxy_l2.o3p.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.relative_azimuth_angle,proxy_l2.o3p.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.total_ozone_column,proxy_l2.o3p.total_ozone_column(DU),Total column ozone,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.stratosphere_ozone_column,proxy_l2.o3p.stratosphere_ozone_column(DU),Stratospheric column ozone,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.troposphere_ozone_column,proxy_l2.o3p.troposphere_ozone_column(DU),Tropospheric column ozone,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.eff_cloud_fraction,proxy_l2.o3p.eff_cloud_fraction(-),Effective cloud fraction,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.eff_cloud_pressure,proxy_l2.o3p.eff_cloud_pressure(hPa),Effective cloud pressure,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.tropopause_index,proxy_l2.o3p.tropopause_index(-),Topopause index,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.albedo,proxy_l2.o3p.albedo(-),Surface albedo,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.ozone_information_content,proxy_l2.o3p.ozone_information_content(-),Ozone information content,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo -tempo.proxy_l2.o3p.ground_pixel_quality_flag,proxy_l2.o3p.ground_pixel_quality_flag(-),Surface type code,-180 -90 180 90,2023-10-17T00:00:00Z,PT1Y,now,tempo hrrr.wind,wind(m/s),U/V-components of wind 10 meters above the surface.,-180 -90 180 90,2016-07-15T00:00:00Z,PT1H,now,hrrr hrrr.wind_10m,wind_10m(m/s),U/V-components of wind 10 meters above the surface.,-180 -90 180 90,2016-07-15T00:00:00Z,PT1H,now,hrrr hrrr.wind_80m,wind_80m(m/s),U/V-components of wind 80 meters above the surface.,-180 -90 180 90,2016-07-15T00:00:00Z,PT1H,now,hrrr @@ -1625,6 +5178,293 @@ hrrr.temperature_goes12_channel4,temperature_goes12_channel4(K),Simulated bright hrrr.temperature_goes11_channel3,temperature_goes11_channel3(K),Simulated brightness temperature for GOES-11 channel 3.,-180 -90 180 90,2016-07-15T00:00:00Z,PT1H,now,hrrr hrrr.temperature_goes11_channel4,temperature_goes11_channel4(K),Simulated brightness temperature for GOES-11 channel 4.,-180 -90 180 90,2016-07-15T00:00:00Z,PT1H,now,hrrr hrrr.visibility,visibility(m),Visibility at the surface.,-180 -90 180 90,2016-07-15T00:00:00Z,PT1H,now,hrrr +viirsnoaa.jrraod.AngsExp1,AngsExp1(-),Angstrom exponent for M4 vs M7 over ocean.,-180 -90 180 90,2017-08-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.jrraod.AngsExp2,AngsExp2(-),Angstrom exponent for M7 vs M10 over ocean.,-180 -90 180 90,2017-08-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.jrraod.AOD550,AOD550(-),Aerosol optical depth at 550 nm.,-180 -90 180 90,2017-08-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.ivaot.angexp,angexp(-),Angstrom exponent.,-180 -90 180 90,2013-06-15T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.ivaot.aotSlant550,aotSlant550(-),Aerosol optical thickness at 550 nm.,-180 -90 180 90,2013-06-15T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.ivaot.faot550,faot550(-),Aerosol optical thickness slant at 550 nm.,-180 -90 180 90,2013-06-15T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_412nm,AerosolOpticalDepth_at_412nm(-),Aerosol optical thickness at 412 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_445nm,AerosolOpticalDepth_at_445nm(-),Aerosol optical thickness at 445 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_488nm,AerosolOpticalDepth_at_488nm(-),Aerosol optical thickness at 488 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_550nm,AerosolOpticalDepth_at_550nm(-),Aerosol optical thickness at 550 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_555nm,AerosolOpticalDepth_at_555nm(-),Aerosol optical thickness at 555 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_672nm,AerosolOpticalDepth_at_672nm(-),Aerosol optical thickness at 672 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_746nm,AerosolOpticalDepth_at_746nm(-),Aerosol optical thickness at 746 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_865nm,AerosolOpticalDepth_at_865nm(-),Aerosol optical thickness at 865 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_1240nm,AerosolOpticalDepth_at_1240nm(-),Aerosol optical thickness at 1240 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_1610nm,AerosolOpticalDepth_at_1610nm(-),Aerosol optical thickness at 1610 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AerosolOpticalDepth_at_2250nm,AerosolOpticalDepth_at_2250nm(-),Aerosol optical thickness at 2250 nm.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.AngstromExponent,AngstromExponent(-),Angstrom exponent.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vaooo.SmallModeFraction,SmallModeFraction(%),Small mode fraction.,-180 -90 180 90,2013-06-01T00:00:00Z,PT1H,now,viirsnoaa +viirsnoaa.vocco.Chlorophyll_a,Chlorophyll_a(mg/m3),Chlorophyll-a concentration.,-180 -90 180 90,2010-09-06T00:00:00Z,PT1H,now,viirsnoaa +tropomi.nrti.no2.nitrogendioxide_tropospheric_column,nitrogendioxide_tropospheric_column(molecules/cm2),Tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_tropospheric_column_precision,nitrogendioxide_tropospheric_column_precision(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_tropospheric_column_precision_kernel,nitrogendioxide_tropospheric_column_precision_kernel(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_stratospheric_column,nitrogendioxide_stratospheric_column(molecules/cm2),Stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_stratospheric_column_precision,nitrogendioxide_stratospheric_column_precision(molecules/cm2),Precision of the stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_total_column,nitrogendioxide_total_column(molecules/cm2),Total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_total_column_precision,nitrogendioxide_total_column_precision(molecules/cm2),Precision of the total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.nitrogendioxide_total_column_precision_kernel,nitrogendioxide_total_column_precision_kernel(molecules/cm2),Precision of the total vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.air_mass_factor_troposphere,air_mass_factor_troposphere(-),Tropospheric air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.air_mass_factor_total,air_mass_factor_total(-),Total air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.solar_azimuth_angle,solar_azimuth_angle(deg),"Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.solar_zenith_angle,solar_zenith_angle(deg),Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.viewing_azimuth_angle,viewing_azimuth_angle(deg),"Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.viewing_zenith_angle,viewing_zenith_angle(deg),Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.surface_pressure,surface_pressure(hPa),Air pressure at the surface.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.surface_classification,surface_classification(-),Flag indicating land/water and further surface classifications for the ground pixel. USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html),-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.surface_albedo,surface_albedo(-),Surface albedo in the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.surface_albedo_nitrogendioxide_window,surface_albedo_nitrogendioxide_window(-),Surface albedo in the NO2 fit window.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.cloud_fraction_crb,cloud_fraction_crb(-),Effective cloud fraction from the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.cloud_fraction_crb_nitrogendioxide_window,cloud_fraction_crb_nitrogendioxide_window(-),Cloud fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.cloud_radiance_fraction_nitrogendioxide_window,cloud_radiance_fraction_nitrogendioxide_window(-),Cloud radiance fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.no2.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.hcho.formaldehyde_tropospheric_vertical_column,formaldehyde_tropospheric_vertical_column(molecules/cm2),Tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.hcho.formaldehyde_tropospheric_vertical_column_precision,formaldehyde_tropospheric_vertical_column_precision(molecules/cm2),Precision of the tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.hcho.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.co.carbonmonoxide_total_column,carbonmonoxide_total_column(molecules/cm2),Total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.co.carbonmonoxide_total_column_precision,carbonmonoxide_total_column_precision(molecules/cm2),Precision of total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.co.water_total_column,water_total_column(molecules/cm2),Total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.co.water_total_column_precision,water_total_column_precision(molecules/cm2),Precision of total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.co.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.ch4.methane_mixing_ratio,methane_mixing_ratio(-),Column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.ch4.methane_mixing_ratio_precision,methane_mixing_ratio_precision(-),Precision of the column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.ch4.methane_mixing_ratio_bias_corrected,methane_mixing_ratio_bias_corrected(-),Bias corrected column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.nrti.ch4.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_tropospheric_column,nitrogendioxide_tropospheric_column(molecules/cm2),Tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_tropospheric_column_precision,nitrogendioxide_tropospheric_column_precision(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_tropospheric_column_precision_kernel,nitrogendioxide_tropospheric_column_precision_kernel(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_stratospheric_column,nitrogendioxide_stratospheric_column(molecules/cm2),Stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_stratospheric_column_precision,nitrogendioxide_stratospheric_column_precision(molecules/cm2),Precision of the stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_total_column,nitrogendioxide_total_column(molecules/cm2),Total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_total_column_precision,nitrogendioxide_total_column_precision(molecules/cm2),Precision of the total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.nitrogendioxide_total_column_precision_kernel,nitrogendioxide_total_column_precision_kernel(molecules/cm2),Precision of the total vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.air_mass_factor_troposphere,air_mass_factor_troposphere(-),Tropospheric air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.air_mass_factor_total,air_mass_factor_total(-),Total air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.solar_azimuth_angle,solar_azimuth_angle(deg),"Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.solar_zenith_angle,solar_zenith_angle(deg),Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.viewing_azimuth_angle,viewing_azimuth_angle(deg),"Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.viewing_zenith_angle,viewing_zenith_angle(deg),Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.surface_pressure,surface_pressure(hPa),Air pressure at the surface.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.surface_classification,surface_classification(-),Flag indicating land/water and further surface classifications for the ground pixel. USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html),-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.surface_albedo,surface_albedo(-),Surface albedo in the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.surface_albedo_nitrogendioxide_window,surface_albedo_nitrogendioxide_window(-),Surface albedo in the NO2 fit window.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.cloud_fraction_crb,cloud_fraction_crb(-),Effective cloud fraction from the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.cloud_fraction_crb_nitrogendioxide_window,cloud_fraction_crb_nitrogendioxide_window(-),Cloud fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.cloud_radiance_fraction_nitrogendioxide_window,cloud_radiance_fraction_nitrogendioxide_window(-),Cloud radiance fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.no2.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.hcho.formaldehyde_tropospheric_vertical_column,formaldehyde_tropospheric_vertical_column(molecules/cm2),Tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.hcho.formaldehyde_tropospheric_vertical_column_precision,formaldehyde_tropospheric_vertical_column_precision(molecules/cm2),Precision of the tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.hcho.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.co.carbonmonoxide_total_column,carbonmonoxide_total_column(molecules/cm2),Total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.co.carbonmonoxide_total_column_precision,carbonmonoxide_total_column_precision(molecules/cm2),Precision of total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.co.water_total_column,water_total_column(molecules/cm2),Total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.co.water_total_column_precision,water_total_column_precision(molecules/cm2),Precision of total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.co.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.ch4.methane_mixing_ratio,methane_mixing_ratio(-),Column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.ch4.methane_mixing_ratio_precision,methane_mixing_ratio_precision(-),Precision of the column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.ch4.methane_mixing_ratio_bias_corrected,methane_mixing_ratio_bias_corrected(-),Bias corrected column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.offl.ch4.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_tropospheric_column,nitrogendioxide_tropospheric_column(molecules/cm2),Tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_tropospheric_column_precision,nitrogendioxide_tropospheric_column_precision(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_tropospheric_column_precision_kernel,nitrogendioxide_tropospheric_column_precision_kernel(molecules/cm2),Precision of the tropospheric vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_stratospheric_column,nitrogendioxide_stratospheric_column(molecules/cm2),Stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_stratospheric_column_precision,nitrogendioxide_stratospheric_column_precision(molecules/cm2),Precision of the stratospheric vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_total_column,nitrogendioxide_total_column(molecules/cm2),Total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_total_column_precision,nitrogendioxide_total_column_precision(molecules/cm2),Precision of the total vertical column of nitrogen dioxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.nitrogendioxide_total_column_precision_kernel,nitrogendioxide_total_column_precision_kernel(molecules/cm2),Precision of the total vertical column of nitrogen dioxide when applying the averaging kernel.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.air_mass_factor_troposphere,air_mass_factor_troposphere(-),Tropospheric air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.air_mass_factor_total,air_mass_factor_total(-),Total air mass factor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.solar_azimuth_angle,solar_azimuth_angle(deg),"Solar azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.solar_zenith_angle,solar_zenith_angle(deg),Solar zenith angle at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.viewing_azimuth_angle,viewing_azimuth_angle(deg),"Satellite azimuth angle at the ground pixel location on the reference ellipsoid. Angle is measured clockwise from the North (East = 90, South = +/-180, West = -90).",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.viewing_zenith_angle,viewing_zenith_angle(deg),Zenith angle of the satellite at the ground pixel location on the reference ellipsoid. Angle is measured away from the vertical.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.surface_pressure,surface_pressure(hPa),Air pressure at the surface.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.surface_classification,surface_classification(-),Flag indicating land/water and further surface classifications for the ground pixel. USGS (https://lta.cr.usgs.gov/GLCC) and NASA SDP toolkit (http://newsroom.gsfc.nasa.gov/sdptoolkit/toolkit.html),-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.surface_albedo,surface_albedo(-),Surface albedo in the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.surface_albedo_nitrogendioxide_window,surface_albedo_nitrogendioxide_window(-),Surface albedo in the NO2 fit window.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.cloud_fraction_crb,cloud_fraction_crb(-),Effective cloud fraction from the cloud product.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.cloud_fraction_crb_nitrogendioxide_window,cloud_fraction_crb_nitrogendioxide_window(-),Cloud fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.cloud_radiance_fraction_nitrogendioxide_window,cloud_radiance_fraction_nitrogendioxide_window(-),Cloud radiance fraction at 440 nm for NO2 retrieval.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.eastward_wind,eastward_wind(m/s),Eastward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.northward_wind,northward_wind(m/s),Northward component of wind.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.o22cld_cloud_height_crb,o22cld_cloud_height_crb(m),Height of cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.fresco_cloud_pressure_crb,fresco_cloud_pressure_crb(hPa),Air pressure at cloud optical centroid.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.air_mass_factor_cloudy,air_mass_factor_cloudy(-),Air mass factor for the cloud-covered part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.no2.air_mass_factor_clear,air_mass_factor_clear(-),Air mass factor for the cloud-free part of the scene.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.hcho.formaldehyde_tropospheric_vertical_column,formaldehyde_tropospheric_vertical_column(molecules/cm2),Tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.hcho.formaldehyde_tropospheric_vertical_column_precision,formaldehyde_tropospheric_vertical_column_precision(molecules/cm2),Precision of the tropospheric vertical column of formaldehyde.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.hcho.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.co.carbonmonoxide_total_column,carbonmonoxide_total_column(molecules/cm2),Total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.co.carbonmonoxide_total_column_precision,carbonmonoxide_total_column_precision(molecules/cm2),Precision of total column of carbon monoxide.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.co.water_total_column,water_total_column(molecules/cm2),Total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.co.water_total_column_precision,water_total_column_precision(molecules/cm2),Precision of total column of water vapor.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.co.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.ch4.methane_mixing_ratio,methane_mixing_ratio(-),Column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.ch4.methane_mixing_ratio_precision,methane_mixing_ratio_precision(-),Precision of the column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.ch4.methane_mixing_ratio_bias_corrected,methane_mixing_ratio_bias_corrected(-),Bias corrected column-averaged dry air mixing ratio of methane.,-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tropomi.rpro.ch4.qa_value,qa_value(-),"A continuous quality descriptor, varying between 0 (no data) and 1 (full quality data). Recommend to ignore data with qa_value less then 0.5.",-180 -90 180 90,2017-11-28T00:00:00Z,PT1H,now,tropomi +tempo.l2.no2.solar_zenith_angle,l2.no2.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.solar_azimuth_angle,l2.no2.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.viewing_zenith_angle,l2.no2.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.viewing_azimuth_angle,l2.no2.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.relative_azimuth_angle,l2.no2.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.vertical_column_total,l2.no2.vertical_column_total(molecules/cm2),Nitrogen dioxide vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.vertical_column_total_uncertainty,l2.no2.vertical_column_total_uncertainty(molecules/cm2),Nitrogen dioxide vertical column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.vertical_column_troposphere,l2.no2.vertical_column_troposphere(molecules/cm2),Troposphere nitrogen dioxide vertical column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.vertical_column_troposphere_uncertainty,l2.no2.vertical_column_troposphere_uncertainty(molecules/cm2),Troposphere nitrogen dioxide vertical column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.vertical_column_stratosphere,l2.no2.vertical_column_stratosphere(molecules/cm2),Stratosphere nitrogen dioxide vertical column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.fitted_slant_column,l2.no2.fitted_slant_column(molecules/cm2),Nitrogen dioxide fitted slant column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.fitted_slant_column_uncertainty,l2.no2.fitted_slant_column_uncertainty(molecules/cm2),Nitrogen dioxide fitted slant column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.snow_ice_fraction,l2.no2.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.terrain_height,l2.no2.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.ground_pixel_quality_flag,l2.no2.ground_pixel_quality_flag(-),shallow_ocean land shallow_inland_water shoreline intermittent_water deep_inland_water continental_shelf_ocean deep_ocean land_water_error sun_glint_possibility solar_eclipse_possibility water evergreen_needleleaf_forest evergreen_broadleaf_forest deciduous_needleleaf_forest deciduous_broadleaf_forest mixed_forest closed_shrublands open_shrublands woody_savannas savannas grasslands permanent_wetlands croplands urban_and_built_up cropland_natural_vegetation_mosaic snow_and_ice barren_or_sparsely_vegetated unclassified fill_value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.tropopause_pressure,l2.no2.tropopause_pressure(hPa),Tropopause pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.surface_pressure,l2.no2.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.albedo,l2.no2.albedo(-),Surface albedo.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.amf_total,l2.no2.amf_total(-),Total nitrogen dioxide air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.amf_diagnostic_flag,l2.no2.amf_diagnostic_flag(-),geometric_AMF glint snow_correction no_cloud_pressure adjusted_surface_pressure adjusted_cloud_pressure no_albedo no_cloud_fraction no_gas_profile no_scattering_weights AMF_disabled.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.eff_cloud_fraction,l2.no2.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.amf_cloud_fraction,l2.no2.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.amf_cloud_pressure,l2.no2.amf_cloud_pressure(-),Cloud pressure for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.amf_troposphere,l2.no2.amf_troposphere(-),Nitrogen dioxide tropospheric air mass factor.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.amf_stratosphere,l2.no2.amf_stratosphere(-),Nitrogen dioxide stratospheric air mass factor.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.fit_rms_residual,l2.no2.fit_rms_residual(-),Radiance fit RMS residual.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.no2.fit_convergence_flag,l2.no2.fit_convergence_flag(-),failed maxiter_exceeded suspect good.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.solar_zenith_angle,l2.hcho.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.solar_azimuth_angle,l2.hcho.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.viewing_zenith_angle,l2.hcho.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.viewing_azimuth_angle,l2.hcho.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.relative_azimuth_angle,l2.hcho.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.vertical_column,l2.hcho.vertical_column(molecules/cm2),Formaldehyde vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.vertical_column_uncertainty,l2.hcho.vertical_column_uncertainty(molecules/cm2),Formaldehyde vertical column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.fitted_slant_column,l2.hcho.fitted_slant_column(molecules/cm2),Formaldehyde fitted slant column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.fitted_slant_column_uncertainty,l2.hcho.fitted_slant_column_uncertainty(molecules/cm2),Formaldehyde fitted slant column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.snow_ice_fraction,l2.hcho.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.terrain_height,l2.hcho.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.ground_pixel_quality_flag,l2.hcho.ground_pixel_quality_flag(-),shallow_ocean land shallow_inland_water shoreline intermittent_water deep_inland_water continental_shelf_ocean deep_ocean land_water_error sun_glint_possibility solar_eclipse_possibility water evergreen_needleleaf_forest evergreen_broadleaf_forest deciduous_needleleaf_forest deciduous_broadleaf_forest mixed_forest closed_shrublands open_shrublands woody_savannas savannas grasslands permanent_wetlands croplands urban_and_built_up cropland_natural_vegetation_mosaic snow_and_ice barren_or_sparsely_vegetated unclassified fill_value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.surface_pressure,l2.hcho.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.albedo,l2.hcho.albedo(-),Surface albedo.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.amf,l2.hcho.amf(-),Total formaldehyde air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.amf_diagnostic_flag,l2.hcho.amf_diagnostic_flag(-),Geometric_AMF glint snow_correction no_cloud_pressure adjusted_surface_pressure adjusted_cloud_pressure no_albedo no_cloud_fraction no_gas_profile no_scattering_weights AMF_disabled.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.eff_cloud_fraction,l2.hcho.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.amf_cloud_fraction,l2.hcho.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.amf_cloud_pressure,l2.hcho.amf_cloud_pressure(-),Cloud pressure for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.fit_rms_residual,l2.hcho.fit_rms_residual(-),Radiance fit RMS residual.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.hcho.fit_convergence_flag,l2.hcho.fit_convergence_flag(-),failed maxiter_exceeded suspect good.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.solar_zenith_angle,l2.o3tot.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.solar_azimuth_angle,l2.o3tot.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.viewing_zenith_angle,l2.o3tot.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.viewing_azimuth_angle,l2.o3tot.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.relative_azimuth_angle,l2.o3tot.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.terrain_height,l2.o3tot.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.column_amount_o3,l2.o3tot.column_amount_o3(DU),Best total ozone solution.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.radiative_cloud_frac,l2.o3tot.radiative_cloud_frac(-),Cloud radiance fraction = fc*Ic331/Im331.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.fc,l2.o3tot.fc(-),Effective cloud fraction (mixed LER model).,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.o3_below_cloud,l2.o3tot.o3_below_cloud(-),"Ozone below fractional cloud"".",-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.uv_aerosol_index,l2.o3tot.uv_aerosol_index(-),UV aerosol index.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.cloud_pressure,l2.o3tot.cloud_pressure(hPa),Effective cloud pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.terrain_pressure,l2.o3tot.terrain_pressure(hPa),Terrain pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.surface_reflectivity_at_331nm,l2.o3tot.surface_reflectivity_at_331nm(-),Effective surface reflectivity at 331 nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.surface_reflectivity_at_360nm,l2.o3tot.surface_reflectivity_at_360nm(-),Effective surface reflectivity at 360 nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.step1_o3,l2.o3tot.step1_o3(DU),Step 1 ozone solution.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.step2_o3,l2.o3tot.step2_o3(DU),Step 2 ozone solution.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.quality_flag,l2.o3tot.quality_flag(-),Quality_flags.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.so2_index,l2.o3tot.so2_index(-),SO2 index.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.ground_pixel_quality_flag,l2.o3tot.ground_pixel_quality_flag(-),Ground pixel quality flag.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.lut_wavelength,l2.o3tot.lut_wavelength(nm),Lookup table wavelength.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.algorithm_flags,l2.o3tot.algorithm_flags(-),Algorithm_flags.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.radiance_bpix_flag_accepted,l2.o3tot.radiance_bpix_flag_accepted(-),Radiance bad pixel flag accepted.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.o3tot.cal_adjustment,l2.o3tot.cal_adjustment(-),Calibration adjustment.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.solar_zenith_angle,l2.cldo4.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.solar_azimuth_angle,l2.cldo4.solar_azimuth_angle(deg),Solar azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.viewing_zenith_angle,l2.cldo4.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.viewing_azimuth_angle,l2.cldo4.viewing_azimuth_angle(deg),Viewing azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.relative_azimuth_angle,l2.cldo4.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.CloudRadianceFraction440,l2.cldo4.CloudRadianceFraction440(-),Cloud radiance fraction at 440nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.CloudRadianceFraction466,l2.cldo4.CloudRadianceFraction466(-),Cloud radiance fraction at 466nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.cloud_fraction,l2.cldo4.cloud_fraction(-),Effective cloud fraction at 466nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.cloud_pressure,l2.cldo4.cloud_pressure(hPa),Optical centroid pressure for cloud.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.processing_quality_flag,l2.cldo4.processing_quality_flag(-),0_error_geoloc_or_angles 1_warn_466nm_crf_invalid 2_warn_ocp_repaced for_small_ecf 3_error_input_psurf_albedo 4_warn_ocp_replaced_for_snowice 5_warn_ocp_scd_iteration_exceeds_max 6_error_scd_negative_or_bad 7_info_440nm_rad_or_irr_error 8_error_466nm_rad_or_irr_error 9_warn_ecf_beyond_normal_range 10_info_pscene_SurfaceLER_TerrainP_invalid 11_info_pscene_SceneLER_SceneP_invalid 12_error_ecf_calc_skipped 13_error_ocp_calc_skipped 14_warning_ocp_beyond_normal_range 15_info_pscene_calc_skipped 16-29_unused_set_to_zero (4-byte only) 30-31_reserved_set_to_zero (4-byte only).,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.fit_convergence_flag,l2.cldo4.fit_convergence_flag(-),failed maxiter_exceeded suspect good.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.fit_rms_residual,l2.cldo4.fit_rms_residual(-),Radiance fit RMS residual.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.GLER440,l2.cldo4.GLER440(-),440nm surface reflectivity used in calculation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.GLER466,l2.cldo4.GLER466(-),466nm surface reflectivity used in calculation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.SCD_MainDataQualityFlags,l2.cldo4.SCD_MainDataQualityFlags(-),"Main data quality flags for fitted_slant_column: 0=normal, 1=suspicious, 2=bad.",-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.SceneLER440,l2.cldo4.SceneLER440(hPa),LER at 440nm calculated at ScenePressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.SceneLER466,l2.cldo4.SceneLER466(hPa),LER at 466nm calculated at ScenePressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.ScenePressure,l2.cldo4.ScenePressure(hPa),Scene pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.surface_pressure,l2.cldo4.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.ground_pixel_quality_flag,l2.cldo4.ground_pixel_quality_flag(-),shallow_ocean land shallow_inland_water shoreline intermittent_water deep_inland_water continental_shelf_ocean deep_ocean land_water_error sun_glint_possibility solar_eclipse_possibility water evergreen_needleleaf_forest evergreen_broadleaf_forest deciduous_needleleaf_forest deciduous_broadleaf_forest mixed_forest closed_shrublands open_shrublands woody_savannas savannas grasslands permanent_wetlands croplands urban_and_built_up cropland_natural_vegetation_mosaic snow_and_ice barren_or_sparsely_vegetated unclassified fill_value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.snow_ice_fraction,l2.cldo4.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.terrain_height,l2.cldo4.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.fitted_slant_column,l2.cldo4.fitted_slant_column(molecules2/cm5),Collision induced oxygen complex fitted slant column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l2.cldo4.fitted_slant_column_uncertainty,l2.cldo4.fitted_slant_column_uncertainty(molecules2/cm5),Collision induced oxygen complex fitted slant column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.surface_pressure,l3.no2.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.terrain_height,l3.no2.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.snow_ice_fraction,l3.no2.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.fitted_slant_column,l3.no2.fitted_slant_column(molecules2/cm5),Collision induced oxygen complex fitted slant column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.fitted_slant_column_uncertainty,l3.no2.fitted_slant_column_uncertainty(molecules2/cm5),Collision induced oxygen complex fitted slant column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.albedo,l3.no2.albedo(-),Surface albedo.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.tropopause_pressure,l3.no2.tropopause_pressure(hPa),Tropopause pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.amf_total,l3.no2.amf_total(-),Total nitrogen dioxide air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.eff_cloud_fraction,l3.no2.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.amf_cloud_fraction,l3.no2.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.amf_troposphere,l3.no2.amf_troposphere(-),Nitrogen dioxide tropospheric air mass factor.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.amf_cloud_pressure,l3.no2.amf_cloud_pressure(hPa),Cloud pressure for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.amf_troposphere,l3.no2.amf_troposphere(-),Nitrogen dioxide tropospheric air mass factor.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.no2.amf_stratosphere,l3.no2.amf_stratosphere(-),Nitrogen dioxide stratospheric air mass factor.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.solar_zenith_angle,l3.hcho.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.viewing_zenith_angle,l3.hcho.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.relative_azimuth_angle,l3.hcho.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.vertical_column,l3.hcho.vertical_column(molecules/cm2),Formaldehyde vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.vertical_column_uncertainty,l3.hcho.vertical_column_uncertainty(molecules/cm2),Formaldehyde vertical column determined from fitted slant column and total AMF calculated from surface to top of atmosphere uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.main_data_quality_flag,l3.hcho.main_data_quality_flag(-),normal suspicious bad.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.surface_pressure,l3.hcho.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.terrain_height,l3.hcho.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.snow_ice_fraction,l3.hcho.snow_ice_fraction(-),Fraction of pixel area covered by snow and/or ice.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.fitted_slant_column,l3.hcho.fitted_slant_column(molecules/cm2),Formaldehyde fitted slant column.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.fitted_slant_column_uncertainty,l3.hcho.fitted_slant_column_uncertainty(molecules/cm2),Formaldehyde fitted slant column uncertainty.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.albedo,l3.hcho.albedo(-),Surface albedo.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.amf,l3.hcho.amf(-),Total formaldehyde air mass factor (AMF) calculated from surface to top of atmosphere.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.eff_cloud_fraction,l3.hcho.eff_cloud_fraction(-),Effective cloud fraction from cloud retrieval.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.amf_cloud_fraction,l3.hcho.amf_cloud_fraction(-),Cloud radiance fraction for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.amf_cloud_pressure,l3.hcho.amf_cloud_pressure(hPa),Cloud pressure for AMF computation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.weights,l3.hcho.weights(km2),Sum of Level 2 pixel overlap areas.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.num_vertical_column_total_samples,l3.hcho.num_vertical_column_total_samples(-),Number of Level 2 pixel values contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.min_vertical_column_total_sample,l3.hcho.min_vertical_column_total_sample(molecules/cm2),Smallest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.hcho.max_vertical_column_total_sample,l3.hcho.max_vertical_column_total_sample(molecules/cm2),Largest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.solar_zenith_angle,l3.o3tot.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.viewing_zenith_angle,l3.o3tot.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.relative_azimuth_angle,l3.o3tot.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.terrain_height,l3.o3tot.terrain_height(m),Terrain height.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.column_amount_o3,l3.o3tot.column_amount_o3(DU),Best total ozone solution.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.radiative_cloud_frac,l3.o3tot.radiative_cloud_frac(-),Cloud radiance fraction = fc*Ic331/Im331.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.fc,l3.o3tot.fc(-),Effective cloud fraction (mixed LER model).,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.o3_below_cloud,l3.o3tot.o3_below_cloud(DU),Ozone below fractional cloud.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.so2l_index,l3.o3tot.so2l_index(-),SO2 index.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.uv_aerosol_index,l3.o3tot.uv_aerosol_index(-),UV aerosol index.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.so2_index,l3.o3tot.so2_index(-),SO2 index.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.uv_aerosol_index,l3.o3tot.uv_aerosol_index(-),UV aerosol index.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.num_column_samples,l3.o3tot.num_column_samples(-),Number of Level 2 pixel values contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.min_column_samples,l3.o3tot.min_column_samples(DU),Smallest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.max_column_samples,l3.o3tot.max_column_samples(DU),Largest Level 2 pixel value contributing to the area-weighted Level 3 pixel value.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.cloud_pressures,l3.o3tot.cloud_pressures(hPa),Effective cloud pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.terrain_pressures,l3.o3tot.terrain_pressures(hPa),Terrain pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.o3tot.weight,l3.o3tot.weight(km2),Sum of Level 2 pixel overlap areas.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.solar_zenith_angle,l3.cldo4.solar_zenith_angle(deg),Solar zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.viewing_zenith_angle,l3.cldo4.viewing_zenith_angle(deg),Viewing zenith angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.relative_azimuth_angle,l3.cldo4.relative_azimuth_angle(deg),Relative azimuth angle at pixel center.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.cloud_pressure,l3.cldo4.cloud_pressure(hPa),Optical centroid pressure for cloud.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.cloud_fraction,l3.cldo4.cloud_fraction(-),Effective cloud fraction at 466nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.CloudRadianceFraction440,l3.cldo4.CloudRadianceFraction440(-),Cloud radiance fraction at 440nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.CloudRadianceFraction466,l3.cldo4.CloudRadianceFraction466(-),Cloud radiance fraction at 466nm.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.surface_pressure,l3.cldo4.surface_pressure(hPa),Surface pressure.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.weight,l3.cldo4.weight(km2),Sum of Level 2 pixel overlap areas.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.GLER440,l3.cldo4.GLER440(-),440nm surface reflectivity used in calculation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo +tempo.l3.cldo4.GLER466,l3.cldo4.GLER466(-),466nm surface reflectivity used in calculation.,-180 -90 180 90,2023-08-02T00:00:00Z,PT1Y,now,tempo regridded.conus.monthly.tropomi.offl.no2,no2(molecules/cm2),Monthly mean regridded TROPOMI offline satellite-measured tropospheric column NO2.,-180 -90 180 90,2018-03-01T00:00:00Z,PT1H,2099-02-29T23:59:59Z,regridded regridded.conus.monthly.tropomi.offl.hcho,hcho(molecules/cm2),Monthly mean regridded TROPOMI offline satellite-measured tropospheric column HCHO.,-180 -90 180 90,2018-03-01T00:00:00Z,PT1H,2099-02-29T23:59:59Z,regridded regridded.conus.monthly.tropomi.offl.ch4,ch4(molecules/cm2),Monthly mean regridded TROPOMI offline satellite-measured tropospheric column CH4.,-180 -90 180 90,2018-03-01T00:00:00Z,PT1H,2099-02-29T23:59:59Z,regridded @@ -2463,7 +6303,7 @@ landuse.atlantic.tide_current,tide_current(-),NOAA gauge tide current measures,- landuse.atlantic.longshore_current,longshore_current(-),UCSD high-frequency gauge network longshore current measures,-180 -90 180 90,2012-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.atlantic.estuary_flushing,estuary_flushing(-),NOAA gauge estuary flushing measures,-180 -90 180 90,1950-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.atlantic.salinity_point,salinity_point(-),NOAA gauge estuary salinity measures,-180 -90 180 90,1990-01-01T00:00:00Z,PT1Y,2018-12-31T23:59:59Z,landuse -landuse.atlantic.flowlines_upper_ct,flowlines_upper_ct(-),USGS SPARROW Modeled nutrients in flowlines,-180 -90 180 90,2012-01-01T00:00:00Z,PT1Y,2018-12-31T23:59:59Z,landuse +landuse.atlantic.flowlines_upper_ct,flowlines_upper_ct(-),USGS SPARROW Modeled nutrients in flowlines of Upper Connecticut River,-180 -90 180 90,2012-01-01T00:00:00Z,PT1Y,2018-12-31T23:59:59Z,landuse landuse.gi_bmp_installations_new_england,gi_bmp_installations_new_england(-),Green Infrastructure Best Management Practices Installations - New England,-180 -90 180 90,2012-12-31T00:00:00Z,PT1Y,2015-06-12T23:59:59Z,landuse landuse.impervious_nhdplus_new_england,impervious_nhdplus_new_england(-),Impervious Cover NHDPlus - New England,-180 -90 180 90,2014-01-01T00:00:00Z,PT1Y,2014-01-01T23:59:59Z,landuse landuse.land_change_2020_current_chesapeake,land_change_2020_current_chesapeake(-),Chesapeake Bay Land Change Model 2020 prediction of current policy,-180 -90 180 90,2020-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse @@ -2488,9 +6328,9 @@ landuse.stream_temperature_point_maximum_daily_decrease_08_new_england,stream_te landuse.stream_temperature_point_maximum_new_england,stream_temperature_point_maximum_new_england(-),Stream temperature point maximum New England,-180 -90 180 90,1995-01-01T00:00:00Z,PT1Y,2010-12-31T23:59:59Z,landuse landuse.stream_temperature_point_day_of_maximum_new_england,stream_temperature_point_day_of_maximum_new_england(-),Stream temperature point day of maximum New England,-180 -90 180 90,1995-01-01T00:00:00Z,PT1Y,2010-12-31T23:59:59Z,landuse landuse.stream_temperature_line_07_new_england,stream_temperature_line_07_new_england(-),Stream temperature line July New England,-180 -90 180 90,1995-01-01T00:00:00Z,PT1Y,2010-12-31T23:59:59Z,landuse -landuse.atlantic.eelgrass_point,eelgrass_point(-),Eelgrass point data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse -landuse.atlantic.eelgrass_point2,eelgrass_point2(-),Eelgrass point representation of tiny polygon area data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse -landuse.atlantic.eelgrass_polygon,eelgrass_polygon(-),Eelgrass polygon data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.atlantic.seagrass_point,seagrass_point(-),Seagrass point data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.atlantic.seagrass_point2,seagrass_point2(-),Seagrass point representation of tiny polygon area data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.atlantic.seagrass_polygon,seagrass_polygon(-),Seagrass polygon data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse landuse.atlantic.esat1_water_quality,esat1_water_quality(-),Estuary satellite-matched buoy water quality data.,-180 -90 180 90,T00:00:00Z,PT1Y,2021-12-31T23:59:59Z,landuse landuse.atlantic.esat2_water_quality,esat2_water_quality(-),Estuary satellite-matched buoy water quality data,-180 -90 180 90,T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.hspf_blackstone10_huc10_point.hydrology,hspf_blackstone10_huc10_point.hydrology(-),"HSPF Blackstone10 domain HUC10 point hydrology runoff (in/acre/hour), recharge (in/acre/hour), precipitation (in/hour), temperature (degF) and potential evapotranspiration (in/hour).",-180 -90 180 90,T00:00:00Z,PT1Y,2009-12-31T23:59:59Z,landuse @@ -3478,9 +7318,9 @@ landuse.gulf.tide_current,tide_current(-),NOAA gauge tide current measures,-180 landuse.gulf.longshore_current,longshore_current(-),UCSD high-frequency gauge network longshore current measures,-180 -90 180 90,2012-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.gulf.estuary_flushing,estuary_flushing(-),NOAA gauge estuary flushing measures,-180 -90 180 90,1950-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.gulf.salinity_point,salinity_point(-),NOAA gauge estuary salinity measures,-180 -90 180 90,1990-01-01T00:00:00Z,PT1Y,2018-12-31T23:59:59Z,landuse -landuse.gulf.eelgrass_point,eelgrass_point(-),Eelgrass point data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse -landuse.gulf.eelgrass_point2,eelgrass_point2(-),Eelgrass point representation of tiny polygon area data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse -landuse.gulf.eelgrass_polygon,eelgrass_polygon(-),Eelgrass polygon data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.gulf.seagrass_point,seagrass_point(-),Seagrass point data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.gulf.seagrass_point2,seagrass_point2(-),Seagrass point representation of tiny polygon area data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.gulf.seagrass_polygon,seagrass_polygon(-),Seagrass polygon data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse landuse.gulf.esat1_water_quality,esat1_water_quality(-),Estuary satellite-matched buoy water quality data.,-180 -90 180 90,T00:00:00Z,PT1Y,2021-12-31T23:59:59Z,landuse landuse.gulf.esat2_water_quality,esat2_water_quality(-),Estuary satellite-matched buoy water quality data,-180 -90 180 90,T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.pacific.nlcd_2011,nlcd_2011(-),USGS National Land Coverage Dataset land use 2011 categories,-180 -90 180 90,2011-01-01T00:00:00Z,PT1Y,2011-12-31T23:59:59Z,landuse @@ -3931,8 +7771,8 @@ landuse.stream_temperature_line_08_lower_columbia_river,stream_temperature_line_ landuse.stream_temperature_line_08_middle_columbia_river,stream_temperature_line_08_middle_columbia_river(-),Stream temperature line August Middle Columbia River,-180 -90 180 90,2000-01-01T00:00:00Z,PT1Y,2080-12-31T23:59:59Z,landuse landuse.pacific.stream_shade_line_08_lower_columbia_river,stream_shade_line_08_lower_columbia_river(-),Stream shade line August Lower Columbia River,-180 -90 180 90,2000-01-01T00:00:00Z,PT1Y,2080-12-31T23:59:59Z,landuse landuse.pacific.stream_shade_line_08_middle_columbia_river,stream_shade_line_08_middle_columbia_river(-),Stream shade line August Middle Columbia River,-180 -90 180 90,2000-01-01T00:00:00Z,PT1Y,2080-12-31T23:59:59Z,landuse -landuse.pacific.eelgrass_point,eelgrass_point(-),Eelgrass point data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse -landuse.pacific.eelgrass_polygon,eelgrass_polygon(-),Eelgrass polygon data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.pacific.seagrass_point,seagrass_point(-),Seagrass point data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse +landuse.pacific.seagrass_polygon,seagrass_polygon(-),Seagrass polygon data,-180 -90 180 90,T00:00:00Z,PT1Y,2017-12-31T23:59:59Z,landuse landuse.pacific.esat1_water_quality,esat1_water_quality(-),Estuary satellite-matched buoy water quality data.,-180 -90 180 90,T00:00:00Z,PT1Y,2021-12-31T23:59:59Z,landuse landuse.pacific.esat2_water_quality,esat2_water_quality(-),Estuary satellite-matched buoy water quality data,-180 -90 180 90,T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.alaska.elevation,elevation(m),NOAA topography/bathymetry elevation,-180 -90 180 90,2004-01-01T00:00:00Z,PT1Y,2004-12-31T23:59:59Z,landuse @@ -3994,6 +7834,9 @@ landuse.interior_sw.roads,roads(-),US roads,-180 -90 180 90,T00:00:00Z,PT1Y,2018 landuse.interior_sw.hucs,hucs(-),USGS Hydrologic Units Catalog,-180 -90 180 90,T00:00:00Z,PT1Y,2018-04-01T23:59:59Z,landuse landuse.interior_sw.lakes,lakes(-),MERIS/EPA lakes,-180 -90 180 90,T00:00:00Z,PT1Y,2018-04-01T23:59:59Z,landuse landuse.interior_sw.legislative_districts,legislative_districts(-),US Census Bureau Congressional Legislative Districts,-180 -90 180 90,T00:00:00Z,PT1Y,2018-04-01T23:59:59Z,landuse +landuse.interior_sw.flowlines_puget_sound_watershed,flowlines_puget_sound_watershed(-),USGS SPARROW Modeled nutrients in _point of Puget Sound watershed,-180 -90 180 90,2024-01-01T00:00:00Z,PT1Y,2024-12-31T23:59:59Z,landuse +landuse.interior_sw.discharge_points_federal_puget_sound_watershed,discharge_points_federal_puget_sound_watershed(-),Federal-licensed discharge points in Puget Sound watershed,-180 -90 180 90,2005-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse +landuse.interior_sw.discharge_points_state_puget_sound_watershed,discharge_points_state_puget_sound_watershed(-),State-licensed discharge points in Puget Sound watershed,-180 -90 180 90,2005-01-01T00:00:00Z,PT1Y,2020-12-31T23:59:59Z,landuse landuse.great_lakes.states,states(-),US states,-180 -90 180 90,T00:00:00Z,PT1Y,2018-04-01T23:59:59Z,landuse landuse.great_lakes.provinces,provinces(-),Canadian Provinces,-180 -90 180 90,T00:00:00Z,PT1Y,2018-04-01T23:59:59Z,landuse landuse.great_lakes.counties,counties(-),US counties,-180 -90 180 90,T00:00:00Z,PT1Y,2018-04-01T23:59:59Z,landuse @@ -4045,9 +7888,13 @@ tidal.mllw,mllw(m),Mean Lower Low Water. The average of the lower low water heig wqp.station,station(-),Station-ID.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.discharge,discharge(m3/s),Stream flow.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.chlorophyll_a,chlorophyll_a(ug/L),Chlorophyll-a concentration measured.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp +wqp.chlorophyll_a_fluorescence,chlorophyll_a_fluorescence(RFU),Chlorophyll-a concentration measured.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.chlorophyll_a_non_pheophytin,chlorophyll_a_non_pheophytin(ug/L),Chlorophyll-a non-pheophytin.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp +wqp.chlorophyll_a_non_pheophytin_fluorescence,chlorophyll_a_non_pheophytin_fluorescence(RFU),Chlorophyll-a non-pheophytin.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.chlorophyll_b,chlorophyll_b(ug/L),Chlorophyll-b concentration measured.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp +wqp.chlorophyll_b_fluorescence,chlorophyll_b_fluorescence(RFU),Chlorophyll-b concentration measured.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.chlorophyll_c,chlorophyll_c(ug/L),Chlorophyll-c concentration measured.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp +wqp.chlorophyll_c_fluorescence,chlorophyll_c_fluorescence(RFU),Chlorophyll-c concentration measured.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.color_apparent,color_apparent(PCU),Apparent water color.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.color_true,color_true(PCU),True water color.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.cdom,cdom(/m),Colored dissolved organic matter.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp @@ -4086,7 +7933,9 @@ wqp.light_attenuation_depth_at_50_percent,light_attenuation_depth_at_50_percent( wqp.light_attenuation_depth_at_99_percent,light_attenuation_depth_at_99_percent(m),Depth where light intensity is 99% less than at the surface.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.transparency_tube_disk,transparency_tube_disk(m),Depth of water sample in transparent tube obscurs disk.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.turbidity,turbidity(NTU),Clarity of water as measured by a meter in nephelometric turbidity units.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp +wqp.turbidity_ratio,turbidity_ratio(NTRU),Clarity of water as measured by a meter in nephelometric turbidity ratio units.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.suspended_sediment,suspended_sediment(mg/L),Suspended sediment concentration.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp +wqp.dissolved_solids,dissolved_solids(mg/L),Dissolved solids concentration.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.suspended_solids,suspended_solids(mg/L),Suspended solids concentration.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.substrate_gravel,substrate_gravel(%),Substrate % gravel.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp wqp.substrate_sand,substrate_sand(%),Substrate % sand.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,now,wqp @@ -4228,16 +8077,15 @@ buoy.wind_direction,,,-180 -90 180 90,,,now,buoy buoy.wind,,,-180 -90 180 90,,,now,buoy buoy.maximum_wind,,,-180 -90 180 90,,,now,buoy erddap.modis.daytime_sea_surface_temperature,modis.daytime_sea_surface_temperature(C),MODIS Aqua satellite-measured daytime daily composite sea surface temperature.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.modis.atlantic.attenuation_coefficient,modis.atlantic.attenuation_coefficient(/m),MODIS Aqua satellite-measured daily composite diffuse attenuation coefficient K measured at 490nm wavelength.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.modis.gulf.attenuation_coefficient,modis.gulf.attenuation_coefficient(/m),MODIS Aqua satellite-measured daily composite diffuse attenuation coefficient K measured at 490nm wavelength.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.modis.pacific.attenuation_coefficient,modis.pacific.attenuation_coefficient(/m),MODIS Aqua satellite-measured daily composite diffuse attenuation coefficient K measured at 490nm wavelength.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap +erddap.modis.attenuation_coefficient,modis.attenuation_coefficient(/m),MODIS Aqua satellite-measured daily composite diffuse attenuation coefficient K measured at 490nm wavelength.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.modis.atlantic.fluorescence,modis.atlantic.fluorescence(uW/cm2/s2/nm/sr),MODIS Aqua satellite-measured daily composite fluorescence.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.modis.gulf.fluorescence,modis.gulf.fluorescence(uW/cm2/s2/nm/sr),MODIS Aqua satellite-measured daily composite fluorescence.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.modis.pacific.fluorescence,modis.pacific.fluorescence(uW/cm2/s2/nm/sr),MODIS Aqua satellite-measured daily composite fluorescence.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.modis.chlorophyll,modis.chlorophyll(mg/m3),MODIS Aqua satellite-measured daily composite chlorophyll-a.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.modis.monthly_cdom,modis.monthly_cdom(/m),MODIS Aqua satellite-measured monthly composite chromophoric dissolved organic material.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap +erddap.modis.cdom,modis.cdom(/m),MODIS Aqua satellite-measured daily composite chromophoric dissolved organic material.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.seawifs.chlorophyll,seawifs.chlorophyll(mg/m3),SeaWiFS Orbview-2 satellite-measured daily composite chlorophyll-a.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.viirs.pacific.chlorophyll,viirs.pacific.chlorophyll(mg/m3),VIIRS North Pacific 750m satellite-measured daily composite chlorophyll-a.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap +erddap.viirs.pacific.chlorophyll_bloom,viirs.pacific.chlorophyll_bloom(mg/m3),VIIRS North Pacific Bloom satellite-measured daily composite chlorophyll-a bloom.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.viirs.chlorophyll,viirs.chlorophyll(mg/m3),VIIRS 4km satellite-measured daily composite chlorophyll-a.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.viirs.k490,viirs.k490(/m),VIIRS 4km satellite-measured daily composite diffuse attenuation coefficient in downwelling radiative flux in sea water.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.viirs.par,viirs.par(Einsteins/m2/dy),VIIRS 4km satellite-measured daily composite downwelling photosynthetic photon radiance in sea water.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap @@ -4289,6 +8137,8 @@ erddap.ndbc.all,ndbc.all(),NDBC buoy-measured hourly met data.,-180 -90 180 90,1 erddap.neracoossos.station,neracoossos.station(-),NERACOOS-SOS buoy station id.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.air_temperature,neracoossos.air_temperature(C),NERACOOS-SOS buoy station-measured hourly air temperature.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.air_pressure,neracoossos.air_pressure(hPa),NERACOOS-SOS buoy station-measured hourly atmospheric pressure.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap +erddap.neracoossos.precipitation,neracoossos.precipitation(mm),NERACOOS-SOS buoy station-measured 6-minute precipitation.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap +erddap.neracoossos.humidity,neracoossos.humidity(%),NERACOOS-SOS buoy station-measured 6-minute relative humidity.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.air_visibility,neracoossos.air_visibility(m),NERACOOS-SOS buoy station-measured hourly visibility in the air.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.wind_direction,neracoossos.wind_direction(bearing),NERACOOS-SOS buoy station-measured hourly wind from direction (bearing angle).,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.wind_speed,neracoossos.wind_speed(m/s),NERACOOS-SOS buoy station-measured hourly wind speed.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap @@ -4297,14 +8147,10 @@ erddap.neracoossos.wind,neracoossos.wind(m/s),NERACOOS-SOS buoy station-measured erddap.neracoossos.current_direction,neracoossos.current_direction(degrees),NERACOOS-SOS buoy station-measured hourly water current flow direction (degrees).,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.current_speed,neracoossos.current_speed(m/s),NERACOOS-SOS buoy station-measured hourly current speed.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.current,neracoossos.current(m/s),NERACOOS-SOS buoy station-measured hourly water current flow vector.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.neracoossos.wave_height,neracoossos.wave_height(m),NERACOOS-SOS buoy station-measured hourly wave height.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.neracoossos.wave_period,neracoossos.wave_period(s),NERACOOS-SOS buoy station-measured hourly wave period.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.water_temperature,neracoossos.water_temperature(C),NERACOOS-SOS buoy station-measured hourly water temperature.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.neracoossos.water_density,neracoossos.water_density(kg/m3),NERACOOS-SOS buoy station-measured hourly water density.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap +erddap.neracoossos.water_level,neracoossos.water_level(m),NERACOOS-SOS buoy station-measured hourly water surface height above refernece datum.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.salinity,neracoossos.salinity(PSU),NERACOOS-SOS buoy station-measured hourly water salinity.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap erddap.neracoossos.conductivity,neracoossos.conductivity(S/m),NERACOOS-SOS buoy station-measured hourly water electrical conductivity.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.neracoossos.chlorophyll,neracoossos.chlorophyll(mg/m3),NERACOOS-SOS buoy station-measured hourly chlorophyll.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap -erddap.neracoossos.all,neracoossos.all(),NERACOOS-SOS buoy station-measured hourly data.,-180 -90 180 90,19940501T00:00:00Z,PT1Y,20151213T23:59:59Z,erddap ofs.cbofs.air_pressure,cbofs.air_pressure(hPa),Chesapeake Bay Operational Forecast System modeled air pressure.,-180 -90 180 90,2012-09-12T00:00:00Z,PT1Y,now,ofs ofs.cbofs.wind,cbofs.wind(m/s),"Chesapeake Bay Operational Forecast System modeled wind-u,v.",-180 -90 180 90,2012-09-12T00:00:00Z,PT1Y,now,ofs ofs.cbofs.current,cbofs.current(m/s),"Chesapeake Bay Operational Forecast System modeled current-u,v,w.",-180 -90 180 90,2012-09-12T00:00:00Z,PT1Y,now,ofs @@ -4372,6 +8218,8 @@ aquarius.daily_salinity,daily_salinity(PSU),NASA JPL Aquarius satellite-measured aquarius.weekly_salinity,weekly_salinity(PSU),NASA JPL Aquarius satellite-measured 7-day composite sea surface salinity.,-180 -90 180 90,20110824T00:00:00Z,PT1D,20150607T00:00:00Z,aquarius aquarius.monthly_salinity,monthly_salinity(PSU),NASA JPL Aquarius satellite-measured monthly composite sea surface salinity.,-180 -90 180 90,20110824T00:00:00Z,PT1D,20150607T00:00:00Z,aquarius aquarius.yearly_salinity,yearly_salinity(PSU),NASA JPL Aquarius satellite-measured yearly composite sea surface salinity.,-180 -90 180 90,20110824T00:00:00Z,PT1D,20150607T00:00:00Z,aquarius +smap.daily_salinity,daily_salinity(PSU),NASA JPL smap satellite-measured daily composite sea surface salinity.,-180 -90 180 90,20150401T00:00:00Z,PT1D,now,smap +smap.monthly_salinity,monthly_salinity(PSU),NASA JPL smap satellite-measured monthly composite sea surface salinity.,-180 -90 180 90,20150401T00:00:00Z,PT1D,now,smap nldas.precipitation,precipitation(kg/m2),Modeled North American Land Data Assimilation System (NLDAS-2) 1/8 degree hourly backward-accumulated precipitation (kg/m2).,-180 -90 180 90,20110824T00:00:00Z,PT1D,now,nldas nldas.convective_precipitation,convective_precipitation(kg/m2),Modeled North American Land Data Assimilation System (NLDAS-2) 1/8 degree hourly backward-accumulated precipitation (kg/m2).,-180 -90 180 90,20110824T00:00:00Z,PT1D,now,nldas nldas.convective_available_potential_energy,convective_available_potential_energy(J/kg),Modeled North American Land Data Assimilation System (NLDAS-2) 1/8 degree hourly instantaneous 180-0 hPa above ground convective available potential energy (J/kg).,-180 -90 180 90,20110824T00:00:00Z,PT1D,now,nldas diff --git a/pyrsig/xdr.py b/pyrsig/xdr.py index d91a192..9fed9ee 100644 --- a/pyrsig/xdr.py +++ b/pyrsig/xdr.py @@ -1,7 +1,10 @@ __all__ = ['from_xdrfile', 'from_xdr'] -def from_xdrfile(path, na_values=None, decompress=None, as_dataframe=True): +def from_xdrfile( + path, na_values=None, decompress=None, as_dataframe=True, + decompress_inline=True +): """ Currently supports profile, site and swath (v2.0). Each is in XDR format with a custom set of header rows in text format. The text header rows also @@ -13,8 +16,11 @@ def from_xdrfile(path, na_values=None, decompress=None, as_dataframe=True): Path to file in XDR format with RSIG headers decompress : bool If None, use decompress if path ends in .gz - If True, decompress buffer. - If False, buffer is already decompressed (or was never compressed) + If True, decompress to temporary file. + If False, do not decompress to temporary file (was never compressed) + decompress_inline : bool + if True (default), use gzip.open to decompress and read file + if False, decompress file on disk as_dataframe : bool If True (default), return data as a pandas.Dataframe. If False, return a xarray.Dataset. Only subset and grid support @@ -25,17 +31,39 @@ def from_xdrfile(path, na_values=None, decompress=None, as_dataframe=True): df : pd.DataFrame Dataframe with XDR content """ + import gzip + import os + import pandas as pd + if decompress is None: decompress = path.endswith('.gz') - with open(path, 'rb') as inf: - buf = inf.read() - return from_xdr( - buf, decompress=decompress, na_values=na_values, - as_dataframe=as_dataframe - ) + fsize = os.stat(path).st_size + if fsize == 20: + return pd.DataFrame() + elif fsize < 20: + raise IOError('File likely failed to download.') + if decompress: + if decompress_inline: + inf = gzip.open(path) + else: + temppath = path.replace('.gz', '') + assert temppath != path + if not os.path.exists(temppath): + with gzip.open(path, 'rb') as inf: + with open(temppath, 'wb') as outf: + outf.write(inf.read()) + inf = open(temppath, 'rb') + else: + inf = open(path, 'rb') + outf = from_xdr( + inf, decompress=decompress, na_values=na_values, + as_dataframe=as_dataframe + ) + inf.close() + return outf -def from_xdr(buffer, na_values=None, decompress=False, as_dataframe=True): +def from_xdr(inf, na_values=None, decompress=False, as_dataframe=True): """ Currently supports profile, site and swath (v2.0). Each is in XDR format with a custom set of header rows in text format. The text header rows also @@ -49,13 +77,13 @@ def from_xdr(buffer, na_values=None, decompress=False, as_dataframe=True): Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + inf : file + Data file in XDR format with RSIG headers na_values : scalar Used to remove known missing values. decompress : bool - If True, decompress buffer. - If False, buffer is already decompressed (or was never compressed) + If True, decompress to temporary file. + If False, do not decompress to temporary file (was never compressed) as_dataframe : bool If True (default), return data as a pandas.Dataframe. If False, return a xarray.Dataset. Only subset and grid support @@ -66,59 +94,56 @@ def from_xdr(buffer, na_values=None, decompress=False, as_dataframe=True): df : pd.DataFrame Dataframe with XDR content """ - import gzip import numpy as np - if decompress: - buffer = gzip.decompress(buffer) - defspec = buffer[:40].decode().split('\n')[0].lower().strip() + inf.seek(0, 0) + defspec = inf.read(40).decode().split('\n')[0].lower().strip() + inf.seek(0, 0) if defspec.startswith('profile'): - df = from_profile(buffer) + df = from_profile(inf) elif defspec.startswith('site'): - df = from_site(buffer) + df = from_site(inf) elif defspec.startswith('point'): - df = from_point(buffer) + df = from_point(inf) elif defspec.startswith('swath'): - df = from_swath(buffer) + df = from_swath(inf) elif defspec.startswith('calipso'): - df = from_calipso(buffer) + df = from_calipso(inf) elif defspec.startswith('polygon'): - df = from_polygon(buffer) + df = from_polygon(inf) elif defspec.startswith('grid'): - df = from_grid(buffer, as_dataframe=as_dataframe) + df = from_grid(inf, as_dataframe=as_dataframe) elif defspec.startswith('subset'): - df = from_subset(buffer, as_dataframe=as_dataframe) + df = from_subset(inf, as_dataframe=as_dataframe) else: raise IOError(f'{defspec} not in profile, site, swath') if na_values is not None: - df = df.replace(na_values, np.nan) + df.replace(na_values, np.nan, inplace=True) return df -def from_polygon(buffer): +def from_polygon(bf): """ Currently supports Polygon (v1.0) which has 10 header rows in text format. The text header rows also describe the binary portion of the file, which includes three segments of data corresponding to shx, shp, and dbf files - embeded within the buffer. + embeded within the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers Returns ------- df : pd.DataFrame Dataframe with XDR content """ - import io import tempfile import geopandas as gpd - bf = io.BytesIO(buffer) for i in range(10): _l = bf.readline().decode().strip() if i == 0: @@ -138,26 +163,28 @@ def from_polygon(buffer): dbfe = dbfs + dbfn with tempfile.TemporaryDirectory() as td: filestem = f'{td}/{prefix}_{dates}_{datee}' + bf.seek(shxs, 0) with open(filestem + '.shx', 'wb') as shxf: - shxf.write(buffer[shxs:shxe]) + shxf.write(bf.read(shxe - shxs)) with open(filestem + '.shp', 'wb') as shpf: - shpf.write(buffer[shps:shpe]) + shpf.write(bf.read(shpe - shps)) with open(filestem + '.dbf', 'wb') as dbff: - dbff.write(buffer[dbfs:dbfe]) + dbff.write(bf.read(dbfe - dbfs)) outdf = gpd.read_file(filestem + '.shp') + outdf.crs = 4326 return outdf -def from_profile(buffer): +def from_profile(bf): """ Currently supports Profile (v2.0) which has 14 header rows in text format. The text header rows also describe the binary portion of the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers Returns ------- @@ -180,10 +207,7 @@ def from_profile(buffer): """ import numpy as np import pandas as pd - import xdrlib - import io - bf = io.BytesIO(buffer) for i in range(14): _l = bf.readline() if i == 0: @@ -195,24 +219,17 @@ def from_profile(buffer): elif i == 10: units = _l.decode().strip().split() - n = bf.tell() - up = xdrlib.Unpacker(buffer) - up.set_position(n) - - notes = [up.unpack_fstring(80).decode().strip() for i in range(nprof)] - longnpb = up.unpack_fstring(nprof * 8) - longnp = np.frombuffer(longnpb, dtype='>l') - sdn = up.get_position() + notes = [bf.read(80).decode().strip() for i in range(nprof)] + longnp = np.frombuffer(bf.read(nprof * 8), dtype='>l') # Read all values at once - # vals = np.frombuffer(buffer[sdn:], dtype='>d') dfs = [] - up.set_position(sdn) varwunits = [varkey + f'({units[i]})' for i, varkey in enumerate(varkeys)] for i, npoints in enumerate(longnp): nfloats = npoints * nvar - vals = np.array(up.unpack_farray(nfloats, up.unpack_double)).reshape( + vals = np.frombuffer(bf.read(nfloats * 8), dtype='>d').reshape( nvar, npoints ) + vals = vals.byteswap().view(vals.dtype.newbyteorder()) df = pd.DataFrame(dict(zip(varwunits, vals))) df['NOTE'] = notes[i] dfs.append(df) @@ -247,15 +264,15 @@ def from_profile(buffer): return df -def from_swath(buffer): +def from_swath(bf): """ Currently supports Swath (v2.0) which has 14 header rows in text format. The text header rows also describe the binary portion of the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers Returns ------- @@ -280,10 +297,7 @@ def from_swath(buffer): import numpy as np import pandas as pd - import xdrlib - import io - bf = io.BytesIO(buffer) for i in range(14): _l = bf.readline() if i == 0: @@ -299,34 +313,28 @@ def from_swath(buffer): assert (defspec == defspec) - n = bf.tell() - up = xdrlib.Unpacker(buffer) - up.set_position(n) - # MSB 64-bit integers (yyyydddhhmm) timestamps[scans] - nts = np.frombuffer(up.unpack_fstring(nscan * 8), dtype='>l') + nts = np.frombuffer(bf.read(nscan * 8), dtype='>l') # MSB 64-bit integers points[scans] - nps = np.frombuffer(up.unpack_fstring(nscan * 8), dtype='>l') - + nps = np.frombuffer(bf.read(nscan * 8), dtype='>l') infmt = '%Y%j%H%M' outfmt = '%Y-%m-%dT%H:%M:%S%z' timestamps = pd.to_datetime(nts, format=infmt, utc=True).strftime(outfmt) - sdn = up.get_position() # Read all values at once # IEEE-754 64-bit reals data_1[variables][points_1] ... # data_S[variables][points_S] dfs = [] - up.set_position(sdn) varwunits = [varkey + f'({units[i]})' for i, varkey in enumerate(varkeys)] # To-do # Switch from iterative unpacking to numpy.frombuffer, which is much faster # this requires some fancy indexing and complex repeats. for i, npoints in enumerate(nps): nfloats = npoints * nvar - vals = np.array(up.unpack_farray(nfloats, up.unpack_double)).reshape( + vals = np.frombuffer(bf.read(nfloats * 8), dtype='>d').reshape( nvar, npoints ) + vals = vals.byteswap().view(vals.dtype.newbyteorder()) df = pd.DataFrame(dict(zip(varwunits, vals))) df['Timestamp(UTC)'] = timestamps[i] dfs.append(df) @@ -344,15 +352,15 @@ def from_swath(buffer): return df -def from_site(buffer): +def from_site(bf): """ Currently supports Site (v2.0) which has 14 header rows in text format. The text header rows also describe the binary portion of the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers Returns ------- @@ -376,10 +384,7 @@ def from_site(buffer): """ import numpy as np import pandas as pd - import xdrlib - import io - bf = io.BytesIO(buffer) for i in range(13): _l = bf.readline() if i == 0: @@ -393,27 +398,20 @@ def from_site(buffer): elif i == 8: units = _l.decode().strip().split() - time = pd.date_range(stime, periods=nt, freq='H') - n = bf.tell() - up = xdrlib.Unpacker(buffer) - up.set_position(n) + time = pd.date_range(stime, periods=nt, freq='h') + notes = [bf.read(80).decode().strip() for i in range(nsite)] - notes = [up.unpack_fstring(80).decode().strip() for i in range(nsite)] - - nis = np.frombuffer(up.unpack_fstring(nsite * 4), dtype='>i') - xys = np.frombuffer(up.unpack_fstring(nsite * 8), dtype='>f').reshape( + nis = np.frombuffer(bf.read(nsite * 4), dtype='>i') + xys = np.frombuffer(bf.read(nsite * 8), dtype='>f').reshape( nsite, 2 ) - sdn = up.get_position() # Read all values at once - # vals = np.fromstring(buffer[sdn:], dtype='>d') - up.set_position(sdn) varwunits = [varkey + f'({units[i]})' for i, varkey in enumerate(varkeys)] - # Unpacking data using from buffer, which is much faster than iteratively + # Unpacking data using frombuffer, which is much faster than iteratively # calling xdr.unpack_farray - vals = np.frombuffer(buffer[sdn:], dtype='>f').reshape(1, nsite, nt) + vals = np.frombuffer(bf.read(), dtype='>f').reshape(1, nsite, nt) atimes = np.array(time, ndmin=1)[None, :].repeat(nsite, 0).ravel() anotes = np.array(notes)[:, None].repeat(nt, 1).T.ravel() astation = nis[:, None].repeat(nt, 1).T.ravel() @@ -458,15 +456,15 @@ def from_site(buffer): return df -def from_point(buffer): +def from_point(bf): """ Currently supports Point (v1.0) which has 12 header rows in text format. The text header rows also describe the binary portion of the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers Returns ------- @@ -488,10 +486,7 @@ def from_point(buffer): """ import numpy as np import pandas as pd - import xdrlib - import io - bf = io.BytesIO(buffer) for i in range(11): _l = bf.readline() if i == 0: @@ -506,15 +501,11 @@ def from_point(buffer): elif i == 8: units = _l.decode().strip().split() - n = bf.tell() - up = xdrlib.Unpacker(buffer) - up.set_position(n) - - notes = [up.unpack_fstring(80).decode().strip() for i in range(npoint)] + notes = [bf.read(80).decode().strip() for i in range(npoint)] - sdn = up.get_position() - # Use numpy to unpack from buffer becuase it is faster than unpack - vals = np.frombuffer(buffer[sdn:], dtype='>d').reshape(nvar, npoint) + # Use numpy to unpack frombuffer becuase it is faster than unpack + vals = np.frombuffer(bf.read(), dtype='>d').reshape(nvar, npoint) + vals = vals.byteswap().view(vals.dtype.newbyteorder()) varkeys = [ {'id': 'STATION'}.get(varkey, varkey).upper() for varkey in varkeys @@ -545,15 +536,15 @@ def from_point(buffer): return df -def from_calipso(buffer): +def from_calipso(bf): """ Currently supports Calipso (v1.0) which has 15 header rows in text format. The text header rows also describe the binary portion of the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers Returns ------- @@ -581,11 +572,8 @@ def from_calipso(buffer): """ import numpy as np import pandas as pd - import xdrlib - import io import xarray as xr - bf = io.BytesIO(buffer) headerlines = [] for i in range(15): _l = bf.readline().decode() @@ -605,22 +593,18 @@ def from_calipso(buffer): # bbox = [float(d) for d in _l.strip().split()] pass # not loading time because it is duplicative - n = bf.tell() - up = xdrlib.Unpacker(buffer) - up.set_position(n) - sdn = up.get_position() - stime = sdn + stime = bf.tell() etime = stime + nprof * 8 sbnd = etime ebnd = sbnd + (nprof * 4) * 8 sdims = ebnd edims = sdims + (nprof * 2) * 8 sdata = edims - # time = np.frombuffer(buffer[stime:etime], dtype='>l') - # bounds = np.frombuffer( - # buffer[sbnd:ebnd], dtype='>d' - # ).reshape(nprof, 2, 2) - dims = np.frombuffer(buffer[sdims:edims], dtype='>l').reshape(nprof, 2) + # time = np.frombuffer(bf.read(etime - stime), dtype='>l') + # bshape = [nprof, 2, 2] + # tbnds = np.frombuffer(bf.read(ebnd - sbnd), dtype='>d').reshape(*bshape) + bf.seek(sdims, 0) + dims = np.frombuffer(bf.read(edims - sdims), dtype='>l').reshape(nprof, 2) if ( not (dims[:, 1] == dims[0, 1]).all() ): @@ -636,7 +620,8 @@ def from_calipso(buffer): data = [] for iprof, (npoint, nlev) in enumerate(dims): edata = sdata + (3 * npoint + 2 * npoint * nlev) * 8 - vals = np.frombuffer(buffer[sdata:edata], dtype='>d') + vals = np.frombuffer(bf.read(edata - sdata), dtype='>d') + vals = vals.byteswap().view(vals.dtype.newbyteorder()) sd = 0 ed = sd + npoint * 3 ptimes, plons, plats = vals[sd:ed].reshape(3, npoint) @@ -670,15 +655,15 @@ def from_calipso(buffer): return df -def from_grid(buffer, as_dataframe=True): +def from_grid(bf, as_dataframe=True): """ Currently supports Grid (v1.0) which has 12 header rows in text format. The text header rows also describe the binary portion of the file. Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers as_dataframe : bool If True (default), return data as a pandas.Dataframe. If False, return a xarray.Dataset. @@ -710,10 +695,8 @@ def from_grid(buffer, as_dataframe=True): """ import numpy as np import pandas as pd - import io import xarray as xr - bf = io.BytesIO(buffer) headerlines = [] for i in range(12): _l = bf.readline().decode().strip() @@ -734,21 +717,15 @@ def from_grid(buffer, as_dataframe=True): # bbox = [float(d) for d in _l.strip().split()] pass # not loading time because it is duplicative - sdn = bf.tell() - # [rows][columns]: - slon = sdn - elon = slon + nrow * ncol * 8 - # [rows][columns]: - slat = elon - elat = slat + nrow * ncol * 8 - # [timesteps][variables][rows][columns]: - svar = elat - evar = svar + ntime * nvar * nrow * ncol * 8 - lon = np.frombuffer(buffer[slon:elon], dtype='>d').reshape(nrow, ncol) - lat = np.frombuffer(buffer[slat:elat], dtype='>d').reshape(nrow, ncol) - data = np.frombuffer(buffer[svar:evar], dtype='>d').reshape( - ntime, nvar, nrow, ncol - ) + nbytes = nrow * ncol * 8 + lon = np.frombuffer(bf.read(nbytes), dtype='>d').reshape(nrow, ncol) + lon = lon.byteswap().view(lon.dtype.newbyteorder()) + lat = np.frombuffer(bf.read(nbytes), dtype='>d').reshape(nrow, ncol) + lat = lat.byteswap().view(lat.dtype.newbyteorder()) + dshape = ntime, nvar, nrow, ncol + nbytes = np.prod(dshape) * 8 + data = np.frombuffer(bf.read(nbytes), dtype='>d').reshape(*dshape) + data = data.byteswap().view(data.dtype.newbyteorder()) ds = xr.Dataset() ds.attrs['rsig_program'] = rsig_program dt = pd.to_timedelta('3600s') @@ -781,7 +758,7 @@ def from_grid(buffer, as_dataframe=True): return ds -def from_subset(buffer, as_dataframe=True): +def from_subset(bf, as_dataframe=True): """ Currently supports Subset (v9.0) which has 17 header rows in text format. The text header rows also describe the binary portion of the file. This @@ -792,8 +769,8 @@ def from_subset(buffer, as_dataframe=True): Arguments --------- - buffer : bytes - Data buffer in XDR format with RSIG headers + bf : file + File opened in byte read in XDR format with RSIG headers as_dataframe : bool If True (default), return data as a pandas.Dataframe. If False, return a xarray.Dataset. @@ -832,12 +809,10 @@ def from_subset(buffer, as_dataframe=True): """ import numpy as np import pandas as pd - import io import xarray as xr from .utils import get_proj4 import pyproj - bf = io.BytesIO(buffer) headerlines = [] for i in range(17): _l = bf.readline().decode().strip() @@ -868,6 +843,12 @@ def from_subset(buffer, as_dataframe=True): projparts = np.array(_l.split(), dtype='d') vgparts = np.array(projparts[-nlay - 3:], dtype='f') gridparts = projparts[:-len(vgparts)] + elif i == 16: + is64 = '64-bit' in _l + if is64: + dtval = '>d' + else: + dtval = '>f' vgprops = {} vgprops['VGTYP'] = np.int32(vgparts[0]) @@ -893,6 +874,8 @@ def from_subset(buffer, as_dataframe=True): projattrs['P_GAM'] = crsprops['lon_0'] projattrs['XCENT'] = crsprops['lon_0'] projattrs['YCENT'] = crsprops['lat_0'] + elif 'lonlat' in crshdr: + projattrs['GDTYP'] = 1 else: raise KeyError(f'Need implement {crshdr}') # projattrs['GDTYP'] = 7 # merc @@ -900,8 +883,7 @@ def from_subset(buffer, as_dataframe=True): proj4 = get_proj4(projattrs, earth_radius=earth_radius) proj = pyproj.Proj(proj4) - sdn = bf.tell() - data = np.frombuffer(buffer[sdn:], dtype='>f').reshape( + data = np.frombuffer(bf.read(), dtype=dtval).reshape( nvar, ntime, nlay, nrow, ncol ) ds = xr.Dataset() @@ -940,7 +922,7 @@ def from_subset(buffer, as_dataframe=True): ds[vk] = dims, vals, attrs if as_dataframe: - df = ds.astype('f').to_dataframe() + df = ds.astype(dtval[1:]).to_dataframe() time = df.index.get_level_values('TSTEP') df['Timestamp(UTC)'] = time.strftime('%Y-%m-%dT%H:%M:%S+0000') keepcols = ['Timestamp(UTC)', 'LONGITUDE', 'LATITUDE'] + varkeys