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}
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
nhdplus_path(data_paths$nhdplus_gdb)
staged_nhd <- stage_national_data(nhdplus_data = data_paths$nhdplus_gdb,
output_path = data_paths$nhdplus_dir)
nhd_rds <- fix_headwaters(staged_nhd$flowline, gsub("flowline.rds", "flowline_update.rds", staged_nhd$flowline),
new_atts = data_paths$new_nhdp_atts, nhdpath = data_paths$nhdplus_gdb)
# Need DnMinorHyd for switching POIs downstream of watebodies/dams
VAA <- get_vaa(atts = c("dnminorhyd"), path = get_vaa_path(), download = TRUE)
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))
try(nhd <- select(nhd, -c(minNet, WB, struct_POI, struct_Net, POI_ID)))
# HUC02 includes some
if(VPU == "02"){
grep_exp <-"^02|^04"
} else if (VPU == "08") {
grep_exp <- "^03|^08"
} else {
grep_exp <- paste0("^", substr(VPU, start = 1, stop = 2))
}
HUC12_COMIDs <- read_sf(data_paths$hu12_points_path, "hu_points") %>%
# 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
tmp_POIs <- huc12_POIs
# Load HUC12 POIs as the tmpPOIs if they already exist
tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
nhd <- read_sf(nav_gpkg, nhd_flowline)
if(all(is.na(tmp_POIs$Type_Gages))) {
# Previously identified streamgages within Gage_Selection.Rmd
streamgages_VPU <- read_sf("cache/Gages_info.gpkg", "Gages") %>%
filter(COMID %in% nhd$COMID) %>%
switchDiv(., nhd)
streamgages <- streamgages_VPU %>%
# If multiple gages per COMID, pick one with highest rank as rep POI_ID
# Derive GAGE POIs; use NHD as we've alredy filtered by NWIS DA in the Gage selection step
tmp_POIs <- POI_creation(streamgages, nhd, "Gages") %>%
addType(., tmp_POIs, "Gages")
# As a fail-safe, write out list of gages not assigned a POI
if(nrow(filter(streamgages_VPU, !site_no %in% tmp_POIs$Type_Gages)) > 0) {
write_sf(filter(streamgages_VPU, !site_no %in% tmp_POIs$Type_Gages),
# Start documenting gages that are dropped out; these gages have no mean daily Q
gage_document(filter(streamgages_VPU, !site_no %in% tmp_POIs$Type_Gages) %>%
select(site_no),
"Gages_info", "VPU 01; low gage score")
# Write out geopackage layer representing POIs for given theme
# Derive or load Thermoelectric POIs ----------------------
if(all(is.na(tmp_POIs$Type_TE))) {
if(VPU == "08"){
nhd$VPUID <- "08"
} else {
nhd$VPUID <- substr(nhd$RPUID, 1, 2)
}
# 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), COMID, VPUID), by = "COMID") %>%
filter(grepl(paste0("^", substr(VPU, 1, 2), ".*"), .data$VPUID), COMID > 0) %>%
switchDiv(., nhd) %>%
summarize(EIA_PLANT = paste0(unique(EIA_PLANT_), collapse = " "), count = n())
# Derive TE POIs
tmp_POIs <- POI_creation(st_drop_geometry(TE_COMIDs), filter(nhd, dend == 1), "TE") %>%
addType(., tmp_POIs, "TE")
# As a fail-safe, write out list of TE plants not assigned a POI
if(nrow(filter(TE_COMIDs, !COMID %in% tmp_POIs$COMID)) > 0) {
write_sf(filter(TE_COMIDs, !COMID %in% tmp_POIs$COMID),
nav_gpkg, "unassigned_TE")
}
# Write out geopackage layer representing POIs for given theme
} else {
# Load TE POIs if they already exist
}
```
# 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, minNet == 1), "Conf") %>%
addType(., tmp_POIs, "Conf")
write_sf(nhd, nav_gpkg, nhd_flowline)
write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
nhd <- read_sf(nav_gpkg, nhd_flowline)
tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
# 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
} else {
# Load NID POIs if they already exist
# 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_layer)
# Segments that are in waterbodies
nhd <- mutate(nhd, WB = ifelse(WBAREACOMI > 0 & WBAREACOMI %in% WBs_VPU$COMID, 1, 0))
wbout_COMIDs <- filter(nhd, dend == 1 & WB == 1) %>%
select(COMID, WBAREACOMI)
wbin_COMIDs <- filter(nhd, WB == 0,
DnHydroseq %in% filter(nhd, WB == 1)$Hydroseq,
TotDASqKM >= min_da_km) %>%
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, nhd_flowline)
write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
nhd <- read_sf(nav_gpkg, nhd_flowline)
```{r Final POIs}
# Derive final POI set ----------------------

Blodgett, David L.
committed
if(needs_layer(nav_gpkg, pois_all_layer)) {
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,
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

Blodgett, David L.
committed
write_sf(new_POIs, nav_gpkg, poi_moved_layer)
write_sf(xWalk, nav_gpkg, poi_xwalk_layer)
# write out final POIs

Blodgett, David L.
committed
write_sf(final_POIs, nav_gpkg, pois_all_layer)
} else {
# If no fixes designate as NA
poi_fix <- NA
# write out final POIs

Blodgett, David L.
committed
write_sf(tmp_POIs, nav_gpkg, pois_all_layer)
# Need all three sets for attribution below

Blodgett, David L.
committed
final_POIs <- read_sf(nav_gpkg, pois_all_layer)
new_POIs <- if(layer_exists(nav_gpkg, poi_moved_layer)) read_sf(nav_gpkg, poi_moved_layer) else (NA)
xWalk <- if(layer_exists(nav_gpkg, poi_xwalk_layer)) read_sf(nav_gpkg, poi_xwalk_layer) 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 ----------------------
# 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, nhd_flowline)
write_sf(nsegments, nav_gpkg, nsegments_layer)
# Read in NHDPlusV2 flowline simple features and filter by vector processing unit (VPU)

Blodgett, David L.
committed
final_POIs <- read_sf(nav_gpkg, pois_all_layer)
nhd_Final <- read_sf(nav_gpkg, nhd_flowline)
nsegments <- read_sf(nav_gpkg, nsegments_layer)
# 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"))
```
#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, final_poi_layer)
write_sf(nhd_Final, nav_gpkg, nhd_flowline)
write_sf(out_HUC12$segs, nav_gpkg, nsegments_layer)
final_POIs2 <- read_sf(nav_gpkg, final_poi_layer)
nhd_Final <- read_sf(nav_gpkg, nhd_flowline)
nsegments <- read_sf(nav_gpkg, nsegments_layer)