SECOORA Notebook 1

Fetch Sea Surface Height time-series data

This notebook fetches weekly time-series of all the SECOORA observations and models available in the NGDC and SECOORA THREDDS catalogs.


In [1]:
import time

start_time = time.time()

Save configuration


In [2]:
import os
try:
    import cPickle as pickle
except ImportError:
    import pickle

import iris
import cf_units
from datetime import datetime
from utilities import CF_names, fetch_range, start_log

# 1-week start of data.
kw = dict(start=datetime(2014, 7, 1, 12), days=6)
start, stop = fetch_range(**kw)

# SECOORA region (NC, SC GA, FL).
bbox = [-87.40, 24.25, -74.70, 36.70]

# CF-names.
sos_name = 'water_surface_height_above_reference_datum'
name_list = CF_names[sos_name]

# Units.
units = cf_units.Unit('meters')

# Logging.
run_name = '{:%Y-%m-%d}'.format(stop)
log = start_log(start, stop, bbox)

# SECOORA models.
secoora_models = ['SABGOM', 'USEAST',
                  'USF_ROMS', 'USF_SWAN', 'USF_FVCOM']

# Config.
fname = os.path.join(run_name, 'config.pkl')
config = dict(start=start,
              stop=stop,
              bbox=bbox,
              name_list=name_list,
              units=units,
              run_name=run_name,
              secoora_models=secoora_models)

with open(fname,'wb') as f:
    pickle.dump(config, f)

In [3]:
from owslib import fes
from utilities import fes_date_filter

kw = dict(wildCard='*',
          escapeChar='\\',
          singleChar='?',
          propertyname='apiso:AnyText')

or_filt = fes.Or([fes.PropertyIsLike(literal=('*%s*' % val), **kw)
                  for val in name_list])

# Exclude ROMS Averages and History files.
not_filt = fes.Not([fes.PropertyIsLike(literal='*Averages*', **kw)])

begin, end = fes_date_filter(start, stop)
filter_list = [fes.And([fes.BBox(bbox), begin, end, or_filt, not_filt])]

In [4]:
from owslib.csw import CatalogueServiceWeb

endpoint = 'http://www.ngdc.noaa.gov/geoportal/csw'
csw = CatalogueServiceWeb(endpoint, timeout=60)
csw.getrecords2(constraints=filter_list, maxrecords=1000, esn='full')

fmt = '{:*^64}'.format
log.info(fmt(' Catalog information '))
log.info("URL: {}".format(endpoint))
log.info("CSW version: {}".format(csw.version))
log.info("Number of datasets available: {}".format(len(csw.records.keys())))

In [5]:
from utilities import service_urls

dap_urls = service_urls(csw.records, service='odp:url')
sos_urls = service_urls(csw.records, service='sos:url')

log.info(fmt(' CSW '))
for rec, item in csw.records.items():
    log.info('{}'.format(item.title))

log.info(fmt(' SOS '))
for url in sos_urls:
    log.info('{}'.format(url))

log.info(fmt(' DAP '))
for url in dap_urls:
    log.info('{}.html'.format(url))

In [6]:
from utilities import is_station

# Filter out some station endpoints.
non_stations = []
for url in dap_urls:
    try:
        if not is_station(url):
            non_stations.append(url)
    except RuntimeError as e:
        log.warn("Could not access URL {}. {!r}".format(url, e))

dap_urls = non_stations

log.info(fmt(' Filtered DAP '))
for url in dap_urls:
    log.info('{}.html'.format(url))

Add SECOORA models and observations


In [7]:
from utilities import titles, fix_url

for secoora_model in secoora_models:
    if titles[secoora_model] not in dap_urls:
        log.warning('{} not in the NGDC csw'.format(secoora_model))
        dap_urls.append(titles[secoora_model])

# NOTE: USEAST is not archived at the moment!
# https://github.com/ioos/secoora/issues/173
dap_urls = [fix_url(start, url) if
            'SABGOM' in url else url for url in dap_urls]

In [8]:
import warnings
from iris.exceptions import CoordinateNotFoundError, ConstraintMismatchError

from utilities import (TimeoutException, secoora_buoys,
                       quick_load_cubes, proc_cube)

urls = list(secoora_buoys())
buoys = dict()
if not urls:
    raise ValueError("Did not find any SECOORA buoys!")

for url in urls:
    try:
        with warnings.catch_warnings():
            warnings.simplefilter("ignore")  # Suppress iris warnings.
            kw = dict(bbox=bbox, time=(start, stop), units=units)
            cubes = quick_load_cubes(url, name_list)
            cubes = [proc_cube(cube, **kw) for cube in cubes]
        buoy = url.split('/')[-1].split('.nc')[0]
        if len(cubes) == 1:
            buoys.update({buoy: cubes[0]})
        else:
            #[buoys.update({'{}_{}'.format(buoy, k): cube}) for
            # k, cube in list(enumerate(cubes))]
            # FIXME: For now I am choosing the first sensor.
            buoys.update({buoy: cubes[0]})
    except (RuntimeError, ValueError, TimeoutException,
            ConstraintMismatchError, CoordinateNotFoundError) as e:
        log.warning('Cannot get cube for: {}\n{}'.format(url, e))

In [9]:
from pyoos.collectors.coops.coops_sos import CoopsSos

collector = CoopsSos()

datum = 'NAVD'
collector.set_datum(datum)

collector.end_time = stop
collector.start_time = start
collector.variables = [sos_name]

ofrs = collector.server.offerings
title = collector.server.identification.title
log.info(fmt(' Collector offerings '))
log.info('{}: {} offerings'.format(title, len(ofrs)))

In [10]:
from pandas import read_csv
from utilities import sos_request

params = dict(observedProperty=sos_name,
              eventTime=start.strftime('%Y-%m-%dT%H:%M:%SZ'),
              featureOfInterest='BBOX:{0},{1},{2},{3}'.format(*bbox),
              offering='urn:ioos:network:NOAA.NOS.CO-OPS:WaterLevelActive')

uri = 'http://opendap.co-ops.nos.noaa.gov/ioos-dif-sos/SOS'
url = sos_request(uri, **params)
observations = read_csv(url)

log.info('SOS URL request: {}'.format(url))

Clean the DataFrame


In [11]:
from utilities import get_coops_metadata, to_html

columns = {'datum_id': 'datum',
           'sensor_id': 'sensor',
           'station_id': 'station',
           'latitude (degree)': 'lat',
           'longitude (degree)': 'lon',
           'vertical_position (m)': 'height',
           'water_surface_height_above_reference_datum (m)': sos_name}

observations.rename(columns=columns, inplace=True)

observations['datum'] = [s.split(':')[-1] for s in observations['datum']]

observations['sensor'] = [s.split(':')[-1] for s in observations['sensor']]
observations['station'] = [s.split(':')[-1] for s in observations['station']]
observations['name'] = [get_coops_metadata(s)[0] for s in observations['station']]

observations.set_index('name', inplace=True)
to_html(observations.head())


Out[11]:
station sensor lat lon date_time water_surface_height_above_reference_datum datum height sigma quality_flags
name
Duck, NC 8651370 A1 36.1831 -75.7467 2014-07-01T12:00:00Z 0.535 MLLW 5.663 0.125 0;0;0;0
Oregon Inlet Marina, NC 8652587 A1 35.7942 -75.5481 2014-07-01T12:00:00Z 0.219 MLLW 0.788 0.001 0;0;0;0
USCG Station Hatteras, NC 8654467 A1 35.2086 -75.7042 2014-07-01T12:00:00Z 0.179 MLLW 8.345 0.001 0;0;0;0
Beaufort, NC 8656483 A1 34.7200 -76.6700 2014-07-01T12:00:00Z 0.552 MLLW 0.562 0.002 0;0;0;0
Wilmington, NC 8658120 A1 34.2275 -77.9536 2014-07-01T12:00:00Z 0.183 MLLW 0.747 0.006 0;0;0;0

In [12]:
from pandas import DataFrame
from utilities import secoora2df

if buoys:
    secoora_observations = secoora2df(buoys, sos_name)
    to_html(secoora_observations.head())
else:
    secoora_observations = DataFrame()

In [13]:
from pandas import concat


all_obs = concat([observations, secoora_observations], axis=0)
to_html(concat([all_obs.head(2), all_obs.tail(2)]))


Out[13]:
date_time datum height lat lon quality_flags sensor sigma station water_surface_height_above_reference_datum
name
Duck, NC 2014-07-01T12:00:00Z MLLW 5.663 36.183100 -75.746700 0;0;0;0 A1 0.125 8651370 0.535000
Oregon Inlet Marina, NC 2014-07-01T12:00:00Z MLLW 0.788 35.794200 -75.548100 0;0;0;0 A1 0.001 8652587 0.219000
Binney Dock station 2014-00-01T12:00:00Z NaN NaN 27.467546 -80.300850 NaN NA NaN fldep.binneydock. -0.215533
Gordon River Inlet station 2014-00-01T12:00:00Z NaN NaN 26.093140 -81.798141 NaN NA NaN fldep.gordonriverinlet. -0.054746

Uniform 6-min time base for model/data comparison


In [14]:
from owslib.ows import ExceptionReport
from utilities import pyoos2df, save_timeseries

iris.FUTURE.netcdf_promote = True

log.info(fmt(' Observations '))
outfile = '{}-OBS_DATA.nc'.format(run_name)
outfile = os.path.join(run_name, outfile)

log.info(fmt(' Downloading to file {} '.format(outfile)))
data, bad_station = dict(), []
col = 'water_surface_height_above_reference_datum (m)'
for station in observations.index:
    station_code = observations['station'][station]
    try:
        df = pyoos2df(collector, station_code, df_name=station)
        data.update({station_code: df[col]})
    except ExceptionReport as e:
        bad_station.append(station_code)
        log.warning("[{}] {}:\n{}".format(station_code, station, e))
obs_data = DataFrame.from_dict(data)

Split good and bad vertical datum stations.


In [15]:
pattern = '|'.join(bad_station)
if pattern:
    all_obs['bad_station'] = all_obs.station.str.contains(pattern)
    observations = observations[~observations.station.str.contains(pattern)]
else:
    all_obs['bad_station'] = ~all_obs.station.str.contains(pattern)

# Save updated `all_obs.csv`.
fname = '{}-all_obs.csv'.format(run_name)
fname = os.path.join(run_name, fname)
all_obs.to_csv(fname)

comment = "Several stations from http://opendap.co-ops.nos.noaa.gov"
kw = dict(longitude=observations.lon,
          latitude=observations.lat,
          station_attr=dict(cf_role="timeseries_id"),
          cube_attr=dict(featureType='timeSeries',
                         Conventions='CF-1.6',
                         standard_name_vocabulary='CF-1.6',
                         cdm_data_type="Station",
                         comment=comment,
                         datum=datum,
                         url=url))

save_timeseries(obs_data, outfile=outfile,
                standard_name=sos_name, **kw)

to_html(obs_data.head())


Out[15]:
8651370 8652587 8658163 8661070 8662245 8665530 8720030 8720218 8720219 8720226 8720357 8720503 8720625 8721604 8722670 8723214 8723970 8724580 8725110 8725520 8726384 8727520 8728690 8729108 8729840
date_time
2014-07-01 12:00:00 -0.132 0.004 0.018 -0.041 -0.122 0.018 -0.376 -0.262 -0.320 -0.133 0.071 0.126 0.242 -0.160 -0.126 -0.290 -0.099 -0.220 -0.127 -0.005 -0.057 0.067 0.131 0.044 0.106
2014-07-01 12:06:00 -0.102 0.007 0.044 -0.003 -0.096 0.049 -0.347 -0.228 -0.313 -0.132 0.068 0.120 0.236 -0.144 -0.111 -0.290 -0.103 -0.218 -0.138 -0.002 -0.057 0.051 0.146 0.055 0.113
2014-07-01 12:12:00 -0.073 0.010 0.067 0.024 -0.070 0.083 -0.312 -0.203 -0.304 -0.130 0.067 0.117 0.229 -0.121 -0.076 -0.280 -0.108 -0.218 -0.165 0.000 -0.054 0.029 0.157 0.055 0.121
2014-07-01 12:18:00 -0.068 0.016 0.092 0.051 -0.045 0.118 -0.278 -0.185 -0.293 -0.128 0.063 0.109 0.221 -0.130 -0.067 -0.263 -0.112 -0.218 -0.161 0.001 -0.055 0.007 0.165 0.054 0.121
2014-07-01 12:24:00 -0.013 0.021 0.091 0.085 -0.019 0.153 -0.243 -0.161 -0.281 -0.125 0.066 0.108 0.213 -0.092 -0.048 -0.244 -0.115 -0.206 -0.167 0.002 -0.058 -0.010 0.165 0.053 0.123

SECOORA Observations


In [16]:
import numpy as np
from pandas import DataFrame

def extract_series(cube, station):
    time = cube.coord(axis='T')
    date_time = time.units.num2date(cube.coord(axis='T').points)
    data = cube.data
    return DataFrame(data, columns=[station], index=date_time)


if buoys:
    secoora_obs_data = []
    for station, cube in list(buoys.items()):
        df = extract_series(cube, station)
        secoora_obs_data.append(df)
    # Some series have duplicated times!
    kw = dict(subset='index', take_last=True)
    secoora_obs_data = [obs.reset_index().drop_duplicates(**kw).set_index('index') for
                        obs in secoora_obs_data]
    secoora_obs_data = concat(secoora_obs_data, axis=1)
else:
    secoora_obs_data = DataFrame()

These buoys need some QA/QC before saving


In [17]:
from utilities.qaqc import filter_spikes, threshold_series

if buoys:
    secoora_obs_data.apply(threshold_series, args=(0, 40))
    secoora_obs_data.apply(filter_spikes)

    # Interpolate to the same index as SOS.
    index = obs_data.index
    kw = dict(method='time', limit=30)
    secoora_obs_data = secoora_obs_data.reindex(index).interpolate(**kw).ix[index]

    log.info(fmt(' SECOORA Observations '))
    fname = '{}-SECOORA_OBS_DATA.nc'.format(run_name)
    fname = os.path.join(run_name, fname)

    log.info(fmt(' Downloading to file {} '.format(fname)))

    url = "http://129.252.139.124/thredds/catalog_platforms.html"
    comment = "Several stations {}".format(url)
    kw = dict(longitude=secoora_observations.lon,
              latitude=secoora_observations.lat,
              station_attr=dict(cf_role="timeseries_id"),
              cube_attr=dict(featureType='timeSeries',
                             Conventions='CF-1.6',
                             standard_name_vocabulary='CF-1.6',
                             cdm_data_type="Station",
                             comment=comment,
                             url=url))

    save_timeseries(secoora_obs_data, outfile=fname,
                    standard_name=sos_name, **kw)

    to_html(secoora_obs_data.head())

Loop discovered models and save the nearest time-series


In [18]:
from iris.exceptions import (CoordinateNotFoundError, ConstraintMismatchError,
                             MergeError)

from utilities import time_limit, get_model_name, is_model

log.info(fmt(' Models '))
cubes = dict()

with warnings.catch_warnings():
    warnings.simplefilter("ignore")  # Suppress iris warnings.
    for k, url in enumerate(dap_urls):
        log.info('\n[Reading url {}/{}]: {}'.format(k+1, len(dap_urls), url))
        try:
            with time_limit(60*5):
                cube = quick_load_cubes(url, name_list, callback=None, strict=True)
                if is_model(cube):
                    cube = proc_cube(cube, bbox=bbox, time=(start, stop), units=units)
                else:
                    log.warning("[Not model data]: {}".format(url))
                    continue
                mod_name, model_full_name = get_model_name(cube, url)
                cubes.update({mod_name: cube})
        except (TimeoutException, RuntimeError, ValueError,
                ConstraintMismatchError, CoordinateNotFoundError,
                IndexError) as e:
            log.warning('Cannot get cube for: {}\n{}'.format(url, e))

In [19]:
from iris.pandas import as_series

from utilities import (make_tree, get_nearest_water,
                       add_station, ensure_timeseries)

for mod_name, cube in cubes.items():
    fname = '{}-{}.nc'.format(run_name, mod_name)
    fname = os.path.join(run_name, fname)
    log.info(fmt(' Saving to file {} '.format(fname)))
    try:
        tree, lon, lat = make_tree(cube)
    except CoordinateNotFoundError as e:
        log.warning('Cannot create KDTree for: {}'.format(mod_name))
        continue
    # Get model series at observed locations.
    raw_series = dict()
    for station, obs in all_obs.iterrows():
        try:
            kw = dict(k=10, max_dist=0.04, min_var=0.01)
            args = cube, tree, obs.lon, obs.lat
            series, dist, idx = get_nearest_water(*args, **kw)
        except ValueError as e:
            status = "No Data"
            log.info('[{}] {}'.format(status, obs.name))
            continue
        except RuntimeError as e:
            status = "Failed"
            log.info('[{}] {}. ({})'.format(status, obs.name, e.message))
            continue
        if not series:
            status = "Land   "
        else:
            raw_series.update({obs['station']: series})
            series = as_series(series)
            status = "Water  "

        log.info('[{}] {}'.format(status, obs.name))

    if raw_series:  # Save cube.
        for station, cube in raw_series.items():
            cube = add_station(cube, station)
        try:
            cube = iris.cube.CubeList(raw_series.values()).merge_cube()
        except MergeError as e:
            log.warning(e)

        ensure_timeseries(cube)
        iris.save(cube, fname)
        del cube

    log.info(fmt('Finished processing {}\n'.format(mod_name)))

In [20]:
from utilities import nbviewer_link, make_qr

make_qr(nbviewer_link('00-fetch_data.ipynb'))


Out[20]:

In [21]:
elapsed = time.time() - start_time
log.info('{:.2f} minutes'.format(elapsed/60.))
log.info('EOF')

with open('{}/log.txt'.format(run_name)) as f:
    print(f.read())


11:29:33 INFO: ************Saving data inside directory 2014-07-07*************
11:29:33 INFO: *********************** Run information ************************
11:29:33 INFO: Run date: 2016-01-31 14:29:33
11:29:33 INFO: Download start: 2014-07-01 12:00:00
11:29:33 INFO: Download stop: 2014-07-07 12:00:00
11:29:33 INFO: Bounding box: -87.40, 24.25,-74.70, 36.70
11:29:33 INFO: *********************** Software version ***********************
11:29:33 INFO: Iris version: 1.9.1
11:29:33 INFO: owslib version: 0.10.3
11:29:33 INFO: pyoos version: 0.7.0
11:29:39 INFO: ********************* Catalog information **********************
11:29:39 INFO: URL: http://www.ngdc.noaa.gov/geoportal/csw
11:29:39 INFO: CSW version: 2.0.2
11:29:39 INFO: Number of datasets available: 22
11:29:39 INFO: ***************************** CSW ******************************
11:29:39 INFO: USF FVCOM - Nowcast Aggregation
11:29:39 INFO: ROMS/TOMS 3.0 - New Floria Shelf Application
11:29:39 INFO: COAWST Forecast System : USGS : US East Coast and Gulf of Mexico (Experimental)
11:29:39 INFO: ROMS ESPRESSO Real-Time Operational IS4DVAR Forecast System Version 2 (NEW) 2013-present FMRC History
11:29:39 INFO: NOAA.NOS.CO-OPS SOS
11:29:39 INFO: HYbrid Coordinate Ocean Model (HYCOM): Global
11:29:39 INFO: ESTOFS Storm Surge Model - Atlantic - v1.0.0 - NOAA - NCEP - ADCIRC
11:29:39 INFO: fldep.bingslanding.
11:29:39 INFO: fldep.binneydock.
11:29:39 INFO: fldep.gordonriverinlet.
11:29:39 INFO: fldep.melbourne.
11:29:39 INFO: fldep.naplesbay.
11:29:39 INFO: fldep.poncedeleonsouth.
11:29:39 INFO: fldep.redbaypoint.
11:29:39 INFO: fldep.stlucieinlet.
11:29:39 INFO: fldep.tolomatoriver.
11:29:39 INFO: fldep.verobeach.
11:29:39 INFO: usf.apk.ngwlms
11:29:39 INFO: usf.bcp.ngwlms
11:29:39 INFO: usf.fhp.ngwlms
11:29:39 INFO: usf.shp.ngwlms
11:29:39 INFO: usf.tas.ngwlms
11:29:39 INFO: ***************************** SOS ******************************
11:29:39 INFO: http://opendap.co-ops.nos.noaa.gov/ioos-dif-sos/SOS?service=SOS&request=GetCapabilities&acceptVersions=1.0.0
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.bingslanding..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.binneydock..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.gordonriverinlet..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.melbourne..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.naplesbay..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.poncedeleonsouth..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.redbaypoint..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.stlucieinlet..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.tolomatoriver..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/fldep.verobeach..nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/usf.apk.ngwlms.nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/usf.bcp.ngwlms.nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/usf.fhp.ngwlms.nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/usf.shp.ngwlms.nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: http://tds.secoora.org/thredds/sos/usf.tas.ngwlms.nc?service=SOS&version=1.0.0&request=GetCapabilities
11:29:39 INFO: ***************************** DAP ******************************
11:29:39 INFO: http://crow.marine.usf.edu:8080/thredds/dodsC/FVCOM-Nowcast-Agg.nc.html
11:29:39 INFO: http://crow.marine.usf.edu:8080/thredds/dodsC/WFS_ROMS_NF_model/USF_Ocean_Circulation_Group_West_Florida_Shelf_Daily_ROMS_Nowcast_Forecast_Model_Data_best.ncd.html
11:29:39 INFO: http://geoport-dev.whoi.edu/thredds/dodsC/estofs/atlantic.html
11:29:39 INFO: http://geoport.whoi.edu/thredds/dodsC/coawst_4/use/fmrc/coawst_4_use_best.ncd.html
11:29:39 INFO: http://oos.soest.hawaii.edu/thredds/dodsC/pacioos/hycom/global.html
11:29:39 INFO: http://tds.marine.rutgers.edu/thredds/dodsC/roms/espresso/2013_da/his/ESPRESSO_Real-Time_v2_History_Best.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.bingslanding..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.binneydock..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.gordonriverinlet..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.melbourne..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.naplesbay..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.poncedeleonsouth..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.redbaypoint..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.stlucieinlet..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.tolomatoriver..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/fldep.verobeach..nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/usf.apk.ngwlms.nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/usf.bcp.ngwlms.nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/usf.fhp.ngwlms.nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/usf.shp.ngwlms.nc.html
11:29:39 INFO: http://tds.secoora.org/thredds/dodsC/usf.tas.ngwlms.nc.html
11:30:49 INFO: ************************* Filtered DAP *************************
11:30:49 INFO: http://crow.marine.usf.edu:8080/thredds/dodsC/FVCOM-Nowcast-Agg.nc.html
11:30:49 INFO: http://crow.marine.usf.edu:8080/thredds/dodsC/WFS_ROMS_NF_model/USF_Ocean_Circulation_Group_West_Florida_Shelf_Daily_ROMS_Nowcast_Forecast_Model_Data_best.ncd.html
11:30:49 INFO: http://geoport-dev.whoi.edu/thredds/dodsC/estofs/atlantic.html
11:30:49 INFO: http://geoport.whoi.edu/thredds/dodsC/coawst_4/use/fmrc/coawst_4_use_best.ncd.html
11:30:49 INFO: http://oos.soest.hawaii.edu/thredds/dodsC/pacioos/hycom/global.html
11:30:49 INFO: http://tds.marine.rutgers.edu/thredds/dodsC/roms/espresso/2013_da/his/ESPRESSO_Real-Time_v2_History_Best.html
11:30:49 WARNING: SABGOM not in the NGDC csw
11:30:49 WARNING: USEAST not in the NGDC csw
11:30:49 WARNING: USF_SWAN not in the NGDC csw
11:30:55 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/fit.sispnj.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/fit.sispnj.met.nc.
11:31:02 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c10.imet.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c10.imet.nc.
11:31:06 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.nfb.ngwlms.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.nfb.ngwlms.nc.
11:31:21 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c21.weatherpak.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c21.weatherpak.nc.
11:31:40 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c10.mcat.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c10.mcat.nc.
11:31:54 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/c10_salinity_water_temp.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/c10_salinity_water_temp.nc.
11:32:12 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/QC_C10_Temp_full.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/QC_C10_Temp_full.nc.
11:32:22 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/QC_C10_Sal_full.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/QC_C10_Sal_full.nc.
11:32:25 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c12.mcat.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c12.mcat.nc.
11:32:28 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c13.mcat.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c13.mcat.nc.
11:32:30 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c10.mcat_2011.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c10.mcat_2011.nc.
11:32:33 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c12.mcat_2011.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c12.mcat_2011.nc.
11:32:37 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/usf.c13.mcat_2011.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/usf.c13.mcat_2011.nc.
11:32:43 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/carocoops.sun2.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/carocoops.sun2.buoy.nc.
11:32:49 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/carocoops.frp2.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/carocoops.frp2.buoy.nc.
11:32:57 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/carocoops.cap2.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/carocoops.cap2.buoy.nc.
11:33:07 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/cormp.ilm3.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/cormp.ilm3.buoy.nc.
11:33:18 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/cormp.ilm2.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/cormp.ilm2.buoy.nc.
11:33:20 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/cormp.ilm1.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/cormp.ilm1.buoy.nc.
11:33:25 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/cormp.lej3.buoy.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/cormp.lej3.buoy.nc.
11:33:31 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/sccf.gulfofmexico.wq.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/sccf.gulfofmexico.wq.nc.
11:33:36 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/sccf.shellpoint.wq.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/sccf.shellpoint.wq.nc.
11:33:42 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/sccf.redfishpass.wq.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/sccf.redfishpass.wq.nc.
11:33:47 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/sccf.tarponbay.wq.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/sccf.tarponbay.wq.nc.
11:33:52 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/sccf.fortmyers.wq.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/sccf.fortmyers.wq.nc.
11:34:19 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/fldep.redbaypoint..nc
istart must be different from istop! Got istart 43 and  istop 43
11:35:44 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/lbhmc.2ndave.pier.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/lbhmc.2ndave.pier.nc.
11:35:51 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/lbhmc.cherrygrove.pier.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/lbhmc.cherrygrove.pier.nc.
11:36:01 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/lbhmc.apachepier.pier.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/lbhmc.apachepier.pier.nc.
11:36:06 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.wiwf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.wiwf1.met.nc.
11:36:11 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.lbrf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.lbrf1.met.nc.
11:36:16 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.bobf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.bobf1.met.nc.
11:36:21 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.trrf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.trrf1.met.nc.
11:36:27 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.wwef1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.wwef1.met.nc.
11:36:31 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.lrif1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.lrif1.met.nc.
11:36:37 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.bwsf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.bwsf1.met.nc.
11:36:42 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.pkyf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.pkyf1.met.nc.
11:36:47 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.lmdf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.lmdf1.met.nc.
11:36:53 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.cnbf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.cnbf1.met.nc.
11:36:58 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.hcef1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.hcef1.met.nc.
11:37:03 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.jkyf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.jkyf1.met.nc.
11:37:09 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.wrbf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.wrbf1.met.nc.
11:37:14 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.gbif1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.gbif1.met.nc.
11:37:20 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.ppta1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.ppta1.met.nc.
11:37:25 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.bdvf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.bdvf1.met.nc.
11:37:30 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.lrkf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.lrkf1.met.nc.
11:37:35 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.bnkf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.bnkf1.met.nc.
11:37:41 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.gbtf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.gbtf1.met.nc.
11:37:46 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.tcvf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.tcvf1.met.nc.
11:37:51 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.canf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.canf1.met.nc.
11:37:57 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.lbsf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.lbsf1.met.nc.
11:38:03 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.mukf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.mukf1.met.nc.
11:38:09 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.dkkf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.dkkf1.met.nc.
11:38:14 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/enp.cwaf1.met.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/enp.cwaf1.met.nc.
11:38:26 WARNING: Cannot get cube for: http://129.252.139.124/thredds/dodsC/fau.lobo.1.nc
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://129.252.139.124/thredds/dodsC/fau.lobo.1.nc.
11:38:31 INFO: ********************* Collector offerings **********************
11:38:31 INFO: NOAA.NOS.CO-OPS SOS: 1075 offerings
11:38:33 INFO: SOS URL request: http://opendap.co-ops.nos.noaa.gov/ioos-dif-sos/SOS?eventTime=2014-07-01T12%3A00%3A00Z&service=SOS&offering=urn%3Aioos%3Anetwork%3ANOAA.NOS.CO-OPS%3AWaterLevelActive&request=GetObservation&version=1.0.0&responseFormat=text%2Fcsv&featureOfInterest=BBOX%3A-87.4%2C24.25%2C-74.7%2C36.7&observedProperty=water_surface_height_above_reference_datum
11:40:00 INFO: ************************* Observations *************************
11:40:00 INFO: **** Downloading to file 2014-07-07/2014-07-07-OBS_DATA.nc *****
11:40:01 WARNING: /home/filipe/miniconda3/envs/secoora-skill/lib/python2.7/site-packages/utilities/secoora.py:693: FutureWarning: the 'cols' keyword is deprecated, use 'subset' instead
  df = df.drop_duplicates(cols='date_time').set_index('date_time')

11:40:02 WARNING: [8654467] USCG Station Hatteras, NC:
'Wrong Datum for this station: The correct Datum values are: MHHW, MHW, MTL, MSL, MLW, MLLW, STND'
11:40:03 WARNING: [8656483] Beaufort, NC:
'Wrong Datum for this station: The correct Datum values are: MHHW, MHW, MTL, MSL, MLW, MLLW, STND'
11:40:03 WARNING: [8658120] Wilmington, NC:
'Wrong Datum for this station: The correct Datum values are: MHHW, MHW, MTL, MSL, MLW, MLLW, STND'
11:41:23 WARNING: [8726520] St Petersburg, FL:
'Wrong Datum for this station: The correct Datum values are: MHHW, MHW, MTL, MSL, MLW, MLLW, STND'
11:41:23 WARNING: [8726607] Old Port Tampa, FL:
'Wrong Datum for this station: The correct Datum values are: MHHW, MHW, MTL, MSL, MLW, MLLW, STND'
11:41:34 WARNING: [8729210] Panama City Beach, FL:
'Wrong Datum for this station: The correct Datum values are: MHHW, MHW, MTL, MSL, MLW, MLLW, STND'
11:41:43 WARNING: /home/filipe/miniconda3/envs/secoora-skill/lib/python2.7/site-packages/iris/fileformats/netcdf.py:1786: UserWarning: NetCDF default saving behaviour currently assigns the outermost dimensions to unlimited. This behaviour is to be deprecated, in favour of no automatic assignment. To switch to the new behaviour, set iris.FUTURE.netcdf_no_unlimited to True.
  warnings.warn(msg)

11:41:43 WARNING: /home/filipe/miniconda3/envs/secoora-skill/lib/python2.7/site-packages/ipykernel/__main__.py:19: FutureWarning: the take_last=True keyword is deprecated, use keep='last' instead

11:41:43 INFO: ********************* SECOORA Observations *********************
11:41:43 INFO:  Downloading to file 2014-07-07/2014-07-07-SECOORA_OBS_DATA.nc *
11:41:43 INFO: **************************** Models ****************************
11:41:43 INFO: 
[Reading url 1/9]: http://crow.marine.usf.edu:8080/thredds/dodsC/FVCOM-Nowcast-Agg.nc
11:41:58 INFO: 
[Reading url 2/9]: http://crow.marine.usf.edu:8080/thredds/dodsC/WFS_ROMS_NF_model/USF_Ocean_Circulation_Group_West_Florida_Shelf_Daily_ROMS_Nowcast_Forecast_Model_Data_best.ncd
11:42:05 INFO: 
[Reading url 3/9]: http://geoport-dev.whoi.edu/thredds/dodsC/estofs/atlantic
11:42:30 INFO: 
[Reading url 4/9]: http://geoport.whoi.edu/thredds/dodsC/coawst_4/use/fmrc/coawst_4_use_best.ncd
11:43:03 INFO: 
[Reading url 5/9]: http://oos.soest.hawaii.edu/thredds/dodsC/pacioos/hycom/global
11:43:06 INFO: 
[Reading url 6/9]: http://tds.marine.rutgers.edu/thredds/dodsC/roms/espresso/2013_da/his/ESPRESSO_Real-Time_v2_History_Best
11:43:15 INFO: 
[Reading url 7/9]: http://omgarch1.meas.ncsu.edu:8080/thredds/dodsC/fmrc/sabgom/SABGOM_Forecast_Model_Run_Collection_best.ncd
11:43:26 INFO: 
[Reading url 8/9]: http://omgsrv1.meas.ncsu.edu:8080/thredds/dodsC/fmrc/us_east/US_East_Forecast_Model_Run_Collection_best.ncd
11:43:44 WARNING: Cannot get cube for: http://omgsrv1.meas.ncsu.edu:8080/thredds/dodsC/fmrc/us_east/US_East_Forecast_Model_Run_Collection_best.ncd
istart must be different from istop! Got istart 0 and  istop 0
11:43:44 INFO: 
[Reading url 9/9]: http://crow.marine.usf.edu:8080/thredds/dodsC/WFS_SWAN_NF_model/USF_Ocean_Circulation_Group_West_Florida_Shelf_Daily_SWAN_Nowcast_Forecast_Wave_Model_Data_best.ncd
11:43:44 WARNING: Cannot get cube for: http://crow.marine.usf.edu:8080/thredds/dodsC/WFS_SWAN_NF_model/USF_Ocean_Circulation_Group_West_Florida_Shelf_Daily_SWAN_Nowcast_Forecast_Wave_Model_Data_best.ncd
Cannot find ['sea_surface_height', 'sea_surface_elevation', 'sea_surface_height_above_geoid', 'sea_surface_height_above_sea_level', 'water_surface_height_above_reference_datum', 'sea_surface_height_above_reference_ellipsoid'] in http://crow.marine.usf.edu:8080/thredds/dodsC/WFS_SWAN_NF_model/USF_Ocean_Circulation_Group_West_Florida_Shelf_Daily_SWAN_Nowcast_Forecast_Wave_Model_Data_best.ncd.
11:43:44 INFO: **** Saving to file 2014-07-07/2014-07-07-SABGOM_ARCHIVE.nc ****
11:43:48 INFO: [Water  ] Duck, NC
11:43:53 INFO: [Water  ] Oregon Inlet Marina, NC
11:43:55 INFO: [Water  ] USCG Station Hatteras, NC
11:43:57 INFO: [Land   ] Beaufort, NC
11:44:03 INFO: [Land   ] Wilmington, NC
11:44:05 INFO: [Water  ] Wrightsville Beach, NC
11:44:07 INFO: [Water  ] Springmaid Pier, SC
11:44:11 INFO: [Water  ] Oyster Landing (N Inlet Estuary), SC
11:44:16 INFO: [Land   ] Charleston, SC
11:44:18 INFO: [Land   ] Fernandina Beach, FL
11:44:23 INFO: [Land   ] Mayport (Bar Pilots Dock), FL
11:44:28 INFO: [Land   ] Dames Point, FL
11:44:35 INFO: [Land   ] Southbank Riverwalk, St Johns River, FL
11:44:39 INFO: [Land   ] I-295 Bridge, St Johns River, FL
11:44:44 INFO: [Land   ] Red Bay Point, St Johns River, FL
11:44:49 INFO: [Land   ] Racy Point, St Johns River, FL
11:44:52 INFO: [Water  ] Trident Pier, FL
11:44:55 INFO: [Water  ] Lake Worth Pier, FL
11:44:58 INFO: [Water  ] Virginia Key, FL
11:45:01 INFO: [Water  ] Vaca Key, FL
11:45:03 INFO: [Water  ] Key West, FL
11:45:05 INFO: [Land   ] Naples, FL
11:45:08 INFO: [Land   ] Fort Myers, FL
11:45:10 INFO: [Water  ] Port Manatee, FL
11:45:12 INFO: [Water  ] St Petersburg, FL
11:45:15 INFO: [Water  ] Old Port Tampa, FL
11:45:17 INFO: [Water  ] Cedar Key, FL
11:45:21 INFO: [Land   ] Apalachicola, FL
11:45:25 INFO: [Land   ] Panama City, FL
11:45:28 INFO: [Water  ] Panama City Beach, FL
11:45:30 INFO: [Land   ] Pensacola, FL
11:45:33 INFO: [Land   ] Tolomato River station
11:45:35 INFO: [Water  ] Fred Howard Park
11:45:37 INFO: [Land   ] usf_tas_ngwlms
11:45:40 INFO: [Land   ] Big Carlos Pass
11:45:45 INFO: [Water  ] Shell Point
11:45:47 INFO: [Water  ] St Lucie Inlet station
11:45:51 INFO: [Land   ] Naples Bay station
11:45:56 INFO: [Land   ] Vero Beach station
11:46:01 INFO: [Land   ] Ponce De Leon South station
11:46:06 INFO: [Land   ] Melbourne station
11:46:11 INFO: [Land   ] Aripeka
11:46:13 INFO: [Land   ] Bing's Landing station
11:46:19 INFO: [Land   ] Binney Dock station
11:46:21 INFO: [Land   ] Gordon River Inlet station
11:47:06 INFO: **************Finished processing SABGOM_ARCHIVE
***************
11:47:06 INFO: ******** Saving to file 2014-07-07/2014-07-07-ESTOFS.nc ********
11:47:10 INFO: [Water  ] Duck, NC
11:47:12 INFO: [Water  ] Oregon Inlet Marina, NC
11:47:14 INFO: [Water  ] USCG Station Hatteras, NC
11:47:17 INFO: [Water  ] Beaufort, NC
11:47:17 INFO: [No Data] Wilmington, NC
11:47:19 INFO: [Water  ] Wrightsville Beach, NC
11:47:21 INFO: [Water  ] Springmaid Pier, SC
11:47:23 INFO: [Water  ] Oyster Landing (N Inlet Estuary), SC
11:47:23 INFO: [No Data] Charleston, SC
11:47:25 INFO: [Water  ] Fernandina Beach, FL
11:47:27 INFO: [Water  ] Mayport (Bar Pilots Dock), FL
11:47:27 INFO: [No Data] Dames Point, FL
11:47:27 INFO: [No Data] Southbank Riverwalk, St Johns River, FL
11:47:27 INFO: [No Data] I-295 Bridge, St Johns River, FL
11:47:27 INFO: [No Data] Red Bay Point, St Johns River, FL
11:47:27 INFO: [No Data] Racy Point, St Johns River, FL
11:47:29 INFO: [Water  ] Trident Pier, FL
11:47:31 INFO: [Water  ] Lake Worth Pier, FL
11:47:33 INFO: [Water  ] Virginia Key, FL
11:47:35 INFO: [Water  ] Vaca Key, FL
11:47:37 INFO: [Water  ] Key West, FL
11:47:38 INFO: [Water  ] Naples, FL
11:47:38 INFO: [No Data] Fort Myers, FL
11:47:40 INFO: [Water  ] Port Manatee, FL
11:47:42 INFO: [Water  ] St Petersburg, FL
11:47:43 INFO: [Water  ] Old Port Tampa, FL
11:47:44 INFO: [Water  ] Cedar Key, FL
11:47:46 INFO: [Water  ] Apalachicola, FL
11:47:46 INFO: [No Data] Panama City, FL
11:47:47 INFO: [Water  ] Panama City Beach, FL
11:47:47 INFO: [No Data] Pensacola, FL
11:47:49 INFO: [Water  ] Tolomato River station
11:47:50 INFO: [Water  ] Fred Howard Park
11:47:51 INFO: [Water  ] usf_tas_ngwlms
11:47:52 INFO: [Water  ] Big Carlos Pass
11:47:53 INFO: [Water  ] Shell Point
11:47:55 INFO: [Water  ] St Lucie Inlet station
11:47:56 INFO: [Water  ] Naples Bay station
11:47:57 INFO: [Water  ] Vero Beach station
11:47:59 INFO: [Water  ] Ponce De Leon South station
11:48:00 INFO: [Water  ] Melbourne station
11:48:01 INFO: [Water  ] Aripeka
11:48:03 INFO: [Water  ] Bing's Landing station
11:48:04 INFO: [Water  ] Binney Dock station
11:48:05 INFO: [Water  ] Gordon River Inlet station
11:48:05 INFO: ******************Finished processing ESTOFS
*******************
11:48:05 INFO: ******** Saving to file 2014-07-07/2014-07-07-HYCOM.nc *********
11:48:31 INFO: [Land   ] Duck, NC
11:48:35 INFO: [Water  ] Oregon Inlet Marina, NC
11:48:38 INFO: [Land   ] USCG Station Hatteras, NC
11:48:41 INFO: [Land   ] Beaufort, NC
11:48:44 INFO: [Land   ] Wilmington, NC
11:48:47 INFO: [Water  ] Wrightsville Beach, NC
11:48:47 INFO: [No Data] Springmaid Pier, SC
11:48:51 INFO: [Land   ] Oyster Landing (N Inlet Estuary), SC
11:48:53 INFO: [Land   ] Charleston, SC
11:48:56 INFO: [Land   ] Fernandina Beach, FL
11:49:00 INFO: [Land   ] Mayport (Bar Pilots Dock), FL
11:49:03 INFO: [Land   ] Dames Point, FL
11:49:06 INFO: [Land   ] Southbank Riverwalk, St Johns River, FL
11:49:09 INFO: [Land   ] I-295 Bridge, St Johns River, FL
11:49:12 INFO: [Land   ] Red Bay Point, St Johns River, FL
11:49:12 INFO: [No Data] Racy Point, St Johns River, FL
11:49:16 INFO: [Land   ] Trident Pier, FL
11:49:22 INFO: [Water  ] Lake Worth Pier, FL
11:49:26 INFO: [Land   ] Virginia Key, FL
11:49:30 INFO: [Land   ] Vaca Key, FL
11:49:34 INFO: [Land   ] Key West, FL
11:49:34 INFO: [No Data] Naples, FL
11:49:37 INFO: [Land   ] Fort Myers, FL
11:49:40 INFO: [Land   ] Port Manatee, FL
11:49:45 INFO: [Land   ] St Petersburg, FL
11:49:50 INFO: [Land   ] Old Port Tampa, FL
11:49:54 INFO: [Land   ] Cedar Key, FL
11:49:57 INFO: [Land   ] Apalachicola, FL
11:50:01 INFO: [Land   ] Panama City, FL
11:50:01 INFO: [No Data] Panama City Beach, FL
11:50:04 INFO: [Land   ] Pensacola, FL
11:50:07 INFO: [Land   ] Tolomato River station
11:50:11 INFO: [Land   ] Fred Howard Park
11:50:17 INFO: [Land   ] usf_tas_ngwlms
11:50:17 INFO: [No Data] Big Carlos Pass
11:50:23 INFO: [Land   ] Shell Point
11:50:27 INFO: [Land   ] St Lucie Inlet station
11:50:30 INFO: [Land   ] Naples Bay station
11:50:34 INFO: [Land   ] Vero Beach station
11:50:37 INFO: [Water  ] Ponce De Leon South station
11:50:41 INFO: [Land   ] Melbourne station
11:50:44 INFO: [Land   ] Aripeka
11:50:47 INFO: [Land   ] Bing's Landing station
11:50:51 INFO: [Land   ] Binney Dock station
11:50:54 INFO: [Land   ] Gordon River Inlet station
11:50:54 INFO: *******************Finished processing HYCOM
*******************
11:50:54 INFO: ******* Saving to file 2014-07-07/2014-07-07-USF_ROMS.nc *******
11:50:54 INFO: [No Data] Duck, NC
11:50:54 INFO: [No Data] Oregon Inlet Marina, NC
11:50:54 INFO: [No Data] USCG Station Hatteras, NC
11:50:54 INFO: [No Data] Beaufort, NC
11:50:54 INFO: [No Data] Wilmington, NC
11:50:54 INFO: [No Data] Wrightsville Beach, NC
11:50:54 INFO: [No Data] Springmaid Pier, SC
11:50:54 INFO: [No Data] Oyster Landing (N Inlet Estuary), SC
11:50:54 INFO: [No Data] Charleston, SC
11:50:54 INFO: [No Data] Fernandina Beach, FL
11:50:54 INFO: [No Data] Mayport (Bar Pilots Dock), FL
11:50:54 INFO: [No Data] Dames Point, FL
11:50:54 INFO: [No Data] Southbank Riverwalk, St Johns River, FL
11:50:54 INFO: [No Data] I-295 Bridge, St Johns River, FL
11:50:54 INFO: [No Data] Red Bay Point, St Johns River, FL
11:50:54 INFO: [No Data] Racy Point, St Johns River, FL
11:50:54 INFO: [No Data] Trident Pier, FL
11:50:54 INFO: [No Data] Lake Worth Pier, FL
11:50:54 INFO: [No Data] Virginia Key, FL
11:50:56 INFO: [Water  ] Vaca Key, FL
11:50:56 INFO: [No Data] Key West, FL
11:50:58 INFO: [Water  ] Naples, FL
11:51:00 INFO: [Water  ] Fort Myers, FL
11:51:02 INFO: [Water  ] Port Manatee, FL
11:51:04 INFO: [Water  ] St Petersburg, FL
11:51:06 INFO: [Water  ] Old Port Tampa, FL
11:51:07 INFO: [Water  ] Cedar Key, FL
11:51:09 INFO: [Water  ] Apalachicola, FL
11:51:10 INFO: [Water  ] Panama City, FL
11:51:12 INFO: [Water  ] Panama City Beach, FL
11:51:12 INFO: [No Data] Pensacola, FL
11:51:12 INFO: [No Data] Tolomato River station
11:51:13 INFO: [Water  ] Fred Howard Park
11:51:15 INFO: [Water  ] usf_tas_ngwlms
11:51:16 INFO: [Water  ] Big Carlos Pass
11:51:18 INFO: [Water  ] Shell Point
11:51:18 INFO: [No Data] St Lucie Inlet station
11:51:19 INFO: [Water  ] Naples Bay station
11:51:19 INFO: [No Data] Vero Beach station
11:51:19 INFO: [No Data] Ponce De Leon South station
11:51:19 INFO: [No Data] Melbourne station
11:51:21 INFO: [Water  ] Aripeka
11:51:21 INFO: [No Data] Bing's Landing station
11:51:21 INFO: [No Data] Binney Dock station
11:51:22 INFO: [Water  ] Gordon River Inlet station
11:51:47 INFO: *****************Finished processing USF_ROMS
******************
11:51:47 INFO: ****** Saving to file 2014-07-07/2014-07-07-USF_FVCOM.nc *******
11:51:47 INFO: [No Data] Duck, NC
11:51:47 INFO: [No Data] Oregon Inlet Marina, NC
11:51:47 INFO: [No Data] USCG Station Hatteras, NC
11:51:47 INFO: [No Data] Beaufort, NC
11:51:47 INFO: [No Data] Wilmington, NC
11:51:47 INFO: [No Data] Wrightsville Beach, NC
11:51:47 INFO: [No Data] Springmaid Pier, SC
11:51:47 INFO: [No Data] Oyster Landing (N Inlet Estuary), SC
11:51:47 INFO: [No Data] Charleston, SC
11:51:47 INFO: [No Data] Fernandina Beach, FL
11:51:47 INFO: [No Data] Mayport (Bar Pilots Dock), FL
11:51:47 INFO: [No Data] Dames Point, FL
11:51:47 INFO: [No Data] Southbank Riverwalk, St Johns River, FL
11:51:47 INFO: [No Data] I-295 Bridge, St Johns River, FL
11:51:47 INFO: [No Data] Red Bay Point, St Johns River, FL
11:51:47 INFO: [No Data] Racy Point, St Johns River, FL
11:51:47 INFO: [No Data] Trident Pier, FL
11:51:47 INFO: [No Data] Lake Worth Pier, FL
11:51:47 INFO: [No Data] Virginia Key, FL
11:51:53 INFO: [Water  ] Vaca Key, FL
11:51:59 INFO: [Water  ] Key West, FL
11:52:05 INFO: [Water  ] Naples, FL
11:52:11 INFO: [Water  ] Fort Myers, FL
11:52:17 INFO: [Water  ] Port Manatee, FL
11:52:23 INFO: [Water  ] St Petersburg, FL
11:52:28 INFO: [Water  ] Old Port Tampa, FL
11:52:35 INFO: [Water  ] Cedar Key, FL
11:52:41 INFO: [Water  ] Apalachicola, FL
11:52:41 INFO: [No Data] Panama City, FL
11:52:43 INFO: [Water  ] Panama City Beach, FL
11:52:43 INFO: [No Data] Pensacola, FL
11:52:43 INFO: [No Data] Tolomato River station
11:52:49 INFO: [Water  ] Fred Howard Park
11:52:50 INFO: [Water  ] usf_tas_ngwlms
11:52:56 INFO: [Water  ] Big Carlos Pass
11:53:01 INFO: [Water  ] Shell Point
11:53:01 INFO: [No Data] St Lucie Inlet station
11:53:02 INFO: [Water  ] Naples Bay station
11:53:02 INFO: [No Data] Vero Beach station
11:53:02 INFO: [No Data] Ponce De Leon South station
11:53:02 INFO: [No Data] Melbourne station
11:53:03 INFO: [Water  ] Aripeka
11:53:03 INFO: [No Data] Bing's Landing station
11:53:03 INFO: [No Data] Binney Dock station
11:53:04 INFO: [Water  ] Gordon River Inlet station
11:53:04 INFO: *****************Finished processing USF_FVCOM
*****************
11:53:04 INFO: ******* Saving to file 2014-07-07/2014-07-07-COAWST_4.nc *******
11:53:28 INFO: [Land   ] Duck, NC
11:53:33 INFO: [Water  ] Oregon Inlet Marina, NC
11:53:38 INFO: [Water  ] USCG Station Hatteras, NC
11:53:43 INFO: [Water  ] Beaufort, NC
11:53:48 INFO: [Land   ] Wilmington, NC
11:53:53 INFO: [Water  ] Wrightsville Beach, NC
11:53:58 INFO: [Water  ] Springmaid Pier, SC
11:54:03 INFO: [Land   ] Oyster Landing (N Inlet Estuary), SC
11:54:13 INFO: [Water  ] Charleston, SC
11:54:22 INFO: [Land   ] Fernandina Beach, FL
11:54:32 INFO: [Land   ] Mayport (Bar Pilots Dock), FL
11:54:42 INFO: [Land   ] Dames Point, FL
11:54:51 INFO: [Land   ] Southbank Riverwalk, St Johns River, FL
11:55:01 INFO: [Land   ] I-295 Bridge, St Johns River, FL
11:55:10 INFO: [Land   ] Red Bay Point, St Johns River, FL
11:55:15 INFO: [Land   ] Racy Point, St Johns River, FL
11:55:20 INFO: [Land   ] Trident Pier, FL
11:55:25 INFO: [Water  ] Lake Worth Pier, FL
11:55:35 INFO: [Water  ] Virginia Key, FL
11:55:45 INFO: [Land   ] Vaca Key, FL
11:55:50 INFO: [Water  ] Key West, FL
11:56:00 INFO: [Water  ] Naples, FL
11:56:10 INFO: [Land   ] Fort Myers, FL
11:56:14 INFO: [Land   ] Port Manatee, FL
11:56:24 INFO: [Water  ] St Petersburg, FL
11:56:29 INFO: [Water  ] Old Port Tampa, FL
11:56:34 INFO: [Water  ] Cedar Key, FL
11:56:38 INFO: [Water  ] Apalachicola, FL
11:56:43 INFO: [Water  ] Panama City, FL
11:56:48 INFO: [Water  ] Panama City Beach, FL
11:56:52 INFO: [Water  ] Pensacola, FL
11:56:57 INFO: [Land   ] Tolomato River station
11:57:02 INFO: [Land   ] Fred Howard Park
11:57:13 INFO: [Land   ] usf_tas_ngwlms
11:57:18 INFO: [Water  ] Big Carlos Pass
11:57:27 INFO: [Water  ] Shell Point
11:57:31 INFO: [Water  ] St Lucie Inlet station
11:57:41 INFO: [Land   ] Naples Bay station
11:57:46 INFO: [Water  ] Vero Beach station
11:57:51 INFO: [Water  ] Ponce De Leon South station
11:57:55 INFO: [Land   ] Melbourne station
11:58:05 INFO: [Water  ] Aripeka
11:58:10 INFO: [Land   ] Bing's Landing station
11:58:14 INFO: [Water  ] Binney Dock station
11:58:19 INFO: [Land   ] Gordon River Inlet station
12:00:02 INFO: *****************Finished processing COAWST_4
******************
12:00:02 INFO: **** Saving to file 2014-07-07/2014-07-07-ROMS_ESPRESSO.nc *****
12:00:06 INFO: [Land   ] Duck, NC
12:00:08 INFO: [Water  ] Oregon Inlet Marina, NC
12:00:10 INFO: [Land   ] USCG Station Hatteras, NC
12:00:12 INFO: [Water  ] Beaufort, NC
12:00:12 INFO: [No Data] Wilmington, NC
12:00:12 INFO: [No Data] Wrightsville Beach, NC
12:00:12 INFO: [No Data] Springmaid Pier, SC
12:00:12 INFO: [No Data] Oyster Landing (N Inlet Estuary), SC
12:00:12 INFO: [No Data] Charleston, SC
12:00:12 INFO: [No Data] Fernandina Beach, FL
12:00:12 INFO: [No Data] Mayport (Bar Pilots Dock), FL
12:00:12 INFO: [No Data] Dames Point, FL
12:00:12 INFO: [No Data] Southbank Riverwalk, St Johns River, FL
12:00:12 INFO: [No Data] I-295 Bridge, St Johns River, FL
12:00:12 INFO: [No Data] Red Bay Point, St Johns River, FL
12:00:12 INFO: [No Data] Racy Point, St Johns River, FL
12:00:12 INFO: [No Data] Trident Pier, FL
12:00:12 INFO: [No Data] Lake Worth Pier, FL
12:00:12 INFO: [No Data] Virginia Key, FL
12:00:12 INFO: [No Data] Vaca Key, FL
12:00:12 INFO: [No Data] Key West, FL
12:00:12 INFO: [No Data] Naples, FL
12:00:12 INFO: [No Data] Fort Myers, FL
12:00:12 INFO: [No Data] Port Manatee, FL
12:00:12 INFO: [No Data] St Petersburg, FL
12:00:12 INFO: [No Data] Old Port Tampa, FL
12:00:12 INFO: [No Data] Cedar Key, FL
12:00:12 INFO: [No Data] Apalachicola, FL
12:00:12 INFO: [No Data] Panama City, FL
12:00:12 INFO: [No Data] Panama City Beach, FL
12:00:12 INFO: [No Data] Pensacola, FL
12:00:12 INFO: [No Data] Tolomato River station
12:00:12 INFO: [No Data] Fred Howard Park
12:00:12 INFO: [No Data] usf_tas_ngwlms
12:00:12 INFO: [No Data] Big Carlos Pass
12:00:12 INFO: [No Data] Shell Point
12:00:12 INFO: [No Data] St Lucie Inlet station
12:00:12 INFO: [No Data] Naples Bay station
12:00:12 INFO: [No Data] Vero Beach station
12:00:12 INFO: [No Data] Ponce De Leon South station
12:00:12 INFO: [No Data] Melbourne station
12:00:12 INFO: [No Data] Aripeka
12:00:12 INFO: [No Data] Bing's Landing station
12:00:12 INFO: [No Data] Binney Dock station
12:00:12 INFO: [No Data] Gordon River Inlet station
12:00:16 INFO: ***************Finished processing ROMS_ESPRESSO
***************
12:00:16 INFO: 30.75 minutes
12:00:16 INFO: EOF