Abstract
TheR
package ipdw
provides functions for
interpolation of georeferenced point data via Inverse Path Distance
Weighting. Useful for coastal marine applications where barriers in the
landscape preclude interpolation with Euclidean distances. This method
of interpolation requires significant computation and is only practical
for relatively small and coarse grids. The ipdw
implementation may provide additional flexibility and greater speed
relative to alternatives.
This vignette describes ipdw
, an R
package
which provides the functionality to perform interpolation of
georeferenced point data using inverse path distance weighting (Suominen, Tolvanen, and Kalliola 2010).
Interpolation is accomplished in two steps. First, path distances are
calculated from each georeferenced (measurement) point to each
prediction point. Path distances, which honor barriers in the landscape,
are calculated based on cell-to-cell movement through an underlying
Raster
object (Hijmans 2014)
that represents movement cost. These path distances are subsequently
used as interpolation weights. The two-step routine follows the order of
operations described in Suominen, Tolvanen, and
Kalliola (2010) substituting the ESRI path distance algorithm
Mitchell (2012) with the
gdistance
(Etten 2014)
wrapped version of the igraph
(Csardi and Nepusz 2006) adjacency
algorithm.
The ipdw
package was developed with coastal marine
applications in mind where path distances (as the fish swims) rather
than Euclidean (as the crow flies) distances more accurately represent
spatial connectivity (Little, Edwards, and Porter
1997). Interpolation of sparse grids in coastal areas otherwise
end up bleeding through land areas (Stachelek and
Madden 2015). The remainder of this vignette provides an example
of such a situation using the Kattegat salinity dataset (Diggle and Lophaven 2006) found within the
geoR
package.
library(ipdw)
To begin, we need to load an object representing point observations
as either a matrix of coordinates or a
SpatialPointsDataFrame
object and an object representing a
coastline as a SpatialPolygonsDataFrame
object. The data
for this demonstration come from a built-in dataset in the
geoR
package for the Kattegat basin of Denmark (see
?geoR::kattegat
).
library(rgdal)
<- readOGR(system.file("extdata/kattegat_coast.gpkg", package = "ipdw")) pols
## Warning in OGRSpatialRef(dsn, layer, morphFromESRI = morphFromESRI, dumpSRS
## = dumpSRS, : Discarded datum unknown in Proj4 definition: +proj=utm +zone=32
## +ellps=GRS80 +units=m +no_defs
<- readOGR(system.file("extdata/kattegat_pnts.gpkg", package = "ipdw")) pnts
## Warning in OGRSpatialRef(dsn, layer, morphFromESRI = morphFromESRI, dumpSRS
## = dumpSRS, : Discarded datum unknown in Proj4 definition: +proj=utm +zone=32
## +ellps=GRS80 +units=m +no_defs
We can use this SpatialPolygons
object to create a cost
raster defining travel through land areas with a very high cost. As a
result, interpolation neighborhoods will be defined based on in-water
rather than Euclidean distances. Cost raster creation is accomplished
with the ipdw
function costrasterGen
. By
default, open water areas are set to a per unit travel cost of 1 whereas
land areas are set to a per unit travel cost of 10,000. Note that a
projection is defined for the costrasterGen
function by the
projstr
parameter. It is critical to check the resolution
of the cost raster before proceeding. The resolution of the cost raster
will determine the resolution of the interpolated output. If the
resolution is too fine, this will result in very long processing times.
If necessary, coarsen the cost raster with the raster
function aggregate
.
<- costrasterGen(pnts, pols, extent = "pnts",
costras projstr = projection(pols))
## Warning in sp::proj4string(xymat): CRS object has comment, which is lost in output; in tests, see
## https://cran.r-project.org/web/packages/sp/vignettes/CRS_warnings.html
## Warning in sp::proj4string(pols): CRS object has comment, which is lost in output; in tests, see
## https://cran.r-project.org/web/packages/sp/vignettes/CRS_warnings.html
# insert contiguous barrier
160:170, 1:80] <- 10000 costras[
In order to evaluate the utility of IPDW, we split the dataset into
seperate training and validation datasets. The training dataset is
created in a spatially balanced manner by building a grid and randomly
selecting one measurement point per grid cell. In the following code
block, the size of this grid is defined as 2 times the average distance
among measurement points. Average distance is computed using the
spatstat
package (Baddeley and
Turner 2005). Random selection is accomplished with the
gdata
function resample
(Warnes et al. 2014). Subsetting the full
dataset is not required to run ipdw
. Alternative means of
estimating interpolation errors, such as leave-one-out cross validation,
are in development.
# find average nearest neighbor
library(spatstat)
<- owin(range(coordinates(pnts)[, 1]), range(coordinates(pnts)[, 2]))
W <- ppp(coordinates(pnts)[, 1], coordinates(pnts)[, 2], window = W)
kat.pp <- mean(nndist(kat.pp))
mean.neighdist
# grid building
<- mean.neighdist * 2
gridsize <- gridsize / res(costras)[1]
grainscale.fac <- aggregate(costras, fact = grainscale.fac)
gridras <- rasterToPolygons(gridras)
gridpol $value <- row.names(gridpol)
gridpol
# spatial join
<- over(pnts, gridpol)
fulldataset.over <- cbind(data.frame(fulldataset.over),
fulldataset.over setNames(data.frame(pnts),
c("id", "salinity", "x.utm", "y.utm", "optional")))
# grid selection
set.seed(2)
<- unique(fulldataset.over$value)
gridlev for (i in seq_along(gridlev)) {
<- subset(fulldataset.over, fulldataset.over$value == gridlev[i])
activesub <- gdata::resample(seq_len(nrow(activesub)), 1)
selectnum if (i == 1) {
<- activesub[selectnum, ]
training
}else {
<- rbind(training, activesub[selectnum, ])
training
} }
Next, we save the training and validation datasets as objects of
class SpatialPointsDataFrame
. Note that the projection of
the training and validation datasets matches the cost raster we created
previously. Calculations within the ipdw
package require
projected datasets. More about R
projections can be found
from the PROJ.4 documentation at the Open Source Geospatial Foundation
(https://proj4.org).
<- fulldataset.over[!(row.names(fulldataset.over) %in%
validate row.names(training)), ]
<- cbind(training$x.utm, training$y.utm)
xy <- SpatialPointsDataFrame(xy, training)
training <- cbind(validate$x.utm, validate$y.utm)
xy <- SpatialPointsDataFrame(xy, validate)
validate projection(training) <- projection(pnts)
projection(validate) <- projection(pnts)
plot(costras)
points(training)
points(validate, col = "red")
We have assembled an object of class
SpatialPointsDataFrame
to be interpolated and an underlying
cost raster of class Raster
. We can either proceed in a
single step using the high-level ipdw
function
ipdw
or in two steps using calls to the
pathdistGen
and ipdwInterp
functions. For
simplicity, the single step option, ipdw
, is shown below.
The two step option would be useful for the case where we want
interpolate multiple parameters of the same
SpatialPointsDataFrame
object using a single
RasterStack
of path distances.
<- c("salinity")
paramlist <- ipdw(training, costras, range = mean.neighdist * 10, paramlist,
final.ipdw overlapped = TRUE)
plot(final.ipdw, main = "Kattegat salinity (ppt)")
We can evaluate the benefits of IPDW by comparing its output against
Inverse Distance Weighting with Euclidean distances. The following
section generates an interpolated surface via IDW. First, prediction
points are generated. Then the gstat
(Pebesma 2004) IDW functionality is called with
the same inputs as the previous section above. Differences between the
outputs of two methodologies are shown in Figure 2.
<- rasterToPoints(costras, fun = function(x) {
idw.grid < 10000
x spatial = TRUE)
}, gridded(idw.grid) <- TRUE
<- gstat::idw(salinity ~ 1, training, idw.grid, maxdist = mean.neighdist * 10,
kat.idw debug.level = 0)
<- raster(kat.idw) final.idw
par(mfrow = c(1, 3), mar = c(5.1, 4.1, 4.1, 5.1))
plot(final.ipdw, main = "IPDW")
plot(final.idw, main = "IDW")
plot(final.idw - final.ipdw, main = "IDW versus IPDW")
We can compare interpolation errors quantitatively using the
errorGen
function. Figure 3 shows a plot of the validation
dataset against the interpolated estimates at those points. The
validation dataset enters into the function both as a
SpatialPointsDataFrame
object and as the underlying values
contained in the data slot.
<- data.frame(validate$salinity)
measured.spdf coordinates(measured.spdf) <- coordinates(validate)
<- errorGen(final.ipdw, measured.spdf, measured.spdf@data)
valid.ipdw <- errorGen(final.idw, measured.spdf, measured.spdf@data) valid.idw
par(mfrow = c(1, 2))
<- errorGen(final.ipdw, measured.spdf, measured.spdf@data,
valid.ipdw plot = TRUE, title = "IPDW")
<- errorGen(final.idw, measured.spdf, measured.spdf@data,
valid.idw plot = TRUE, title = "IDW")
Results from IDW and IPDW appear similar because no validation points
are present in the area downstream (south) of the contiguous barrier
(Figure 1, 2). Up to this point, we have seen a simple implementation of
IPDW requiring only a SpatialPointsDataFrame
and a cost
Raster
.
Test comparisons between the ipdw
and the ESRI (Mitchell 2012; Suominen, Tolvanen, and Kalliola
2010) implementations of IPDW found ipdw
to be much
faster and more flexible. In particular, the high-level function
ipdw
provides the ability to run IPDW in one step while the
lower-level function ipdwInterp
can be called multiple
times following pathdistGen
in order to interpolate
multiple parameters of a single SpatialPointsDataFrame
.
This is accomplished by saving the output from
pathdistGen
.