Newer
Older

Blodgett, David L.
committed
---
title: "NHD Navigate"
output: html_document
editor_options:
chunk_output_type: console

Blodgett, David L.
committed
---
This notebook Generate Segments and POIS from POI data sources and builds
a minimally-sufficient stream network connecting all POis, as well as generating first-cut of
national segment network.

Blodgett, David L.
committed
knitr::opts_chunk$set(error = TRUE, cache = FALSE)

Blodgett, David L.
committed
```{r setup}
# Load data and libraries ----------------------
source("R/utils.R")

Blodgett, David L.
committed
source("R/NHD_navigate.R")
source("R/hyrefactor_funs.R")
# Load Configuration of environment
source("R/config.R")
# Load NHDPlus Data if precprocessed to RDS format

Blodgett, David L.
committed
nhdplus_path(data_paths$nhdplus_gdb)
staged_nhd <- stage_national_data(nhdplus_data = data_paths$nhdplus_gdb,
output_path = data_paths$nhdplus_dir)
# Derive or load HUC12 POIs ----------------------
# Still need to deal with some duplicate HUC12s
if (needs_layer(nav_gpkg, nhdflowline)){
# Subset NHD by VPU
nhd <- VPU_Subset(staged_nhd$flowline, VPU, new_atts = data_paths$new_nhdp_atts, nhdpath = data_paths$nhdplus_gdb)
if("arbolate_sum" %in% names(nhd)) nhd <- rename(nhd, ArbolateSu = arbolate_sum)
# Filter and write dendritic/non-coastal subset to gpkg
# This will be iterated over to produce the final network after POIs identified
non_dend <- unique(unlist(lapply(filter(nhd, TerminalFl == 1 & TotDASqKM < min_da_km)
%>% pull(COMID), NetworkNav, st_drop_geometry(nhd))))
# Add fields to note dendritic and POI flowlines
nhd <- nhd %>%
mutate(dend = ifelse(!COMID %in% non_dend, 1, 0),
poi = ifelse(!COMID %in% non_dend & TotDASqKM >= min_da_km, 1, 0))
write_sf(nhd, nav_gpkg, nhdflowline)
} else {
nhd <- read_sf(nav_gpkg, nhdflowline)
try(nhd <- select(nhd, -c(minNet, WB, struct_POI, struct_Net, POI_ID)))
# Join Dave's HUC12 outlets with NHD
HUC12_COMIDs <- read_sf(data_paths$hu12_points_path, "hu_points") %>%
filter(grepl(paste0("^", substr(VPU, start = 1, stop = 2)), .data$HUC12)) %>%
select(COMID, HUC12) %>%
switchDiv(., nhd) %>%
# Remove this when HUC12 outlets finished
group_by(COMID) %>%
slice(1)
# Create POIs - some r05 HUC12 POIs not in R05 NHD
huc12_POIs <- POI_creation(st_drop_geometry(HUC12_COMIDs), filter(nhd, poi == 1), "HUC12")
# Write out geopackage layer representing POIs for given theme
write_sf(huc12_POIs, nav_gpkg, temp_POIs)
tmp_POIs <- huc12_POIs
# Load HUC12 POIs as the tmpPOIs if they already exist
tmp_POIs <- read_sf(nav_gpkg, temp_POIs)
nhd <- read_sf(nav_gpkg, nhdflowline)
# Derive gage POIs----------------------
# Note several POIs have multiple gages indexed
# Need to add in drainage area threshold
if(all(is.na(tmp_POIs$Type_Gages))) {
# Previously identified streamgages within Gage_Selection.Rmd
streamgages <- read_sf("cache/Gages_info.gpkg", "Gages") %>%
filter(COMID %in% nhd$COMID) %>%
# these two lines below will not be needed when Marilyn finishes Gage work
# Should we keep all streamgages larger than 10 km or stick with min_da_km threshold
# Derive GAGE POIs; use NHD as we've alredy filtered by NWIS DA in the Gage selection step
tmp_POIs <- POI_creation(streamgages, filter(nhd, poi == 1), "Gages") %>%
addType(., tmp_POIs, "Gages")
# Write out geopackage layer representing POIs for given theme
write_sf(tmp_POIs, nav_gpkg, temp_POIs)
tmp_POIs <- read_sf(nav_gpkg, temp_POIs)
# Derive or load Thermoelectric POIs ----------------------
if(all(is.na(tmp_POIs$Type_TE))) {
# Read in Thermoelectric shapefile
TE_COMIDs <- read_sf(data_paths$TE_points_path, "2015_TE_Model_Estimates_lat.long_COMIDs") %>%
mutate(COMID = as.integer(COMID)) %>%
inner_join(., select(st_drop_geometry(nhd), c(COMID, VPUID)), by = "COMID") %>%
filter(grepl(paste0("^", VPU, ".*"), .data$VPUID), COMID > 0) %>%
summarize(EIA_PLANT = paste0(unique(EIA_PLANT_), collapse = " "), count = n())
tmp_POIs <- POI_creation(st_drop_geometry(TE_COMIDs), nhd, "TE") %>%
addType(., tmp_POIs, "TE")
# Write out geopackage layer representing POIs for given theme
write_sf(tmp_POIs, nav_gpkg, temp_POIs)
} else {
# Load TE POIs if they already exist
tmp_POIs <- read_sf(nav_gpkg, temp_POIs)
}
```
# Derive POIs at confluences where they are absent ----------------------
if(all(is.na(tmp_POIs$Type_Conf))) {
# Navigate upstream from each POI and determine minimally-sufficient network between current POI sets
up_net <- unique(unlist(lapply(unique(tmp_POIs$COMID), NetworkNav, nhd)))
finalNet <- unique(NetworkConnection(up_net, st_drop_geometry(nhd)))
# Subset NHDPlusV2 flowlines to navigation results and write to shapefile
nhd <- mutate(nhd, minNet = ifelse(COMID %in% finalNet, 1, 0))
conf_COMIDs <- st_drop_geometry(filter(nhd, minNet == 1)) %>%
group_by(DnHydroseq) %>%
filter(n()> 1) %>%
mutate(Type_Conf = LevelPathI) %>%
tmp_POIs <- POI_creation(conf_COMIDs, filter(nhd, dend ==1), "Conf") %>%
addType(., tmp_POIs, "Conf")
write_sf(nhd, nav_gpkg, nhdflowline)
write_sf(tmp_POIs, nav_gpkg, temp_POIs)
nhd <- read_sf(nav_gpkg, nhdflowline)
tmp_POIs <- read_sf(nav_gpkg, temp_POIs)
# Derive or load NID POIs ----------------------
if(all(is.na(tmp_POIs$Type_NID))) {
# Read in NID shapefile
NID_COMIDs <- read.csv(file.path(data_paths$NID_points_path, "NID_attributes_20170612.txt"), stringsAsFactors = FALSE) %>%
filter(ONNHDPLUS == 1, FlowLcomid %in% filter(nhd, dend ==1)$COMID) %>%
group_by(FlowLcomid) %>%
summarize(Type_NID = paste0(unique(NIDID), collapse = " "))
tmp_POIs <- POI_creation(NID_COMIDs, filter(nhd, dend ==1), "NID") %>%
addType(., tmp_POIs, "NID", bind = FALSE)
# Write out geopackage layer representing POIs for given theme
write_sf(tmp_POIs, nav_gpkg, temp_POIs)
} else {
# Load NID POIs if they already exist
tmp_POIs <- read_sf(nav_gpkg, temp_POIs)
# Derive or load Waterbody POIs ----------------------
if(all(is.na(tmp_POIs$Type_WBOut))) {
# Read in waterbodies
WBs_VPU <- readRDS("data/NHDPlusNationalData/nhdplus_waterbodies.rds") %>%
filter(FTYPE %in% c("LakePond", "Reservoir") &
AREASQKM >= (min_da_km/2) &
COMID %in% filter(nhd, minNet == 1)$WBAREACOMI) %>%
st_sf()
write_sf(st_transform(WBs_VPU, 4269), nav_gpkg, WBs)
# Segments that are in waterbodies
nhd <- mutate(nhd, WB = ifelse(WBAREACOMI > 0 & WBAREACOMI %in% WBs_VPU$COMID, 1, 0))
wbout_COMIDs <- filter(nhd, WB == 1) %>%
select(COMID, WBAREACOMI)
wbin_COMIDs <- filter(nhd, WB == 0, DnHydroseq %in% filter(nhd, WB == 1)$Hydroseq) %>%
inner_join(st_drop_geometry(filter(nhd, minNet == 1)) %>%
select(Hydroseq, WBAREACOMI), by = c("DnHydroseq" = "Hydroseq")) %>%
tmp_POIs <- POI_creation(filter(wbout_COMIDs, !COMID %in% wbin_COMIDs$COMID), filter(nhd, poi == 1), "WBOut") %>%
tmp_POIs <- POI_creation(filter(wbin_COMIDs, !COMID %in% wbout_COMIDs$COMID), filter(nhd, poi == 1), "WBIn") %>%
write_sf(nhd, nav_gpkg, nhdflowline)
write_sf(tmp_POIs, nav_gpkg, temp_POIs)
tmp_POIs <- read_sf(nav_gpkg, temp_POIs)
nhd <- read_sf(nav_gpkg, nhdflowline)
```{r Final POIs}
# Derive final POI set ----------------------
if(needs_layer(nav_gpkg, pois_all)) {
unCon_POIs <- filter(st_drop_geometry(filter(nhd, minNet == 1)), COMID %in% tmp_POIs$COMID, AreaSqKM == 0)
# If any POIs happened to fall on flowlines w/o catchment
if (nrow(unCon_POIs) >0){
# For confluence POIs falling on Flowlines w/o catchments, derive upstream valid flowline,
poi_fix <- DS_poiFix(tmp_POIs, filter(nhd, dend == 1)) #%>%
new_POIs <- st_compatibalize(poi_fix$new_POIs, tmp_POIs)
xWalk <- poi_fix$xWalk
# POIs that didn't need to be moved
tmp_POIs_fixed <- filter(tmp_POIs, !COMID %in% c(poi_fix$xWalk$oldPOI, poi_fix$xWalk$COMID))
# bind together
final_POIs <- bind_rows(tmp_POIs_fixed, select(poi_fix$new_POIs, -c(oldPOI, to_com)))
# Write out fixes
write_sf(new_POIs, nav_gpkg, poi_moved)
write_sf(xWalk, nav_gpkg, poi_xWalk)
# write out final POIs
write_sf(final_POIs, nav_gpkg, pois_all)
} else {
# If no fixes designate as NA
poi_fix <- NA
# write out final POIs
write_sf(tmp_POIs, nav_gpkg, pois_all)
}
# Need all three sets for attribution below
final_POIs <- read_sf(nav_gpkg, pois_all)
new_POIs <- if(layer_exists(nav_gpkg, poi_moved)) read_sf(nav_gpkg, poi_moved) else (NA)
xWalk <- if(layer_exists(nav_gpkg, poi_xWalk)) read_sf(nav_gpkg, poi_xWalk) else (NA)
unCon_POIs <- filter(st_drop_geometry(filter(nhd, minNet == 1)), COMID %in% tmp_POIs$COMID, AreaSqKM == 0)
}
```

Bock, Andy
committed
```{r Final segments}
# Derive first cut of segments ----------------------
if(needs_layer(nav_gpkg, n_segments)) {
# Sort POIs by Levelpath and Hydrosequence in upstream to downstream order
seg_POIs <- filter(st_drop_geometry(nhd), COMID %in% tmp_POIs$COMID, COMID %in% filter(nhd, minNet == 1)$COMID)
inc_segs <- segment_increment(filter(nhd, minNet == 1), seg_POIs)
nhd_Final <- nhd %>%
left_join(select(inc_segs, COMID, POI_ID), by = "COMID")
# create and write out final dissolved segments
nsegments_fin <- segment_creation(nhd_Final, xWalk)
nhd_Final <- select(nhd_Final, -POI_ID) %>%
left_join(select(st_drop_geometry(nsegments_fin$raw_segs), COMID, POI_ID), by = "COMID")
nsegments <- nsegments_fin$diss_segs
# Produce the minimal POIs needed to derive the network based on LP and terminal outlets
strucFeat <- structPOIsNet(nhd_Final, final_POIs)
nhd_Final <- nhd_Final %>%
mutate(struct_POI = ifelse(COMID %in% strucFeat$struc_POIs$COMID, 1, 0),
struct_Net = ifelse(COMID %in% strucFeat$structnet$COMID, 1, 0))
write_sf(nhd_Final, nav_gpkg, nhdflowline)
write_sf(nsegments, nav_gpkg, n_segments)
# Read in NHDPlusV2 flowline simple features and filter by vector processing unit (VPU)
final_POIs <- read_sf(nav_gpkg, pois_all)
nhd_Final <- read_sf(nav_gpkg, nhdflowline)
nsegments <- read_sf(nav_gpkg, n_segments)
# Ensure that all the problem POIs have been taken care of
sub <- nhd_Final %>% filter(COMID %in% final_POIs$COMID)
print (paste0(nrow(sub[sub$AreaSqKM == 0,]), " POIs on flowlines with no local drainage contributions"))
```
if(needs_layer(nav_gpkg, pois_merge)) {
#1 Move POIs downstream by category
out_gages <- POI_move_down(nav_gpkg, final_POIs, nsegments, filter(nhd_Final, !is.na(POI_ID)), "Type_Gages", .05)
out_HUC12 <- POI_move_down(nav_gpkg, out_gages$allPOIs, out_gages$segs, out_gages$FL, "Type_HUC12", .10)
nhd_Final <- select(nhd_Final, -POI_ID) %>%
left_join(st_drop_geometry(out_HUC12$FL) %>%
select(COMID, POI_ID), by = "COMID")
# Write out geopackage layer representing POIs for given theme
write_sf(out_HUC12$allPOIs, nav_gpkg, pois_merge)
write_sf(out_HUC12$segs, nav_gpkg, n_segments)
} else {
final_POIs <- read_sf(nav_gpkg, pois_merge)
nhd_Final <- read_sf(nav_gpkg, nhdflowline)
nsegments <- read_sf(nav_gpkg, n_segments)
}