This workshop/tutorial will explore how to work with vector spatial data in R. We will load spatial data, examine the structure of the spatial data within R, perform some simple analyses using both vector spatial data and raster spatial data, and see some ways to create nice visuals of spatial information. Once you feel comfortable working with spatial data in R, you will rarely have to worry about using a GIS application at all.
For this workshop/tutorial, we will work through a simplified analysis to examine the proportion of British Columbia’s coastal waters that are protected by marine protected areas (MPAs). This is based on the Ocean Health Index Lasting Special Places sub-goal of the Sense of Place goal.
Here are two different ways to read in spatial vector data, each with advantages and disadvantages:
rgdal::readOGR()dir_spatial   <- 'spatial_data'
layer_bc <- 'ohibc_rgn_simple'
poly_bc_rgn <- readOGR(dsn = dir_spatial, layer = layer_bc, stringsAsFactors = FALSE)## OGR data source with driver: ESRI Shapefile 
## Source: "spatial_data", layer: "ohibc_rgn_simple"
## with 8 features
## It has 3 fields### you can easily plot polygons, though complex polys take a while
plot(poly_bc_rgn, col = 'light blue', border = 'blue')dsn is the data source name. It can be a .gdb or a directory with shapefiles in it. It can be relative or absolute file path.
dsn is not a fan of ~ as a shortcut for home directory, e.g. dsn = '~/github/ohiprep.path.expand(), e.g. dsn = path.expand('~/github/ohiprep')layer is the layer name.
ogrListLayers() can help identify the layers within the .gdb if you’re not sure.layer should be the base name of the shapefile (without the .shp extension). E.g. if you want rgn_all_mol_med_res.shp, then layer = 'rgn_all_mol_low_res'.p4s allows you to input a proj.4 string to indicate projection information (CRS - coordinate reference system). If there’s already a .prj file associated with this layer, readOGR() will automatically read it in.Quick aside on projections and coordinate reference systems:
'+proj=longlat +datum=WGS84 +no_defs +ellps=WGS84 +towgs84=0,0,0''+proj=moll +lon_0=0 +x_0=0 +y_0=0 +datum=WGS84 +units=m +no_defs''+proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000 +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0'maptools::readShapePoly()shp_bc <- file.path(dir_spatial, layer_bc)
p4s_bc <- CRS('+proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000 +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0')
poly_bc_rgn <- readShapePoly(fn = shp_bc, proj4string = p4s_bc)
plot(poly_bc_rgn, col = 'light blue', border = 'blue')fn is the full filename, leaving off the .shp extension. This has to be a shapefile (not a .gdb).proj4string is an optional proj.4 CRS designation.
readShapePoly() does not read .prj files, so it will not know the projection unless you manually tell it.proj4string = CRS('+proj=moll +lon_0=0 +x_0=0 +y_0=0 +datum=WGS84 +units=m +no_defs')readOGR() vs readShapePoly()readOGR() and readShapePoly() (and its cousins readShapeLines(), readShapePoints(), etc) also have analogous write functions.readShapePoly() seems to be significantly faster than readOGR() for big shapefiles.readShapePoly() doesn’t work on .gdb, which readOGR() can do.
readShapePoly() doesn’t automatically read in CRS info from a .prj file; you have to manually provide the coordinate reference system.readOGR() where possible (especially for smaller files), to automatically use projection/CRS information where it is available.Once the shapefile is read in, it becomes a SpatialPolygonsDataFrame object (from the sp package). SpatialPolygonsDataFrame store shape info and attributes in different slots, with a structure like this:
SpatialPolygonsDataFrame (top level structure)
@data: a dataframe that holds the attribute table; each row correlates with a polygon in the polygons slot.@polygons: a list of Polygons-class objects, each with their own bits and pieces. Each item in the list is a complete polygon feature, made up of sub-polygons; and each item in the list corresponds with a row in the dataframe in the data slot.@plotOrder: a vector of integers showing which order to plot the polygons list@bbox: info on the bounding coordinates (x & y min & max).@proj4string: a CRS object that contains projection or coordinate system infoSpatialPolygonsDataFrame structure
Each of these slots can be accessed by a @ symbol (rather than a $ symbol). If your SpatialPolygonsDataFrame is called x, then you can access the attribute table by calling x@data and treat it exactly like a regular data frame (though be wary of operations that might change the order or length of the data frame - confusion and chaos will reign!)
### view the overall structure
summary(poly_bc_rgn)## Object of class SpatialPolygonsDataFrame
## Coordinates:
##        min     max
## x 159642.4 1237659
## y 173874.5 1222687
## Is projected: TRUE 
## proj4string :
## [+proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000
## +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0]
## Data attributes:
##                    rgn_name     rgn_id        rgn_code
##  Aristazabal Island    :1   Min.   :1.00   AZ     :1  
##  Central Coast         :1   1st Qu.:2.75   CC     :1  
##  Haida Gwaii           :1   Median :4.50   HG     :1  
##  North Coast           :1   Mean   :4.50   NC     :1  
##  North Vancouver Island:1   3rd Qu.:6.25   NV     :1  
##  Pacific Offshore      :1   Max.   :8.00   PO     :1  
##  (Other)               :2                  (Other):2# str(poly_bc_rgn, max.level = 3) ### view object structure, similar to summary
### list the slots for this S4 object
slotNames(poly_bc_rgn)## [1] "data"        "polygons"    "plotOrder"   "bbox"        "proj4string"### check out the attribute table in the data slot
head(poly_bc_rgn@data)##                 rgn_name rgn_id rgn_code
## 0  West Vancouver Island      5       WV
## 1      Strait of Georgia      6       SG
## 2            North Coast      1       NC
## 3            Haida Gwaii      2       HG
## 4          Central Coast      3       CC
## 5 North Vancouver Island      4       NV### check out the basics of the polygon features
summary(poly_bc_rgn@polygons)  ### summary of the polygon features##      Length Class    Mode
## [1,] 1      Polygons S4  
## [2,] 1      Polygons S4  
## [3,] 1      Polygons S4  
## [4,] 1      Polygons S4  
## [5,] 1      Polygons S4  
## [6,] 1      Polygons S4  
## [7,] 1      Polygons S4  
## [8,] 1      Polygons S4# str(poly_bc_rgn@polygons, max.level = 3)
### inspect one of the smaller sub-polys that make up the first polygon
### feature; this one draws a small hole in the main polygon
poly_bc_rgn@polygons[[1]]@Polygons[[2]] ## An object of class "Polygon"
## Slot "labpt":
## [1] 958586.6 510488.3
## 
## Slot "area":
## [1] 30115.12
## 
## Slot "hole":
## [1] TRUE
## 
## Slot "ringDir":
## [1] -1
## 
## Slot "coords":
##          [,1]     [,2]
## [1,] 958598.4 510391.4
## [2,] 958708.1 510505.0
## [3,] 958610.9 510624.9
## [4,] 958445.0 510410.6
## [5,] 958598.4 510391.4### check out the CRS info
poly_bc_rgn@proj4string## CRS arguments:
##  +proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000
## +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0You can also manipulate these slots individually, for example filtering out rows of the dataframe in the data slot, but you will also need to treat the other slots accordingly.
If you’d like to add a column of data to the SpatialPolygonsDataFrame, for example harvest tonnes or a region ID value, you should be able to simply access the data slot and treat it like a data frame.
NOTE: When accessing the @data slot, keep in mind that all of the polygon information is in the @polygons slot - and the order of rows in @data needs to stay matched up with the order of the list in @polygons. Changing the order of rows (or adding/deleting rows) in @data DOES NOT make analogous changes to @polygons… and chaos ensues.
### create a data frame of harvest per region.  Note not all regions are represented here!
harv_data <- data.frame(rgn_id   = c(  1,  2,  3,  5,  8),
                        h_tonnes = c(105, 89, 74, 21, 11))
### use left_join to join data to attributes table without changing order
poly_bc_rgn@data <- poly_bc_rgn@data %>%
  left_join(harv_data, by = 'rgn_id')
### note unassigned regions have NA for harvest tonnage
poly_bc_rgn@data##                 rgn_name rgn_id rgn_code h_tonnes
## 1  West Vancouver Island      5       WV       21
## 2      Strait of Georgia      6       SG       NA
## 3            North Coast      1       NC      105
## 4            Haida Gwaii      2       HG       89
## 5          Central Coast      3       CC       74
## 6 North Vancouver Island      4       NV       NA
## 7     Aristazabal Island      8       AZ       11
## 8       Pacific Offshore      7       PO       NAYou should also be able to use dplyr- and tidyr-type functions like mutate() and group_by() (since group_by() doesn’t reorder the rows); just be careful of things like filter(), arrange(), summarize(), and full_join() that might reorder or add or delete rows.
poly_bc_rgn@data <- poly_bc_rgn@data %>%
  mutate(
    h_kg   = h_tonnes * 1000,
    h_tot  = sum(h_tonnes, na.rm = TRUE),
    h_prop = round(h_tonnes/h_tot, 3))
poly_bc_rgn@data##                 rgn_name rgn_id rgn_code h_tonnes   h_kg h_tot h_prop
## 1  West Vancouver Island      5       WV       21  21000   300  0.070
## 2      Strait of Georgia      6       SG       NA     NA   300     NA
## 3            North Coast      1       NC      105 105000   300  0.350
## 4            Haida Gwaii      2       HG       89  89000   300  0.297
## 5          Central Coast      3       CC       74  74000   300  0.247
## 6 North Vancouver Island      4       NV       NA     NA   300     NA
## 7     Aristazabal Island      8       AZ       11  11000   300  0.037
## 8       Pacific Offshore      7       PO       NA     NA   300     NAUse indexing to select just rows where there is harvest data. This eliminates the polygons as well as the attribute table rows, and resets the plot order. Probably safer than filtering on the data slot directly…
### Select only regions with non-NA harvest values
poly_bc_harvest <- poly_bc_rgn[!is.na(poly_bc_rgn@data$h_tonnes), ]
### or use base::subset (but not dplyr::filter)
poly_bc_harvest <- poly_bc_rgn %>% subset(!is.na(h_tonnes))
poly_bc_harvest@data##                rgn_name rgn_id rgn_code h_tonnes   h_kg h_tot h_prop
## 1 West Vancouver Island      5       WV       21  21000   300  0.070
## 3           North Coast      1       NC      105 105000   300  0.350
## 4           Haida Gwaii      2       HG       89  89000   300  0.297
## 5         Central Coast      3       CC       74  74000   300  0.247
## 7    Aristazabal Island      8       AZ       11  11000   300  0.037plot(poly_bc_rgn,     col = rgb(.7, .7, 1),      border = rgb(0, 0, 1))
plot(poly_bc_harvest, col = rgb(.7, .3, .3, .5), border = rgb(1, 0, 0, .5), add = TRUE)fun fact: the rgb() function allows you to specify color by Red/Green/Blue proportions (0 to 1), but also allows a fourth argument for ‘alpha’ (opacity) to create semi-transparent layers. There are also similar hsv() and hcl() functions if you are a graphics nerd and prefer to specify hue/saturation/value or hue/chroma/luminance…
Mismatched coordinate reference systems are just as much a pain in R as they are in ArcGIS or QGIS. But they’re easy to work with once you know how to inspect them and re-project them.
### Load and plot the MPA map on top of the regions
poly_bc_mpa <- readOGR(dsn = dir_spatial, layer = 'mpa_bc_simple')## OGR data source with driver: ESRI Shapefile 
## Source: "spatial_data", layer: "mpa_bc_simple"
## with 18 features
## It has 28 fieldsplot(poly_bc_rgn, col = rgb(.7, .7, 1), border = rgb(0, 0, 1))
plot(poly_bc_mpa, col = rgb(1, .5, .5, .5), border = rgb(1, 0, 0, .5), add = TRUE)Note that the MPA polys don’t show up on the map! That’s because of a CRS error…
poly_bc_mpa@proj4string ## CRS arguments:
##  +proj=longlat +datum=WGS84 +no_defs +ellps=WGS84 +towgs84=0,0,0This layer’s CRS is WGS84, but the BC regions map is in BC Albers projection.
If the proj4string had been NA (e.g. if we had used readShapePoly() and not specified a CRS), we could manually set the projection by accessing the @proj4string slot: * poly_bc_mpa@proj4string <- CRS('+proj=longlat +datum=WGS84 +no_defs +ellps=WGS84 +towgs84=0,0,0')
Reprojecting to a new CRS is not as simple as just assigning a new CRS to the @proj4string slot though… instead, we can use the rgdal::spTransform() function.
poly_bc_mpa <- spTransform(poly_bc_mpa, p4s_bc)
poly_bc_mpa@proj4string## CRS arguments:
##  +proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000
## +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0poly_bc_rgn@proj4string  ### OK, now they match!## CRS arguments:
##  +proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000
## +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0plot(poly_bc_rgn, col = rgb(.7, .7, 1), border = rgb(0, 0, 1))
plot(poly_bc_mpa, col = rgb(1, .5, .5, .5), border = rgb(1, .3, .3, .8), add = TRUE)  ### The semi-transparency not only looks awesome, but also
  ### allows us to see whether there are any overlapping polygons!Note that transforming projections might introduce geometry errors in a previously error-free Spatial object… for notes on checking and fixing this, see the appendix.
The rgeos package has many of the standard geoprocessing tools available, for example: gArea(), gDifference(), gIntersection(), gBuffer()… and the raster package builds further upon some of these. For example, rgeos::gIntersection() and raster::intersect() both return polygon entities but gIntersection() drops the data frames (apparently on purpose…?)
Let’s apply those to our polygon layers, in order to find how much of the coastline is protected by marine protected areas. Here’s what we’ll try:
raster::intersect()) the MPA layer with the 3 nautical mile offshore layerrgeos::gArea()) of the near-shore ocean, from the coastline out to 3 nautical miles, for each of BC’s regions.### Load in the 3 nm buffer layer
poly_bc_3nm <- readShapePoly(fn = file.path(dir_spatial, 'ohibc_offshore_3nm_simple'), proj4string = p4s_bc)
### plot regions, mpa layer, and 3 nm regions
plot(poly_bc_rgn, col = rgb(.7, .7, 1), border = rgb(0, 0, 1))
plot(poly_bc_mpa, col = rgb(1, .5, .5, .5), border = rgb(1, .3, .3, .8), add = TRUE)
plot(poly_bc_3nm, col = rgb(.5, 1, .5, .5), border = rgb(.3, 1, .3, .8), add = TRUE)
### Intersect the MPA layer with the 3 nm regions layer
poly_bc_3nm_mpa <- raster::intersect(poly_bc_mpa, poly_bc_3nm)
### plot the new intersected layer
plot(poly_bc_3nm_mpa, col = rgb(1, 1, .5, .5), border = rgb(1, 1, .3, .7), add = TRUE)### Calculate area of protected areas and coastal regions, and attach to polygons
poly_bc_3nm_mpa@data$area_km2 <- gArea(poly_bc_3nm_mpa, byid = TRUE) / 1e6
poly_bc_3nm@data$area_km2 <- gArea(poly_bc_3nm, byid = TRUE) / 1e6
### Summarize the total protected area within each region
prot_area_df <- poly_bc_3nm_mpa@data %>%
  group_by(rgn_id, rgn_name, rgn_code) %>%
  summarize(prot_area_km2 = sum(area_km2)) %>%
  left_join(poly_bc_3nm@data %>% 
              select(rgn_id, tot_area_km2 = area_km2),
            by = 'rgn_id') %>%
  mutate(prot_area_pct = round(prot_area_km2 / tot_area_km2, 3) * 100)
# pretty static table
knitr::kable(prot_area_df)| rgn_id | rgn_name | rgn_code | prot_area_km2 | tot_area_km2 | prot_area_pct | 
|---|---|---|---|---|---|
| 1 | North Coast | NC | 1112.2263 | 8022.5917 | 13.9 | 
| 2 | Haida Gwaii | HG | 2693.6903 | 6717.9962 | 40.1 | 
| 3 | Central Coast | CC | 675.9824 | 5191.9460 | 13.0 | 
| 4 | North Vancouver Island | NV | 780.4560 | 6462.7713 | 12.1 | 
| 5 | West Vancouver Island | WV | 447.7321 | 4553.7525 | 9.8 | 
| 6 | Strait of Georgia | SG | 349.5775 | 6265.3581 | 5.6 | 
| 8 | Aristazabal Island | AZ | 110.2948 | 909.7969 | 12.1 | 
# or interactive table
DT::datatable(prot_area_df)Extracting raster data into regions defined by a SpatialPolygons* object is pretty easy, using the extract() function from the raster package. In next few code chunks we’ll repeat the analysis from above, to identify the percent of BC’s near-shore ocean that is protected by MPAs, using rasters.
While it is possible to use vector geoprocessing to figure this out, overlapping polygons could be double-counted, so this time I will instead rasterize the MPA polygons, prioritizing the earliest date of protection, then we’ll tally up the protected area and total area. First step - establish a base raster.
We will use the extents of the poly_bc_rgn to set raster extents and then round to nearest 10 km. There are a couple of ways we can find the extents of the layer: raster::extent() or just access the @bbox slot of the SpatialPolygonsDataFrame object.
Resolution note: since we’re trying to analyze protected areas within a 3-nm-wide feature, our resolution should be AT MOST half the size of that feature, or 1.5 nm.
ext <- extent(poly_bc_rgn); ext## class       : Extent 
## xmin        : 159642.4 
## xmax        : 1237659 
## ymin        : 173874.5 
## ymax        : 1222687ext1 <- poly_bc_rgn@bbox; ext1##        min     max
## x 159642.4 1237659
## y 173874.5 1222687ext@xmin <- round(ext@xmin - 5000, -4); ext@ymin <- round(ext@ymin - 5000, -4)
### expand the extents out to round 10 km edges
ext@xmax <- round(ext@xmax + 5000, -4); ext@ymax <- round(ext@ymax + 5000, -4)
### if using the @bbox option, use ext1['x', 'min'] and such
reso <- 2500 ### BC Albers uses meters as units, set resolution to a 2.5-km grid
xcol <- (ext@xmax - ext@xmin)/reso ### determine # of columns from extents and resolution
yrow <- (ext@ymax - ext@ymin)/reso ### determine # of rows
rast_base <- raster(ext, yrow, xcol, crs = p4s_bc)
rast_base ### inspect it: resolution and extents are nice and clean## class       : RasterLayer 
## dimensions  : 424, 436, 184864  (nrow, ncol, ncell)
## resolution  : 2500, 2500  (x, y)
## extent      : 150000, 1240000, 170000, 1230000  (xmin, xmax, ymin, ymax)
## coord. ref. : +proj=aea +lat_1=50 +lat_2=58.5 +lat_0=45 +lon_0=-126 +x_0=1000000 +y_0=0 +datum=NAD83 +units=m +no_defs +ellps=GRS80 +towgs84=0,0,0Next step: rasterize the MPA polygons. See later in the doc for info on gdalUtils::gdal_rasterize() as an alternative to raster::rasterize() that is way faster, avoids some odd problems, but has some arcane arguments and a fairly important limitation. raster::rasterize() is probably your best bet in general.
In this case, we will rasterize the MPA polygons using the rast_base raster to set extents and cell size. The cells will get the value of the STATUS_YR attribute (the year in which the MPA was designated); for overlapping MPAs, the earliest year (‘min’) will be used.
rast_bc_mpa <- rasterize(poly_bc_mpa, rast_base, field = 'STATUS_YR', fun = 'min')Note that the raster package also contains functions for rasterToPolygons(), rasterToPoints(), etc. to turn rasters into vector spatial objects.
raster::extract()Now the big step: raster::extract(). Basically we will overlay a set of region polygons on top of our raster, and group the cells by which region they fall into. For cells that overlap the border between multiple regions, it will even tell us how much of the cell falls into each region (if we set weights = TRUE), but this is very slow…
raster::extract() image
Note that extract() is also a function in the tidyr package and elsewhere; so I generally force the issue by calling raster::extract() just to make sure.
The basic arguments are simply the raster with the interesting data, and the polygon features that define the regions of interest. There are other arguments, but one set of arguments that may be interesting is weights and/or normalizeWeights.
weights (logical): if weights = TRUE, provides info on how much of a cell was covered by the polygon in question.normalizeWeights (logical): if normalizeWeights = TRUE then the reported weights will be normalized for each polygon, so the total for each polygon adds up to 1.00. If you just want the fraction of cell coverage for each cell, set normalizeWeights = FALSE.It’s a bit processor-intensive so be patient…
### plot the MPA raster with the 3 nm regions on top, just to see
plot(poly_bc_rgn, col = rgb(.7, .7, 1, .5), border = NA)
plot(rast_bc_mpa, add = TRUE)
plot(poly_bc_3nm, col = rgb(1, .5, .5, .5), border = NA, add = TRUE)### Extract the MPA raster cells by region
mpa_by_rgn <- raster::extract(rast_bc_mpa, poly_bc_3nm, weights = FALSE)
# mpa_by_rgn_weights <- raster::extract(rast_bc_mpa, poly_bc_3nm, weights = TRUE, normalizeWeights = FALSE)raster::extract() output into something usefulraster::extract() returns a list of vectors; each list item is a vector of all the cell values contained within one of the polygon features (poly_bc_3nm@polygons). At this point, we need to assign a non-generic name to our list items so we can keep track. The following line names the list items according to the rgn_id column in the attribute table contained in poly_bc_3nm@data (this works since the list is in order of items in the @polygons slot, which is the same order of attributes in the @data slot).
names(mpa_by_rgn) <- poly_bc_3nm@data$rgn_id
# names(mpa_by_rgn_weights) <- poly_bc_3nm@data$rgn_idTo get the data out of annoying list form and into convenient data frame form, this next code chunk does the following:
mpa_rgn_df) that we will build up as we unlist each list item.rgn_ids in the previous step)
rgn_id (from loop index) and the entire list of cell values for that particular rgn_iddata_rgn_df (first time through, tacks onto an empty data frame)Voilà ! a data frame of cell values by region.
### For the dataframe without cell weights, each list is just a
### vector of values, so we can simply assign that to a column in
### the data frame.
mpa_rgn_df <- data.frame()
for (rgn_id in names(mpa_by_rgn)) {
  temp_df <- data.frame(rgn_id = as.numeric(rgn_id), 
                        year   = unlist(mpa_by_rgn[[rgn_id]]))
  mpa_rgn_df <- rbind(mpa_rgn_df, temp_df)
}
### for the dataframe with cell weights, each list item is a 
### matrix containing value & weight, so we can unlist it into a temp
### matrix and then assign each variable separately.  
# mpa_rgn_weights_df <- data.frame()
# for (rgn_id in names(mpa_by_rgn_weights)) {
#   temp_matrix <- unlist(mpa_by_rgn_weights[[rgn_id]])
#   temp_df <- data.frame(rgn_id, year = temp_matrix$value, wt = temp_matrix$weight)
#   mpa_rgn_df <- rbind(mpa_rgn_weights_df, temp_df)
# }Now we can use that data frame like any regular data frame. Let’s find out how many cells in each region, and how many of those cells are protected by MPAs. We’ll ignore the year for now; any cell with a non-NA will count as protected.
prot_area_df2 <- mpa_rgn_df %>%
  group_by(rgn_id) %>%
  summarize(cells_mpa     = sum(!is.na(year)),
            cells_tot     = n(),
            prot_area_pct = round(cells_mpa/cells_tot, 3) * 100) %>%
  left_join(poly_bc_rgn@data %>%
              select(rgn_id, rgn_name),
            by = 'rgn_id')
prot_area_df <- prot_area_df %>%
  rename(prot_pct_vec = prot_area_pct) %>%
  left_join(prot_area_df2 %>%
              select(rgn_id, prot_pct_rast = prot_area_pct))## Joining by: "rgn_id"knitr::kable(prot_area_df)| rgn_id | rgn_name | rgn_code | prot_area_km2 | tot_area_km2 | prot_pct_vec | prot_pct_rast | 
|---|---|---|---|---|---|---|
| 1 | North Coast | NC | 1112.2263 | 8022.5917 | 13.9 | 13.7 | 
| 2 | Haida Gwaii | HG | 2693.6903 | 6717.9962 | 40.1 | 40.9 | 
| 3 | Central Coast | CC | 675.9824 | 5191.9460 | 13.0 | 13.2 | 
| 4 | North Vancouver Island | NV | 780.4560 | 6462.7713 | 12.1 | 12.4 | 
| 5 | West Vancouver Island | WV | 447.7321 | 4553.7525 | 9.8 | 9.7 | 
| 6 | Strait of Georgia | SG | 349.5775 | 6265.3581 | 5.6 | 5.7 | 
| 8 | Aristazabal Island | AZ | 110.2948 | 909.7969 | 12.1 | 12.2 | 
Note the small differences in the protected area percent, depending on whether raster or vector method was used.
To see much of this stuff put into action, check out OHIBC LSP script and its associated functions.
For a more complex version that maintains the spatial distribution of the data, check out OHI global 2015 SPP_ICO goal script and its associated functions. In these scripts, a raster of cell IDs is extracted against polygons for many different species; the resulting lists tell which cell IDs contain which species.
This downres_polygons.R script was used to simplify the high resolution global polygon shapefiles (308 MB of polygon fun) into lower resolution files (.7 MB and 11 MB versions) for quicker plotting. While the script itself may not be all that useful to you, there are plenty of examples of digging into and manipulating the details of SpatialPolygonsDataFrame objects. The script first examines each polygon feature, and strips out sub-polygons whose area falls below a certain threshold; then it simplifies the geometry of the remaining polygons using a Douglas-Peuker algorithm.
Most of what you need to know about rasters is covered in Jamie’s spatial data workshop. One added point: an alternative method of rasterizing vector data, when raster::rasterize() is causing problems.
Note that one major issue with gdal_rasterize() (aside from the arcane argument list) is that in the event of overlapping polygons, there’s no place for a decision rule as to which polygon value gets assigned to the cell. If you know there are no overlaps, then this is a very fast and seemingly accurate option.
library(gdalUtils)
rast_3nm_gdal <- gdal_rasterize(
    src_datasource = file.path(dir_spatial, 'ohibc_offshore_3nm.shp'),
      # src_datasource needs to be an OGR readable format (e.g. .shp)
      # NOTE: doesn't need source to already be in memory!
    dst_filename = file.path(dir_spatial, 'rast_3nm_gdal.tif'), 
      # destination for output
    a = 'rgn_id', 
      # the attribute in the shapefile to be assigned to the cell values
    te = c(ext@xmin, ext@ymin, ext@xmax, ext@ymax), 
      # extents for output raster
    tr = c(2500, 2500),   
      # resolution for x and y; for my projection, 2500 m resolution
    tap = TRUE, 
      # target aligned pixels - align coords of extent of output to values of -tr
    a_nodata = NA, 
      # nodata value for raster; otherwise they will be filled in with zeroes
    output_Raster = TRUE, 
      # return output as a RasterBrick? 
    verbose = TRUE)
  ### unused but interesting arguments:
    # l,     # layer; maybe needed if src_datasource is .gdb, with mult layers
    # of,    # output format; default = GTiff, so I left it stay as default
    # a_srs  # override projectionThe rgeos package has some helpful functions for manipulating SpatialPolygons - including ways to check invalid geometries and typical GIS tools for checking and manipulating geometries, such as gUnion(), gDifference(), gIntersection(), gBuffer(), etc.
Sometimes shape files have errors - common ones are too few points or self-intersections. These errors can be problems with the original data, or can accidentally be introduced when re-projecting, simplifying, or operating on polygons. rgeos::gIsValid() can tell you whether the SpatialPolygons* object is valid or not, but it can’t fix the problems directly.
cleangeo package has tools for identifying problems, and has a tool to repair geometries.rgn <- readShapePoly(fn = file.path(dir_spatial, 'ohibc_rgn'))
gIsValid(rgn, byid = TRUE) 
### cleangeo provides an alternate way of checking geometries if
### you'd like more details on the problems.
library(cleangeo)
report  <- clgeo_CollectionReport(rgn)
issues  <- report %>% filter(valid == FALSE)
issues ### two polygons with problems
### How to fix it? go into QGIS and fix the geometry (use the reported points)
### But just for fun, let's try cleangeo! Not perfect - check your results.
rgn_clean <- clgeo_Clean(rgn, print.log = TRUE)
issues  <- clgeo_CollectionReport(rgn_clean)
             %>% filter(valid == FALSE)
issues ### No more issues?  though gIsValid seems to disagree...ggplot works with data frames; so if you want to plot a polygon, you need to first turn it into a data frame. ggplot2::fortify() takes care of this. The region argument lets you assign a variable within the attribute table to become a region identifier.
Note: make sure you have all your CRS and projection stuff figured out first!
library(ggplot2)
library(RColorBrewer)
### Fortify the existing poly_bc_rgn SpatialPolygonsDataFrame into a
### data frame that ggplot can work with.  
poly_rgn_df <- fortify(poly_bc_rgn, region = 'rgn_id') %>%
  rename(rgn_id = id) %>%
  mutate(rgn_id = as.integer(rgn_id)) 
### if you get the error "Error: isTRUE(gpclibPermitStatus()) is not TRUE" you
### might need to do this: install.packages("gpclib", type="source")
### then restart R to basically override the permit...
### Note: Even though we already have a map with harvest data attached,
### I'm not sure that there's a good way to keep all the attributes
### so I'm just left-joining harvest data to the fortified data frame.
n_rgn <- length(poly_bc_rgn@data$rgn_id)
harv_data2 <- data.frame(rgn_id   = c(1:n_rgn),
                         h_tonnes = c(105, 89, 74, NA, 21, 0, NA, 11))
poly_rgn_df <- poly_rgn_df %>%
  left_join(harv_data2, by = 'rgn_id')
head(poly_rgn_df)##       long      lat order  hole piece rgn_id group h_tonnes
## 1 817328.2 914944.0     1 FALSE     1      1   1.1      105
## 2 816340.1 913734.0     2 FALSE     1      1   1.1      105
## 3 814515.5 915410.4     3 FALSE     1      1   1.1      105
## 4 814090.3 915889.2     4 FALSE     1      1   1.1      105
## 5 812669.2 917070.7     5 FALSE     1      1   1.1      105
## 6 812384.2 917604.8     6 FALSE     1      1   1.1      105scale_lim <- c(0, max(poly_rgn_df$h_tonnes))
 
### To plot land forms, let's load a land shapefile too.
poly_land    <- readShapePoly(fn = file.path(dir_spatial, 'ohibc_land_simple'), proj4string = p4s_bc)
poly_land_df <- fortify(poly_land)## Regions defined for each Polygonsdf_plot <- ggplot(data = poly_rgn_df, aes(x = long, y = lat, group = group, fill = h_tonnes)) +  
  theme(axis.ticks = element_blank(), axis.text = element_blank(),
        text = element_text(family = 'Helvetica', color = 'gray30', size = 12),
        plot.title = element_text(size = rel(1.5), hjust = 0, face = 'bold'),
        legend.position = 'right',
        panel.grid = element_blank()) + 
  scale_fill_gradientn(colours = brewer.pal(10, 'RdYlBu'), space = 'Lab', 
                       na.value = 'gray80', limits = scale_lim) + 
  geom_polygon(color = 'gray80', size = 0.1) +
  geom_polygon(data = poly_land_df, color = 'gray40', fill = 'gray45', size = 0.25) +
    ### df_plot order: EEZ score polygons, then land polygons (dark grey).
  labs(title = 'OHI BC harvest by region', 
       fill  = 'Harvest (tonnes)',
       x = NULL, y = NULL)
         
print(df_plot)### ggsave() saves the most recent ggplot object by default
ggsave(file.path(dir_spatial, 'bc_harvest.png'), width = 10, height = 6)The tmap package uses a similar grammar to ggplot2, but seems way more intuitive for plotting maps. You build up a map layer by layer, without having to do anything special to manipulate the polygons as you do for ggplot.
tmap uses tm_shape() to define the object to be plotted, similar to ggplot(); and then layer assignments, similar to geom_line() or geom_boxplot() etc. See here for more: https://cran.r-project.org/web/packages/tmap/vignettes/tmap-nutshell.html.
First let’s set up a basic map, and then use this to see what happens when we add additional layers, styles, etc.
library(tmap)
library(RColorBrewer)
head(poly_bc_rgn@data, 3) ### what attributes can we plot?##                rgn_name rgn_id rgn_code h_tonnes   h_kg h_tot h_prop
## 1 West Vancouver Island      5       WV       21  21000   300   0.07
## 2     Strait of Georgia      6       SG       NA     NA   300     NA
## 3           North Coast      1       NC      105 105000   300   0.35#                rgn_name rgn_id rgn_code h_tonnes   h_kg h_tot h_prop
# 1 West Vancouver Island      5       WV       21  21000   300   0.07
# 2     Strait of Georgia      6       SG       NA     NA   300     NA
# 3           North Coast      1       NC      105 105000   300   0.35
### set up base map, with land underneath and ocean regions on top
bc_map_base <-   
  tm_shape(poly_land) + ### this creates the bottom layer as the shaded land
    tm_fill(col = 'grey40')
bc_map_base <- bc_map_base +
  tm_shape(poly_bc_rgn, is.master = TRUE) + ### is.master so this layer will drive extents, etc
    tm_fill(col = 'h_tonnes',
            title = "Harvest (tonnes)") +
    tm_borders(col = 'grey30', lwd = 1)
print(bc_map_base)Add a few extra layers to the base map; each of these layers directly accesses the attribute table (@data) in our BC harvest spatial polygons object. You can also add additional shapes (e.g. we could add a layer based on the BC MPA spatial polygons object).
### add additional layers to the base map, to display other data
bc_map_layers <- bc_map_base +
    tm_bubbles(col = 'rgn_id', size = 'h_prop',
               title.size = "Harvest (proportion)", 
               legend.col.show = FALSE) +
    tm_text('rgn_code', size = 'h_prop', root = 5, 
            legend.size.show = FALSE)
print(bc_map_layers)Map styles and small multiples are easy to do; and there is plenty of direct control on the formatting of the legend and other elements of the map.
### add some formatting and style to the base map
bc_map_styled <- bc_map_base +
  tm_format_Europe() + ### some auto-formatting of legend, plot area, etc...
  tm_style_cobalt(title = 'British Columbia harvest')
print(bc_map_styled)### small multiples by passing a vector of variables to a layer
bc_map_multi <- bc_map_base +
  tm_shape(poly_bc_rgn, is.master = TRUE) + ### is.master so this will drive extents, etc
    tm_polygons(col = c('rgn_id', 'h_tonnes'))
print(bc_map_multi)### format the legend of the base map
bc_map_legend <- bc_map_base +
  tm_style_cobalt(title = 'British Columbia harvest') +
  tm_legend(text.size=1,
            title.size=1.2,
            position = c("left","bottom"), 
            bg.color = "white", 
            bg.alpha=.2, 
            frame="gray50", 
            height=.6, 
            hist.width=.2,
            hist.height=.2, 
            hist.bg.color="gray60", 
            hist.bg.alpha=.5)
print(bc_map_legend)### instead of ggsave:
save_tmap(bc_map_legend, "img/bc_map.png", width=1200, height=1000)## Map saved to /home/ohara/github/spatial_analysis2_R/img/bc_map.png## Resolution: 1200 by 1000 pixels## Size: 4 by 3.333333 inches (300 dpi)Here’s an example of a map created using tmap, with all the relevant code from the page above: 
Interactive maps can be created using other tools such as leaflet and plotly; these probably deserve a workshop all on their own.