SlideShare a Scribd company logo
Discontinuous Hamiltonian Monte Carlo
for discontinuous and discrete distributions
Aki Nishimura
joint work with David Dunson and Jianfeng Lu
SAMSI Workshop: Trends and Advances in Monte Carlo Sampling Algorithms
December 12, 2017
Models with discrete params / discontinuous likelihoods
Discrete : unknown population size, change points
Discontinuous : nonparametric generalized Bayes, threshold effects
Hamiltonian Monte Carlo (HMC) for Bayesian computation
Bayesian inference often relies on Markov chain Monte Carlo.
HMC has become popular as an efficient general-purpose algorithm:
allows for more flexible generative models (e.g. non-conjugacy).
a critical building block of probabilistic programming languages.
Hamiltonian Monte Carlo (HMC) for Bayesian computation
Idea of a probabilistic programming language: you specify the model,
then the software takes care of the rest.
Hamiltonian Monte Carlo (HMC) for Bayesian computation
Idea of a probabilistic programming language: you specify the model,
then the software takes care of the rest.
Probabilistic programming languages can algorithmically evaluate
(unnormalized) log posterior density.
(unnormalized) log conditional densities efficiently by taking
advantage of conditional independence structure.
gradients of log density.
Hamiltonian Monte Carlo (HMC) for Bayesian computation
Idea of a probabilistic programming language: you specify the model,
then the software takes care of the rest.
Probabilistic programming languages can algorithmically evaluate
(unnormalized) log posterior density.
(unnormalized) log conditional densities efficiently by taking
advantage of conditional independence structure.
gradients of log density.
HMC is well-suited to such softwares and has demonstrated
a number of empirical successes e.g. through Stan and PyMC.
better theoretical scalability in the number of parameters
(Beskos et al., 2013).
HMC and discrete parameters / discontinuous likelihoods
HMC is based on solutions of an ordinary differential equation.
But the ODE makes no sense for discrete parameters / discontinuous
likelihoods.
HMC and discrete parameters / discontinuous likelihoods
HMC is based on solutions of an ordinary differential equation.
But the ODE makes no sense for discrete parameters / discontinuous
likelihoods.
HMC’s inability to handle discrete parameters is considered the most
serious drawback (Gelman et al., 2015; Monnahan et al., 2016).
HMC and discrete parameters / discontinuous likelihoods
HMC is based on solutions of an ordinary differential equation.
But the ODE makes no sense for discrete parameters / discontinuous
likelihoods.
HMC’s inability to handle discrete parameters is considered the most
serious drawback (Gelman et al., 2015; Monnahan et al., 2016).
Existing approaches in special cases:
smooth surrogate function for binary pairwise Markov random
field models (Zhang et al., 2012).
treat discrete parameters as continuous if the likelihood still
makes sense (Berger et al., 2012).
Our approach: discontinous HMC
Features:
allows for a discontinuous target distribution.
handles discrete parameters through embedding them into a
continuous space.
fits within the framework of probabilistic programming languages.
Our approach: discontinous HMC
Features:
allows for a discontinuous target distribution.
handles discrete parameters through embedding them into a
continuous space.
fits within the framework of probabilistic programming languages.
Techniques:
is motivated by theory of measure-valued differential equation &
event-driven Monte Carlo.
is based on a novel numerical method for discontinuous dynamics.
Our approach: discontinous HMC
Features:
allows for a discontinuous target distribution.
handles discrete parameters through embedding them into a
continuous space.
fits within the framework of probabilistic programming languages.
Techniques:
is motivated by theory of measure-valued differential equation &
event-driven Monte Carlo.
is based on a novel numerical method for discontinuous dynamics.
Theoretical properties:
generalizes (and hence outperforms) variable-at-a-time Metropolis.
achieves a high acceptance rate that indicates a scaling property
comparable to HMC.
Review of HMC
Table of Contents
1 Review of HMC
2 Turning discrete problems into discontinuous ones
3 Theory of discontinuous Hamiltonian dynamics
4 Numerical method for discontinuous dynamics
5 Numerical results
6 Results
Review of HMC
HMC in its basic form
HMC samples from an augmented parameter space (θ, p) where:
π(θ, p) ∝ πΘ(θ) × N (p ; 0, mI)
U(θ) = − log πΘ(θ) is called potential energy.
Review of HMC
HMC in its basic form
HMC samples from an augmented parameter space (θ, p) where:
π(θ, p) ∝ πΘ(θ) × N (p ; 0, mI)
U(θ) = − log πΘ(θ) is called potential energy.
Transition rule of HMC
Given the current state (θ0, p0), HMC generates the next state as follows:
1 Re-sample p0 ∼ N (0, mI)
2 Generate a Metropolis proposal by solving Hamilton’s equation:
dθ
dt
= m−1
p,
dp
dt
= − θU(θ) (1)
with the initial condition (θ0, p0).
3 Accept or reject the proposal.
Review of HMC
HMC in its basic form
HMC samples from an augmented parameter space (θ, p) where:
π(θ, p) ∝ πΘ(θ) × N (p ; 0, mI)
U(θ) = − log πΘ(θ) is called potential energy.
Transition rule of HMC
Given the current state (θ0, p0), HMC generates the next state as follows:
1 Re-sample p0 ∼ N (0, mI)
2 Generate a Metropolis proposal by solving Hamilton’s equation:
dθ
dt
= m−1
p,
dp
dt
= − θU(θ) (1)
with the initial condition (θ0, p0).
3 Accept or reject the proposal.
Interpretation of (1): dθ
dt = velocity, mass × d
dt (velocity) = − θU(θ)
Review of HMC
Visual illustration: HMC in action
HMC for a 2d Gaussian (correlation = 0.9)
Review of HMC
HMC in a more general form
HMC samples from an augmented parameter space (θ, p) where:
π(θ, p) ∝ πΘ(θ) × πP (p)
K(p) = − log πP (p) is called kinetic energy.
Transition rule of HMC
Given the current state (θ0, p0), HMC generates the next state as follows:
1 Re-sample p0 ∼ πP (·).
2 Generate a Metropolis proposal by solving Hamilton’s equation:
dθ
dt
= pK(p)
dp
dt
= − θU(θ) (2)
with the initial condition (θ0, p0).
3 Accept or reject the proposal.
Review of HMC
Properties of Hamiltonian dynamics
Conservation of energy:
U(θ(t)) + K(p(t)) = U(θ0) + K(p0) for all t ∈ R
a basis for high acceptance probabilities of HMC proposals.
Review of HMC
Properties of Hamiltonian dynamics
Conservation of energy:
U(θ(t)) + K(p(t)) = U(θ0) + K(p0) for all t ∈ R
a basis for high acceptance probabilities of HMC proposals.
Reversibility & Volume-preservation
symmetry of proposals “P(x → x∗) = P(x∗ → x)”
Turning discrete problems into discontinuous ones
Table of Contents
1 Review of HMC
2 Turning discrete problems into discontinuous ones
3 Theory of discontinuous Hamiltonian dynamics
4 Numerical method for discontinuous dynamics
5 Numerical results
6 Results
Turning discrete problems into discontinuous ones
Turning discrete problem into discontinuous one
Consider a discrete parameter N ∈ Z+ with a prior πN (·).
Map N into a continuous parameter N such that
N = n if and only if N ∈ (an, an+1]
To match the distribution of N, the corresponding density of N is
πN
(˜n) =
n≥1
πN (n)
an+1 − an
1{an < ˜n ≤ an+1}
Turning discrete problems into discontinuous ones
Turning discrete problem into discontinuous one
0 2 4 6 8 10
n
0.0
0.2
0.4
0.6
Massfunction
pmf (n+1) 2
0 2 4 6 8 10
n
0.0
0.2
0.4
0.6
Density
log-scale
embedding
linear-scale
embedding
Figure: Relating a discrete mass function (left) to a density function (right).
Turning discrete problems into discontinuous ones
What about more complex discrete spaces?
Graphs? Trees?
For “momentum” to be useful, we need a notion of direction.
Turning discrete problems into discontinuous ones
What about more complex discrete spaces?
Short answer: I don’t know. (Let me know if you got ideas.)
Graphs? Trees?
For “momentum” to be useful, we need a notion of direction.
Theory of discontinuous Hamiltonian dynamics
Table of Contents
1 Review of HMC
2 Turning discrete problems into discontinuous ones
3 Theory of discontinuous Hamiltonian dynamics
4 Numerical method for discontinuous dynamics
5 Numerical results
6 Results
Theory of discontinuous Hamiltonian dynamics
Theory of discontinuous Hamiltonian dynamics
When U(θ) = − log π(θ) is discontinuous, Hamilton’s equations
dθ
dt
= pK(p)
dp
dt
= − θU(θ) (3)
becomes a measure-valued differential equation / inclusion.
θi
U(θ)
Figure:
Theory of discontinuous Hamiltonian dynamics
Theory of discontinuous Hamiltonian dynamics
Define discontinuous dynamics as a limit of smooth dynamics:
Uδ — smooth approximations of U i.e. limδ→0 Uδ = U.
(θδ, pδ)(t) — the solution corresponding to Uδ.
θi
U(θ)
Uδ(θ)
Figure:
Theory of discontinuous Hamiltonian dynamics
Theory of discontinuous Hamiltonian dynamics
Define discontinuous dynamics as a limit of smooth dynamics:
Uδ — smooth approximations of U i.e. limδ→0 Uδ = U.
(θδ, pδ)(t) — the solution corresponding to Uδ.
(θ, p)(t) := limδ→0(θδ, pδ)(t).
θi
U(θ)
Uδ(θ)
Figure: Example trajectory θ(t) of discontinuous Hamiltonian dynamics.
Theory of discontinuous Hamiltonian dynamics
Behavior of dynamics at discontinuity
When the trajectory θ(t) encounters a discontinuity of U at event
time te, the momentum p(t) undergoes an instantaneous change.
Theory of discontinuous Hamiltonian dynamics
Behavior of dynamics at discontinuity
When the trajectory θ(t) encounters a discontinuity of U at event
time te, the momentum p(t) undergoes an instantaneous change.
The change in p occurs only in the direction of “− θU(θ)”:
p(t+
e ) = p(t−
e ) − γ ν (θ(te))
where ν(θ) is orthonormal to the discontinuity boundary of U.
Theory of discontinuous Hamiltonian dynamics
Behavior of dynamics at discontinuity
When the trajectory θ(t) encounters a discontinuity of U at event
time te, the momentum p(t) undergoes an instantaneous change.
The change in p occurs only in the direction of “− θU(θ)”:
p(t+
e ) = p(t−
e ) − γ ν (θ(te))
where ν(θ) is orthonormal to the discontinuity boundary of U.
The scalar γ is determined by the energy conservation principle:
K(p(t+
e )) − K(p(t−
e )) = U(θ(t−
e )) − U(θ(t+
e ))
(provided K(p) is convex and K(p) → ∞ as p → ∞).
Numerical method for discontinuous dynamics
Table of Contents
1 Review of HMC
2 Turning discrete problems into discontinuous ones
3 Theory of discontinuous Hamiltonian dynamics
4 Numerical method for discontinuous dynamics
5 Numerical results
6 Results
Numerical method for discontinuous dynamics
Dealing with discontinuity
Numerical method for discontinuous dynamics
Dealing with discontinuity
How about ignoring them?
Numerical method for discontinuous dynamics
Dealing with discontinuity
How about ignoring them?
Leapfrog integrator completely fails to preserve the energy.
i.e. low (or even negligible) acceptance probabilities.
Numerical method for discontinuous dynamics
Event-driven approach at discontinuity
Pakman and Paninski (2013) and Afshar and Domke (2015):
Detect discontinuities and treat them appropriately.
(Event-driven Monte Carlo of Alder and Wainwright (1959).)
Numerical method for discontinuous dynamics
Event-driven approach at discontinuity
Pakman and Paninski (2013) and Afshar and Domke (2015):
Detect discontinuities and treat them appropriately.
(Event-driven Monte Carlo of Alder and Wainwright (1959).)
Problem: in Gaussian momentum case, the change in U(θ) must be
computed across every single discontinuity.
Numerical method for discontinuous dynamics
Problem with Gaussian momentum & existing approach
Say var(N) ≈ 1, 000. Then a Metropolis step N → N ± 1, 000
should have a good chance of acceptance.
The numerical method requires 1, 000 density evaluations (ouch!)
for a corresponding transition.
ΔU ≈ .01
Figure: Conditional distribution of an embedded discrete parameter in
the Jolly-Seber example.
Numerical method for discontinuous dynamics
Laplace momentum: better alternative
Consider a Laplace momentum π(p) ∝ i exp(−m−1
i |pi|).
The corresponding Hamilton’s equation is
dθ
dt
= m−1
· sign(p),
dp
dt
= − θU(θ)
Numerical method for discontinuous dynamics
Laplace momentum: better alternative
Consider a Laplace momentum π(p) ∝ i exp(−m−1
i |pi|).
The corresponding Hamilton’s equation is
dθ
dt
= m−1
· sign(p),
dp
dt
= − θU(θ)
Key property: the velocity dθ/dt depends only on the signs of pi’s
and not on their magnitudes.
This property allows an accurate numerical approximation
without keeping track of small changes in pi’s.
Numerical method for discontinuous dynamics
Numerical method for Laplace momentum
Observation: approximating dynamics based on Laplace momentum is
simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ)
θ θ* = θ + Δt × m-1 sign(p)
U(θ)
p
Numerical method for discontinuous dynamics
Numerical method for Laplace momentum
Observation: approximating dynamics based on Laplace momentum is
simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ)
θ θ* = θ + Δt × m-1 sign(p)
U(θ)
p U(θ*) − U(θ) < K(p) ?
Numerical method for discontinuous dynamics
Numerical method for Laplace momentum
Observation: approximating dynamics based on Laplace momentum is
simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ)
θ θ* = θ + Δt × m-1 sign(p)
U(θ)
U(θ*) − U(θ) = K(p) − K(p*)
p*
Numerical method for discontinuous dynamics
Numerical method for Laplace momentum
Observation: approximating dynamics based on Laplace momentum is
simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ)
θ θ*
U(θ*) − U(θ)
p
Numerical method for discontinuous dynamics
Numerical method for Laplace momentum
Observation: approximating dynamics based on Laplace momentum is
simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ)
p* ← - p
θ* ← θ
Numerical method for discontinuous dynamics
Coordinate-wise integration for Laplace momentum
For θ ∈ Rd, we can split the ODE into its coordinate-wise component:
dθi
dt
= m−1
i sign(pi),
dpi
dt
= −∂θi
U(θ),
dθ−i
dt
=
dp−i
dt
= 0 (4)
Numerical method for discontinuous dynamics
Coordinate-wise integration for Laplace momentum
4 2 0 2
4
2
0
2
4
0
1
2
3
4
5
Figure: Trajectory of a numerical solution via the coordinate-wise integrator.
Numerical method for discontinuous dynamics
Coordinate-wise integration for Laplace momentum
Reversibility preserved by symmetric splitting or randomly permuting
the coordinates.
We can also use Laplace momentum for discrete parameters and
Gaussian momentum for continuous parameters.
Numerical method for discontinuous dynamics
Properties of discontinuous HMC
When using independent Laplace momentum,
Proposals are rejection-free thanks to exact energy conservation.1
1
But too big of a stepsize leads to poor mixing.
Numerical method for discontinuous dynamics
Properties of discontinuous HMC
When using independent Laplace momentum,
Proposals are rejection-free thanks to exact energy conservation.1
Taking one numerical integration step of DHMC
≡
Variable-at-a-time Metropolis.
1
But too big of a stepsize leads to poor mixing.
Numerical method for discontinuous dynamics
Properties of discontinuous HMC
When using independent Laplace momentum,
Proposals are rejection-free thanks to exact energy conservation.1
Taking one numerical integration step of DHMC
≡
Variable-at-a-time Metropolis.
When mixing Laplace and Gaussian momentum:
Errors in energy is O(∆t2), and hence 1 − O(∆t4) acceptance rate.
1
But too big of a stepsize leads to poor mixing.
Numerical results
Table of Contents
1 Review of HMC
2 Turning discrete problems into discontinuous ones
3 Theory of discontinuous Hamiltonian dynamics
4 Numerical method for discontinuous dynamics
5 Numerical results
6 Results
Numerical results
Numerical results: Jolly-Seber (capture-recapture) model
Data : the number of marked / unmarked individuals over multiple
capture occasions
Parameters : population sizes, capture probabilities, survival rates
Numerical results
Numerical results: Jolly-Seber model
One computational challenge arises from unidentifiability between an
unknown capture probability qi and population size Ni.
0 5
log(q1/(1 q1))
2.0
2.5
3.0
log10(N1)
Numerical results
Numerical results: Jolly-Seber model
Table: Performance summary of each algorithm on the Jolly-Serber example.
ESS per 100 samples ESS per minute Path length Iter time
DHMC (diagonal) 45.5 424 45 87.7
DHMC (identity) 24.1 126 77.5 157
NUTS-Gibbs 1.04 6.38 150 133
Metropolis 0.0714 58.5 1 1
ESS : effective sample sizes (minimum over
the first and second moment estimators)
diagonal / identity : choice of mass matrix
Metropolis : optimal random walk Metropolis
NUTS-Gibbs : alternate update of continuous &
discrete params as employed by PyMC
Numerical results
Numerical results: generalized Bayesian inference
For a given loss function (y, θ) of interest, a generalized posterior
(Bissiri et al., 2016) is given by
πpost(θ) ∝ exp − i (yi, θ) πprior(θ)
We consider a binary classification with the 0-1 loss
(y, θ) = 1{y = sign(x θ)} for y ∈ {−1, 1}.
Numerical results
Numerical results: generalized Bayesian inference
For a given loss function (y, θ) of interest, a generalized posterior
(Bissiri et al., 2016) is given by
πpost(θ) ∝ exp − i (yi, θ) πprior(θ)
We consider a binary classification with the 0-1 loss
(y, θ) = 1{y = sign(x θ)} for y ∈ {−1, 1}.
9.2 9.0 8.8
Intercept
0
2
4
6
Density(conditional)
Numerical results
Numerical results: generalized Bayesian inference
Data: semiconductor quality with various sensor measurements
Goal: predict faulty products / infer relevant sensor measurements
Numerical results
Numerical results: generalized Bayesian inference
Table: Performance summary on the generalized Bayesian posterior example.
ESS per 100 samples ESS per minute Path length Iter time
DHMC 26.3 76 25 972
Metropolis 0.00809 (± 0.0018) 0.227 1 1
Variable-at-a-time 0.514 (± 0.039) 39.8 1 36.2
9.2 9.0 8.8
Intercept
0
2
4
6
Density(conditional)
Results
Table of Contents
1 Review of HMC
2 Turning discrete problems into discontinuous ones
3 Theory of discontinuous Hamiltonian dynamics
4 Numerical method for discontinuous dynamics
5 Numerical results
6 Results
Results
Summary
Hamiltonian dynamics based on Laplace momentum allows an
efficient exploration of discontinuous target distributions.
Numerical method with exact energy conservation property.
Results
Future directions
Test DHMC on a wider range of applications in the context of a
probabilistic programming language.
Explore the utility of Laplace momentum as an alternative to
Gaussian one.
What to do with more complex discrete spaces?
Develop notion of directions.
Avoid rejections by “swapping” probability between θ and p.
Results
References
Nishimura, A., Dunson, D. and Lu, J. (2017) “Discontinuous Hamiltonian
Monte Carlo for sampling discrete parameters,” arXiv:1705.08510.
Code available at
https://github.com/aki-nishimura/discontinuous-hmc
Results
The End
Thank you!

More Related Content

What's hot

MCMC and likelihood-free methods
MCMC and likelihood-free methodsMCMC and likelihood-free methods
MCMC and likelihood-free methods
Christian Robert
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
The Statistical and Applied Mathematical Sciences Institute
 
Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...
Valentin De Bortoli
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
Bayesian hybrid variable selection under generalized linear models
Bayesian hybrid variable selection under generalized linear modelsBayesian hybrid variable selection under generalized linear models
Bayesian hybrid variable selection under generalized linear models
Caleb (Shiqiang) Jin
 
Delayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithmsDelayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithms
Christian Robert
 
Approximate Bayesian Computation with Quasi-Likelihoods
Approximate Bayesian Computation with Quasi-LikelihoodsApproximate Bayesian Computation with Quasi-Likelihoods
Approximate Bayesian Computation with Quasi-Likelihoods
Stefano Cabras
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
Christian Robert
 
QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...
QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...
QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...
The Statistical and Applied Mathematical Sciences Institute
 
Chris Sherlock's slides
Chris Sherlock's slidesChris Sherlock's slides
Chris Sherlock's slides
Christian Robert
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
Mark Girolami's Read Paper 2010
Mark Girolami's Read Paper 2010Mark Girolami's Read Paper 2010
Mark Girolami's Read Paper 2010
Christian Robert
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
Christian Robert
 
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithmsRao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Christian Robert
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
ABC in Venezia
ABC in VeneziaABC in Venezia
ABC in Venezia
Christian Robert
 
Can we estimate a constant?
Can we estimate a constant?Can we estimate a constant?
Can we estimate a constant?
Christian Robert
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
Nested sampling
Nested samplingNested sampling
Nested sampling
Christian Robert
 
Coordinate sampler: A non-reversible Gibbs-like sampler
Coordinate sampler: A non-reversible Gibbs-like samplerCoordinate sampler: A non-reversible Gibbs-like sampler
Coordinate sampler: A non-reversible Gibbs-like sampler
Christian Robert
 

What's hot (20)

MCMC and likelihood-free methods
MCMC and likelihood-free methodsMCMC and likelihood-free methods
MCMC and likelihood-free methods
 
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop,...
 
Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...Maximum likelihood estimation of regularisation parameters in inverse problem...
Maximum likelihood estimation of regularisation parameters in inverse problem...
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Bayesian hybrid variable selection under generalized linear models
Bayesian hybrid variable selection under generalized linear modelsBayesian hybrid variable selection under generalized linear models
Bayesian hybrid variable selection under generalized linear models
 
Delayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithmsDelayed acceptance for Metropolis-Hastings algorithms
Delayed acceptance for Metropolis-Hastings algorithms
 
Approximate Bayesian Computation with Quasi-Likelihoods
Approximate Bayesian Computation with Quasi-LikelihoodsApproximate Bayesian Computation with Quasi-Likelihoods
Approximate Bayesian Computation with Quasi-Likelihoods
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
 
QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...
QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...
QMC Opening Workshop, High Accuracy Algorithms for Interpolating and Integrat...
 
Chris Sherlock's slides
Chris Sherlock's slidesChris Sherlock's slides
Chris Sherlock's slides
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Mark Girolami's Read Paper 2010
Mark Girolami's Read Paper 2010Mark Girolami's Read Paper 2010
Mark Girolami's Read Paper 2010
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
 
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithmsRao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
Rao-Blackwellisation schemes for accelerating Metropolis-Hastings algorithms
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
ABC in Venezia
ABC in VeneziaABC in Venezia
ABC in Venezia
 
Can we estimate a constant?
Can we estimate a constant?Can we estimate a constant?
Can we estimate a constant?
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
 
Nested sampling
Nested samplingNested sampling
Nested sampling
 
Coordinate sampler: A non-reversible Gibbs-like sampler
Coordinate sampler: A non-reversible Gibbs-like samplerCoordinate sampler: A non-reversible Gibbs-like sampler
Coordinate sampler: A non-reversible Gibbs-like sampler
 

Similar to QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop, Discontinuous Hamiltonian Monte Carlo for Sampling Discrete Parameters - Aki Nishimura, Dec 12, 2017

HMC and NUTS
HMC and NUTSHMC and NUTS
HMC and NUTS
Marco Banterle
 
intro
introintro
Program on Mathematical and Statistical Methods for Climate and the Earth Sys...
Program on Mathematical and Statistical Methods for Climate and the Earth Sys...Program on Mathematical and Statistical Methods for Climate and the Earth Sys...
Program on Mathematical and Statistical Methods for Climate and the Earth Sys...
The Statistical and Applied Mathematical Sciences Institute
 
International Journal of Mathematics and Statistics Invention (IJMSI)
International Journal of Mathematics and Statistics Invention (IJMSI) International Journal of Mathematics and Statistics Invention (IJMSI)
International Journal of Mathematics and Statistics Invention (IJMSI)
inventionjournals
 
Modeling and quantification of uncertainties in numerical aerodynamics
Modeling and quantification of uncertainties in numerical aerodynamicsModeling and quantification of uncertainties in numerical aerodynamics
Modeling and quantification of uncertainties in numerical aerodynamics
Alexander Litvinenko
 
Research internship on optimal stochastic theory with financial application u...
Research internship on optimal stochastic theory with financial application u...Research internship on optimal stochastic theory with financial application u...
Research internship on optimal stochastic theory with financial application u...
Asma Ben Slimene
 
Presentation on stochastic control problem with financial applications (Merto...
Presentation on stochastic control problem with financial applications (Merto...Presentation on stochastic control problem with financial applications (Merto...
Presentation on stochastic control problem with financial applications (Merto...
Asma Ben Slimene
 
QMC: Transition Workshop - Discussion of "Representative Points for Small and...
QMC: Transition Workshop - Discussion of "Representative Points for Small and...QMC: Transition Workshop - Discussion of "Representative Points for Small and...
QMC: Transition Workshop - Discussion of "Representative Points for Small and...
The Statistical and Applied Mathematical Sciences Institute
 
Nature16059
Nature16059Nature16059
Nature16059
Lagal Tchixa
 
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithmno U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
Christian Robert
 
HOME ASSIGNMENT (0).pptx
HOME ASSIGNMENT (0).pptxHOME ASSIGNMENT (0).pptx
HOME ASSIGNMENT (0).pptx
SayedulHassan1
 
article_imen_ridha_2016_version_finale
article_imen_ridha_2016_version_finalearticle_imen_ridha_2016_version_finale
article_imen_ridha_2016_version_finaleMdimagh Ridha
 
Monte Carlo Berkeley.pptx
Monte Carlo Berkeley.pptxMonte Carlo Berkeley.pptx
Monte Carlo Berkeley.pptx
HaibinSu2
 
HOME ASSIGNMENT omar ali.pptx
HOME ASSIGNMENT omar ali.pptxHOME ASSIGNMENT omar ali.pptx
HOME ASSIGNMENT omar ali.pptx
SayedulHassan1
 
Approximation in Stochastic Integer Programming
Approximation in Stochastic Integer ProgrammingApproximation in Stochastic Integer Programming
Approximation in Stochastic Integer Programming
SSA KPI
 
Metropolis-Hastings MCMC Short Tutorial
Metropolis-Hastings MCMC Short TutorialMetropolis-Hastings MCMC Short Tutorial
Metropolis-Hastings MCMC Short Tutorial
Ralph Schlosser
 
Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...
Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...
Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...
BRNSS Publication Hub
 
06_AJMS_256_20-compressed.pdf
06_AJMS_256_20-compressed.pdf06_AJMS_256_20-compressed.pdf
06_AJMS_256_20-compressed.pdf
BRNSS Publication Hub
 
Regularization Methods to Solve
Regularization Methods to SolveRegularization Methods to Solve
Regularization Methods to SolveKomal Goyal
 
CHN and Swap Heuristic to Solve the Maximum Independent Set Problem
CHN and Swap Heuristic to Solve the Maximum Independent Set ProblemCHN and Swap Heuristic to Solve the Maximum Independent Set Problem
CHN and Swap Heuristic to Solve the Maximum Independent Set Problem
IJECEIAES
 

Similar to QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop, Discontinuous Hamiltonian Monte Carlo for Sampling Discrete Parameters - Aki Nishimura, Dec 12, 2017 (20)

HMC and NUTS
HMC and NUTSHMC and NUTS
HMC and NUTS
 
intro
introintro
intro
 
Program on Mathematical and Statistical Methods for Climate and the Earth Sys...
Program on Mathematical and Statistical Methods for Climate and the Earth Sys...Program on Mathematical and Statistical Methods for Climate and the Earth Sys...
Program on Mathematical and Statistical Methods for Climate and the Earth Sys...
 
International Journal of Mathematics and Statistics Invention (IJMSI)
International Journal of Mathematics and Statistics Invention (IJMSI) International Journal of Mathematics and Statistics Invention (IJMSI)
International Journal of Mathematics and Statistics Invention (IJMSI)
 
Modeling and quantification of uncertainties in numerical aerodynamics
Modeling and quantification of uncertainties in numerical aerodynamicsModeling and quantification of uncertainties in numerical aerodynamics
Modeling and quantification of uncertainties in numerical aerodynamics
 
Research internship on optimal stochastic theory with financial application u...
Research internship on optimal stochastic theory with financial application u...Research internship on optimal stochastic theory with financial application u...
Research internship on optimal stochastic theory with financial application u...
 
Presentation on stochastic control problem with financial applications (Merto...
Presentation on stochastic control problem with financial applications (Merto...Presentation on stochastic control problem with financial applications (Merto...
Presentation on stochastic control problem with financial applications (Merto...
 
QMC: Transition Workshop - Discussion of "Representative Points for Small and...
QMC: Transition Workshop - Discussion of "Representative Points for Small and...QMC: Transition Workshop - Discussion of "Representative Points for Small and...
QMC: Transition Workshop - Discussion of "Representative Points for Small and...
 
Nature16059
Nature16059Nature16059
Nature16059
 
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithmno U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
 
HOME ASSIGNMENT (0).pptx
HOME ASSIGNMENT (0).pptxHOME ASSIGNMENT (0).pptx
HOME ASSIGNMENT (0).pptx
 
article_imen_ridha_2016_version_finale
article_imen_ridha_2016_version_finalearticle_imen_ridha_2016_version_finale
article_imen_ridha_2016_version_finale
 
Monte Carlo Berkeley.pptx
Monte Carlo Berkeley.pptxMonte Carlo Berkeley.pptx
Monte Carlo Berkeley.pptx
 
HOME ASSIGNMENT omar ali.pptx
HOME ASSIGNMENT omar ali.pptxHOME ASSIGNMENT omar ali.pptx
HOME ASSIGNMENT omar ali.pptx
 
Approximation in Stochastic Integer Programming
Approximation in Stochastic Integer ProgrammingApproximation in Stochastic Integer Programming
Approximation in Stochastic Integer Programming
 
Metropolis-Hastings MCMC Short Tutorial
Metropolis-Hastings MCMC Short TutorialMetropolis-Hastings MCMC Short Tutorial
Metropolis-Hastings MCMC Short Tutorial
 
Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...
Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...
Solving High-order Non-linear Partial Differential Equations by Modified q-Ho...
 
06_AJMS_256_20-compressed.pdf
06_AJMS_256_20-compressed.pdf06_AJMS_256_20-compressed.pdf
06_AJMS_256_20-compressed.pdf
 
Regularization Methods to Solve
Regularization Methods to SolveRegularization Methods to Solve
Regularization Methods to Solve
 
CHN and Swap Heuristic to Solve the Maximum Independent Set Problem
CHN and Swap Heuristic to Solve the Maximum Independent Set ProblemCHN and Swap Heuristic to Solve the Maximum Independent Set Problem
CHN and Swap Heuristic to Solve the Maximum Independent Set Problem
 

More from The Statistical and Applied Mathematical Sciences Institute

Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...
Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...
Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...
The Statistical and Applied Mathematical Sciences Institute
 
2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...
2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...
2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...
Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...
Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...
Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...
Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - A Bracketing Relationship between Differe...
Causal Inference Opening Workshop - A Bracketing Relationship between Differe...Causal Inference Opening Workshop - A Bracketing Relationship between Differe...
Causal Inference Opening Workshop - A Bracketing Relationship between Differe...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...
Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...
Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Difference-in-differences: more than meet...
Causal Inference Opening Workshop - Difference-in-differences: more than meet...Causal Inference Opening Workshop - Difference-in-differences: more than meet...
Causal Inference Opening Workshop - Difference-in-differences: more than meet...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...
Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...
Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...
Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...
Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...
Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...
Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...
Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...
Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...
Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...
Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...
Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...
Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...
Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...
Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...
Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...
Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...
The Statistical and Applied Mathematical Sciences Institute
 
Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...
Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...
Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...
The Statistical and Applied Mathematical Sciences Institute
 
2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...
2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...
2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...
The Statistical and Applied Mathematical Sciences Institute
 
2019 Fall Series: Professional Development, Writing Academic Papers…What Work...
2019 Fall Series: Professional Development, Writing Academic Papers…What Work...2019 Fall Series: Professional Development, Writing Academic Papers…What Work...
2019 Fall Series: Professional Development, Writing Academic Papers…What Work...
The Statistical and Applied Mathematical Sciences Institute
 
2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...
2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...
2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...
The Statistical and Applied Mathematical Sciences Institute
 
2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...
2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...
2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...
The Statistical and Applied Mathematical Sciences Institute
 

More from The Statistical and Applied Mathematical Sciences Institute (20)

Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...
Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...
Causal Inference Opening Workshop - Latent Variable Models, Causal Inference,...
 
2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...
2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...
2019 Fall Series: Special Guest Lecture - 0-1 Phase Transitions in High Dimen...
 
Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...
Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...
Causal Inference Opening Workshop - Causal Discovery in Neuroimaging Data - F...
 
Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...
Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...
Causal Inference Opening Workshop - Smooth Extensions to BART for Heterogeneo...
 
Causal Inference Opening Workshop - A Bracketing Relationship between Differe...
Causal Inference Opening Workshop - A Bracketing Relationship between Differe...Causal Inference Opening Workshop - A Bracketing Relationship between Differe...
Causal Inference Opening Workshop - A Bracketing Relationship between Differe...
 
Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...
Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...
Causal Inference Opening Workshop - Testing Weak Nulls in Matched Observation...
 
Causal Inference Opening Workshop - Difference-in-differences: more than meet...
Causal Inference Opening Workshop - Difference-in-differences: more than meet...Causal Inference Opening Workshop - Difference-in-differences: more than meet...
Causal Inference Opening Workshop - Difference-in-differences: more than meet...
 
Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...
Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...
Causal Inference Opening Workshop - New Statistical Learning Methods for Esti...
 
Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...
Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...
Causal Inference Opening Workshop - Bipartite Causal Inference with Interfere...
 
Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...
Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...
Causal Inference Opening Workshop - Bridging the Gap Between Causal Literatur...
 
Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...
Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...
Causal Inference Opening Workshop - Some Applications of Reinforcement Learni...
 
Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...
Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...
Causal Inference Opening Workshop - Bracketing Bounds for Differences-in-Diff...
 
Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...
Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...
Causal Inference Opening Workshop - Assisting the Impact of State Polcies: Br...
 
Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...
Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...
Causal Inference Opening Workshop - Experimenting in Equilibrium - Stefan Wag...
 
Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...
Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...
Causal Inference Opening Workshop - Targeted Learning for Causal Inference Ba...
 
Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...
Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...
Causal Inference Opening Workshop - Bayesian Nonparametric Models for Treatme...
 
2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...
2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...
2019 Fall Series: Special Guest Lecture - Adversarial Risk Analysis of the Ge...
 
2019 Fall Series: Professional Development, Writing Academic Papers…What Work...
2019 Fall Series: Professional Development, Writing Academic Papers…What Work...2019 Fall Series: Professional Development, Writing Academic Papers…What Work...
2019 Fall Series: Professional Development, Writing Academic Papers…What Work...
 
2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...
2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...
2019 GDRR: Blockchain Data Analytics - Machine Learning in/for Blockchain: Fu...
 
2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...
2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...
2019 GDRR: Blockchain Data Analytics - QuTrack: Model Life Cycle Management f...
 

Recently uploaded

Unit 2- Research Aptitude (UGC NET Paper I).pdf
Unit 2- Research Aptitude (UGC NET Paper I).pdfUnit 2- Research Aptitude (UGC NET Paper I).pdf
Unit 2- Research Aptitude (UGC NET Paper I).pdf
Thiyagu K
 
aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa
aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa
aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa
siemaillard
 
Cambridge International AS A Level Biology Coursebook - EBook (MaryFosbery J...
Cambridge International AS  A Level Biology Coursebook - EBook (MaryFosbery J...Cambridge International AS  A Level Biology Coursebook - EBook (MaryFosbery J...
Cambridge International AS A Level Biology Coursebook - EBook (MaryFosbery J...
AzmatAli747758
 
Sectors of the Indian Economy - Class 10 Study Notes pdf
Sectors of the Indian Economy - Class 10 Study Notes pdfSectors of the Indian Economy - Class 10 Study Notes pdf
Sectors of the Indian Economy - Class 10 Study Notes pdf
Vivekanand Anglo Vedic Academy
 
1.4 modern child centered education - mahatma gandhi-2.pptx
1.4 modern child centered education - mahatma gandhi-2.pptx1.4 modern child centered education - mahatma gandhi-2.pptx
1.4 modern child centered education - mahatma gandhi-2.pptx
JosvitaDsouza2
 
TESDA TM1 REVIEWER FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...
TESDA TM1 REVIEWER  FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...TESDA TM1 REVIEWER  FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...
TESDA TM1 REVIEWER FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...
EugeneSaldivar
 
How to Split Bills in the Odoo 17 POS Module
How to Split Bills in the Odoo 17 POS ModuleHow to Split Bills in the Odoo 17 POS Module
How to Split Bills in the Odoo 17 POS Module
Celine George
 
Thesis Statement for students diagnonsed withADHD.ppt
Thesis Statement for students diagnonsed withADHD.pptThesis Statement for students diagnonsed withADHD.ppt
Thesis Statement for students diagnonsed withADHD.ppt
EverAndrsGuerraGuerr
 
Additional Benefits for Employee Website.pdf
Additional Benefits for Employee Website.pdfAdditional Benefits for Employee Website.pdf
Additional Benefits for Employee Website.pdf
joachimlavalley1
 
MARUTI SUZUKI- A Successful Joint Venture in India.pptx
MARUTI SUZUKI- A Successful Joint Venture in India.pptxMARUTI SUZUKI- A Successful Joint Venture in India.pptx
MARUTI SUZUKI- A Successful Joint Venture in India.pptx
bennyroshan06
 
Synthetic Fiber Construction in lab .pptx
Synthetic Fiber Construction in lab .pptxSynthetic Fiber Construction in lab .pptx
Synthetic Fiber Construction in lab .pptx
Pavel ( NSTU)
 
The geography of Taylor Swift - some ideas
The geography of Taylor Swift - some ideasThe geography of Taylor Swift - some ideas
The geography of Taylor Swift - some ideas
GeoBlogs
 
The French Revolution Class 9 Study Material pdf free download
The French Revolution Class 9 Study Material pdf free downloadThe French Revolution Class 9 Study Material pdf free download
The French Revolution Class 9 Study Material pdf free download
Vivekanand Anglo Vedic Academy
 
The Roman Empire A Historical Colossus.pdf
The Roman Empire A Historical Colossus.pdfThe Roman Empire A Historical Colossus.pdf
The Roman Empire A Historical Colossus.pdf
kaushalkr1407
 
Operation Blue Star - Saka Neela Tara
Operation Blue Star   -  Saka Neela TaraOperation Blue Star   -  Saka Neela Tara
Operation Blue Star - Saka Neela Tara
Balvir Singh
 
Overview on Edible Vaccine: Pros & Cons with Mechanism
Overview on Edible Vaccine: Pros & Cons with MechanismOverview on Edible Vaccine: Pros & Cons with Mechanism
Overview on Edible Vaccine: Pros & Cons with Mechanism
DeeptiGupta154
 
The Art Pastor's Guide to Sabbath | Steve Thomason
The Art Pastor's Guide to Sabbath | Steve ThomasonThe Art Pastor's Guide to Sabbath | Steve Thomason
The Art Pastor's Guide to Sabbath | Steve Thomason
Steve Thomason
 
Supporting (UKRI) OA monographs at Salford.pptx
Supporting (UKRI) OA monographs at Salford.pptxSupporting (UKRI) OA monographs at Salford.pptx
Supporting (UKRI) OA monographs at Salford.pptx
Jisc
 
How to Create Map Views in the Odoo 17 ERP
How to Create Map Views in the Odoo 17 ERPHow to Create Map Views in the Odoo 17 ERP
How to Create Map Views in the Odoo 17 ERP
Celine George
 
Digital Tools and AI for Teaching Learning and Research
Digital Tools and AI for Teaching Learning and ResearchDigital Tools and AI for Teaching Learning and Research
Digital Tools and AI for Teaching Learning and Research
Vikramjit Singh
 

Recently uploaded (20)

Unit 2- Research Aptitude (UGC NET Paper I).pdf
Unit 2- Research Aptitude (UGC NET Paper I).pdfUnit 2- Research Aptitude (UGC NET Paper I).pdf
Unit 2- Research Aptitude (UGC NET Paper I).pdf
 
aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa
aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa
aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa
 
Cambridge International AS A Level Biology Coursebook - EBook (MaryFosbery J...
Cambridge International AS  A Level Biology Coursebook - EBook (MaryFosbery J...Cambridge International AS  A Level Biology Coursebook - EBook (MaryFosbery J...
Cambridge International AS A Level Biology Coursebook - EBook (MaryFosbery J...
 
Sectors of the Indian Economy - Class 10 Study Notes pdf
Sectors of the Indian Economy - Class 10 Study Notes pdfSectors of the Indian Economy - Class 10 Study Notes pdf
Sectors of the Indian Economy - Class 10 Study Notes pdf
 
1.4 modern child centered education - mahatma gandhi-2.pptx
1.4 modern child centered education - mahatma gandhi-2.pptx1.4 modern child centered education - mahatma gandhi-2.pptx
1.4 modern child centered education - mahatma gandhi-2.pptx
 
TESDA TM1 REVIEWER FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...
TESDA TM1 REVIEWER  FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...TESDA TM1 REVIEWER  FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...
TESDA TM1 REVIEWER FOR NATIONAL ASSESSMENT WRITTEN AND ORAL QUESTIONS WITH A...
 
How to Split Bills in the Odoo 17 POS Module
How to Split Bills in the Odoo 17 POS ModuleHow to Split Bills in the Odoo 17 POS Module
How to Split Bills in the Odoo 17 POS Module
 
Thesis Statement for students diagnonsed withADHD.ppt
Thesis Statement for students diagnonsed withADHD.pptThesis Statement for students diagnonsed withADHD.ppt
Thesis Statement for students diagnonsed withADHD.ppt
 
Additional Benefits for Employee Website.pdf
Additional Benefits for Employee Website.pdfAdditional Benefits for Employee Website.pdf
Additional Benefits for Employee Website.pdf
 
MARUTI SUZUKI- A Successful Joint Venture in India.pptx
MARUTI SUZUKI- A Successful Joint Venture in India.pptxMARUTI SUZUKI- A Successful Joint Venture in India.pptx
MARUTI SUZUKI- A Successful Joint Venture in India.pptx
 
Synthetic Fiber Construction in lab .pptx
Synthetic Fiber Construction in lab .pptxSynthetic Fiber Construction in lab .pptx
Synthetic Fiber Construction in lab .pptx
 
The geography of Taylor Swift - some ideas
The geography of Taylor Swift - some ideasThe geography of Taylor Swift - some ideas
The geography of Taylor Swift - some ideas
 
The French Revolution Class 9 Study Material pdf free download
The French Revolution Class 9 Study Material pdf free downloadThe French Revolution Class 9 Study Material pdf free download
The French Revolution Class 9 Study Material pdf free download
 
The Roman Empire A Historical Colossus.pdf
The Roman Empire A Historical Colossus.pdfThe Roman Empire A Historical Colossus.pdf
The Roman Empire A Historical Colossus.pdf
 
Operation Blue Star - Saka Neela Tara
Operation Blue Star   -  Saka Neela TaraOperation Blue Star   -  Saka Neela Tara
Operation Blue Star - Saka Neela Tara
 
Overview on Edible Vaccine: Pros & Cons with Mechanism
Overview on Edible Vaccine: Pros & Cons with MechanismOverview on Edible Vaccine: Pros & Cons with Mechanism
Overview on Edible Vaccine: Pros & Cons with Mechanism
 
The Art Pastor's Guide to Sabbath | Steve Thomason
The Art Pastor's Guide to Sabbath | Steve ThomasonThe Art Pastor's Guide to Sabbath | Steve Thomason
The Art Pastor's Guide to Sabbath | Steve Thomason
 
Supporting (UKRI) OA monographs at Salford.pptx
Supporting (UKRI) OA monographs at Salford.pptxSupporting (UKRI) OA monographs at Salford.pptx
Supporting (UKRI) OA monographs at Salford.pptx
 
How to Create Map Views in the Odoo 17 ERP
How to Create Map Views in the Odoo 17 ERPHow to Create Map Views in the Odoo 17 ERP
How to Create Map Views in the Odoo 17 ERP
 
Digital Tools and AI for Teaching Learning and Research
Digital Tools and AI for Teaching Learning and ResearchDigital Tools and AI for Teaching Learning and Research
Digital Tools and AI for Teaching Learning and Research
 

QMC Program: Trends and Advances in Monte Carlo Sampling Algorithms Workshop, Discontinuous Hamiltonian Monte Carlo for Sampling Discrete Parameters - Aki Nishimura, Dec 12, 2017

  • 1. Discontinuous Hamiltonian Monte Carlo for discontinuous and discrete distributions Aki Nishimura joint work with David Dunson and Jianfeng Lu SAMSI Workshop: Trends and Advances in Monte Carlo Sampling Algorithms December 12, 2017
  • 2. Models with discrete params / discontinuous likelihoods Discrete : unknown population size, change points Discontinuous : nonparametric generalized Bayes, threshold effects
  • 3. Hamiltonian Monte Carlo (HMC) for Bayesian computation Bayesian inference often relies on Markov chain Monte Carlo. HMC has become popular as an efficient general-purpose algorithm: allows for more flexible generative models (e.g. non-conjugacy). a critical building block of probabilistic programming languages.
  • 4. Hamiltonian Monte Carlo (HMC) for Bayesian computation Idea of a probabilistic programming language: you specify the model, then the software takes care of the rest.
  • 5. Hamiltonian Monte Carlo (HMC) for Bayesian computation Idea of a probabilistic programming language: you specify the model, then the software takes care of the rest. Probabilistic programming languages can algorithmically evaluate (unnormalized) log posterior density. (unnormalized) log conditional densities efficiently by taking advantage of conditional independence structure. gradients of log density.
  • 6. Hamiltonian Monte Carlo (HMC) for Bayesian computation Idea of a probabilistic programming language: you specify the model, then the software takes care of the rest. Probabilistic programming languages can algorithmically evaluate (unnormalized) log posterior density. (unnormalized) log conditional densities efficiently by taking advantage of conditional independence structure. gradients of log density. HMC is well-suited to such softwares and has demonstrated a number of empirical successes e.g. through Stan and PyMC. better theoretical scalability in the number of parameters (Beskos et al., 2013).
  • 7. HMC and discrete parameters / discontinuous likelihoods HMC is based on solutions of an ordinary differential equation. But the ODE makes no sense for discrete parameters / discontinuous likelihoods.
  • 8. HMC and discrete parameters / discontinuous likelihoods HMC is based on solutions of an ordinary differential equation. But the ODE makes no sense for discrete parameters / discontinuous likelihoods. HMC’s inability to handle discrete parameters is considered the most serious drawback (Gelman et al., 2015; Monnahan et al., 2016).
  • 9. HMC and discrete parameters / discontinuous likelihoods HMC is based on solutions of an ordinary differential equation. But the ODE makes no sense for discrete parameters / discontinuous likelihoods. HMC’s inability to handle discrete parameters is considered the most serious drawback (Gelman et al., 2015; Monnahan et al., 2016). Existing approaches in special cases: smooth surrogate function for binary pairwise Markov random field models (Zhang et al., 2012). treat discrete parameters as continuous if the likelihood still makes sense (Berger et al., 2012).
  • 10. Our approach: discontinous HMC Features: allows for a discontinuous target distribution. handles discrete parameters through embedding them into a continuous space. fits within the framework of probabilistic programming languages.
  • 11. Our approach: discontinous HMC Features: allows for a discontinuous target distribution. handles discrete parameters through embedding them into a continuous space. fits within the framework of probabilistic programming languages. Techniques: is motivated by theory of measure-valued differential equation & event-driven Monte Carlo. is based on a novel numerical method for discontinuous dynamics.
  • 12. Our approach: discontinous HMC Features: allows for a discontinuous target distribution. handles discrete parameters through embedding them into a continuous space. fits within the framework of probabilistic programming languages. Techniques: is motivated by theory of measure-valued differential equation & event-driven Monte Carlo. is based on a novel numerical method for discontinuous dynamics. Theoretical properties: generalizes (and hence outperforms) variable-at-a-time Metropolis. achieves a high acceptance rate that indicates a scaling property comparable to HMC.
  • 13. Review of HMC Table of Contents 1 Review of HMC 2 Turning discrete problems into discontinuous ones 3 Theory of discontinuous Hamiltonian dynamics 4 Numerical method for discontinuous dynamics 5 Numerical results 6 Results
  • 14. Review of HMC HMC in its basic form HMC samples from an augmented parameter space (θ, p) where: π(θ, p) ∝ πΘ(θ) × N (p ; 0, mI) U(θ) = − log πΘ(θ) is called potential energy.
  • 15. Review of HMC HMC in its basic form HMC samples from an augmented parameter space (θ, p) where: π(θ, p) ∝ πΘ(θ) × N (p ; 0, mI) U(θ) = − log πΘ(θ) is called potential energy. Transition rule of HMC Given the current state (θ0, p0), HMC generates the next state as follows: 1 Re-sample p0 ∼ N (0, mI) 2 Generate a Metropolis proposal by solving Hamilton’s equation: dθ dt = m−1 p, dp dt = − θU(θ) (1) with the initial condition (θ0, p0). 3 Accept or reject the proposal.
  • 16. Review of HMC HMC in its basic form HMC samples from an augmented parameter space (θ, p) where: π(θ, p) ∝ πΘ(θ) × N (p ; 0, mI) U(θ) = − log πΘ(θ) is called potential energy. Transition rule of HMC Given the current state (θ0, p0), HMC generates the next state as follows: 1 Re-sample p0 ∼ N (0, mI) 2 Generate a Metropolis proposal by solving Hamilton’s equation: dθ dt = m−1 p, dp dt = − θU(θ) (1) with the initial condition (θ0, p0). 3 Accept or reject the proposal. Interpretation of (1): dθ dt = velocity, mass × d dt (velocity) = − θU(θ)
  • 17. Review of HMC Visual illustration: HMC in action HMC for a 2d Gaussian (correlation = 0.9)
  • 18. Review of HMC HMC in a more general form HMC samples from an augmented parameter space (θ, p) where: π(θ, p) ∝ πΘ(θ) × πP (p) K(p) = − log πP (p) is called kinetic energy. Transition rule of HMC Given the current state (θ0, p0), HMC generates the next state as follows: 1 Re-sample p0 ∼ πP (·). 2 Generate a Metropolis proposal by solving Hamilton’s equation: dθ dt = pK(p) dp dt = − θU(θ) (2) with the initial condition (θ0, p0). 3 Accept or reject the proposal.
  • 19. Review of HMC Properties of Hamiltonian dynamics Conservation of energy: U(θ(t)) + K(p(t)) = U(θ0) + K(p0) for all t ∈ R a basis for high acceptance probabilities of HMC proposals.
  • 20. Review of HMC Properties of Hamiltonian dynamics Conservation of energy: U(θ(t)) + K(p(t)) = U(θ0) + K(p0) for all t ∈ R a basis for high acceptance probabilities of HMC proposals. Reversibility & Volume-preservation symmetry of proposals “P(x → x∗) = P(x∗ → x)”
  • 21. Turning discrete problems into discontinuous ones Table of Contents 1 Review of HMC 2 Turning discrete problems into discontinuous ones 3 Theory of discontinuous Hamiltonian dynamics 4 Numerical method for discontinuous dynamics 5 Numerical results 6 Results
  • 22. Turning discrete problems into discontinuous ones Turning discrete problem into discontinuous one Consider a discrete parameter N ∈ Z+ with a prior πN (·). Map N into a continuous parameter N such that N = n if and only if N ∈ (an, an+1] To match the distribution of N, the corresponding density of N is πN (˜n) = n≥1 πN (n) an+1 − an 1{an < ˜n ≤ an+1}
  • 23. Turning discrete problems into discontinuous ones Turning discrete problem into discontinuous one 0 2 4 6 8 10 n 0.0 0.2 0.4 0.6 Massfunction pmf (n+1) 2 0 2 4 6 8 10 n 0.0 0.2 0.4 0.6 Density log-scale embedding linear-scale embedding Figure: Relating a discrete mass function (left) to a density function (right).
  • 24. Turning discrete problems into discontinuous ones What about more complex discrete spaces? Graphs? Trees? For “momentum” to be useful, we need a notion of direction.
  • 25. Turning discrete problems into discontinuous ones What about more complex discrete spaces? Short answer: I don’t know. (Let me know if you got ideas.) Graphs? Trees? For “momentum” to be useful, we need a notion of direction.
  • 26. Theory of discontinuous Hamiltonian dynamics Table of Contents 1 Review of HMC 2 Turning discrete problems into discontinuous ones 3 Theory of discontinuous Hamiltonian dynamics 4 Numerical method for discontinuous dynamics 5 Numerical results 6 Results
  • 27. Theory of discontinuous Hamiltonian dynamics Theory of discontinuous Hamiltonian dynamics When U(θ) = − log π(θ) is discontinuous, Hamilton’s equations dθ dt = pK(p) dp dt = − θU(θ) (3) becomes a measure-valued differential equation / inclusion. θi U(θ) Figure:
  • 28. Theory of discontinuous Hamiltonian dynamics Theory of discontinuous Hamiltonian dynamics Define discontinuous dynamics as a limit of smooth dynamics: Uδ — smooth approximations of U i.e. limδ→0 Uδ = U. (θδ, pδ)(t) — the solution corresponding to Uδ. θi U(θ) Uδ(θ) Figure:
  • 29. Theory of discontinuous Hamiltonian dynamics Theory of discontinuous Hamiltonian dynamics Define discontinuous dynamics as a limit of smooth dynamics: Uδ — smooth approximations of U i.e. limδ→0 Uδ = U. (θδ, pδ)(t) — the solution corresponding to Uδ. (θ, p)(t) := limδ→0(θδ, pδ)(t). θi U(θ) Uδ(θ) Figure: Example trajectory θ(t) of discontinuous Hamiltonian dynamics.
  • 30. Theory of discontinuous Hamiltonian dynamics Behavior of dynamics at discontinuity When the trajectory θ(t) encounters a discontinuity of U at event time te, the momentum p(t) undergoes an instantaneous change.
  • 31. Theory of discontinuous Hamiltonian dynamics Behavior of dynamics at discontinuity When the trajectory θ(t) encounters a discontinuity of U at event time te, the momentum p(t) undergoes an instantaneous change. The change in p occurs only in the direction of “− θU(θ)”: p(t+ e ) = p(t− e ) − γ ν (θ(te)) where ν(θ) is orthonormal to the discontinuity boundary of U.
  • 32. Theory of discontinuous Hamiltonian dynamics Behavior of dynamics at discontinuity When the trajectory θ(t) encounters a discontinuity of U at event time te, the momentum p(t) undergoes an instantaneous change. The change in p occurs only in the direction of “− θU(θ)”: p(t+ e ) = p(t− e ) − γ ν (θ(te)) where ν(θ) is orthonormal to the discontinuity boundary of U. The scalar γ is determined by the energy conservation principle: K(p(t+ e )) − K(p(t− e )) = U(θ(t− e )) − U(θ(t+ e )) (provided K(p) is convex and K(p) → ∞ as p → ∞).
  • 33. Numerical method for discontinuous dynamics Table of Contents 1 Review of HMC 2 Turning discrete problems into discontinuous ones 3 Theory of discontinuous Hamiltonian dynamics 4 Numerical method for discontinuous dynamics 5 Numerical results 6 Results
  • 34. Numerical method for discontinuous dynamics Dealing with discontinuity
  • 35. Numerical method for discontinuous dynamics Dealing with discontinuity How about ignoring them?
  • 36. Numerical method for discontinuous dynamics Dealing with discontinuity How about ignoring them? Leapfrog integrator completely fails to preserve the energy. i.e. low (or even negligible) acceptance probabilities.
  • 37. Numerical method for discontinuous dynamics Event-driven approach at discontinuity Pakman and Paninski (2013) and Afshar and Domke (2015): Detect discontinuities and treat them appropriately. (Event-driven Monte Carlo of Alder and Wainwright (1959).)
  • 38. Numerical method for discontinuous dynamics Event-driven approach at discontinuity Pakman and Paninski (2013) and Afshar and Domke (2015): Detect discontinuities and treat them appropriately. (Event-driven Monte Carlo of Alder and Wainwright (1959).) Problem: in Gaussian momentum case, the change in U(θ) must be computed across every single discontinuity.
  • 39. Numerical method for discontinuous dynamics Problem with Gaussian momentum & existing approach Say var(N) ≈ 1, 000. Then a Metropolis step N → N ± 1, 000 should have a good chance of acceptance. The numerical method requires 1, 000 density evaluations (ouch!) for a corresponding transition. ΔU ≈ .01 Figure: Conditional distribution of an embedded discrete parameter in the Jolly-Seber example.
  • 40. Numerical method for discontinuous dynamics Laplace momentum: better alternative Consider a Laplace momentum π(p) ∝ i exp(−m−1 i |pi|). The corresponding Hamilton’s equation is dθ dt = m−1 · sign(p), dp dt = − θU(θ)
  • 41. Numerical method for discontinuous dynamics Laplace momentum: better alternative Consider a Laplace momentum π(p) ∝ i exp(−m−1 i |pi|). The corresponding Hamilton’s equation is dθ dt = m−1 · sign(p), dp dt = − θU(θ) Key property: the velocity dθ/dt depends only on the signs of pi’s and not on their magnitudes. This property allows an accurate numerical approximation without keeping track of small changes in pi’s.
  • 42. Numerical method for discontinuous dynamics Numerical method for Laplace momentum Observation: approximating dynamics based on Laplace momentum is simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ) θ θ* = θ + Δt × m-1 sign(p) U(θ) p
  • 43. Numerical method for discontinuous dynamics Numerical method for Laplace momentum Observation: approximating dynamics based on Laplace momentum is simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ) θ θ* = θ + Δt × m-1 sign(p) U(θ) p U(θ*) − U(θ) < K(p) ?
  • 44. Numerical method for discontinuous dynamics Numerical method for Laplace momentum Observation: approximating dynamics based on Laplace momentum is simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ) θ θ* = θ + Δt × m-1 sign(p) U(θ) U(θ*) − U(θ) = K(p) − K(p*) p*
  • 45. Numerical method for discontinuous dynamics Numerical method for Laplace momentum Observation: approximating dynamics based on Laplace momentum is simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ) θ θ* U(θ*) − U(θ) p
  • 46. Numerical method for discontinuous dynamics Numerical method for Laplace momentum Observation: approximating dynamics based on Laplace momentum is simple in a 1-D case — dθ/dt = m−1 sign(p), dp/dt = − U(θ) p* ← - p θ* ← θ
  • 47. Numerical method for discontinuous dynamics Coordinate-wise integration for Laplace momentum For θ ∈ Rd, we can split the ODE into its coordinate-wise component: dθi dt = m−1 i sign(pi), dpi dt = −∂θi U(θ), dθ−i dt = dp−i dt = 0 (4)
  • 48. Numerical method for discontinuous dynamics Coordinate-wise integration for Laplace momentum 4 2 0 2 4 2 0 2 4 0 1 2 3 4 5 Figure: Trajectory of a numerical solution via the coordinate-wise integrator.
  • 49. Numerical method for discontinuous dynamics Coordinate-wise integration for Laplace momentum Reversibility preserved by symmetric splitting or randomly permuting the coordinates. We can also use Laplace momentum for discrete parameters and Gaussian momentum for continuous parameters.
  • 50. Numerical method for discontinuous dynamics Properties of discontinuous HMC When using independent Laplace momentum, Proposals are rejection-free thanks to exact energy conservation.1 1 But too big of a stepsize leads to poor mixing.
  • 51. Numerical method for discontinuous dynamics Properties of discontinuous HMC When using independent Laplace momentum, Proposals are rejection-free thanks to exact energy conservation.1 Taking one numerical integration step of DHMC ≡ Variable-at-a-time Metropolis. 1 But too big of a stepsize leads to poor mixing.
  • 52. Numerical method for discontinuous dynamics Properties of discontinuous HMC When using independent Laplace momentum, Proposals are rejection-free thanks to exact energy conservation.1 Taking one numerical integration step of DHMC ≡ Variable-at-a-time Metropolis. When mixing Laplace and Gaussian momentum: Errors in energy is O(∆t2), and hence 1 − O(∆t4) acceptance rate. 1 But too big of a stepsize leads to poor mixing.
  • 53. Numerical results Table of Contents 1 Review of HMC 2 Turning discrete problems into discontinuous ones 3 Theory of discontinuous Hamiltonian dynamics 4 Numerical method for discontinuous dynamics 5 Numerical results 6 Results
  • 54. Numerical results Numerical results: Jolly-Seber (capture-recapture) model Data : the number of marked / unmarked individuals over multiple capture occasions Parameters : population sizes, capture probabilities, survival rates
  • 55. Numerical results Numerical results: Jolly-Seber model One computational challenge arises from unidentifiability between an unknown capture probability qi and population size Ni. 0 5 log(q1/(1 q1)) 2.0 2.5 3.0 log10(N1)
  • 56. Numerical results Numerical results: Jolly-Seber model Table: Performance summary of each algorithm on the Jolly-Serber example. ESS per 100 samples ESS per minute Path length Iter time DHMC (diagonal) 45.5 424 45 87.7 DHMC (identity) 24.1 126 77.5 157 NUTS-Gibbs 1.04 6.38 150 133 Metropolis 0.0714 58.5 1 1 ESS : effective sample sizes (minimum over the first and second moment estimators) diagonal / identity : choice of mass matrix Metropolis : optimal random walk Metropolis NUTS-Gibbs : alternate update of continuous & discrete params as employed by PyMC
  • 57. Numerical results Numerical results: generalized Bayesian inference For a given loss function (y, θ) of interest, a generalized posterior (Bissiri et al., 2016) is given by πpost(θ) ∝ exp − i (yi, θ) πprior(θ) We consider a binary classification with the 0-1 loss (y, θ) = 1{y = sign(x θ)} for y ∈ {−1, 1}.
  • 58. Numerical results Numerical results: generalized Bayesian inference For a given loss function (y, θ) of interest, a generalized posterior (Bissiri et al., 2016) is given by πpost(θ) ∝ exp − i (yi, θ) πprior(θ) We consider a binary classification with the 0-1 loss (y, θ) = 1{y = sign(x θ)} for y ∈ {−1, 1}. 9.2 9.0 8.8 Intercept 0 2 4 6 Density(conditional)
  • 59. Numerical results Numerical results: generalized Bayesian inference Data: semiconductor quality with various sensor measurements Goal: predict faulty products / infer relevant sensor measurements
  • 60. Numerical results Numerical results: generalized Bayesian inference Table: Performance summary on the generalized Bayesian posterior example. ESS per 100 samples ESS per minute Path length Iter time DHMC 26.3 76 25 972 Metropolis 0.00809 (± 0.0018) 0.227 1 1 Variable-at-a-time 0.514 (± 0.039) 39.8 1 36.2 9.2 9.0 8.8 Intercept 0 2 4 6 Density(conditional)
  • 61. Results Table of Contents 1 Review of HMC 2 Turning discrete problems into discontinuous ones 3 Theory of discontinuous Hamiltonian dynamics 4 Numerical method for discontinuous dynamics 5 Numerical results 6 Results
  • 62. Results Summary Hamiltonian dynamics based on Laplace momentum allows an efficient exploration of discontinuous target distributions. Numerical method with exact energy conservation property.
  • 63. Results Future directions Test DHMC on a wider range of applications in the context of a probabilistic programming language. Explore the utility of Laplace momentum as an alternative to Gaussian one. What to do with more complex discrete spaces? Develop notion of directions. Avoid rejections by “swapping” probability between θ and p.
  • 64. Results References Nishimura, A., Dunson, D. and Lu, J. (2017) “Discontinuous Hamiltonian Monte Carlo for sampling discrete parameters,” arXiv:1705.08510. Code available at https://github.com/aki-nishimura/discontinuous-hmc