Skip to content
Snippets Groups Projects
02_NHD_navigate.Rmd 13.2 KiB
Newer Older
editor_options:
  chunk_output_type: console
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.
knitr::opts_chunk$set(error = TRUE, cache = FALSE)
# Load custom functions
source("R/hyrefactor_funs.R")

# Load Configuration of environment
source("R/config.R")
# Load NHDPlus Data if precprocessed to RDS format
Bock, Andy's avatar
Bock, Andy committed
nhdplus_path(data_paths$nhdplus_gdb)
staged_nhd <- stage_national_data(nhdplus_data = data_paths$nhdplus_gdb,
                                  output_path  = data_paths$nhdplus_dir)
Bock, Andy's avatar
Bock, Andy committed
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)
Bock, Andy's avatar
Bock, Andy committed

# Need DnMinorHyd for switching POIs downstream of watebodies/dams
nhd_orig <- readRDS(file.path(data_paths$nhdplus_dir, "nhdplus_flowline.rds")) %>%
  st_drop_geometry() %>%
  select(COMID, DnMinorHyd)
Bock, Andy's avatar
Bock, Andy committed

```{r huc12 POIs}
Bock, Andy's avatar
Bock, Andy committed
#  Derive or load HUC12 POIs
Blodgett, David L.'s avatar
Blodgett, David L. committed
if(needs_layer(nav_gpkg, nav_poi_layer)) {
Blodgett, David L.'s avatar
Blodgett, David L. committed
  if (needs_layer(nav_gpkg, nhd_flowline)){
Bock, Andy's avatar
Bock, Andy committed
    # Subset NHD by VPU
Bock, Andy's avatar
Bock, Andy committed
    nhd <- VPU_Subset(nhd_rds, VPU) %>%
      left_join(nhd_orig, by = "COMID")
    if("arbolate_sum" %in% names(nhd)) nhd <- rename(nhd, ArbolateSu = arbolate_sum)
    
Bock, Andy's avatar
Bock, Andy committed
    # 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),
Bock, Andy's avatar
Bock, Andy committed
             poi = ifelse(!COMID %in% non_dend & TotDASqKM >= min_da_km, 1, 0)) 
Blodgett, David L.'s avatar
Blodgett, David L. committed
    write_sf(nhd, nav_gpkg, nhd_flowline)
Bock, Andy's avatar
Bock, Andy committed
  } else {
Blodgett, David L.'s avatar
Blodgett, David L. committed
     nhd <- read_sf(nav_gpkg, nhd_flowline)
     try(nhd <- select(nhd, -c(minNet, WB, struct_POI, struct_Net, POI_ID)))
Bock, Andy's avatar
Bock, Andy committed
  # Join 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)) %>%
Bock, Andy's avatar
Bock, Andy committed
    #filter(grepl("^02|^04", .data$HUC12)) %>% 
Bock, Andy's avatar
Bock, Andy committed
    select(COMID, HUC12) %>%
    #switchDiv(., nhd) %>%
    # Remove this when HUC12 outlets finished
    group_by(COMID) %>% 
    slice(1)
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Create POIs - some r05 HUC12 POIs not in R05 NHD
  huc12_POIs <- POI_creation(st_drop_geometry(HUC12_COMIDs), filter(nhd, poi == 1), "HUC12")
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Write out geopackage layer representing POIs for given theme
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(huc12_POIs, nav_gpkg, nav_poi_layer)
  # Load HUC12 POIs as the tmpPOIs if they already exist
Blodgett, David L.'s avatar
Blodgett, David L. committed
  tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer) 
  nhd <- read_sf(nav_gpkg, nhd_flowline)
```{r streamgage POIs}
if(all(is.na(tmp_POIs$Type_Gages))) { 
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Previously identified streamgages within Gage_Selection.Rmd
Bock, Andy's avatar
Bock, Andy committed
  streamgages <- read_sf("cache/Gages_info.gpkg", "Gages") %>%
Bock, Andy's avatar
Bock, Andy committed
    #filter(source != "GFv11" ) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    select(COMID, Gage_no) %>%
    filter(COMID %in% nhd$COMID) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    st_drop_geometry() %>%
    # 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
Bock, Andy's avatar
Bock, Andy committed
    switchDiv(., nhd) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    group_by(COMID) %>%
Bock, Andy's avatar
Bock, Andy committed
    top_n(n = -1)
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Derive GAGE POIs; use NHD as we've alredy filtered by NWIS DA in the Gage selection step
Bock, Andy's avatar
Bock, Andy committed
  tmp_POIs <- POI_creation(streamgages, filter(nhd, dend == 1), "Gages") %>%
    addType(., tmp_POIs, "Gages")
Bock, Andy's avatar
Bock, Andy committed
  
  # As a fail-safe, write out list of gages not assigned a POI
  if(nrow(filter(streamgages, !Gage_no %in% tmp_POIs$Type_Gages)) > 0) {
Bock, Andy's avatar
Bock, Andy committed
    write_sf(filter(read_sf("cache/Gages_info.gpkg", "Gages"), !Gage_no %in% tmp_POIs$Type_Gages),
Bock, Andy's avatar
Bock, Andy committed
             nav_gpkg, "unassigned_gages")
  }
  
  # Write out geopackage layer representing POIs for given theme
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
Bock, Andy's avatar
Bock, Andy committed
} else {
Blodgett, David L.'s avatar
Blodgett, David L. committed
  tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
```{r TE POIs}
#  Derive or load Thermoelectric POIs ----------------------
if(all(is.na(tmp_POIs$Type_TE))) {
  
  nhd$VPUID <- substr(nhd$RPUID, 1, 2)
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Read in Thermoelectric shapefile
Blodgett, David L.'s avatar
Blodgett, David L. committed
  TE_COMIDs <- read_sf(data_paths$TE_points_path, "2015_TE_Model_Estimates_lat.long_COMIDs") %>%
    mutate(COMID = as.integer(COMID)) %>%
Bock, Andy's avatar
Bock, Andy committed
    inner_join(., select(st_drop_geometry(nhd), COMID, VPUID), by = "COMID") %>%
Bock, Andy's avatar
Bock, Andy committed
    filter(grepl(paste0("^", substr(VPU, 1, 2), ".*"), .data$VPUID), COMID > 0) %>%
    #filter(grepl("^02.*|^04.*", data$VPUID), COMID > 0) %>% 
    switchDiv(., nhd) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    group_by(COMID) %>%
    summarize(EIA_PLANT = paste0(unique(EIA_PLANT_), collapse = " "), count = n()) 
Bock, Andy's avatar
Bock, Andy committed
  
   # Derive TE POIs
  tmp_POIs <- POI_creation(st_drop_geometry(TE_COMIDs), filter(nhd, dend == 1), "TE") %>%
    addType(., tmp_POIs, "TE")
Blodgett, David L.'s avatar
Blodgett, David L. committed

Bock, Andy's avatar
Bock, Andy committed
  # 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
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
} else {
  # Load TE POIs if they already exist
Blodgett, David L.'s avatar
Blodgett, David L. committed
  tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
```{r Confluence 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))
  
  # Create new confluence POIs
  conf_COMIDs <- st_drop_geometry(filter(nhd, minNet == 1)) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    # Downstream hydrosequence of 0 indicates
Bock, Andy's avatar
Bock, Andy committed
    #   the flowline is terminating or
Blodgett, David L.'s avatar
Blodgett, David L. committed
    #   leaving the domain, so they
Bock, Andy's avatar
Bock, Andy committed
    #   are excluded from this process
Bock, Andy's avatar
Bock, Andy committed
    filter(DnHydroseq > 0) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    group_by(DnHydroseq) %>%
    filter(n()> 1) %>%
    mutate(Type_Conf = LevelPathI) %>%
    select(COMID, Type_Conf)
Blodgett, David L.'s avatar
Blodgett, David L. committed

Bock, Andy's avatar
Bock, Andy committed
  tmp_POIs <- POI_creation(conf_COMIDs, filter(nhd, minNet == 1), "Conf") %>%
    addType(., tmp_POIs, "Conf")
  
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(nhd, nav_gpkg, nhd_flowline)
  write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
Blodgett, David L.'s avatar
Blodgett, David L. committed
  nhd <- read_sf(nav_gpkg, nhd_flowline)
  tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
```{r NID POIs}
#  Derive or load NID POIs ----------------------
if(all(is.na(tmp_POIs$Type_NID))) {
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # 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) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    switchDiv(., nhd) %>%
    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)
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Write out geopackage layer representing POIs for given theme
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
} else {
  # Load NID POIs if they already exist
Blodgett, David L.'s avatar
Blodgett, David L. committed
  tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
```{r waterbody POIs}
#  Derive or load Waterbody POIs ----------------------
if(all(is.na(tmp_POIs$Type_WBOut))) {
Blodgett, David L.'s avatar
Blodgett, David L. committed

  WBs_VPU <- readRDS("data/NHDPlusNationalData/nhdplus_waterbodies.rds") %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    mutate(FTYPE = as.character(FTYPE)) %>%
    filter(FTYPE %in% c("LakePond", "Reservoir") &
             AREASQKM >= (min_da_km/2) &
           COMID %in% filter(nhd, minNet == 1)$WBAREACOMI) %>%
    st_sf()
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Write out waterbodies
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(st_transform(WBs_VPU, 4269), nav_gpkg, WBs_layer)
Blodgett, David L.'s avatar
Blodgett, David L. committed

  # Segments that are in waterbodies
  nhd <- mutate(nhd, WB = ifelse(WBAREACOMI > 0 & WBAREACOMI %in% WBs_VPU$COMID, 1, 0))
Blodgett, David L.'s avatar
Blodgett, David L. committed

Bock, Andy's avatar
Bock, Andy committed
  wbout_COMIDs <- filter(nhd, dend == 1 & WB == 1) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    group_by(WBAREACOMI) %>%
Bock, Andy's avatar
Bock, Andy committed
    slice(which.min(Hydroseq)) %>%
Bock, Andy's avatar
Bock, Andy committed
    switchDiv(., nhd) %>%
    select(COMID, WBAREACOMI) 
Blodgett, David L.'s avatar
Blodgett, David L. committed

Bock, Andy's avatar
Bock, Andy committed
  wbin_COMIDs <- filter(nhd, WB == 0, 
                        DnHydroseq %in% filter(nhd, WB == 1)$Hydroseq,
                        TotDASqKM >= min_da_km) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    select(-WBAREACOMI) %>%
Bock, Andy's avatar
Bock, Andy committed
    switchDiv(., nhd) %>%
    inner_join(st_drop_geometry(filter(nhd, minNet == 1)) %>%
Bock, Andy's avatar
Bock, Andy committed
                 select(Hydroseq, WBAREACOMI), by = c("DnHydroseq" = "Hydroseq")) %>%
Blodgett, David L.'s avatar
Blodgett, David L. committed
    select(COMID, WBAREACOMI) %>%
    group_by(COMID) %>%
Bock, Andy's avatar
Bock, Andy committed
    slice(n = 1)
  tmp_POIs <- POI_creation(filter(wbout_COMIDs, !COMID %in% wbin_COMIDs$COMID), filter(nhd, poi == 1), "WBOut") %>%
Bock, Andy's avatar
Bock, Andy committed
    addType(., tmp_POIs, "WBOut")
  
  tmp_POIs <- POI_creation(filter(wbin_COMIDs, !COMID %in% wbout_COMIDs$COMID), filter(nhd, poi == 1), "WBIn") %>%
Bock, Andy's avatar
Bock, Andy committed
    addType(., tmp_POIs, "WBIn")
Blodgett, David L.'s avatar
Blodgett, David L. committed

Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(nhd, nav_gpkg, nhd_flowline)
  write_sf(tmp_POIs, nav_gpkg, nav_poi_layer)
Blodgett, David L.'s avatar
Blodgett, David L. committed
  tmp_POIs <- read_sf(nav_gpkg, nav_poi_layer)
  nhd <- read_sf(nav_gpkg, nhd_flowline)
# 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)
# Derive first cut of segments ----------------------
Blodgett, David L.'s avatar
Blodgett, David L. committed
if(needs_layer(nav_gpkg, nsegments_layer)) {
  # 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) 
Bock, Andy's avatar
Bock, Andy committed
  # derive incremental segments from POIs
  inc_segs <- segment_increment(filter(nhd, minNet == 1), seg_POIs) 
Bock, Andy's avatar
Bock, Andy committed
    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))
  
Blodgett, David L.'s avatar
Blodgett, David L. committed
  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)
  final_POIs <- read_sf(nav_gpkg, pois_all)
Blodgett, David L.'s avatar
Blodgett, David L. committed
  nhd_Final <- read_sf(nav_gpkg, nhd_flowline)
  nsegments <- read_sf(nav_gpkg, nsegments_layer)
Bock, Andy's avatar
Bock, Andy committed

# 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"))
```

```{r POI Collapse}
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)
Blodgett, David L.'s avatar
Blodgett, David L. committed
  write_sf(nhd_Final, nav_gpkg, nhd_flowline)
  write_sf(out_HUC12$segs, nav_gpkg, nsegments_layer)
  final_POIs <- read_sf(nav_gpkg, pois_merge)
Blodgett, David L.'s avatar
Blodgett, David L. committed
  nhd_Final <- read_sf(nav_gpkg, nhd_flowline)
  nsegments <- read_sf(nav_gpkg, nsegments_layer)