Title: | Computation of Optimal Transport Plans and Wasserstein Distances |
---|---|
Description: | Solve optimal transport problems. Compute Wasserstein distances (a.k.a. Kantorovitch, Fortet--Mourier, Mallows, Earth Mover's, or minimal L_p distances), return the corresponding transference plans, and display them graphically. Objects that can be compared include grey-scale images, (weighted) point patterns, and mass vectors. |
Authors: | Dominic Schuhmacher [aut, cre], Björn Bähre [aut] (aha and power diagrams), Nicolas Bonneel [aut] (networkflow), Carsten Gottschlich [aut] (simplex and shortlist), Valentin Hartmann [aut] (semidiscrete1), Florian Heinemann [aut] (transport_track and networkflow integration), Bernhard Schmitzer [aut] (shielding), Jörn Schrieber [aut] (subsampling), Timo Wilm [ctb] (wpp) |
Maintainer: | Dominic Schuhmacher <[email protected]> |
License: | GPL (>= 2) |
Version: | 0.15-4 |
Built: | 2024-11-16 05:51:04 UTC |
Source: | https://github.com/dschuhmacher/transport |
Solve optimal transport problems. Compute Wasserstein distances (a.k.a. Kantorovitch, Fortet–Mourier, Mallows, Earth Mover's, or minimal distances), return the corresponding transport plans, and display them graphically. Objects that can be compared include grey-scale images, (weighted) point patterns, and mass vectors.
Package: | transport |
Type: | Package |
Version: | 0.12-1 |
Date: | 2019-08-07 |
License: | GPL (>=2) |
LazyData: | yes |
The main end-user function is transport
. It computes optimal transport plans between images (class pgrid
), point patterns (class pp
), weighted point patterns (class wpp
) and mass vectors, based on various algorithms. These transport plans can be plot
ed. The function wasserstein
allows for the numerical computation of -th order Wasserstein distances.
Most functions in this package are designed for data in two and higher dimensions. A quick tool for computing the -th order Wasserstein distance between univariate samples is
wasserstein1d
.
Dominic Schuhmacher [email protected]
Björn Bähre [email protected] (code for aha
-method)
Nicolas Bonneel [email protected]
(adaptation of LEMON code for fast networkflow
method)
Carsten Gottschlich [email protected]
(original java code for shortlist
and revsimplex
methods)
Valentin Hartmann [email protected] (code for aha
method for p=1
)
Florian Heinemann [email protected]
(integration of networkflow
method)
Bernhard Schmitzer [email protected] (shielding
method)
Jörn Schrieber [email protected] (subsampling
method)
Maintainer: Dominic Schuhmacher [email protected]
See help page for the function transport
.
## See examples for function transport
## See examples for function transport
Solve transportation problem by Aurenhammer–Hoffmann–Aronov Method.
aha(a, b, nscales = 1, scmult = 2, factr = 1e+05, maxit = 10000, powerdiag=FALSE, wasser = FALSE, wasser.spt = NA, approx=FALSE, ...) transport_apply(a, tplan) transport_error(a, b, tplan)
aha(a, b, nscales = 1, scmult = 2, factr = 1e+05, maxit = 10000, powerdiag=FALSE, wasser = FALSE, wasser.spt = NA, approx=FALSE, ...) transport_apply(a, tplan) transport_error(a, b, tplan)
a |
an |
b |
either a matrix such that |
tplan |
a transference plan from a (to b), typically an optimal transference plan obtained by a call to |
nscales , scmult
|
the number of scales to use for the multiscale approach (the default is |
factr , maxit
|
parameters passed to the underlying L-BFGS-B algorithm (via the argument |
powerdiag |
logical. Instead of an optimal transference plan, should the parameters for the optimal power diagram be returned? |
wasser |
logical. Instead of an optimal transference plan, should only the |
wasser.spt |
the number of support points used to approximate the discrete measure |
approx |
logical. If |
... |
further arguments passed to |
The function aha
implements the algorithm by Aurenhammer, Hoffmann and Aronov (1998) for finding optimal transference plans in terms
of the squared Euclidean distance in two dimensions. It follows the more detailed description given in Mérigot (2011) and also implements
the multiscale version presented in the latter paper.
The functions transport_apply
and transport_error
serve for checking the accuracy of the transference plan obtained by aha
.
Since this transference plan is obtained by continuous optimization it will not transport exactly to the measure b
, but to the measure
transport_apply(a, tplan)
. By transport_error(a, b, tplan)
the sum of absolut errors between the transported a
-measure and the b
-measure is obtained.
If powerdiag
and wasser
are both FALSE
, a data frame with columns from
, to
and mass
, which specify from which knot to which other knot what amount of mass is sent in the optimal transference plan. Knots are given as indices in terms of the usual column major enumeration of the matrices a
and b
. There are plot
methods for the classes pgrid
and pp
, which can plot this solution.
If powerdiag
is TRUE and wasser
is FALSE
, a list with components xi
, eta
, w
and rect
, which specify the parameters for the optimal power diagram in the same format as needed for the function power_diagram
. Note that rect is always c(0,m,0,n)
. Since version 0.10-0 the list has a further component wasser.dist
containing the Wasserstein distance.
If wasser
is TRUE
, a data frame with columns wasser.dist
and error.bound
of length one, where error.bound
gives a bound on the absolute error in the Wasserstein distance due to approximating the measure b
by a measure on a smaller number of support points.
Björn Bähre [email protected]
(slightly modified by Dominic Schuhmacher [email protected])
F. Aurenhammer, F. Hoffmann and B. Aronov (1998). Minkowski-type theorems and least-squares clustering. Algorithmica 20(1), 61–76.
Q. Mérigot (2011). A multiscale approach to optimal transport. Eurographics Symposium on Geometry Processing 30(5), 1583–1592.
transport
, which is a convenient wrapper function for various optimal transportation algorithms.
# There is one particular testing configuration on MacOS where the following # command does not return (to be investigated) # res <- aha(random32a$mass, random32b$mass) # plot(random32a, random32b, res, lwd=0.75) aha(random64a$mass, random64b$mass, nscales=3, scmult=5, wasser.spt=512, approx=TRUE)
# There is one particular testing configuration on MacOS where the following # command does not return (to be investigated) # res <- aha(random32a$mass, random32b$mass) # plot(random32a, random32b, res, lwd=0.75) aha(random64a$mass, random64b$mass, nscales=3, scmult=5, wasser.spt=512, approx=TRUE)
Methods for judging near equality of objects of class pgrid or pp or wpp
## S3 method for class 'pgrid' all.equal(target, current, ...) ## S3 method for class 'pp' all.equal(target, current, ...) ## S3 method for class 'wpp' all.equal(target, current, ...)
## S3 method for class 'pgrid' all.equal(target, current, ...) ## S3 method for class 'pp' all.equal(target, current, ...) ## S3 method for class 'wpp' all.equal(target, current, ...)
target , current
|
the objects of the same class to be compared. |
... |
currently without effect. |
Either TRUE
or a vector of mode
“character” describing the differences between target and current.
Dominic Schuhmacher [email protected]
Test whether two objects of the same class are ‘of similar shape’ so that
the function transport
can be applied.
compatible(target, current, ...) ## S3 method for class 'pgrid' compatible(target, current, ...) ## S3 method for class 'pp' compatible(target, current, ...) ## S3 method for class 'wpp' compatible(target, current, ...)
compatible(target, current, ...) ## S3 method for class 'pgrid' compatible(target, current, ...) ## S3 method for class 'pp' compatible(target, current, ...) ## S3 method for class 'wpp' compatible(target, current, ...)
target , current
|
to objects of the same class to be compared. |
... |
currently without effect. |
Logical.
Dominic Schuhmacher [email protected]
A simple wrapper to the image function with a more convenient syntax for plotting matrices "the right way round" as pixel images.
matimage(z, x = 1:dim(z)[1], y = 1:dim(z)[2], rot = TRUE, asp = 1, ...)
matimage(z, x = 1:dim(z)[1], y = 1:dim(z)[2], rot = TRUE, asp = 1, ...)
z |
a numeric matrix. |
x , y
|
(optional) coordinates of the pixels. |
rot |
logical. Whether to plot the matrix "the right way round" so that the pixel
position in the image corresponds to the pixel position in the matrix obtained by |
asp |
the aspect ratio parameter of |
... |
further parameters passed to |
Nothing (invisible NULL).
m <- matrix(1:36,6,6) image(z=m, col = heat.colors(36)) matimage(m, col = heat.colors(36))
m <- matrix(1:36,6,6) image(z=m, col = heat.colors(36)) matimage(m, col = heat.colors(36))
Prints a brief description of a pixel grid or a point pattern.
## S3 method for class 'pgrid' print(x, ...) ## S3 method for class 'pp' print(x, ...) ## S3 method for class 'wpp' print(x, ...) ## S3 method for class 'pgrid' summary(object, ...) ## S3 method for class 'pp' summary(object, ...) ## S3 method for class 'wpp' summary(object, ...)
## S3 method for class 'pgrid' print(x, ...) ## S3 method for class 'pp' print(x, ...) ## S3 method for class 'wpp' print(x, ...) ## S3 method for class 'pgrid' summary(object, ...) ## S3 method for class 'pp' summary(object, ...) ## S3 method for class 'wpp' summary(object, ...)
x , object
|
an object of class pgrid or pp or wpp. |
... |
additional arguments. Currently without effect. |
Currently there is no difference between print and summary.
Dominic Schuhmacher [email protected]
Timo Wilm [email protected]
Construct an object of class "pgrid"
from a matrix or a higher-dimensional array.
pgrid(mass, boundary, gridtriple, generator, structure)
pgrid(mass, boundary, gridtriple, generator, structure)
mass |
a matrix or higher-dimensional array specifing the masses in each pixel / at each pixel centre. |
boundary , gridtriple , generator
|
arguments specifying the positions of the pixels. At most one of these can be specified. |
structure |
optional character string specifying the structure of the grid.
Currently only |
For more detailed explanations of the arguments and other components of the derived object of class "pgrid"
, see
pgrid-object
.
Dominic Schuhmacher [email protected]
Description of pgrid objects.
m <- matrix(1:20, 4, 5) a <- pgrid(m) print(a) print.default(a) ## Not run: plot(a, rot=TRUE) ## End(Not run)
m <- matrix(1:20, 4, 5) a <- pgrid(m) print(a) print.default(a) ## Not run: plot(a, rot=TRUE) ## End(Not run)
The class "pgrid"
(for pixel grid) represents regular quantizations of measures on
(bounded subsets of) . Currently only square quantizations of measures on a rectangles
are supported, which in 2-d can be thought of as grey scale images.
Objects of class "pgrid"
can be created by the function
pgrid
, and are most commonly used as input to the function
transport
. There are methods plot
, print
and
summary
for this class.
An object of class "pgrid"
contains the following elements:
structure |
the structure of the grid. Currently only "square" and "rectangular" are supported.
|
dimension |
the dimension of the space in which the grid is embedded. Must be .
|
n |
the number of pixels along the various coordinates, a vector of length dimension .
|
N |
the total number of pixels. |
boundary |
the outer boundary of the "picture" (i.e. of the support of the measure). A vector of |
length 2*dimension , where the odd entries contain the left and the even entries |
|
contain the right endpoints of the various coordinates. | |
gridtriple |
the rule for generating the pixel centres along the various coordinates. |
A dim by 3 matrix where each row is of the form c(start, end, step) .
|
|
generators |
the pixel centres along the various coordinates. A list of length dim where the |
i -th element is a vector of length n[i] .
|
|
mass |
the array of masses in each pixel / at each pixel centre. In 2-d orientation corresponds |
to the standard orientation of images, see e.g. image . This means that |
|
pixels are arranged on coordinate axes in the order of their indices. | |
Dominic Schuhmacher [email protected]
Constructor function pgrid
.
Methods for plotting objects of class pgrid, pp and wpp, possibly together with a transference plan.
## S3 method for class 'pgrid' plot(x, y = NULL, tplan = NULL, mass = c("colour", "thickness"), length = 0.1, angle = 5, acol, bcol = 4, pcol="goldenrod2", lwd, pmass=TRUE, rot = FALSE, overlay = FALSE, static.mass =TRUE, ...) ## S3 method for class 'pp' plot(x, y = NULL, tplan = NULL, cols = c(4, 2), cex = 0.8, acol = grey(0.3), lwd = 1, overlay = TRUE, ...) ## S3 method for class 'wpp' plot(x, y = NULL, tplan = NULL, pmass=TRUE, tmass=TRUE, cols = c(4, 2), cex = 0.8, aglevel = 0.4, acol = grey(0.3), lwd = 1, overlay = TRUE, ...)
## S3 method for class 'pgrid' plot(x, y = NULL, tplan = NULL, mass = c("colour", "thickness"), length = 0.1, angle = 5, acol, bcol = 4, pcol="goldenrod2", lwd, pmass=TRUE, rot = FALSE, overlay = FALSE, static.mass =TRUE, ...) ## S3 method for class 'pp' plot(x, y = NULL, tplan = NULL, cols = c(4, 2), cex = 0.8, acol = grey(0.3), lwd = 1, overlay = TRUE, ...) ## S3 method for class 'wpp' plot(x, y = NULL, tplan = NULL, pmass=TRUE, tmass=TRUE, cols = c(4, 2), cex = 0.8, aglevel = 0.4, acol = grey(0.3), lwd = 1, overlay = TRUE, ...)
x , y
|
one or two objects of class |
tplan |
a transference plan between the two objects |
mass , pmass , tmass
|
for |
length |
the length of the arrow heads in inches. |
aglevel |
for |
acol |
the colour of the arrows/lines of the transference plan. Ignored for |
angle |
the angle of the arrow heads. |
bcol |
the colour of the cell boundaries for a semidiscrete transport plan. Ignored in all other instances. |
pcol |
the colour of the points representing the discrete masses for a semidiscrete transport plan. Ignored in all other instances. |
cols |
for |
cex , lwd , ...
|
further graphic parameters used by plot. Note that for pgrid objects
|
rot |
logical. Whether the mass matrices of pgrid objects should be rotated before calling
|
overlay |
in the case of two objects |
static.mass |
for a transference plan that explicitly lists the “static mass transports” (i.e.
mass that stays at the same site), should these transports also be plotted as disks
with colours/sizes corresponding to the amount of mass that stays? |
Used for its side effect.
Dominic Schuhmacher [email protected]
Plots the Apollonius diagram, a.k.a. (additively) weighted Voronoi diagram, based on a matrix of points (centers) in 2d and their weights.
plot_apollonius( points, weights, show_points = TRUE, show_weights = TRUE, add_to_weights = 0, add = FALSE, col = 4, lwd = 1.5, ... )
plot_apollonius( points, weights, show_points = TRUE, show_weights = TRUE, add_to_weights = 0, add = FALSE, col = 4, lwd = 1.5, ... )
points |
A two-column matrix containing the 2d points. |
weights |
A vector of weights for the points. |
show_points |
Logical. Should the points be displayed in the plot? Defaults to TRUE. |
show_weights |
Logical. Should the weights be displayed in the plot? Defaults to TRUE. |
add_to_weights |
A value added to the weights to make the plot more informative. |
add |
Logical. Should the plot be added to the current device? Defaults to FALSE. |
col |
The colour for the cell boundaries. |
lwd |
The line width for the cell boundaries. |
... |
Further parameters to the base plot if |
For points with weights
The $i$-th cell of the Apollonius diagram contains all the points x that satisfy
for all . Its boundaries are hyperbola segments.
If show_weights
is TRUE
, grey circles of radii weights + add_to_weights
are plotted around the points. Negative radii are set to zero.
This function requires the Computational Geometry Algorithms Library (CGAL), available at https://www.cgal.org. Adapt the file src/Makevars according to the instructions given there and re-install from source.
Valentin Hartmann [email protected] (most of the code)
Dominic Schuhmacher [email protected] (R-port)
Menelaos Karavelas and Mariette Yvinec. 2D Apollonius Graphs (Delaunay Graphs of Disks). In CGAL User and Reference Manual. CGAL Editorial Board, 4.12 edition, 2018
## Not run: w <- c(0.731, 0.0372, 0.618, 0.113, 0.395, 0.222, 0.124, 0.101, 0.328, 0) points <- matrix(runif(20), 10, 2) plot_apollonius(points, w, add_to_weights = -0.1) ## End(Not run)
## Not run: w <- c(0.731, 0.0372, 0.618, 0.113, 0.395, 0.222, 0.124, 0.101, 0.328, 0) points <- matrix(runif(20), 10, 2) plot_apollonius(points, w, add_to_weights = -0.1) ## End(Not run)
Graphic representation of components of the list returned by unbalanced
.
## S3 method for class 'ut_pgrid' plot(x, what = c("plan", "extra", "trans", "inplace"), axes = FALSE, ...)
## S3 method for class 'ut_pgrid' plot(x, what = c("plan", "extra", "trans", "inplace"), axes = FALSE, ...)
x |
the list returned by |
what |
character. The aspect of the unbalanced transport information to display. |
axes |
logical. Whether to plot axes (ignored for |
... |
further graphics parameters passed to |
Nothing. Used for the side effect.
## Not run: res <- unbalanced( random32a, random32b, p=1, C=0.2, output="all" ) plot( res, what="plan", lwd=1.5, angle=20 ) plot( res, what="trans" ) plot( res, what="extra" ) plot( res, what="inplace" ) ## End(Not run)
## Not run: res <- unbalanced( random32a, random32b, p=1, C=0.2, output="all" ) plot( res, what="plan", lwd=1.5, angle=20 ) plot( res, what="trans" ) plot( res, what="extra" ) plot( res, what="inplace" ) ## End(Not run)
Graphic representation of components of the list returned by unbalanced
.
## S3 method for class 'ut_wpp' plot( x, what = c("plan", "extra", "trans"), axes = FALSE, xlim = c(0, 1), ylim = c(0, 1), ... )
## S3 method for class 'ut_wpp' plot( x, what = c("plan", "extra", "trans"), axes = FALSE, xlim = c(0, 1), ylim = c(0, 1), ... )
x |
the list returned by |
what |
character. The aspect of the unbalanced transport information to display. |
axes |
logical. Whether to plot axes (ignored for |
xlim , ylim
|
numeric vectors of length 2. The x- and y-limits of the plot. |
... |
further graphics parameters passed to |
Nothing. Used for the side effect.
## Not run: set.seed(33) m <- 50 n <- 20 massa <- rexp(m) massb <- rexp(n) a <- wpp( matrix(runif(2*m), m, 2), massa) b <- wpp( matrix(runif(2*n), n, 2), massb) res <- unbalanced(a,b,1,0.3,output="all") plot(res, what="plan") plot(res, what="trans") plot(res, what="extra") ## End(Not run)
## Not run: set.seed(33) m <- 50 n <- 20 massa <- rexp(m) massb <- rexp(n) a <- wpp( matrix(runif(2*m), m, 2), massa) b <- wpp( matrix(runif(2*n), n, 2), massb) res <- unbalanced(a,b,1,0.3,output="all") plot(res, what="plan") plot(res, what="trans") plot(res, what="extra") ## End(Not run)
Compute the power diagram of weighted sites in 2-dimensional space.
power_diagram(xi, eta, w, rect = NA) ## S3 method for class 'power_diagram' plot(x, weights=FALSE, add=FALSE, col=4, lwd=1.5, ...)
power_diagram(xi, eta, w, rect = NA) ## S3 method for class 'power_diagram' plot(x, weights=FALSE, add=FALSE, col=4, lwd=1.5, ...)
xi , eta , w
|
vectors of equal length, where |
rect |
vetor of length |
x |
a power diagram as returned from |
weights |
logical. If |
add |
logical. Should the power diagram be plotted on top of current graphics? |
col |
the color of the cell boundaries. |
lwd , ...
|
further arguments graphic parameters used by |
The function power_diagram
implements an algorithm by Edelsbrunner and Shah (1996) which computes
regular triangulations and thus its dual representation, the power diagram. For point location, an algorithm
devised by Devillers (2002) is used.
Björn Bähre [email protected]
(slightly modified by Dominic Schuhmacher [email protected])
H. Edelsbrunner, N. R. Shah (1996), Incremental Topological Flipping Works for Regular Triangulations, Algorithmica 15, 223–241.
O. Devillers (2002), The Delaunay Hierarchy, International Journal of Foundations of Computer Science 13, 163–180.
xi <- runif(100) eta <- runif(100) w <- runif(100,0,0.005) x <- power_diagram(xi,eta,w,rect=c(0,1,0,1)) plot(x,weights=TRUE)
xi <- runif(100) eta <- runif(100) w <- runif(100,0,0.005) x <- power_diagram(xi,eta,w,rect=c(0,1,0,1)) plot(x,weights=TRUE)
Construct an object of class "pp"
from a matrix.
pp(coordinates)
pp(coordinates)
coordinates |
a matrix specifying the coordinates of the points. Each row corresponds to a point. |
For more detailed explanations of the arguments and other components of the derived object of class "pp"
, see
pp-object
.
Dominic Schuhmacher [email protected]
Description of pp objects.
m <- matrix(c(1,1,2,2,3,1,4,2),4,2) a <- pp(m) print(a) print.default(a) ## Not run: plot(a) ## End(Not run)
m <- matrix(c(1,1,2,2,3,1,4,2),4,2) a <- pp(m) print(a) print.default(a) ## Not run: plot(a) ## End(Not run)
The class "pp"
represents discrete measures with some fixed mass at any of finitely many locations.
Objects of class "pp"
may be created by the function
pp
, and are most commonly used as input to the function
transport
. There are methods plot
, print
and
summary
for this class.
An object of class "pp"
contains the following elements:
dimension |
the dimension of the Euclidean space in which the patterns live. Must be .
|
N |
the total number of points. |
coordinates |
the coordinates of the points. An N dimension matrix, where each row
corresponds to a point.
|
Dominic Schuhmacher [email protected]
Constructor function pp
.
32 x 32, 64 x 64 and 128 x 128 images to illustrate the use of transport.pgrid
. These are objects of
class "pgrid"
.
random32a random32b random64a random64b random128a random128b
random32a random32b random64a random64b random128a random128b
Objects of class ‘pgrid’.
Randomly generated using the package RandomFields
.
Given a vector of return codes, give back the corresponding vector of return strings from the lbfgs library. Nonexistant codes are ignored.
ret_message(n = NULL)
ret_message(n = NULL)
n |
The vector of return codes or |
A named character vector of the corresponding return strings.
Code 0 is ignored, since for technical reasons it is never returned by
the function semidiscrete1
.
Dominic Schuhmacher [email protected]
ret_message() ret_message(c(2,-1023,-1019))
ret_message() ret_message(c(2,-1023,-1019))
Given an object a
of class pgrid
specifying an image and an object b
of class wpp
specifiying a more flexible mass distribution at finitely many points,
find the partition of the image (and hence the optimal transport map) that minimizes the total transport cost
for going from a
to b
.
semidiscrete(a, b, p = 2, method = c("aha"), control = list(), ...)
semidiscrete(a, b, p = 2, method = c("aha"), control = list(), ...)
a |
an object of class |
b |
an object of class |
p |
the power |
method |
the name of the algorithm to use. Currently only |
control |
a named list of parameters for the chosen method or the result of a call to |
... |
currently without effect. |
This is a wrapper for the functions aha
and semidiscrete1
. In the former the
Aurenhammer–Hoffmann–Aronov (1998) method for is implemented in the multiscale variant presented
in Mérigot (2011). In the latter an adapted Aurenhammer–Hoffmann–Aronov method for
is used that
was presented in Hartmann and Schuhmacher (2018).
The present function is automatically called by transport
if the
first argument is of class pgrid
and the second argument is of class wpp
.
An object describing the optimal transport partition for a
and b
.
If p=1
an object of class apollonius_diagram
having components sites
and weights
,
as well as (optionally) wasserstein_dist
and ret_code
(the return code from the call to
semidiscrete1
).
If p=2
an objectof class power_diagram
having components sites
and cells
,
as well as (optionally) wasserstein_dist
. sites
is here a data.frame with columns xi
,
eta
and w
(the weights for the power diagram). cells
is a list with as many
2-column matrix components as there are sites, each describing the - and
-coordinates
of the polygonal cell associated with the corresponding site or
NULL
if the cell of the site is empty.
Plotting methods exist for objects of class apollonius_diagram
, power_diagram
and
for optimal transport maps represented by either of the two.
For p=1
this function requires the Computational Geometry Algorithms Library (CGAL), available at https://www.cgal.org. Adapt the file src/Makevars according to the instructions given there and re-install from source.
Internally the code from liblbfgs 1.10 by Naoaki Okazaki (2010) is used.
Dominic Schuhmacher [email protected]
Björn Bähre [email protected]
Valentin Hartmann [email protected]
F. Aurenhammer, F. Hoffmann and B. Aronov (1998). Minkowski-type theorems and least-squares clustering. Algorithmica 20(1), 61–76.
V. Hartmann and D. Schuhmacher (2017). Semi-discrete optimal transport — the case p=1. Preprint arXiv:1706.07650
M. Karavelas and M. Yvinec. 2D Apollonius Graphs (Delaunay Graphs of Disks). In CGAL User and Reference Manual. CGAL Editorial Board, 4.12 edition, 2018
Q. Mérigot (2011). A multiscale approach to optimal transport. Computer Graphics Forum 30(5), 1583–1592. doi:10.1111/j.1467-8659.2011.02032.x
Naoaki Okazaki (2010). libLBFGS: a library of Limited-memory Broyden-Fletcher-Goldfarb-Shanno (L-BFGS). Version 1.10
plot
, transport
, aha
, semidiscrete1
## See examples for function transport
## See examples for function transport
Computes the weight vector of the Apollonius diagram describing the semidiscrete optimal transport plan for the Euclidean distance cost function and the associated Wasserstein distance.
semidiscrete1( source, target, xrange = c(0, 1), yrange = c(0, 1), verbose = FALSE, reg = 0 )
semidiscrete1( source, target, xrange = c(0, 1), yrange = c(0, 1), verbose = FALSE, reg = 0 )
source |
A matrix specifing the source measure. |
target |
A three-column matrix specifing the target measure in the form x-coordinate, y-coordinate, mass. |
xrange , yrange
|
Vectors with two components defining the window on which
the source measure lives. Defaults to |
verbose |
Logical. Shall information about multiscale progress and L-BFGS return codes be printed? |
reg |
A non-negative regularization parameter. It is usually not necessary to deviate from the default 0. |
A list describing the solution. The components are
weights |
A vector of length equal to the first dimension of |
wasserstein_dist |
The |
ret_code |
A return code. Equal to 1 if everything is OK, since our code
interrupts the usual lbfgs code. Other values can be converted to the
corresponding return message by using |
This function requires the Computational Geometry Algorithms Library (CGAL), available at https://www.cgal.org. Adapt the file src/Makevars according to the instructions given there and re-install from source.
Internally the code from liblbfgs 1.10 by Naoaki Okazaki (2010) is used. See http://www.chokkan.org/software/liblbfgs/.
A stand-alone version of the C++ code of this function is available at https://github.com/valentin-hartmann-research/semi-discrete-transport.
Valentin Hartmann [email protected] (stand-alone C++ code)
Dominic Schuhmacher [email protected] (R-port)
V. Hartmann and D. Schuhmacher (2017). Semi-discrete optimal transport — the case p=1. Preprint arXiv:1706.07650
Menelaos Karavelas and Mariette Yvinec. 2D Apollonius Graphs (Delaunay Graphs of Disks). In CGAL User and Reference Manual. CGAL Editorial Board, 4.12 edition, 2018
Naoaki Okazaki (2010). libLBFGS: a library of Limited-memory Broyden-Fletcher-Goldfarb-Shanno (L-BFGS). Version 1.10
## Not run: # the following function rotates a matrix m clockwise, so # that image(rococlock(m)) has the same orientation as print(m): roclock <- function(m) t(m)[, nrow(m):1] set.seed(30) n <- 20 nu <- matrix(c(runif(2*n), rgamma(n,3,1)), n, 3) pixelbdry <- seq(0,1,length=33) image(pixelbdry, pixelbdry, roclock(random32a$mass), asp=1, col = grey(seq(0,1,length.out=32))) points(nu[,1], nu[,2], pch=16, cex=sqrt(nu[,3])/2, col=2) res <- semidiscrete1(random32a$mass, nu) plot_apollonius(nu[,1:2], res$weights, show_weights = FALSE, add = TRUE) points(nu[,1], nu[,2], pch=16, cex=sqrt(nu[,3])/2, col=2) ## End(Not run)
## Not run: # the following function rotates a matrix m clockwise, so # that image(rococlock(m)) has the same orientation as print(m): roclock <- function(m) t(m)[, nrow(m):1] set.seed(30) n <- 20 nu <- matrix(c(runif(2*n), rgamma(n,3,1)), n, 3) pixelbdry <- seq(0,1,length=33) image(pixelbdry, pixelbdry, roclock(random32a$mass), asp=1, col = grey(seq(0,1,length.out=32))) points(nu[,1], nu[,2], pch=16, cex=sqrt(nu[,3])/2, col=2) res <- semidiscrete1(random32a$mass, nu) plot_apollonius(nu[,1:2], res$weights, show_weights = FALSE, add = TRUE) points(nu[,1], nu[,2], pch=16, cex=sqrt(nu[,3])/2, col=2) ## End(Not run)
Runs the multiscale version of the Shielding Method (a.k.a. Short Cut Method) for computing the optimal transport
(cost/plan) on a rectangular grid in dimensions for the squared Euclidean distance as cost function.
shielding( a, b, nscales = 2, startscale = 1, flood = 0, measureScale = 1e-06, verbose = FALSE, basisKeep = 1, basisRefine = 1 )
shielding( a, b, nscales = 2, startscale = 1, flood = 0, measureScale = 1e-06, verbose = FALSE, basisKeep = 1, basisRefine = 1 )
a , b
|
arrays with |
nscales |
the number of scales generated in the multiscale algorithm. |
startscale |
the first scale on which the problem is solved. |
flood |
a real number. If positive, take the maximum of entry and |
measureScale |
the required precision for the entries. Computations are performed on
|
verbose |
logical. Toggles output to the console about the progress of the algorithm. |
basisKeep , basisRefine
|
internal use only. |
If a
and b
do not have the same sum, they are normalized to sum 1 before
flood
and measureScale
transformations are applied.
A list of components
err |
error code. 0 if everything is ok. |
a_used , b_used
|
the vectorized arrays that were actually used by the algorithm. |
coupling |
a vectorized coupling describing the optimal transport from a_used to b_used |
basis |
a matrix with two columns describing the basis obtained for the optimal transport |
u , v
|
vectors of optimal values in the dual problem |
For larger problems (thousands of grid points) there are considerable speed improvements when shielding
can use the CPLEX numerical solver for the underlying constrained optimization problems.
If a local installation of CPLEX is available, the transport package can be linked against it during installation.
See the file src/Makevars in the source package for instructions.
Bernhard Schmitzer [email protected] and
Dominic Schuhmacher [email protected]
(based on C++ code by Bernhard Schmitzer)
B. Schmitzer (2016). A sparse multiscale algorithm for dense optimal transport. J. Math. Imaging Vision 56(2), 238–259. https://arxiv.org/abs/1510.05466
transport
, which calls this function if appropriate.
## Not run: shielding(random64a$mass,random64b$mass,nscales=6,measureScale=1) ## End(Not run)
## Not run: shielding(random64a$mass,random64b$mass,nscales=6,measureScale=1) ## End(Not run)
Compute a feasible transference plan between two mass vectors.
northwestcorner(a, b) russell(a, b, costm)
northwestcorner(a, b) russell(a, b, costm)
a , b
|
Two numeric vectors (typically containing natural numbers) of length |
costm |
A |
A list whose components are by
matrices, viz.
assignment |
containing as |
basis |
containing as |
The current implementations are in R. Computations may be slow for larger vectors a
and b
.
The computed starting solution may be degenerate, i.e. there may be basic entries where zero mass is assigned.
Dominic Schuhmacher [email protected]
Samples S
elements each of a source and a target measure and
computes the Wasserstein distance between the samples.
The mean distance out of K
tries is returned.
subwasserstein( source, target, S, K = 1, p = 1, costM = NULL, prob = TRUE, precompute = FALSE, method = "networkflow" )
subwasserstein( source, target, S, K = 1, p = 1, costM = NULL, prob = TRUE, precompute = FALSE, method = "networkflow" )
source |
The source measure has to be either a weight vector or an object
of one of the classes |
target |
The target measure needs to be of the same type as the source measure. |
S |
The sample size. |
K |
The number of tries. Defaults to 1. |
p |
The order of the Wasserstein metric (i.e. the power of the distances). Defaults to 1. |
costM |
The cost matrix between the source and target measures. Ignored unless source and target are weight vectors. |
prob |
logical. Should the objects a, b be interpreted as probability measures, i.e. their total mass be normalized to 1? |
precompute |
logical. Should the cost matrix for the large problem be precomputed? |
method |
A string with the name of the method used for optimal transport distance computation. Options are "revsimplex", "shortsimplex" and "primaldual". Defaults to "revsimplex". |
For larger problems setting precompute
to TRUE
is not recommended.
The mean of the K values of the Wasserstein distances between the subsampled measures.
Jörn Schrieber [email protected]
Dominic Schuhmacher [email protected]
M. Sommerfeld, J. Schrieber, Y. Zemel and A. Munk (2018) Optimal Transport: Fast Probabilistic Approximation with Exact Solvers preprint: arXiv:1802.05570
## Not run: subwasserstein(random64a, random64b, S=1000) wasserstein(random64a, random64b) ## End(Not run)
## Not run: subwasserstein(random64a, random64b, S=1000) wasserstein(random64a, random64b) ## End(Not run)
Given two objects a
and b
that specify distributions of mass and an object that specifies (a way to compute) costs,
find the transport plan for going from a
to b
that minimizes the total cost.
transport(a, b, ...) ## Default S3 method: transport(a, b, costm, method = c("networkflow", "shortsimplex", "revsimplex", "primaldual"), fullreturn=FALSE, control = list(), threads=1, ...) ## S3 method for class 'pgrid' transport(a, b, p = NULL, method = c("auto", "networkflow", "revsimplex", "shortsimplex", "shielding", "aha", "primaldual"), fullreturn=FALSE, control = list(), threads=1,...) ## S3 method for class 'pp' transport(a, b, p = 1, method = c("auction", "auctionbf", "networkflow", "shortsimplex", "revsimplex", "primaldual"), fullreturn=FALSE, control = list(), threads=1, ...) ## S3 method for class 'wpp' transport(a, b, p = 1, method = c("networkflow", "revsimplex", "shortsimplex", "primaldual"), fullreturn=FALSE, control = list(), threads=1, ...)
transport(a, b, ...) ## Default S3 method: transport(a, b, costm, method = c("networkflow", "shortsimplex", "revsimplex", "primaldual"), fullreturn=FALSE, control = list(), threads=1, ...) ## S3 method for class 'pgrid' transport(a, b, p = NULL, method = c("auto", "networkflow", "revsimplex", "shortsimplex", "shielding", "aha", "primaldual"), fullreturn=FALSE, control = list(), threads=1,...) ## S3 method for class 'pp' transport(a, b, p = 1, method = c("auction", "auctionbf", "networkflow", "shortsimplex", "revsimplex", "primaldual"), fullreturn=FALSE, control = list(), threads=1, ...) ## S3 method for class 'wpp' transport(a, b, p = 1, method = c("networkflow", "revsimplex", "shortsimplex", "primaldual"), fullreturn=FALSE, control = list(), threads=1, ...)
a , b
|
two objects that describe mass distributions, between which the optimal transport map is to be computed. For the default
method these are vectors of non-negative values. For the other three methods these are objects of the respective classes.
It is also possible to have |
costm |
for the default method a |
p |
for the three specialized methods the power |
method |
the name of the algorithm to use. See details below. |
fullreturn |
A boolean specifying whether the output of the function should also include the dual solution, the optimal transport cost between a and b and the transport plan in matrix form should be returned as well. |
control |
a named list of parameters for the chosen method or the result of a call to |
threads |
An Integer specifying the number of threads used in parallel computing. Currently only available for the method "networkflow". |
... |
currently without effect. |
There is a number of algorithms that are currently implemented and more will be added in future versions of the package. The following is a brief description of each key word used. Much more details can be found in the cited references and in a forthcoming package vignette.
aha
: The Aurenhammer–Hoffmann–Aronov (1998) method with the multiscale approach presented in Mérigot (2011). The original theory was limited to . We refer by
aha
also to the extension of the same idea for as presented in Hartmann and Schuhmacher (2017) and for more general
(currently not implemented).
auction
: The auction algorithm by Bertsekas (1988) with epsilon-scaling, see Bertsekas (1992).
auctionbf
: A refined auction algorithm that combines forward and revers auction, see Bertsekas (1992).
networkflow
: The fast implementation of the network simplex algorithm by Nicolas Bonneel based on the LEMON Library (see citations below).
primaldual
: The primal-dual algorithm as described in Luenberger (2003, Section 5.9).
revsimplex
: The revised simplex algorithm as described in Luenberger and Ye (2008, Section 6.4) with various speed improvements, including a multiscale approach.
shielding
: The shielding (or shortcut) method, as described in Schmitzer (2016).
shortsimplex
: The shortlist method based an a revised simplex algorithm, as described in Gottschlich and Schuhmacher (2014).
The order of the default key words specified for the argument method
gives a rough idea of the relative efficiency of the algorithms for the corresponding class of objects. For a given a
and b
the actual computation times may deviate significantly from this order.
For class pgrid
the default method is "auto"
, which resolves to "revsimplex"
if p
is not 2 or the problem is very small, and to "shielding"
otherwise.
The following table gives information about the applicability of the various algorithms (or sometimes rather their current implementations).
default | pgrid | pp | wpp | |
aha (p=1 or 2!) | - | + | - | @ |
auction | - | - | + | - |
auctionbf | - | - | + | - |
networkflow | + | + | + | + |
primaldual | * | * | * | + |
revsimplex | + | + | * | + |
shielding (p=2!) | - | + | - | - |
shortsimplex | + | + | * | + |
where: + recommended, * applicable (may be slow), - no implementation planned or combination does not make sense; @ indicates that the aha algorithm is available in the special combination where a
is a pgrid
object and b
is a wpp
object (and p
is 2). For more details on this combination see the function semidiscrete
.
Each algorithm has certain parameters supplied by the control
argument. The following table gives an overview of parameter names and
their applicability.
start |
multiscale | individual parameters | |
aha ( !) |
- | + | factr , maxit |
auction |
- | - | lasteps , epsfac |
auctionbf |
- | - | lasteps , epsfac |
networkflow |
- | - | |
primaldual |
- | - | |
revsimplex |
+ | + | |
shielding ( !) |
- | + | |
shortsimplex |
- | - | slength , kfound , psearched |
start
specifies the algorithm for computing a starting solution (if needed). Currently the Modified Row Minimum Rule
(start="modrowmin"
), the North-West Corner Rule (start="nwcorner"
) and the method by Russell (1969) (start="russell"
)
are implemented. When start="auto"
(the default) the ModRowMin Rule is chosen. However,
for transport.pgrid
and p
larger than 1, there are two cases where an automatic multiscale procedure is also performed, i.e. the optimal transport is first computed on coarser grids and information from these solutions is then used for the finer girds.
This happens for
method = "revsimplex"
, where a single coarsening at factor scmult=2
is performed, and for method = "shielding"
, where a number of coarsenings adapted to the dimensions of the array is performed.
For p=1
and method="revsimplex"
, as well as p=2
and method="aha"
there are multiscale versions of
the corresponding algorithms that allows for finer control via the parameters
nscales
, scmult
and returncoarse
. The default value of nscales=1
suppresses
the multiscale version. For larger problems it is advisable to use the multiscale version, which currently is only implemented for
square pgrids in two dimensions. The algorithm proceeds then by coarsening the pgrid nscales-1
times, summarizing
each time scmult^2
pixels into one larger pixels, and then solving the various transport problems starting from the coarsest and
using each previous problem to compute a starting solution to the next finer problem. If returncoarse
is TRUE
, the coarser
problems and their solutions are returned as well (revsimplex
only).
factr
, maxit
are the corresponding components of the control
argument in the optim
L-BFGS-B method.
lasteps
, epsfac
are parameters used for epsilon scaling in the auction algortihm. The algorithm starts with a “transaction cost” per bid of epsfac^k * lasteps
for some reasonable k
generating finer and finer approximate solutions as the k
counts down to zero. Note that in order for the procedure to make sense, epsfac
should be larger than one (typically two- to three-digit) and in order for the final solution to be exact lasteps
should be smaller than 1/n
, where n
is the total number of points in either of the point patterns.
slength
, kfound
, psearched
are the shortlist length, the number of pivot candidates needed, and the percentage of
shortlists searched, respectively.
A data frame with columns from
, to
and mass
that specifies from which element of a
to which element of b
what amount of mass is sent in the optimal transport plan. For class pgrid
elements are specified as vector indices in terms of the usual column major enumeration of the matrices a$mass
and b$mass
. There are plot
methods for the classes pgrid
and pp
, which can plot this solution.
If returncoarse
is TRUE
for the revsimplex
method, a list with components sol
and prob
giving the solutions and problems on the various scales considered. The solution on the finest scale (i.e. the output we obtain when setting returncoarse
to FALSE
) is in sol[[1]]
.
If a
is of class pgrid
and b
of class wpp
(and p=2
), an object of class power_diagram
as described in the help for the function semidiscrete
. The plot
method for class pgrid
can plot this solution.
The combination of the shielding-method with the CPLEX numerical solver outperforms the other algorithms by an order of magnitude for large problems (only applicable for p=2
and objects of class "pgrid"
). If a local installation of CPLEX is available, the transport package can be linked against it during installation. See the file src/Makevars in the source package for instructions.
The combination of the aha-method with p=1
requires the use of CGAL (the Computational Geometry Algorithms Library) for dealing with Apollonius diagrams. If you require this functionality, install it from https://www.cgal.org/download.html and adapt the file src/Makevars of this package according to the instructions given in that file. Then re-install 'transport' from source as usual.
Dominic Schuhmacher [email protected]
Björn Bähre [email protected] (code for aha
-method for p=2
)
Nicolas Bonneel [email protected]
(adaption of LEMON code for fast networkflow
method)
Carsten Gottschlich [email protected]
(original java code for shortlist
and revsimplex
methods)
Valentin Hartmann [email protected] (code for aha
method for p=1
)
Florian Heinemann [email protected]
(integration of networkflow
method)
Bernhard Schmitzer [email protected] (code for shielding
-method)
F. Aurenhammer, F. Hoffmann and B. Aronov (1998). Minkowski-type theorems and least-squares clustering. Algorithmica 20(1), 61–76.
D. P. Bertsekas (1988). The auction algorithm: a distributed relaxation method for the assignment problem. Annals of Operations Research 14(1), 105–123.
D. P. Bertsekas (1992). Auction algorithms for network flow problems: a tutorial introduction. Computational Optimization and Applications 1, 7–66.
N. Bonneel (2018). Fast Network Simplex for Optimal Transport. Github repository, nbonneel/network_simplex.
N. Bonneel, M. van de Panne, S. Paris and W. Heidrich (2011). Displacement interpolation using Lagrangian mass transport. ACM Transactions on Graphics (SIGGRAPH ASIA 2011) 30(6).
Egervary Research Group on Combinatorial Optimization, EGRES (2014). LEMON Graph Library v1.3.1. lemon.cs.elte.hu/trac/lemon.
C. Gottschlich and D. Schuhmacher (2014). The shortlist method for fast computation of the earth mover's distance and finding optimal solutions to transportation problems. PLOS ONE 9(10), e110214. doi:10.1371/journal.pone.0110214
V. Hartmann and D. Schuhmacher (2020). Semi-discrete optimal transport: a solution procedure for the unsquared Euclidean distance case, Mathematical Methods of Operations Research 92, 133–163. doi:10.1007/s00186-020-00703-z
D.G. Luenberger (2003). Linear and nonlinear programming, 2nd ed. Kluwer.
D.G. Luenberger and Y. Ye (2008). Linear and nonlinear programming, 3rd ed. Springer.
Q. Mérigot (2011). A multiscale approach to optimal transport. Computer Graphics Forum 30(5), 1583–1592. doi:10.1111/j.1467-8659.2011.02032.x
B. Schmitzer (2016). A sparse multiscale algorithm for dense optimal transport. J. Math. Imaging Vision 56(2), 238–259. https://arxiv.org/abs/1510.05466
plot
,
wasserstein
,
unbalanced
.
# # example for the default method # a <- c(100, 200, 80, 150, 50, 140, 170, 30, 10, 70) b <- c(60, 120, 150, 110, 40, 90, 160, 120, 70, 80) set.seed(24) costm <- matrix(sample(1:20, 100, replace=TRUE), 10, 10) res <- transport(a,b,costm) # pretty-print solution in matrix form for very small problems: transp <- matrix(0,10,10) transp[cbind(res$from,res$to)] <- res$mass rownames(transp) <- paste(ifelse(nchar(a)==2," ",""),a,sep="") colnames(transp) <- paste(ifelse(nchar(b)==2," ",""),b,sep="") print(transp) # # example for class 'pgrid' # dev.new(width=9, height=4.5) par(mfrow=c(1,2), mai=rep(0.1,4)) image(random32a$mass, col = grey(0:200/200), axes=FALSE) image(random32b$mass, col = grey(0:200/200), axes=FALSE) res <- transport(random32a,random32b) dev.new() par(mai=rep(0,4)) plot(random32a,random32b,res,lwd=1) # # example for class 'pp' # set.seed(27) x <- pp(matrix(runif(400),200,2)) y <- pp(matrix(runif(400),200,2)) res <- transport(x,y) dev.new() par(mai=rep(0.02,4)) plot(x,y,res) # # example for class 'wpp' # set.seed(30) m <- 30 n <- 60 massx <- rexp(m) massx <- massx/sum(massx) massy <- rexp(n) massy <- massy/sum(massy) x <- wpp(matrix(runif(2*m),m,2),massx) y <- wpp(matrix(runif(2*n),n,2),massy) res <- transport(x,y,method="revsimplex") plot(x,y,res) # # example for semidiscrete transport between class # 'pgrid' and class 'wpp' (p=2) # set.seed(33) n <- 100 massb <- rexp(n) massb <- massb/sum(massb)*1e5 b <- wpp(matrix(runif(2*n),n,2),massb) res <- transport(random32a,b,p=2) plot(random32a,b,res) # # example for semidiscrete transport between class # 'pgrid' and class 'wpp' (p=1) # if (transport:::cgal_present()) { set.seed(33) n <- 30 massb <- rexp(n) massb <- massb/sum(massb)*1e5 b <- wpp(matrix(runif(2*n),n,2),massb) res <- transport(random32a,b,p=1) plot(random32a,b,res) }
# # example for the default method # a <- c(100, 200, 80, 150, 50, 140, 170, 30, 10, 70) b <- c(60, 120, 150, 110, 40, 90, 160, 120, 70, 80) set.seed(24) costm <- matrix(sample(1:20, 100, replace=TRUE), 10, 10) res <- transport(a,b,costm) # pretty-print solution in matrix form for very small problems: transp <- matrix(0,10,10) transp[cbind(res$from,res$to)] <- res$mass rownames(transp) <- paste(ifelse(nchar(a)==2," ",""),a,sep="") colnames(transp) <- paste(ifelse(nchar(b)==2," ",""),b,sep="") print(transp) # # example for class 'pgrid' # dev.new(width=9, height=4.5) par(mfrow=c(1,2), mai=rep(0.1,4)) image(random32a$mass, col = grey(0:200/200), axes=FALSE) image(random32b$mass, col = grey(0:200/200), axes=FALSE) res <- transport(random32a,random32b) dev.new() par(mai=rep(0,4)) plot(random32a,random32b,res,lwd=1) # # example for class 'pp' # set.seed(27) x <- pp(matrix(runif(400),200,2)) y <- pp(matrix(runif(400),200,2)) res <- transport(x,y) dev.new() par(mai=rep(0.02,4)) plot(x,y,res) # # example for class 'wpp' # set.seed(30) m <- 30 n <- 60 massx <- rexp(m) massx <- massx/sum(massx) massy <- rexp(n) massy <- massy/sum(massy) x <- wpp(matrix(runif(2*m),m,2),massx) y <- wpp(matrix(runif(2*n),n,2),massy) res <- transport(x,y,method="revsimplex") plot(x,y,res) # # example for semidiscrete transport between class # 'pgrid' and class 'wpp' (p=2) # set.seed(33) n <- 100 massb <- rexp(n) massb <- massb/sum(massb)*1e5 b <- wpp(matrix(runif(2*n),n,2),massb) res <- transport(random32a,b,p=2) plot(random32a,b,res) # # example for semidiscrete transport between class # 'pgrid' and class 'wpp' (p=1) # if (transport:::cgal_present()) { set.seed(33) n <- 30 massb <- rexp(n) massb <- massb/sum(massb)*1e5 b <- wpp(matrix(runif(2*n),n,2),massb) res <- transport(random32a,b,p=1) plot(random32a,b,res) }
Given two objects source
and target
of class pgrid
and a transference plan, typically
the result of a call to transport
, create an animation of the dynamic transference plan
(a.k.a. displacement interpolation)
transport_track(source, target, tplan, K = 50, scmult = 1, smooth = FALSE, H = matrix(c(1,0,0,1),2,2), create.file = c("none","gif_im"), file.name = "Rtransport.gif", fps = 20, cut = FALSE, col=grey((0:1000)/1000),width=800,height=800)
transport_track(source, target, tplan, K = 50, scmult = 1, smooth = FALSE, H = matrix(c(1,0,0,1),2,2), create.file = c("none","gif_im"), file.name = "Rtransport.gif", fps = 20, cut = FALSE, col=grey((0:1000)/1000),width=800,height=800)
source , target
|
objects of class |
tplan |
a transference plan between |
K |
the number of intermediate frames to be produced between |
scmult |
the factor by which the number of pixels in each dimension is multiplied to obtain a smoother rendering of the dynamic transference plan. |
smooth |
logical. Whether a kernel smoothing or a linear binning procedure is used to generate the images. Defaults to |
H |
the bandwith matrix used to perform the two dimensional kernel density estimation or the linear binning respectively. |
create.file |
the file type to be created or |
file.name |
the path for the output file. Ignored if |
fps |
the number of frames per second in the generated gif. The default is 20 frames per second. |
cut |
logical. Whether the boundary pixels are cut off. Currently the only way to deal with the edge effect (see Details). |
col |
the vector of RGB colours which is used to generate the gif, if create.file is not "none". See the documentation of image for more details. |
width |
interger specifying the width of the images used to generate the output gif, if create.file is not "none". |
height |
interger specifying the width of the images used to generate the output gif, if create.file is not "none". |
The intermediate frames are produced by the interpolation formula ,
where
is the transference plan,
and
are the first and second coordinate projections of
onto
, and
. If
is an optimal transference plan this yields the displacement interpolation, at least if we assume
as underlying cost function the Euclidean metric to the
-th power, where
.
The kernel smoothing procedure gives usually nicer animations, but takes several orders of magnitudes longer.
There are currently visible edge effects in both the kernel smoothing and the linear binning procedure that lead to darker pixels at the boundary of the image. The cut parameter may be used to remove the boundary pixels completely and thus produce a smaller output. The edge will be dealt with more adequatly in future versions.
Conversion to an animated gif is performed by a system call to the convert tool of ImageMagick. The latter may have to be installed first.
An array containing the various interpolation images.
Unless create.file="none"
, the function is mainly used for its side effect (saving a file to the specified path).
So the array is returned invisibly.
Running this function with smooth=TRUE
and even moderate K
can take a long time!
Florian Heinemann [email protected]
(slightly modified by Dominic Schuhmacher [email protected])
Function transport
for computing optimal transference plans.
if (requireNamespace("ks", quietly = TRUE)) { tplan <- transport(random32a,random32b) series <- transport_track(random32a, random32b, tplan, scmult=3, create.file="none") dev.new(width=16,height=8) oldpar <- par(mfrow=c(5,10), mai=rep(0.01,4)) for (i in 1:50) { image(series[,,i], col=grey(seq(0,1,0.005)), asp=1, axes=FALSE,zlim=c(min(series),max(series))) } par(oldpar) }
if (requireNamespace("ks", quietly = TRUE)) { tplan <- transport(random32a,random32b) series <- transport_track(random32a, random32b, tplan, scmult=3, create.file="none") dev.new(width=16,height=8) oldpar <- par(mfrow=c(5,10), mai=rep(0.01,4)) for (i in 1:50) { image(series[,,i], col=grey(seq(0,1,0.005)), asp=1, axes=FALSE,zlim=c(min(series),max(series))) } par(oldpar) }
transport
.
Set the control parameters for the algorithm used by the function transport
.
trcontrol(method = c("networkflow", "revsimplex", "shortsimplex", "primaldual", "aha", "shielding", "auction", "auctionbf"), para = list(), start = c("auto", "modrowmin", "nwcorner", "russell"), nscales = 1, scmult = 2,returncoarse = FALSE, a = NULL, b = NULL, M = NULL, N = NULL)
trcontrol(method = c("networkflow", "revsimplex", "shortsimplex", "primaldual", "aha", "shielding", "auction", "auctionbf"), para = list(), start = c("auto", "modrowmin", "nwcorner", "russell"), nscales = 1, scmult = 2,returncoarse = FALSE, a = NULL, b = NULL, M = NULL, N = NULL)
method |
The algorithm to be used to compute the optimal transference plan. See details for the function |
para |
A list of parameters that are specific to the chosen method. See the table on the help page of the function |
start |
If |
nscales , scmult , returncoarse
|
The parameters for the multiscale versions of certain algorithms. See the help on |
a , b , M , N
|
The two objects |
For further details about the parameters of the individual algorithms see the help page for transport
.
A list with components method
, para
, start
, nscales
, scmult
, returncoarse
as
entered or adapted/computed based on the arguments method
, a
, b
, M
, N
.
This function is typically only called by the user to check what the parameter settings used
by the function transport
are for a given problem.
Dominic Schuhmacher [email protected]
Compute optimal transport between unnormalized images / mass distributions on grids
(pgrid
objects) or between mass distributions on general point patterns
(wpp
objects) under the option that mass can be dispose of. Transport cost
per unit is the Euclidean distance of the transport to the p
-th power.
Disposal cost per unit is C^p
.
unbalanced(a, b, ...) ## S3 method for class 'pgrid' unbalanced( a, b, p = 1, C = NULL, method = c("networkflow", "revsimplex"), output = c("dist", "all", "rawres"), threads = 1, ... ) ## S3 method for class 'wpp' unbalanced( a, b, p = 1, C = NULL, method = c("networkflow", "revsimplex"), output = c("dist", "all", "rawres"), threads = 1, ... )
unbalanced(a, b, ...) ## S3 method for class 'pgrid' unbalanced( a, b, p = 1, C = NULL, method = c("networkflow", "revsimplex"), output = c("dist", "all", "rawres"), threads = 1, ... ) ## S3 method for class 'wpp' unbalanced( a, b, p = 1, C = NULL, method = c("networkflow", "revsimplex"), output = c("dist", "all", "rawres"), threads = 1, ... )
a , b
|
|
... |
other arguments. |
p |
a power |
C |
The base disposal cost (without the power |
method |
one of |
output |
character. One of "dist", "all" and "rawres". Determines what the function
returns: only the unbalanced Wasserstein distance; all available information about the
transport plan and the extra mass; or the raw result obtained by the networkflow algorithm.
The latter is the same format as in the |
threads |
an integer specifying the number of threads for parallel computing in connection with the networkflow method. |
Given two non-negative mass distributions ,
on a set
(a pixel grid / image if
a
, b
are of class pgrid
or a more
general weighted point pattern if a
, b
are of class wpp
), this function minimizes the functional
over all satisfying
Thus denotes the amount of mass transported from
to
, whereas
and
are the total mass transported away from
and total mass transported to
, respectively.
Accordingly
and
are the total
amounts of mass of
and
, respectively, that need to be disposed of.
The minimal value of the functional above taken to the is what we refer to as unbalanced
-Wasserstein metric. This metric is used, in various variants, in an number of research papers.
See Heinemann et al. (2022) and the references therein and Müller et al. (2022), Remark 3. We follow the
convention of the latter paper regarding the parametrization and the use of the term unbalanced Wasserstein metric.
The practical difference between the two methods "networkflow" and "revsimplex" can
roughly described as follows. The former is typically faster for large examples (for pgrid
objects 64x64
and beyond), especially if several threads are used. The latter is typically faster
for smaller examples (which may be relevant if pairwise transports between many objects
are computed) and it guarantees a sparse(r) solution, i.e. at most individual
transports, where
and
are the numbers of non-zero masses in
a
and b
, respectively).
Note however that due to the implementation the revsimplex algorithm is a little less
precise (roughly within 1e-7 tolerance). For more details on the algorithms see transport
.
If output = "dist"
a single numeric, the unbalanced -Wasserstein distance.
Otherwise a list. If
output = "all"
the list is of class ut_pgrid
or ut_wpp
according
to the class of the objects a
and b
. It has a
, b
, p
, C
as attributes and
the following components:
dist |
same as for |
plan |
an optimal transport plan. This is a data frame with columns |
atrans , btrans
|
matrices (pgrid) or vectors (wpp) specifying the masses transported from each point and to each point,
respectively. Corresponds to |
aextra , bextra
|
matrices (pgrid) or vectors (wpp) specifying the amount of mass at each point of |
inplace |
(pgrid only) a matrix specifying the amount of mass at each point that can stay in place. Corresponds
to |
Note that atrans + aextra + inplace
(pgrid) or atrans + aextra
(wpp)must be equal
to a$mass
and likewise for b.
A warning occurs if this is not the case (which may indeed happen from time to time for method
revsimplex, but the error reported should be very small).
Florian Heinemann, Marcel Klatt and Axel Munk (2022).
Kantorovich-Rubinstein distance and barycenter for finitely supported measures: Foundations and Algorithms.
Arxiv preprint.
doi:10.48550/arXiv.2112.03581
Raoul Müller, Dominic Schuhmacher and Jorge Mateu (2020).
Metrics and barycenters for point pattern data
Statistics and Computing 30, 953-972.
doi:10.1007/s11222-020-09932-y
plot.ut_pgrid
and plot.ut_wpp
, which can plot the various components of the list obtained for output="all"
.
a <- pgrid(matrix(1:12, 3, 4)) b <- pgrid(matrix(c(9:4, 12:7), 3, 4)) res1 <- unbalanced(a, b, 1, 0.5, output="all") res2 <- unbalanced(a, b, 1, 0.3, output="all") plot(a, b, res1$plan, angle=20, rot=TRUE) plot(a, b, res2$plan, angle=20, rot=TRUE) par(mfrow=c(1,2)) matimage(res2$aextra, x = a$generator[[1]], y = a$generator[[2]]) matimage(res2$bextra, x = b$generator[[1]], y = b$generator[[2]]) set.seed(31) a <- wpp(matrix(runif(8),4,2), 3:6) b <- wpp(matrix(runif(10),5,2), 1:5) res1 <- unbalanced(a, b, 1, 0.5, output="all") res2 <- unbalanced(a, b, 1, 0.3, output="all") plot(a, b, res1$plan) plot(a, b, res2$plan)
a <- pgrid(matrix(1:12, 3, 4)) b <- pgrid(matrix(c(9:4, 12:7), 3, 4)) res1 <- unbalanced(a, b, 1, 0.5, output="all") res2 <- unbalanced(a, b, 1, 0.3, output="all") plot(a, b, res1$plan, angle=20, rot=TRUE) plot(a, b, res2$plan, angle=20, rot=TRUE) par(mfrow=c(1,2)) matimage(res2$aextra, x = a$generator[[1]], y = a$generator[[2]]) matimage(res2$bextra, x = b$generator[[1]], y = b$generator[[2]]) set.seed(31) a <- wpp(matrix(runif(8),4,2), 3:6) b <- wpp(matrix(runif(10),5,2), 1:5) res1 <- unbalanced(a, b, 1, 0.5, output="all") res2 <- unbalanced(a, b, 1, 0.3, output="all") plot(a, b, res1$plan) plot(a, b, res2$plan)
Given two objects a
and b
that specify measures in , compute the Wasserstein distance of
order
p
between the objects.
wasserstein(a, b, p=1, tplan=NULL, costm=NULL, prob=TRUE, ...)
wasserstein(a, b, p=1, tplan=NULL, costm=NULL, prob=TRUE, ...)
a , b
|
two objects that describe mass distributions in |
p |
the power |
tplan |
an optional transference plan in the format returned by the function |
costm |
the matrix of costs between the support points of the measures. Ignored unless |
prob |
logical. Should the objects |
... |
further parameters passed to |
The Wasserstein distance of order p
is defined as the p
-th root of the total cost incurred when transporting measure a
to measure b
in an optimal way, where the cost of transporting a unit of mass from to
is given as the
p
-th
power of the Euclidean distance.
If tplan
is supplied by the user, no checks are performed whether it is optimal for the given problem. So this
function may be used to compare different (maybe suboptimal) transference plans with regard to their total costs.
For further details on the algorithms used, see help of transport
.
A single number, the Wasserstein distance for the specified problem.
Dominic Schuhmacher [email protected]
plot
, transport
, wasserstein1d
# # example for class 'pgrid' # wasserstein(random32a,random32b,p=1) res <- transport(random32a,random32b,p=2) wasserstein(random32a,random32b,p=1,res) # is larger than above: # the optimal transport for p=2 is not optimal for p=1 # # example for class 'pp' # set.seed(27) x <- pp(matrix(runif(500),250,2)) y <- pp(matrix(runif(500),250,2)) wasserstein(x,y,p=1) wasserstein(x,y,p=2)
# # example for class 'pgrid' # wasserstein(random32a,random32b,p=1) res <- transport(random32a,random32b,p=2) wasserstein(random32a,random32b,p=1,res) # is larger than above: # the optimal transport for p=2 is not optimal for p=1 # # example for class 'pp' # set.seed(27) x <- pp(matrix(runif(500),250,2)) y <- pp(matrix(runif(500),250,2)) wasserstein(x,y,p=1) wasserstein(x,y,p=2)
Given two vectors a
and b
, compute the Wasserstein distance of
order p
between their empirical distributions.
wasserstein1d(a, b, p = 1, wa = NULL, wb = NULL)
wasserstein1d(a, b, p = 1, wa = NULL, wb = NULL)
a , b
|
two vectors. |
p |
a positive number. The order of the Wasserstein distance. |
wa , wb
|
optional vectors of non-negative weights for |
The Wasserstein distance of order p
is defined as the p
-th root of the total cost incurred when transporting a pile of mass into another pile of mass in an optimal way, where the cost of transporting a unit of mass from to
is given as the
p
-th power of the Euclidean distance.
In the present function the vector a
represents the locations on the real line of deposits of mass
and the vector
b
the locations of deposits of mass
. If the user specifies weights
wa
and wb
, these default masses are replaced by wa/sum(wa)
and wb/sum(wb)
, respectively.
In terms of the empirical distribution function of locations
with normalized weights
, and the corresponding function
for
b
, the Wasserstein distance in 1-d is given as
where and
are generalized inverses. If
, we also have
A single number, the Wasserstein distance for the specified data.
Dominic Schuhmacher [email protected]
x <- rnorm(200) y <- rnorm(150,2) wasserstein1d(x,y)
x <- rnorm(200) y <- rnorm(150,2) wasserstein1d(x,y)
Construct an object of class "wpp"
from a matrix of points and a vector of masses.
wpp(coordinates, mass)
wpp(coordinates, mass)
coordinates |
a matrix specifying the coordinates of the points. Each row corresponds to a point. |
mass |
a vector of non-negative values specifying the masses at these points. |
For more detailed explanations of the arguments and other components of the returned object of class "wpp"
, see
wpp-object
.
It is legitimate to assign mass 0 to individual points in the arguments. However, when constructing the wpp
-object such points are deleted. The coordinates of the deleted points can still be accessed via the attribute zeropoints
.
Dominic Schuhmacher [email protected]
Timo Wilm [email protected]
Description of pp objects.
m <- matrix(c(1,1,2,2,3,1,4,2),4,2) a <- pp(m) print(a) print.default(a) ## Not run: plot(a) ## End(Not run)
m <- matrix(c(1,1,2,2,3,1,4,2),4,2) a <- pp(m) print(a) print.default(a) ## Not run: plot(a) ## End(Not run)
The class "wpp"
represents discrete measures with positive mass at any of finitely many locations.
Objects of class "wpp"
may be created by the function
wpp
, and are most commonly used as input to the function
transport
. There are methods plot
, print
and
summary
for this class.
An object of class "wpp"
contains the following elements:
dimension |
the dimension of the Euclidean space in which the patterns live. Must be .
|
N |
the total number of point. |
coordinates |
the coordinates of the points. An N dimension matrix, where each row
corresponds to a point.
|
mass |
the masses at these points. A vector of length N of positive numbers.
|
totmass |
the total mass of the point pattern. |
Dominic Schuhmacher [email protected]
Timo Wilm [email protected]
Constructor function wpp
.