SlideShare a Scribd company logo
1 of 41
Download to read offline
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
bayesImageS: Bayesian computation for
medical image segmentation
using a hidden Potts model
Matt Moores
MRC Biostatistics Unit Seminar Series
July 25, 2017
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Acknowledgements
Queensland University of Technology, Brisbane, Australia:
Prof. Kerrie Mengersen
Dr. Fiona Harden
Members of the Volume Analysis Tool project team at the
Radiation Oncology Mater Centre (ROMC):
Cathy Hargrave
A/Prof Michael Poulsen, MD
Timothy Deegan
Emmanuel Baveas
QHealth ethics HREC/12/QPAH/475 and QUT ethics 1200000724
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Outline
1 R packages
bayesImageS
2 Medical Imaging
Image-Guided Radiotherapy
Cone-Beam Computed Tomography
3 Statistical Model
Hidden Potts model
Informative priors
4 Bayesian Computation
Chequerboard Gibbs sampler
Pseudolikelihood
5 Experimental Results
ED phantom experiment
Radiotherapy Patient Data
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Why write an R package?
Portability
Test bed for new statistical methods
Build on existing code
Research impact
Kudos
Hadley Wickham (2015) R packages
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Why C++?
Most statistical algorithms are iterative
Markov chain Monte Carlo
Scalability for large datasets
Rcpp
OpenMP
Eigen or Armadillo
Dirk Eddelbuettel (2013) Seamless R and C++ integration with Rcpp
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Inline
One function at a time:
§
library ( i n l i n e )
sum_logs ← cxxfunction ( signature ( log_vec = "numeric") , plugin = "RcppArmadillo" , body=’
arma::vec log_prob = Rcpp::as<arma::vec>(log_vec);
double suml = 0.0;
double maxl = log_prob.max();
for (unsigned i=0; i < log_prob.n_elem; i++)
{
if (arma::is_finite(log_prob(i)))
suml += exp(log_prob(i) - maxl);
}
return Rcpp::wrap(log(suml) + maxl);
’)
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Annotations
Rcpp wrappers generated automatically:
compileAttributes("myRcppPackage")
R package documentation generated automatically:
roxygenize("myRcppPackage")
§
/ / ’ Compute the effective sample size (ESS) of the particles.
/ / ’
/ / ’ The ESS is a ‘‘rule of thumb’’ for assessing the degeneracy of
/ / ’’ the importance distribution:
/ / ’  deqn {ESS =  frac { (  sum_ { q=1}^Q w_q ) ^ 2 } {  sum_ { q=1}^Q w_q ^2}}
/ / ’
/ / ’’ @param log_weights logarithms of the importance weights of each particle.
/ / ’’ @return the effective sample size, a scalar between 0 and Q
/ / ’’ @references
/ / ’’ Liu, JS (2001) "Monte Carlo Strategies in Scientific Computing." Springer’
/ / [ [ Rcpp : : export ] ]
double effectiveSampleSize ( NumericVector log_weights )
{
double sum_wt = sum_logs ( log_weights ) ;
double sum_sq = sum_logs ( log_weights + log_weights ) ;
double res = exp (sum_wt + sum_wt − sum_sq ) ;
i f ( std : : i s f i n i t e ( res ) ) return res ;
else return 0;
}
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Package Skeleton
Create a new R package:
package.skeleton("myPackage", path=".")
Specific skeletons for each C++ library:
Rcpp.package.skeleton("myRcppPackage")
RcppArmadillo.package.skeleton("MyArmadilloPackage")
RcppEigen.package.skeleton("MyEigenPackage")
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Common Problems
Rcpp parameters are passed by reference (not copied):
Can rely on R for garbage collection
Memory allocation is slower
Can crash R (and Rstudio (and your OS))
R is not thread safe
Cannot call any R functions (even indirectly)
within parallel code!
Drew Schmidt (@wrathematics, 2015) Parallelism, R, and OpenMP
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
bayesImageS
An R package for Bayesian image segmentation
using the hidden Potts model:
RcppArmadillo for fast computation in C++
OpenMP for parallelism
§
library ( bayesImageS )
p r i o r s ← l i s t ("k"=3 ,"mu"=rep (0 ,3) ,"mu.sd"=sigma ,
"sigma"=sigma , "sigma.nu"=c (1 ,1 ,1) ,"beta"=c ( 0 , 3 ) )
mh ← l i s t ( algorithm="pseudo" , bandwidth =0.2)
r e s u l t ← mcmcPotts ( y , neigh , block ,NULL,
55000,5000, priors ,mh)
Eddelbuettel & Sanderson (2014) RcppArmadillo: Accelerating R with
high-performance C++ linear algebra. CSDA 71
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Bayesian computational methods
bayesImageS supports methods for updating the latent labels:
Chequerboard Gibbs sampling (Winkler 2003)
Swendsen-Wang (1987)
and also methods for updating the smoothing parameter β:
Pseudolikelihood (Rydén & Titterington 1998)
Thermodynamic integration (Gelman & Meng 1998)
Exchange algorithm (Murray, Ghahramani & MacKay 2006)
Approximate Bayesian computation (Grelaud et al. 2009)
Sequential Monte Carlo (ABC-SMC) with pre-computation
(Del Moral, Doucet & Jasra 2012; Moores et al. 2015)
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Image-Guided Radiotherapy
Image courtesy of Varian Medical Systems, Inc. All rights reserved.
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Segmentation of Anatomical Structures
Radiography courtesy of Cathy Hargrave, Radiation Oncology Mater Centre,
Queensland Health
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Physiological Variability
Organ Ant-Post Sup-Inf Left-Right
prostate 0.1 ± 4.1mm −0.5 ± 2.9mm 0.2 ± 0.9mm
seminal vesicles 1.2 ± 7.3mm −0.7 ± 4.5mm −0.9 ± 1.9mm
Table: Distribution of observed translations of the organs of interest
Organ Volume Gas
rectum 35 − 140cm3 4 − 26%
bladder 120 − 381cm3
Table: Volume variations in the organs of interest
Frank, et al. (2008) Quantification of Prostate and Seminal Vesicle
Interfraction Variation During IMRT. IJROBP 71(3): 813–820.
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Electron Density phantom
(a) CIRS Model 062 ED phantom (b) Helical, fan-beam CT scanner
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Cone-Beam Computed Tomography
(c) Fan-beam CT (d) Cone-beam CT
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Distribution of Pixel Intensity
Hounsfield unit
Frequency
−1000 −800 −600 −400 −200 0 200
050001000015000
(a) Fan-Beam CT
pixel intensity
Frequency
−1000 −800 −600 −400 −200 0 200
050001000015000
(b) Cone-Beam CT
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Hidden Markov Random Field
Joint distribution of observed pixel intensities y = {yi}n
i=1
and latent labels z = {zi}n
i=1:
p(y, z|µ, σ2
, β) = p(y|µ, σ2
, z)p(z|β) (1)
Additive Gaussian noise:
yi|zi =j
iid
∼ N µj, σ2
j (2)
Potts model:
π(zi|zi, β) =
exp {β i∼ δ(zi, z )}
k
j=1 exp {β i∼ δ(j, z )}
(3)
Potts (1952) Proceedings of the Cambridge Philosophical Society 48(1)
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Inverse Temperature
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Doubly-intractable likelihood
p(β|z) ∝ C(β)−1
π(β) exp {β S(z)} (4)
The normalising constant has computational complexity O(nkn):
C(β) =
z∈Z
exp {β S(z)} (5)
S(z) is the sufficient statistic of the Potts model:
S(z) =
i∼ ∈L
δ(zi, z ) (6)
where L is the set of all unique neighbour pairs.
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Informative Prior for µj and σ2
j
0 1 2 3 4
−1000−800−600−400−2000200
Electron Density
Hounsfieldunit
(a) Fan-Beam CT
0 1 2 3 4
−1000−800−600−400−2000200
Electron Density
pixelintensity
(b) Cone-Beam CT
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
External Field
π(zi|αi, β, zi∼ ) ∝ exp αi(zi) + β
i∼
δ(zi, zj) (7)
Isotropic translation:
αi(zi =j) =
1
nj ν∈j
φ ∆(ϑi, ϑν), µ = 1.2, σ2
= 7.32
(8)
where
ν ∈ j are the image voxels ϑν in object j
φ(x, µ, σ2) is the normal density function
∆(u, v) is the Euclidian distance between the coordinates
of voxel u and voxel v
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
External Field II
(a) Fan-beam CT (b) External Field
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Anisotropy
αi(prostate) ∼ MVN




0.1
−0.5
0.2

 ,


4.12 0 0
0 2.92 0
0 0 0.92




(a) Bitmask (b) External Field
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Seminal Vesicles
αi(SV) ∼ MVN




1.2
−0.7
−0.9

 ,


7.32 0 0
0 4.52 0
0 0 1.92




(a) Bitmask (b) External Field
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
External Field
Organ- and patient-specific external field (slice 49, 16mm Inf)
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Chequerboard Gibbs
A 2D or 3D regular lattice with first-order neighbourhood ∂i:
◦ ◦ ◦ ◦ ◦
◦ ◦ • ◦ ◦
◦ • × • ◦
◦ ◦ • ◦ ◦
◦ ◦ ◦ ◦ ◦
can be partitioned into 2 blocks:
• ◦ • ◦ • ◦ • ◦ • ◦
◦ • ◦ • ◦ • ◦ • ◦ •
• ◦ • ◦ • ◦ • ◦ • ◦
◦ • ◦ • ◦ • ◦ • ◦ •
• ◦ • ◦ • ◦ • ◦ • ◦
◦ • ◦ • ◦ • ◦ • ◦ •
• ◦ • ◦ • ◦ • ◦ • ◦
◦ • ◦ • ◦ • ◦ • ◦ •
• ◦ • ◦ • ◦ • ◦ • ◦
◦ • ◦ • ◦ • ◦ • ◦ •
so that z◦ are conditionally independent, given z•
Roberts & Sahu (1997) JRSS B 59(2): 291–317
Winkler (2nd
ed., 2003) Image analysis, random fields and MCMC methods
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Chequerboard Gibbs II
Algorithm 1 Chequerboard sampling for z
1: for all blocks b do
2: for all pixels i ∈ b do
3: for all labels j ∈ 1 . . . k do
4: Compute λj ← p(yi | zi = j)π(zi = j | zi∼ , β)
5: end for
6: Draw zi ∼ Multinomial(λ1, . . . , λk)
7: end for
8: end for
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Gibbs sampler in C++
§
void gibbsLabels ( const arma : : umat & neigh , const std : : vector <arma : : uvec> & blocks ,
arma : : umat & z , arma : : umat & alloc , const double beta ,
const arma : : mat & log_ x f i e l d )
{
const Rcpp : : NumericVector randU = Rcpp : : r u n i f ( neigh . n_rows ) ;
for ( unsigned b=0; b < blocks . size ( ) ; b++)
{
const arma : : uvec block = blocks [ b ] ;
arma : : vec log_prob ( z . n_cols ) ;
#pragma omp p a r a l l e l for private ( log_prob )
for ( unsigned i =0; i < block . size ( ) ; i ++)
{
for ( unsigned j =0; j < z . n_cols ; j ++)
{
unsigned sum_neigh = 0;
for ( unsigned k=0; k < neigh . n_cols ; k++)
{
sum_neigh += z ( neigh ( block [ i ] , k ) , j ) ;
}
log_prob [ j ] = log_ x f i e l d ( block [ i ] , j ) + beta∗sum_neigh ;
}
double t o t a l _ l l i k e = sum_logs ( log_prob ) ;
double cumProb = 0.0;
z . row ( block [ i ] ) . zeros ( ) ;
for ( unsigned j =0; j < log_prob . n_elem ; j ++)
{
cumProb += exp ( log_prob [ j ] − t o t a l _ l l i k e ) ;
i f ( randU [ block [ i ] ] < cumProb )
{
z ( block [ i ] , j ) = 1;
a l l o c ( block [ i ] , j ) += 1;
break ;
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Pseudolikelihood (PL)
Algorithm 2 Metropolis-Hastings with PL
1: Draw proposal β ∼ q(β |β◦)
2: Approximate p(β |z) and p(β◦|z) using equation (9):
ˆpPL(β|z) ≈
n
i=1
exp{β i∼ δ(zi, z )}
k
j=1 exp{β i∼ δ(j, z )}
(9)
3: Calculate the M-H ratio ρ = ˆpPL(β |z)π(β )q(β◦|β )
ˆpPL(β◦|z)π(β◦)q(β |β◦)
4: Draw u ∼ Uniform[0, 1]
5: if u < min(1, ρ) then
6: β ← β
7: else
8: β ← β◦
9: end if
Rydén & Titterington (1998) JCGS 7(2): 194–211
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Pseudolikelihood in C++
§
double pseudolike ( arma : : mat & ne , arma : : uvec & e ,
double b , unsigned n , unsigned k )
{
double num = 0.0;
double denom = 0.0;
#pragma omp p a r a l l e l for reduction ( + :num, denom)
for ( unsigned i =0; i < n ; i ++)
{
num=num+ne ( e [ i ] , i ) ;
double tdenom =0.0;
for ( unsigned j =0; j < k ; j ++)
{
tdenom=tdenom+exp ( b∗ne ( j , i ) ) ;
}
denom=denom+log ( tdenom ) ;
}
return b∗num−denom ;
}
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Approximation Error
PL for n = 12, k = 3 in comparison to the exact likelihood
calculated using a brute force method:
0 1 2 3 4
6810121416
β
µ
exact
pseudolikelihood
(a) Expectation
0 1 2 3 4
0.00.51.01.52.02.5
β
σ
exact
pseudolikelihood
(b) Standard deviation
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
ED phantom experiment
27 cone-beam CT scans of the ED phantom
Cropped to 376 × 308 pixels and 23 slices
(330 × 270 × 46 mm)
Inner ring of inserts rotated by between 0◦ and 16◦
2D displacement of between 0mm and 25mm
Isotropic external field prior with σ∆ = 7.3mm
9 component Potts model
8 different tissue types, plus water-equivalent background
Priors for noise parameters estimated from 28 fan-beam CT
and 26 cone-beam CT scans
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Image Segmentation
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Quantification of Segmentation Accuracy
Dice similarity coefficient:
DSCg =
2 × |ˆg ∩ g|
|ˆg| + |g|
(10)
where
DSCg is the Dice similarity coefficient for label g
|ˆg| is the count of pixels that were classified with the
label g
|g| is the number of pixels that are known to truly
belong to component g
|ˆg ∩ g| is the count of pixels in g that were labeled
correctly
Dice (1945) Measures of the amount of ecologic association between
species. Ecology 26(3): 297–302.
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Results
Tissue Type Simple Potts External Field
Lung (inhale) 0.540 ± 0.037 0.902 ± 0.009
Lung (exhale) 0.172 ± 0.008 0.814 ± 0.022
Adipose 0.059 ± 0.008 0.704 ± 0.062
Breast 0.077 ± 0.011 0.720 ± 0.048
Water 0.174 ± 0.003 0.964 ± 0.003
Muscle 0.035 ± 0.004 0.697 ± 0.076
Liver 0.020 ± 0.007 0.654 ± 0.033
Spongy Bone 0.094 ± 0.014 0.758 ± 0.018
Dense Bone 0.014 ± 0.001 0.616 ± 0.151
Table: Segmentation Accuracy (Dice Similarity Coefficient ±σ)
Moores, et al. (2014) In Proc. XVII Intl Conf. ICCR; J. Phys: Conf. Ser. 489
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Preliminary Results
−300 −250 −200 −150
150200250300
right−left (mm)
posterior−anterior(mm)
(a) Cone-Beam CT
−300 −250 −200 −150
150200250300
right−left (mm)
posterior−anterior(mm)
(b) Segmentation
Moores, et al. (2015) CSDA 86: 27–41.
R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion
Summary
Informative priors can dramatically improve segmentation
accuracy for noisy data
inverse regression for µ & σ2
external field prior for z
It is feasible to use MCMC for image analysis of realistic
datasets
but auxiliary variable methods don’t scale well
requires parallelized implementation in C++ or Fortran
RcppArmadillo & OpenMP are a good combination
faster algorithms are available, such as VB or ICM
Appendix
For Further Reading I
Moores, Hargrave, Deegan, Poulsen, Harden & Mengersen
An external field prior for the hidden Potts model with application to
cone-beam computed tomography.
CSDA 86: 27–41, 2015.
Moores & Mengersen
bayesImageS: Bayesian methods for image segmentation using a
hidden Potts model.
R package version 0.3-3
https://CRAN.R-project.org/package=bayesImageS
Moores, Drovandi, Mengersen & Robert
Pre-processing for approximate Bayesian computation in image
analysis.
Statistics & Computing 25(1): 23–33, 2015.
Moores, Pettitt & Mengersen
Scalable Bayesian inference for the inverse temperature of a hidden
Potts model.
arXiv:1503.08066 [stat.CO], 2015.
Appendix
For Further Reading II
Eddelbuettel & Sanderson
RcppArmadillo: Accelerating R with high-performance C++ linear
algebra.
Comput. Stat. Data Anal. 71: 1054–63, 2014.
Bates & Eddelbuettel
Fast and elegant numerical linear algebra using the RcppEigen
package.
J. Stat. Soft. 52(5): 1–24, 2013.
Eddelbuettel
Seamless R and C++ integration with Rcpp
Springer-Verlag, 2013.
Wickham
R packages
O’Reilly, 2015.
Appendix
For Further Reading III
Winkler
Image analysis, random fields and Markov chain Monte Carlo methods
2nd
ed., Springer-Verlag, 2003.
Marin & Robert
Bayesian Essentials with R
Springer-Verlag, 2014.
Roberts & Sahu
Updating Schemes, Correlation Structure, Blocking and
Parameterization for the Gibbs Sampler
J. R. Stat. Soc. Ser. B 59(2): 291–317, 1997.
Rydén & Titterington
Computational Bayesian Analysis of Hidden Markov Models
J. Comput. Graph. Stat. 7(2): 194–211, 1998.

More Related Content

What's hot

Graph Edit Distance: Basics & Trends
Graph Edit Distance: Basics & TrendsGraph Edit Distance: Basics & Trends
Graph Edit Distance: Basics & TrendsLuc Brun
 
Multilayer Neural Networks
Multilayer Neural NetworksMultilayer Neural Networks
Multilayer Neural NetworksESCOM
 
Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...
Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...
Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...T. E. BOGALE
 
Positive and negative solutions of a boundary value problem for a fractional ...
Positive and negative solutions of a boundary value problem for a fractional ...Positive and negative solutions of a boundary value problem for a fractional ...
Positive and negative solutions of a boundary value problem for a fractional ...journal ijrtem
 
Stationary Incompressible Viscous Flow Analysis by a Domain Decomposition Method
Stationary Incompressible Viscous Flow Analysis by a Domain Decomposition MethodStationary Incompressible Viscous Flow Analysis by a Domain Decomposition Method
Stationary Incompressible Viscous Flow Analysis by a Domain Decomposition MethodADVENTURE Project
 
Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Alexander Litvinenko
 
Research Project Primus
Research Project PrimusResearch Project Primus
Research Project PrimusPredrag Terzic
 
2.6 all pairsshortestpath
2.6 all pairsshortestpath2.6 all pairsshortestpath
2.6 all pairsshortestpathKrish_ver2
 
A Note on Latent LSTM Allocation
A Note on Latent LSTM AllocationA Note on Latent LSTM Allocation
A Note on Latent LSTM AllocationTomonari Masada
 
Goldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane mapsGoldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane mapsMathieu Dutour Sikiric
 
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 samplerChristian Robert
 
Kumaraswamy disribution
Kumaraswamy disributionKumaraswamy disribution
Kumaraswamy disributionPankaj Das
 
ABC with Wasserstein distances
ABC with Wasserstein distancesABC with Wasserstein distances
ABC with Wasserstein distancesChristian Robert
 
Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...
Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...
Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...Tomonari Masada
 
Ee693 sept2014midsem
Ee693 sept2014midsemEe693 sept2014midsem
Ee693 sept2014midsemGopi Saiteja
 
Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Alexander Litvinenko
 
論文紹介 Fast imagetagging
論文紹介 Fast imagetagging論文紹介 Fast imagetagging
論文紹介 Fast imagetaggingTakashi Abe
 

What's hot (20)

Graph Edit Distance: Basics & Trends
Graph Edit Distance: Basics & TrendsGraph Edit Distance: Basics & Trends
Graph Edit Distance: Basics & Trends
 
Multilayer Neural Networks
Multilayer Neural NetworksMultilayer Neural Networks
Multilayer Neural Networks
 
Triggering patterns of topology changes in dynamic attributed graphs
Triggering patterns of topology changes in dynamic attributed graphsTriggering patterns of topology changes in dynamic attributed graphs
Triggering patterns of topology changes in dynamic attributed graphs
 
Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...
Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...
Transceiver design for single-cell and multi-cell downlink multiuser MIMO sys...
 
Positive and negative solutions of a boundary value problem for a fractional ...
Positive and negative solutions of a boundary value problem for a fractional ...Positive and negative solutions of a boundary value problem for a fractional ...
Positive and negative solutions of a boundary value problem for a fractional ...
 
Stationary Incompressible Viscous Flow Analysis by a Domain Decomposition Method
Stationary Incompressible Viscous Flow Analysis by a Domain Decomposition MethodStationary Incompressible Viscous Flow Analysis by a Domain Decomposition Method
Stationary Incompressible Viscous Flow Analysis by a Domain Decomposition Method
 
Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)
 
A Note on TopicRNN
A Note on TopicRNNA Note on TopicRNN
A Note on TopicRNN
 
Research Project Primus
Research Project PrimusResearch Project Primus
Research Project Primus
 
2.6 all pairsshortestpath
2.6 all pairsshortestpath2.6 all pairsshortestpath
2.6 all pairsshortestpath
 
A Note on Latent LSTM Allocation
A Note on Latent LSTM AllocationA Note on Latent LSTM Allocation
A Note on Latent LSTM Allocation
 
Goldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane mapsGoldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane maps
 
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
 
Kumaraswamy disribution
Kumaraswamy disributionKumaraswamy disribution
Kumaraswamy disribution
 
ABC with Wasserstein distances
ABC with Wasserstein distancesABC with Wasserstein distances
ABC with Wasserstein distances
 
Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...
Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...
Accelerating Collapsed Variational Bayesian Inference for Latent Dirichlet Al...
 
Ee693 sept2014midsem
Ee693 sept2014midsemEe693 sept2014midsem
Ee693 sept2014midsem
 
Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...
 
Feedback Vertex Set
Feedback Vertex SetFeedback Vertex Set
Feedback Vertex Set
 
論文紹介 Fast imagetagging
論文紹介 Fast imagetagging論文紹介 Fast imagetagging
論文紹介 Fast imagetagging
 

Similar to bayesImageS: Bayesian computation for medical Image Segmentation using a hidden Potts Model

Final PhD Seminar
Final PhD SeminarFinal PhD Seminar
Final PhD SeminarMatt Moores
 
Photoacoustic tomography based on the application of virtual detectors
Photoacoustic tomography based on the application of virtual detectorsPhotoacoustic tomography based on the application of virtual detectors
Photoacoustic tomography based on the application of virtual detectorsIAEME Publication
 
Pre-computation for ABC in image analysis
Pre-computation for ABC in image analysisPre-computation for ABC in image analysis
Pre-computation for ABC in image analysisMatt Moores
 
Conference_paper.pdf
Conference_paper.pdfConference_paper.pdf
Conference_paper.pdfNarenRajVivek
 
Quantitative Analysis of DCE-MRI using R
Quantitative Analysis of DCE-MRI using RQuantitative Analysis of DCE-MRI using R
Quantitative Analysis of DCE-MRI using Rbwhitcher
 
Bayesian modelling and computation for Raman spectroscopy
Bayesian modelling and computation for Raman spectroscopyBayesian modelling and computation for Raman spectroscopy
Bayesian modelling and computation for Raman spectroscopyMatt Moores
 
Image quality assessment and statistical evaluation
Image quality assessment and statistical evaluationImage quality assessment and statistical evaluation
Image quality assessment and statistical evaluationDocumentStory
 
Data Driven Choice of Threshold in Cepstrum Based Spectrum Estimate
Data Driven Choice of Threshold in Cepstrum Based Spectrum EstimateData Driven Choice of Threshold in Cepstrum Based Spectrum Estimate
Data Driven Choice of Threshold in Cepstrum Based Spectrum Estimatesipij
 
Precomputation for SMC-ABC with undirected graphical models
Precomputation for SMC-ABC with undirected graphical modelsPrecomputation for SMC-ABC with undirected graphical models
Precomputation for SMC-ABC with undirected graphical modelsMatt Moores
 
A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...
A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...
A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...CSCJournals
 
Sparse Representation for Fetal QRS Detection in Abdominal ECG Recordings
Sparse Representation for Fetal QRS Detection in Abdominal ECG RecordingsSparse Representation for Fetal QRS Detection in Abdominal ECG Recordings
Sparse Representation for Fetal QRS Detection in Abdominal ECG RecordingsRiccardo Bernardini
 
On Dose Reduction and View Number
On Dose Reduction and View NumberOn Dose Reduction and View Number
On Dose Reduction and View NumberKaijie Lu
 
1 FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx
1  FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx1  FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx
1 FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docxmercysuttle
 
SLOPE 1st workshop - presentation 2
SLOPE 1st workshop - presentation 2SLOPE 1st workshop - presentation 2
SLOPE 1st workshop - presentation 2SLOPE Project
 
Bayesian Estimation for Missing Values in Latin Square Design
Bayesian Estimation for Missing Values in Latin Square DesignBayesian Estimation for Missing Values in Latin Square Design
Bayesian Estimation for Missing Values in Latin Square Designinventionjournals
 
(17 22) karthick sir
(17 22) karthick sir(17 22) karthick sir
(17 22) karthick sirIISRTJournals
 
Performance Improvement of Vector Quantization with Bit-parallelism Hardware
Performance Improvement of Vector Quantization with Bit-parallelism HardwarePerformance Improvement of Vector Quantization with Bit-parallelism Hardware
Performance Improvement of Vector Quantization with Bit-parallelism HardwareCSCJournals
 

Similar to bayesImageS: Bayesian computation for medical Image Segmentation using a hidden Potts Model (20)

Final PhD Seminar
Final PhD SeminarFinal PhD Seminar
Final PhD Seminar
 
Photoacoustic tomography based on the application of virtual detectors
Photoacoustic tomography based on the application of virtual detectorsPhotoacoustic tomography based on the application of virtual detectors
Photoacoustic tomography based on the application of virtual detectors
 
Pre-computation for ABC in image analysis
Pre-computation for ABC in image analysisPre-computation for ABC in image analysis
Pre-computation for ABC in image analysis
 
Conference_paper.pdf
Conference_paper.pdfConference_paper.pdf
Conference_paper.pdf
 
Quantitative Analysis of DCE-MRI using R
Quantitative Analysis of DCE-MRI using RQuantitative Analysis of DCE-MRI using R
Quantitative Analysis of DCE-MRI using R
 
Bayesian modelling and computation for Raman spectroscopy
Bayesian modelling and computation for Raman spectroscopyBayesian modelling and computation for Raman spectroscopy
Bayesian modelling and computation for Raman spectroscopy
 
Image quality assessment and statistical evaluation
Image quality assessment and statistical evaluationImage quality assessment and statistical evaluation
Image quality assessment and statistical evaluation
 
Data Driven Choice of Threshold in Cepstrum Based Spectrum Estimate
Data Driven Choice of Threshold in Cepstrum Based Spectrum EstimateData Driven Choice of Threshold in Cepstrum Based Spectrum Estimate
Data Driven Choice of Threshold in Cepstrum Based Spectrum Estimate
 
Precomputation for SMC-ABC with undirected graphical models
Precomputation for SMC-ABC with undirected graphical modelsPrecomputation for SMC-ABC with undirected graphical models
Precomputation for SMC-ABC with undirected graphical models
 
A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...
A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...
A Quantitative Comparative Study of Analytical and Iterative Reconstruction T...
 
Sparse Representation for Fetal QRS Detection in Abdominal ECG Recordings
Sparse Representation for Fetal QRS Detection in Abdominal ECG RecordingsSparse Representation for Fetal QRS Detection in Abdominal ECG Recordings
Sparse Representation for Fetal QRS Detection in Abdominal ECG Recordings
 
On Dose Reduction and View Number
On Dose Reduction and View NumberOn Dose Reduction and View Number
On Dose Reduction and View Number
 
CLIM Program: Remote Sensing Workshop, Blocking Methods for Spatial Statistic...
CLIM Program: Remote Sensing Workshop, Blocking Methods for Spatial Statistic...CLIM Program: Remote Sensing Workshop, Blocking Methods for Spatial Statistic...
CLIM Program: Remote Sensing Workshop, Blocking Methods for Spatial Statistic...
 
1 FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx
1  FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx1  FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx
1 FACULTY OF SCIENCE AND ENGINEERING SCHOOL OF COMPUT.docx
 
RINKEL-ISOTDAQ2015.ppt
RINKEL-ISOTDAQ2015.pptRINKEL-ISOTDAQ2015.ppt
RINKEL-ISOTDAQ2015.ppt
 
SLOPE 1st workshop - presentation 2
SLOPE 1st workshop - presentation 2SLOPE 1st workshop - presentation 2
SLOPE 1st workshop - presentation 2
 
Bayesian Estimation for Missing Values in Latin Square Design
Bayesian Estimation for Missing Values in Latin Square DesignBayesian Estimation for Missing Values in Latin Square Design
Bayesian Estimation for Missing Values in Latin Square Design
 
(17 22) karthick sir
(17 22) karthick sir(17 22) karthick sir
(17 22) karthick sir
 
Performance Improvement of Vector Quantization with Bit-parallelism Hardware
Performance Improvement of Vector Quantization with Bit-parallelism HardwarePerformance Improvement of Vector Quantization with Bit-parallelism Hardware
Performance Improvement of Vector Quantization with Bit-parallelism Hardware
 
A2100106
A2100106A2100106
A2100106
 

More from Matt Moores

bayesImageS: an R package for Bayesian image analysis
bayesImageS: an R package for Bayesian image analysisbayesImageS: an R package for Bayesian image analysis
bayesImageS: an R package for Bayesian image analysisMatt Moores
 
Exploratory Analysis of Multivariate Data
Exploratory Analysis of Multivariate DataExploratory Analysis of Multivariate Data
Exploratory Analysis of Multivariate DataMatt Moores
 
R package bayesImageS: Scalable Inference for Intractable Likelihoods
R package bayesImageS: Scalable Inference for Intractable LikelihoodsR package bayesImageS: Scalable Inference for Intractable Likelihoods
R package bayesImageS: Scalable Inference for Intractable LikelihoodsMatt Moores
 
Approximate Bayesian computation for the Ising/Potts model
Approximate Bayesian computation for the Ising/Potts modelApproximate Bayesian computation for the Ising/Potts model
Approximate Bayesian computation for the Ising/Potts modelMatt Moores
 
Importing satellite imagery into R from NASA and the U.S. Geological Survey
Importing satellite imagery into R from NASA and the U.S. Geological SurveyImporting satellite imagery into R from NASA and the U.S. Geological Survey
Importing satellite imagery into R from NASA and the U.S. Geological SurveyMatt Moores
 
Accelerating Pseudo-Marginal MCMC using Gaussian Processes
Accelerating Pseudo-Marginal MCMC using Gaussian ProcessesAccelerating Pseudo-Marginal MCMC using Gaussian Processes
Accelerating Pseudo-Marginal MCMC using Gaussian ProcessesMatt Moores
 
Variational Bayes
Variational BayesVariational Bayes
Variational BayesMatt Moores
 
Informative Priors for Segmentation of Medical Images
Informative Priors for Segmentation of Medical ImagesInformative Priors for Segmentation of Medical Images
Informative Priors for Segmentation of Medical ImagesMatt Moores
 

More from Matt Moores (10)

bayesImageS: an R package for Bayesian image analysis
bayesImageS: an R package for Bayesian image analysisbayesImageS: an R package for Bayesian image analysis
bayesImageS: an R package for Bayesian image analysis
 
Exploratory Analysis of Multivariate Data
Exploratory Analysis of Multivariate DataExploratory Analysis of Multivariate Data
Exploratory Analysis of Multivariate Data
 
R package bayesImageS: Scalable Inference for Intractable Likelihoods
R package bayesImageS: Scalable Inference for Intractable LikelihoodsR package bayesImageS: Scalable Inference for Intractable Likelihoods
R package bayesImageS: Scalable Inference for Intractable Likelihoods
 
Approximate Bayesian computation for the Ising/Potts model
Approximate Bayesian computation for the Ising/Potts modelApproximate Bayesian computation for the Ising/Potts model
Approximate Bayesian computation for the Ising/Potts model
 
Importing satellite imagery into R from NASA and the U.S. Geological Survey
Importing satellite imagery into R from NASA and the U.S. Geological SurveyImporting satellite imagery into R from NASA and the U.S. Geological Survey
Importing satellite imagery into R from NASA and the U.S. Geological Survey
 
Accelerating Pseudo-Marginal MCMC using Gaussian Processes
Accelerating Pseudo-Marginal MCMC using Gaussian ProcessesAccelerating Pseudo-Marginal MCMC using Gaussian Processes
Accelerating Pseudo-Marginal MCMC using Gaussian Processes
 
Intro to ABC
Intro to ABCIntro to ABC
Intro to ABC
 
Variational Bayes
Variational BayesVariational Bayes
Variational Bayes
 
Parallel R
Parallel RParallel R
Parallel R
 
Informative Priors for Segmentation of Medical Images
Informative Priors for Segmentation of Medical ImagesInformative Priors for Segmentation of Medical Images
Informative Priors for Segmentation of Medical Images
 

Recently uploaded

SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxkessiyaTpeter
 
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...Sérgio Sacani
 
Artificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PArtificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PPRINCE C P
 
Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |
Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |
Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |aasikanpl
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisDiwakar Mishra
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptxanandsmhk
 
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Lokesh Kothari
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxpradhanghanshyam7136
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxjana861314
 
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...anilsa9823
 
Boyles law module in the grade 10 science
Boyles law module in the grade 10 scienceBoyles law module in the grade 10 science
Boyles law module in the grade 10 sciencefloriejanemacaya1
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfSumit Kumar yadav
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...jana861314
 
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bNightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bSérgio Sacani
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRDelhi Call girls
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTSérgio Sacani
 

Recently uploaded (20)

SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptxSOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
SOLUBLE PATTERN RECOGNITION RECEPTORS.pptx
 
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
 
Artificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C PArtificial Intelligence In Microbiology by Dr. Prince C P
Artificial Intelligence In Microbiology by Dr. Prince C P
 
Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |
Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |
Call Us ≽ 9953322196 ≼ Call Girls In Mukherjee Nagar(Delhi) |
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
 
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
Labelling Requirements and Label Claims for Dietary Supplements and Recommend...
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptx
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
 
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
 
Boyles law module in the grade 10 science
Boyles law module in the grade 10 scienceBoyles law module in the grade 10 science
Boyles law module in the grade 10 science
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdf
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
 
The Philosophy of Science
The Philosophy of ScienceThe Philosophy of Science
The Philosophy of Science
 
Engler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomyEngler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomy
 
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bNightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
 
CELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdfCELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdf
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOST
 

bayesImageS: Bayesian computation for medical Image Segmentation using a hidden Potts Model

  • 1. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion bayesImageS: Bayesian computation for medical image segmentation using a hidden Potts model Matt Moores MRC Biostatistics Unit Seminar Series July 25, 2017
  • 2. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Acknowledgements Queensland University of Technology, Brisbane, Australia: Prof. Kerrie Mengersen Dr. Fiona Harden Members of the Volume Analysis Tool project team at the Radiation Oncology Mater Centre (ROMC): Cathy Hargrave A/Prof Michael Poulsen, MD Timothy Deegan Emmanuel Baveas QHealth ethics HREC/12/QPAH/475 and QUT ethics 1200000724
  • 3. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Outline 1 R packages bayesImageS 2 Medical Imaging Image-Guided Radiotherapy Cone-Beam Computed Tomography 3 Statistical Model Hidden Potts model Informative priors 4 Bayesian Computation Chequerboard Gibbs sampler Pseudolikelihood 5 Experimental Results ED phantom experiment Radiotherapy Patient Data
  • 4. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Why write an R package? Portability Test bed for new statistical methods Build on existing code Research impact Kudos Hadley Wickham (2015) R packages
  • 5. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Why C++? Most statistical algorithms are iterative Markov chain Monte Carlo Scalability for large datasets Rcpp OpenMP Eigen or Armadillo Dirk Eddelbuettel (2013) Seamless R and C++ integration with Rcpp
  • 6. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Inline One function at a time: § library ( i n l i n e ) sum_logs ← cxxfunction ( signature ( log_vec = "numeric") , plugin = "RcppArmadillo" , body=’ arma::vec log_prob = Rcpp::as<arma::vec>(log_vec); double suml = 0.0; double maxl = log_prob.max(); for (unsigned i=0; i < log_prob.n_elem; i++) { if (arma::is_finite(log_prob(i))) suml += exp(log_prob(i) - maxl); } return Rcpp::wrap(log(suml) + maxl); ’)
  • 7. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Annotations Rcpp wrappers generated automatically: compileAttributes("myRcppPackage") R package documentation generated automatically: roxygenize("myRcppPackage") § / / ’ Compute the effective sample size (ESS) of the particles. / / ’ / / ’ The ESS is a ‘‘rule of thumb’’ for assessing the degeneracy of / / ’’ the importance distribution: / / ’ deqn {ESS = frac { ( sum_ { q=1}^Q w_q ) ^ 2 } { sum_ { q=1}^Q w_q ^2}} / / ’ / / ’’ @param log_weights logarithms of the importance weights of each particle. / / ’’ @return the effective sample size, a scalar between 0 and Q / / ’’ @references / / ’’ Liu, JS (2001) "Monte Carlo Strategies in Scientific Computing." Springer’ / / [ [ Rcpp : : export ] ] double effectiveSampleSize ( NumericVector log_weights ) { double sum_wt = sum_logs ( log_weights ) ; double sum_sq = sum_logs ( log_weights + log_weights ) ; double res = exp (sum_wt + sum_wt − sum_sq ) ; i f ( std : : i s f i n i t e ( res ) ) return res ; else return 0; }
  • 8. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Package Skeleton Create a new R package: package.skeleton("myPackage", path=".") Specific skeletons for each C++ library: Rcpp.package.skeleton("myRcppPackage") RcppArmadillo.package.skeleton("MyArmadilloPackage") RcppEigen.package.skeleton("MyEigenPackage")
  • 9. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Common Problems Rcpp parameters are passed by reference (not copied): Can rely on R for garbage collection Memory allocation is slower Can crash R (and Rstudio (and your OS)) R is not thread safe Cannot call any R functions (even indirectly) within parallel code! Drew Schmidt (@wrathematics, 2015) Parallelism, R, and OpenMP
  • 10. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion bayesImageS An R package for Bayesian image segmentation using the hidden Potts model: RcppArmadillo for fast computation in C++ OpenMP for parallelism § library ( bayesImageS ) p r i o r s ← l i s t ("k"=3 ,"mu"=rep (0 ,3) ,"mu.sd"=sigma , "sigma"=sigma , "sigma.nu"=c (1 ,1 ,1) ,"beta"=c ( 0 , 3 ) ) mh ← l i s t ( algorithm="pseudo" , bandwidth =0.2) r e s u l t ← mcmcPotts ( y , neigh , block ,NULL, 55000,5000, priors ,mh) Eddelbuettel & Sanderson (2014) RcppArmadillo: Accelerating R with high-performance C++ linear algebra. CSDA 71
  • 11. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Bayesian computational methods bayesImageS supports methods for updating the latent labels: Chequerboard Gibbs sampling (Winkler 2003) Swendsen-Wang (1987) and also methods for updating the smoothing parameter β: Pseudolikelihood (Rydén & Titterington 1998) Thermodynamic integration (Gelman & Meng 1998) Exchange algorithm (Murray, Ghahramani & MacKay 2006) Approximate Bayesian computation (Grelaud et al. 2009) Sequential Monte Carlo (ABC-SMC) with pre-computation (Del Moral, Doucet & Jasra 2012; Moores et al. 2015)
  • 12. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Image-Guided Radiotherapy Image courtesy of Varian Medical Systems, Inc. All rights reserved.
  • 13. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Segmentation of Anatomical Structures Radiography courtesy of Cathy Hargrave, Radiation Oncology Mater Centre, Queensland Health
  • 14. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Physiological Variability Organ Ant-Post Sup-Inf Left-Right prostate 0.1 ± 4.1mm −0.5 ± 2.9mm 0.2 ± 0.9mm seminal vesicles 1.2 ± 7.3mm −0.7 ± 4.5mm −0.9 ± 1.9mm Table: Distribution of observed translations of the organs of interest Organ Volume Gas rectum 35 − 140cm3 4 − 26% bladder 120 − 381cm3 Table: Volume variations in the organs of interest Frank, et al. (2008) Quantification of Prostate and Seminal Vesicle Interfraction Variation During IMRT. IJROBP 71(3): 813–820.
  • 15. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Electron Density phantom (a) CIRS Model 062 ED phantom (b) Helical, fan-beam CT scanner
  • 16. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Cone-Beam Computed Tomography (c) Fan-beam CT (d) Cone-beam CT
  • 17. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Distribution of Pixel Intensity Hounsfield unit Frequency −1000 −800 −600 −400 −200 0 200 050001000015000 (a) Fan-Beam CT pixel intensity Frequency −1000 −800 −600 −400 −200 0 200 050001000015000 (b) Cone-Beam CT
  • 18. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Hidden Markov Random Field Joint distribution of observed pixel intensities y = {yi}n i=1 and latent labels z = {zi}n i=1: p(y, z|µ, σ2 , β) = p(y|µ, σ2 , z)p(z|β) (1) Additive Gaussian noise: yi|zi =j iid ∼ N µj, σ2 j (2) Potts model: π(zi|zi, β) = exp {β i∼ δ(zi, z )} k j=1 exp {β i∼ δ(j, z )} (3) Potts (1952) Proceedings of the Cambridge Philosophical Society 48(1)
  • 19. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Inverse Temperature
  • 20. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Doubly-intractable likelihood p(β|z) ∝ C(β)−1 π(β) exp {β S(z)} (4) The normalising constant has computational complexity O(nkn): C(β) = z∈Z exp {β S(z)} (5) S(z) is the sufficient statistic of the Potts model: S(z) = i∼ ∈L δ(zi, z ) (6) where L is the set of all unique neighbour pairs.
  • 21. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Informative Prior for µj and σ2 j 0 1 2 3 4 −1000−800−600−400−2000200 Electron Density Hounsfieldunit (a) Fan-Beam CT 0 1 2 3 4 −1000−800−600−400−2000200 Electron Density pixelintensity (b) Cone-Beam CT
  • 22. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion External Field π(zi|αi, β, zi∼ ) ∝ exp αi(zi) + β i∼ δ(zi, zj) (7) Isotropic translation: αi(zi =j) = 1 nj ν∈j φ ∆(ϑi, ϑν), µ = 1.2, σ2 = 7.32 (8) where ν ∈ j are the image voxels ϑν in object j φ(x, µ, σ2) is the normal density function ∆(u, v) is the Euclidian distance between the coordinates of voxel u and voxel v
  • 23. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion External Field II (a) Fan-beam CT (b) External Field
  • 24. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Anisotropy αi(prostate) ∼ MVN     0.1 −0.5 0.2   ,   4.12 0 0 0 2.92 0 0 0 0.92     (a) Bitmask (b) External Field
  • 25. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Seminal Vesicles αi(SV) ∼ MVN     1.2 −0.7 −0.9   ,   7.32 0 0 0 4.52 0 0 0 1.92     (a) Bitmask (b) External Field
  • 26. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion External Field Organ- and patient-specific external field (slice 49, 16mm Inf)
  • 27. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Chequerboard Gibbs A 2D or 3D regular lattice with first-order neighbourhood ∂i: ◦ ◦ ◦ ◦ ◦ ◦ ◦ • ◦ ◦ ◦ • × • ◦ ◦ ◦ • ◦ ◦ ◦ ◦ ◦ ◦ ◦ can be partitioned into 2 blocks: • ◦ • ◦ • ◦ • ◦ • ◦ ◦ • ◦ • ◦ • ◦ • ◦ • • ◦ • ◦ • ◦ • ◦ • ◦ ◦ • ◦ • ◦ • ◦ • ◦ • • ◦ • ◦ • ◦ • ◦ • ◦ ◦ • ◦ • ◦ • ◦ • ◦ • • ◦ • ◦ • ◦ • ◦ • ◦ ◦ • ◦ • ◦ • ◦ • ◦ • • ◦ • ◦ • ◦ • ◦ • ◦ ◦ • ◦ • ◦ • ◦ • ◦ • so that z◦ are conditionally independent, given z• Roberts & Sahu (1997) JRSS B 59(2): 291–317 Winkler (2nd ed., 2003) Image analysis, random fields and MCMC methods
  • 28. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Chequerboard Gibbs II Algorithm 1 Chequerboard sampling for z 1: for all blocks b do 2: for all pixels i ∈ b do 3: for all labels j ∈ 1 . . . k do 4: Compute λj ← p(yi | zi = j)π(zi = j | zi∼ , β) 5: end for 6: Draw zi ∼ Multinomial(λ1, . . . , λk) 7: end for 8: end for
  • 29. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Gibbs sampler in C++ § void gibbsLabels ( const arma : : umat & neigh , const std : : vector <arma : : uvec> & blocks , arma : : umat & z , arma : : umat & alloc , const double beta , const arma : : mat & log_ x f i e l d ) { const Rcpp : : NumericVector randU = Rcpp : : r u n i f ( neigh . n_rows ) ; for ( unsigned b=0; b < blocks . size ( ) ; b++) { const arma : : uvec block = blocks [ b ] ; arma : : vec log_prob ( z . n_cols ) ; #pragma omp p a r a l l e l for private ( log_prob ) for ( unsigned i =0; i < block . size ( ) ; i ++) { for ( unsigned j =0; j < z . n_cols ; j ++) { unsigned sum_neigh = 0; for ( unsigned k=0; k < neigh . n_cols ; k++) { sum_neigh += z ( neigh ( block [ i ] , k ) , j ) ; } log_prob [ j ] = log_ x f i e l d ( block [ i ] , j ) + beta∗sum_neigh ; } double t o t a l _ l l i k e = sum_logs ( log_prob ) ; double cumProb = 0.0; z . row ( block [ i ] ) . zeros ( ) ; for ( unsigned j =0; j < log_prob . n_elem ; j ++) { cumProb += exp ( log_prob [ j ] − t o t a l _ l l i k e ) ; i f ( randU [ block [ i ] ] < cumProb ) { z ( block [ i ] , j ) = 1; a l l o c ( block [ i ] , j ) += 1; break ;
  • 30. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Pseudolikelihood (PL) Algorithm 2 Metropolis-Hastings with PL 1: Draw proposal β ∼ q(β |β◦) 2: Approximate p(β |z) and p(β◦|z) using equation (9): ˆpPL(β|z) ≈ n i=1 exp{β i∼ δ(zi, z )} k j=1 exp{β i∼ δ(j, z )} (9) 3: Calculate the M-H ratio ρ = ˆpPL(β |z)π(β )q(β◦|β ) ˆpPL(β◦|z)π(β◦)q(β |β◦) 4: Draw u ∼ Uniform[0, 1] 5: if u < min(1, ρ) then 6: β ← β 7: else 8: β ← β◦ 9: end if Rydén & Titterington (1998) JCGS 7(2): 194–211
  • 31. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Pseudolikelihood in C++ § double pseudolike ( arma : : mat & ne , arma : : uvec & e , double b , unsigned n , unsigned k ) { double num = 0.0; double denom = 0.0; #pragma omp p a r a l l e l for reduction ( + :num, denom) for ( unsigned i =0; i < n ; i ++) { num=num+ne ( e [ i ] , i ) ; double tdenom =0.0; for ( unsigned j =0; j < k ; j ++) { tdenom=tdenom+exp ( b∗ne ( j , i ) ) ; } denom=denom+log ( tdenom ) ; } return b∗num−denom ; }
  • 32. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Approximation Error PL for n = 12, k = 3 in comparison to the exact likelihood calculated using a brute force method: 0 1 2 3 4 6810121416 β µ exact pseudolikelihood (a) Expectation 0 1 2 3 4 0.00.51.01.52.02.5 β σ exact pseudolikelihood (b) Standard deviation
  • 33. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion ED phantom experiment 27 cone-beam CT scans of the ED phantom Cropped to 376 × 308 pixels and 23 slices (330 × 270 × 46 mm) Inner ring of inserts rotated by between 0◦ and 16◦ 2D displacement of between 0mm and 25mm Isotropic external field prior with σ∆ = 7.3mm 9 component Potts model 8 different tissue types, plus water-equivalent background Priors for noise parameters estimated from 28 fan-beam CT and 26 cone-beam CT scans
  • 34. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Image Segmentation
  • 35. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Quantification of Segmentation Accuracy Dice similarity coefficient: DSCg = 2 × |ˆg ∩ g| |ˆg| + |g| (10) where DSCg is the Dice similarity coefficient for label g |ˆg| is the count of pixels that were classified with the label g |g| is the number of pixels that are known to truly belong to component g |ˆg ∩ g| is the count of pixels in g that were labeled correctly Dice (1945) Measures of the amount of ecologic association between species. Ecology 26(3): 297–302.
  • 36. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Results Tissue Type Simple Potts External Field Lung (inhale) 0.540 ± 0.037 0.902 ± 0.009 Lung (exhale) 0.172 ± 0.008 0.814 ± 0.022 Adipose 0.059 ± 0.008 0.704 ± 0.062 Breast 0.077 ± 0.011 0.720 ± 0.048 Water 0.174 ± 0.003 0.964 ± 0.003 Muscle 0.035 ± 0.004 0.697 ± 0.076 Liver 0.020 ± 0.007 0.654 ± 0.033 Spongy Bone 0.094 ± 0.014 0.758 ± 0.018 Dense Bone 0.014 ± 0.001 0.616 ± 0.151 Table: Segmentation Accuracy (Dice Similarity Coefficient ±σ) Moores, et al. (2014) In Proc. XVII Intl Conf. ICCR; J. Phys: Conf. Ser. 489
  • 37. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Preliminary Results −300 −250 −200 −150 150200250300 right−left (mm) posterior−anterior(mm) (a) Cone-Beam CT −300 −250 −200 −150 150200250300 right−left (mm) posterior−anterior(mm) (b) Segmentation Moores, et al. (2015) CSDA 86: 27–41.
  • 38. R packages Medical Imaging Statistical Model Bayesian Computation Experimental Results Conclusion Summary Informative priors can dramatically improve segmentation accuracy for noisy data inverse regression for µ & σ2 external field prior for z It is feasible to use MCMC for image analysis of realistic datasets but auxiliary variable methods don’t scale well requires parallelized implementation in C++ or Fortran RcppArmadillo & OpenMP are a good combination faster algorithms are available, such as VB or ICM
  • 39. Appendix For Further Reading I Moores, Hargrave, Deegan, Poulsen, Harden & Mengersen An external field prior for the hidden Potts model with application to cone-beam computed tomography. CSDA 86: 27–41, 2015. Moores & Mengersen bayesImageS: Bayesian methods for image segmentation using a hidden Potts model. R package version 0.3-3 https://CRAN.R-project.org/package=bayesImageS Moores, Drovandi, Mengersen & Robert Pre-processing for approximate Bayesian computation in image analysis. Statistics & Computing 25(1): 23–33, 2015. Moores, Pettitt & Mengersen Scalable Bayesian inference for the inverse temperature of a hidden Potts model. arXiv:1503.08066 [stat.CO], 2015.
  • 40. Appendix For Further Reading II Eddelbuettel & Sanderson RcppArmadillo: Accelerating R with high-performance C++ linear algebra. Comput. Stat. Data Anal. 71: 1054–63, 2014. Bates & Eddelbuettel Fast and elegant numerical linear algebra using the RcppEigen package. J. Stat. Soft. 52(5): 1–24, 2013. Eddelbuettel Seamless R and C++ integration with Rcpp Springer-Verlag, 2013. Wickham R packages O’Reilly, 2015.
  • 41. Appendix For Further Reading III Winkler Image analysis, random fields and Markov chain Monte Carlo methods 2nd ed., Springer-Verlag, 2003. Marin & Robert Bayesian Essentials with R Springer-Verlag, 2014. Roberts & Sahu Updating Schemes, Correlation Structure, Blocking and Parameterization for the Gibbs Sampler J. R. Stat. Soc. Ser. B 59(2): 291–317, 1997. Rydén & Titterington Computational Bayesian Analysis of Hidden Markov Models J. Comput. Graph. Stat. 7(2): 194–211, 1998.