CS-HMRF
CS-HMRF
a r t i c l e i n f o a b s t r a c t
Article history: The hidden Markov random field (HMRF) model has been widely used in image segmentation, as it
Received 28 February 2013 provides a spatially constrained clustering scheme on two sets of random variables. However, in many
Received in revised form 30 July 2013 HMRF-based segmentation approaches, both the latent class labels and statistical parameters have been
Accepted 31 July 2013
estimated by deterministic techniques, which usually lead to local convergence and less accurate segmen-
Available online 26 September 2013
tation. In this paper, we incorporate the immune inspired clonal selection algorithm (CSA) and Markov
chain Monte Carlo (MCMC) method into HMRF model estimation, and thus propose the HMRF–CSA
Keywords:
algorithm for brain MR image segmentation. Our algorithm employs a three-step iterative process that
Image segmentation
Magnetic resonance imaging (MRI)
consists of MCMC-based class labels estimation, bias field correction and CSA-based statistical parameter
Clonal selection algorithm (CSA) estimation. Since both the MCMC and CSA are global optimization techniques, the proposed algorithm has
Markov random field (MRF) the potential to overcome the drawback of traditional HMRF-based segmentation approaches. We com-
Hidden Markov random field (HMRF) pared our algorithm to the state-of-the-art GA–EM algorithm, deformable cosegmentation algorithm,
Markov chain Monte Carlo (MCMC) the segmentation routines in the widely-used statistical parametric mapping (SPM) software package
and the FMRIB software library (FSL) on both simulated and clinical brain MR images. Our results show
that the proposed HMRF–CSA algorithm is robust to image artifacts and can differentiate major brain
structures more accurately than other three algorithms.
© 2013 Elsevier Ltd. All rights reserved.
1746-8094/$ – see front matter © 2013 Elsevier Ltd. All rights reserved.
http://dx.doi.org/10.1016/j.bspc.2013.07.010
T. Zhang et al. / Biomedical Signal Processing and Control 12 (2014) 10–18 11
For instance, Tohka et al. [6] incorporated the genetic algorithm into segmentation result is obtained from MCMC inference, the image
the likelihood estimation, and thus proposed the GA–EM algorithm, inhomogeneity is estimated and partly removed from the image.
which can produce satisfying segmentation results. Alternatively, The proposed HMRF–CSA algorithm has been compared to the
maximum a posteriori (MAP) estimation is a common substitution state-of-the-art GA–EM method [37], deformable cosegmentation
for the ML estimation when prior knowledge is available. The prior (D–C) algorithm [11], the unified segmentation routine in the SPM
of voxels’ spatial dependence is usually interpreted by modeling the software package [16] and the HMRF–EM segmentation routine
voxel class labels as a Markov random field (MRF) [18–21]. Thus, in the FMRIB Software Library (FSL) [38] on both simulated and
the image segmentation problem can be approached within the clinical brain MR images.
MAP–MRF framework. A classical solution is the iterated condi-
tional modes (ICM) [8,15,22–24]. Despite being computationally 2. Related work
efficient, the ICM algorithm has an evident drawback of locally
convergences. Thus, global stochastic searching based inference 2.1. Image inhomogeneity model
methods, such as the Markov chain Mote Carlo (MCMC) inference
[25], have been extensively studied to substitute for the determi- One of the inherent challenges for MR image analysis is the
nistic routines [26,27]. existence of image inhomogeneity, also known as the bias field
The posterior criterion is to approximate the optimal class labels or intensity non-uniformity (INU) [39–44]. Image inhomogeneity
given the model parameters and the observed image. However, it is referred as a smooth intensity variation across the image, aris-
fails to examine whether the model parameters fit the observed ing from the imperfection of image acquisition [45]. Let a brain
image data. The hidden Markov random field (HMRF) model can MR image be denoted by y = {yi ; i = 1, 2, . . ., N}, where yi repre-
naturally characterize this important penalty, and hence better sents the intensity at voxel i and N is the number of voxels. The
suits the image segmentation problem [19,28]. In this model, both unknown bias field B = {bi ; i = 1, 2, . . ., N} is usually modeled as a
the observed image and hidden voxel labels are assumed to be multiplicative component of y, shown as follows
random variables. Image segmentation is represented as the joint
approximation of the optimal hidden variables and model param- y = B · ŷ + ℵ (1)
eters conditioned on the observed data. The HMRF model was where ŷ is the ideal image, and ℵ∼N(o, n2 ) is the additive Gaussian
introduced into the brain MR image segmentation field by Zhang white noise. Since the bias field B varies slowly in the image, it
et al. [15]. In their HMRF–EM framework, they use a two-step iter- can be defined as a smooth function on the entire image domain.
ative procedure to solve the joint probability. The ICM algorithm We adopt orthogonal polynomials {Wj : j = 1, 2, . . ., NOP } as basis
is first used to approximate the hidden class labels, and then the functions to approximate the bias field [46,47]
EM algorithm is used to estimate the model parameters. Despite
being popular and computationally efficient [29,30], both the ICM
NOP
the image segmentation problem is formulated as maximizing the where i = 1, 2, . . ., I denote iteration number of the MCMC algo-
joint probability of the configuration x and the parameters rithm, C is a cooling factor, here we empirically set T (0) = 4, C =
0.97. Given a brain MR image y and an initialization configura-
(x∗ , ∗ ) = arg max p(x, |y) = arg max p(x|y, )p(|y, x) (5) tion of labels x(0) , the model parameters can be calculated. Define
x x
the jumping density Q(·|x(i) ) that can suggest a random move from
It should be noted that the difference between the posterior x(i) as the Gaussian distribution. At each iteration, draw a candi-
in Eq. (4) and that the joint probability in Eq. (5) is the penalty date x*(i+1) from the proposal density Q (x∗(i+1) |x(i) ), and a random
term p(|y, x), which examines whether the model parameters are sequence u = {uj , j ∈ S} from the uniform distribution u(0, 1), calcu-
consistent with the observations given the configuration x. late the acceptance ratio for each voxel j
∗(i+1)
3. HMRF–CSA algorithm p(xj |y (t) , (t)
˛j = min 1, (11)
(i)
p(xj |y (t) , (t)
The HMRF model aims to jointly estimate the optimal class
labels and model parameters (x,) in Eq. (5). The estimation process (i+1) ∗(i+1)
can be divided into two mutually dependent optimization steps: If uj < ˛j , accept the simulation xj = xj , else reject it and
(i+1)
searching the optimal configuration x* and learning the fittest keep the class label the same as that of the previous iteration xj =
model parameters * . When bias field correction is considered, (i)
xj .
Keep the iteration until reach the maximum iteration number.
the HMRF model estimation can be achieved using the following
three-step iterated procedure Our implementation is summarized in Algorithm I.
⎧ (t+1) Algorithm I: MCMC sampling for voxel classification
⎪ x = arg max p(x|y (t) , (t) )
⎨ x Input: Observed brain MR image y,
y (t+1) = f (y (t) , x(t+1) ) (6) Output: Optimal voxel class labels x*
⎪
⎩ Initialization: segmentation result x(0) or parameters (0)
(t+1) = arg max p(|y (t+1) , x(t+1) ) For iteration i = 1, 2, · · ·, I do
1) Draw a candidate x∗(i+1) from the proposal density Q (x∗(i+1) |x(i) ), and a
where f(·,·) denotes the function that can correct the bias field random sequence u ∈ u(0, 1)
based on the observation y and the segmentation result x, and 2) For each voxel j ∈ S, calculate the acceptance ratio ˛j based on Eq. (11)
∗(i+1)
t ∈ {1, 2, . . .TMax } denotes the current iteration number. At each 3) If uj < ˛j , set xj
(i+1)
= xj . Else, set xj
(i+1) (i)
= xj
iteration, we first utilize the MCMC method to realize the MRF–MAP 4) Update temperature parameter T (i+1)
using Eq. (10)
estimation. With the approximated segmentation results, the bias End For.
field is then estimated. After bias field correction, the CSA is used
to learn the HMRF model parameters. The iteration will stop when
3.2. Bias field correction
reaching the maximum iteration number or the segmentation
result becomes stable.
After the MCMC-based voxel classification, the intermediate
segmentation result x* and minimum energy E = {Ekj,xj = k, j ∈ S}
3.1. MCMC sampling for voxel classification
are obtained. Let us consider the normalized posteriori probability
H = {Hkj ; j = 1, 2, . . .N, k = 1, 2, . . .K} as a soft segmentation result
The first step is to find the optimal configuration x* by MRF–MAP
approximation. We use the MCMC method to solve this opti- exp(−Ekj )
mization problem. According to Eq. (4), given any particular Hkj = p(xj |yj , k ) = K
(12)
configuration x, if we assume yj is mutually independent and k=1
exp(−Ekj )
based on a multivariate Gaussian distribution with parameters
Based on the piecewise constant nature of the ideal MR image,
k = {k , ˙k }, the likelihood is
we define the restored image is as the product of the soft segmen-
p(y|x; ) = N(yj ; k ) (7) tation and the corresponding mean k
j ∈ S,xj =k
K
The joint distribution of the MRF x can be expressed as a Gibbs ŷj = Hkj ∗ k (13)
function [19],
k=1
1 VC (x) The bias field can be estimated by solving the following least-
p(x) exp − (8)
Z T square fitting problem using the singular value decomposition
c∈C
(SVD) based technique [48].
where Z is a normalizing constant, VC (x) denotes the potential of
clique c, C is the assembly of all cliques determined by the neigh-
NOP
borhood system, and T is a temperature parameter. We use the ϕ(t) = arg minϕ ||y./ŷ(t) − ϕj Wj ||2 (14)
Potts model to represent the clique potential. Applying Eq. (7) and j=1
(8) to Eq. (4) and applying the negative logarithmic transformation
to it, we have where “./” represents the point-by-point division. With the esti-
mated combination coefficients, the bias field is obtained as
x∗ = arg minx ∈ X {E(x)} (9)
NOP
(t)
where E(x) = V (x)/T −
c∈C C j ∈ S,x =k
ln(N(yj ; k )) is the energy B(t) = ϕj W j (15)
j
function. j=1
Following the simulated annealing MCMC methods [19], we
define a cooling schedule for temperature parameter T, Then, the bias field corrupted image can be restored as follows
T (i+1) = T (i) × Ci (10) y(t+1) = f (y (t) |x(t) ) = exp(ln y(t) − ln B(t) ) (16)
T. Zhang et al. / Biomedical Signal Processing and Control 12 (2014) 10–18 13
N
K
p(|y, x) ∝ ∼p(y|x; )p() = N(y j |xj = k; k )p(kj ) (17) Bias Field Estimation and
Image Correction
j=1 k=1
where p() is the prior probability of parameters. This prior HMRF Model Estimation
denotes the voxel based Markov property information p(kj ) = Based on CSA
p(xj = k|k∂j ), which can be calculated by the MRF energy. We define
it as the mixture of these terms to balance both the convergence No
and diversity of the parameters, for each voxel j ∈ S Stop?
Fig. 2. Comparison between the segmentation results of four algorithms in simulated brain MR images: (a) 88th transverse slice in the simulated study (with 7% noise and
40% INU); (b) INU corrected image; (c) estimated INU; (d) result of the HMRF–EM algorithm; (e) result of the D–C algorithm; (f) result of the SPM package; (g) result of the
GA–EM algorithm; (h) result of the eHMRF algorithm; (i) result of the proposed HMRF–CSA Algorithm; (j) ground truth.
[6] that is available in the GAMIXTURE package [37], the D–C algo- algorithms were depicted in Fig. 4. It should be noted that the pro-
rithm [11], the classic HMRF–EM algorithm in FSL package, and posed algorithm can remain the good segmentation performance
the unified segmentation routine [12] in the SPM package [16] on with the high noise and INU levels.
simulated T1-weighted brain MR studies obtained from the Brain-
Web dataset [49]. The BrainWeb dataset provides a set of simulated
4.2. Results on clinical data
brain images, which are simulated by an anatomic model with dif-
ferent INU and noise levels. Each simulated study has a dimension
Next, segmentation experiments were performed on 18 clin-
of 181 × 217 × 181 and a voxel size of mm × 1 mm × 1 mm.
ical brain MR studies obtained from the IBSR (Version 2.0) [51].
To demonstrate the performance of the proposed algorithm,
Each study has been spatially normalized into the Talairach ori-
Fig. 2 shows the 88th transverse slice of the simulated study with
entation, and resliced into a dimension of 256 × 256 × 128 voxels
40% INU and 7% noise, bias field corrected image, estimated bias
and a voxel size of 1.0 mm × 1.0 mm × 1.5 mm. The ground truth
field, segmentation results obtained by using four algorithms, and
tissue maps were generated by trained investigators using both
the ground truth tissue map. It reveals that the segmentation result
image histograms and a semi-automated intensity contour map-
produced by the proposed algorithm is more similar to the ground
ping algorithm. Those images have also been processed by the CMA
truth than the results produced by other algorithms.
“autoseg” INU correction routines [51].
Next, we further compared these algorithms in two groups of
The HMRF–CSA algorithm was compared to the state-of-the-art
simulated MR image studies. The first group consists of four studies
GA–EM algorithm [6], D–C algorithm [11], and the brain MR image
with 20% INU and different levels of noise, ranging from 1% to 7%.
segmentation routines in the SPM [16] and the FSL [52] packages,
Since the ground truth tissue map is available, the delineation of
which are very widely used in the neuroimaging community. In
each brain tissue type is assessed quantitatively by using the Dice
each algorithm, we used the default parameters suggested in the
similarity coefficient (DSC) [50].
corresponding software package. The coronal, sagittal and trans-
|Vs (k) ∩ Vg (k)| verse slices of the study “IBSR 14”, corresponding ground truth and
D(Vs (k), Vg (k)) = 2 × (20) voxel classification results obtained by using five algorithms were
|Vs (k)| + |Vg (k)|
shown in Fig. 5. The average accuracy was compared in Table 1.
where Vs (k) is the volume of brain tissue class k in the segmenta- The accuracy of these five algorithms in all studies was measured
tion result, Vg (k) is the corresponding volume in the ground truth, and displayed in Fig. 6. It reveals that, compared to other four
and |V| represents the number of voxels in volume V. The overall widely used approaches, the proposed algorithm can substantially
performance was evaluated by using the segmentation accuracy, improve the accuracy of voxel classification in clinical brain MR
which was calculated as the percentage of correctly classified brain images, especially improving the accuracy of GM and CSF delin-
voxels. eation.
Fig. 3 depicts the segmentation accuracy obtained by those six
algorithms. It shows that the proposed algorithm archives better
accuracy in delineating each brain tissue and in classifying the over- Table 1
all brain volume in most studies. Moreover, with the increasing Average voxel classification accuracy of four algorithms on 18 clinical T1-weighted
brain MR images.
noise or INU levels, the accuracy of the proposed algorithm declines
less than the accuracy of the other three algorithms. It demonstrates FSL D–C algorithm SPM GA–EM Proposed
that the proposed algorithm has an improved ability to resist the Overall 75.06% 75.02% 81.20% 74.97% 82.95%
impact of noise and INU. The second test group consists of four GM 77.35% 73.80% 84.42% 77.90% 84.92%
studies with 40% INU and different levels of noise, ranging from 1% WM 87.08% 88.41% 87.38% 87.23% 83.88%
CSF 16.19% 33.04% 20.31% 14.90% 55.45%
to 7%. Similarly, the segmentation accuracy obtain by those four
T. Zhang et al. / Biomedical Signal Processing and Control 12 (2014) 10–18 15
Fig. 3. Comparison of the segmentation accuracy of six algorithms in T1-weighted brain MR images with 20% INU and 1–7% noises.
Fig. 4. Comparison of the segmentation accuracy of five algorithms in T1-weighted brain MR images with 40% INU and 1–7% noises.
Fig. 5. Comparison of the image segmentation results of five algorithms in clinical brain MR images: (a) T1-weighted brain MR study from IBSR (IBSR 14); (b) result of the
SPM package; (c) result of the FSL package; (d) result of the D–C method; (e) result of the GA–EM algorithm; (f) result of the proposed HMRF–CSA algorithm; (g) ground truth
tissue map.
90%
Overall Accuracy
85%
80% D-C Algorithm
75% FSL
70% GA-EM
65% HMRF-CSA
60% SPM
90%
85%
DSC of GM
95%
90%
DSC of WM
D-C Method
85%
FSL
80%
GA-EM
75% HMRF-CSA
70% SPM
90%
80%
70%
DSC of CSF
Fig. 6. Comparison of the voxel classification accuracy of five algorithms on 18 clinical T1-weighted brain MR images.
T. Zhang et al. / Biomedical Signal Processing and Control 12 (2014) 10–18 17
Acknowledgements
[20] Y. Xia, S. Eberl, L. Wen, M. Fulham, D.D. Feng, Dual-modality brain PET-CT image [36] L.N.D. Castro, F.J.V. Zuben, Clonal selection algorithm with engineering appli-
segmentation based on adaptive use of functional and anatomical information, cations, in: GECCO 2000, Workshop on Artificial Immune Systems and their
Computerized Medical Imaging and Graphics 36 (2012) 47–53. Applications, Las Vegas, USA, 2000, pp. 36–37.
[21] Y. Xia, D. Feng, R. Zhao, Adaptive segmentation of textured images by using the [37] J. Tohka, MIXTUREGA, in http://www.1.cs.tut.fi/∼jupeto/gamixture.html.
coupled Markov random field model, IEEE Transactions on Image Processing [38] FMRIB Software Library, in http://fsl.fmrib.ox.ac.uk/fsl/.
15 (2006) 3559–3566. [39] M. Styner, Parametric estimate of intensity inhomogeneities applied to MRI,
[22] J. Besag, On the statistical analysis of dirty pictures, Journal of the Royal Statis- IEEE Transactions on Medical Imaging 19 (2000) 153–165.
tical Society. Series B (Methodological) 48 (3) (1986) 259–302. [40] M.N. Ahmed, S.M. Yamany, N. Mohamed, A.A. Farag, T. Moriarty, A modified
[23] B. Scherrer, M. Dojat, F. Forbes, C. Garbay, Agentification of Markov model- fuzzy c-means algorithm for bias field estimation and segmentation of MRI
based segmentation: application to magnetic resonance brain scans, Artificial data, IEEE Transactions on Medical Imaging 21 (2002) 193–199.
Intelligence in Medicine 46 (2009) 81–95. [41] K. Van Leemput, F. Maes, D. Vandermeulen, P. Suetens, Automated model-based
[24] Z. Liang, S. Wang, An EM approach to MAP solution of segmenting tissue mix- bias field correction of MR images of the brain, IEEE Transactions on Medical
tures: a numerical analysis, IEEE Transactions on Medical Imaging 28 (2009) Imaging 18 (1999) 885–896.
297–310. [42] J.D. Gispert, S. Reig, J. Pascau, J.J. Vaquero, P. García-Barreno, M. Desco, Method
[25] J. Besag, C. Kooperberg, On conditional and intrinsic autoregressions, for bias field correction of brain T1-weighted magnetic images minimizing
Biometrika 82 (1995) 733–746. segmentation error, Human Brain Mapping 22 (2004) 133–144.
[26] Z. Tu, S.C. Zhu, Image segmentation by data-driven Markov chain Monte Carlo, [43] L. Chunming, H. Rui, D. Zhaohua, J.C. Gatenby, D.N. Metaxas, J.C. Gore, A level set
IEEE Transactions on Pattern Analysis and Machine Intelligence 24 (2002) method for image segmentation in the presence of intensity inhomogeneities
657–673. with application to MRI, IEEE Transactions on Image Processing 20 (2011)
[27] K. Kayabol, E.E. Kuruoglu, B. Sankur, Bayesian separation of images modeled 2007–2016.
with MRFs using MCMC, IEEE Transactions on Image Processing 18 (2009) [44] E.B. Lewis, N.C. Fox, Correction of differential intensity inhomogeneity in lon-
982–994. gitudinal MR images, NeuroImage 23 (2004) 75–83.
[28] H. Kunsch, S. Geman, A. Kehagias, Hidden Markov random fields, The Annals of [45] U. Vovk, F. Pernuš, B. Likar, A review of methods for correction of inten-
Applied Probability 5 (1995) 577–602. sity inhomogeneity in MRI, IEEE Transactions on Medical Imaging 26 (2007)
[29] S. M’hiri, L. Cammoun, F. Ghorbel, Speeding up HMRF EM algorithms for fast 405–421.
unsupervised image segmentation by Bootstrap resampling: application to the [46] Z. Ji, Q. Sun, Y. Xia, Q. Chen, D. Xia, D. Feng, Generalized rough fuzzy c-means
brain tissue segmentation, Signal Processing 87 (2007) 2544–2559. algorithm for brain MR image segmentation, Computer Methods and Programs
[30] J. Nie, Z. Xue, T. Liu, G.S. Young, K. Setayesh, L. Guo, S.T.C. Wong, Auto- in Biomedicine 108 (2012) 644–655.
mated brain tumor segmentation using spatial accuracy-weighted hidden [47] M.J.D. Powell, Approximation Theory and Methods, Cambridge University
Markov random field, Computerized Medical Imaging and Graphics 33 (2009) Press, Cambridge CB2 1RP, 1981.
431–441. [48] Å. Björck, Numerical Methods for Least Squares Problems, SIAM, Society for
[31] F. Destrempes, M. Mignotte, J.F. Angers, A stochastic method for Bayesian Industrial and Applied Mathematics, Philadelphia, PA, 1996.
estimation of hidden Markov random field models with application [49] C.A. Cocosco, V. Kollokian, R.K.-S. Kwan, A.C. Evans, BrainWeb: online interface
to a color model, IEEE Transactions on Image Processing 14 (2005) to a 3D MRI simulated brain database, NeuroImage 5 (1997) 425.
1096–1108. [50] A. Bharatha, M. Hirose, N. Hata, S.K. Warfield, M. Ferrant, K.H. Zou, E. Suarez-
[32] F. Forbes, G. Fort, Combining Monte Carlo and mean-field-like methods Santana, J. Ruiz-Alzola, A.D. Amico, R.A. Cormack, R. Kikinis, F.A. Jolesz, C.M.
for inference in hidden Markov random fields, IEEE Transactions on Image Tempany, Evaluation of three-dimensional finite element-based deformable
Processing 16 (2007) 824–837. registration of pre- and intra-operative prostate imaging, Medical Physics 28
[33] A.R. Ferreira da Silva, Bayesian mixture models of variable dimension for image (2001) 2551–2560.
segmentation, Computer Methods and Programs in Biomedicine 94 (2009) [51] The Internet Brain Segmentation Repository, in http://www.cma.
1–14. mgh.harvard.edu/ibsr/.
[34] B. Haktanirlar Ulutas, S. Kulturel-Konak, A review of clonal selection algorithm [52] S.M. Smith, M. Jenkinson, M.W. Woolrich, C.F. Beckmann, T.E.J. Behrens, H.
and its applications, Artificial Intelligence Review 36 (2011) 117–138. Johansen-Berg, P.R. Bannister, M. De Luca, I. Drobnjak, D.E. Flitney, R.K. Niazy,
[35] L.N. De Castro, F.J. Von Zuben, Learning and optimization using the clonal J. Saunders, J. Vickers, Y. Zhang, N. De Stefano, J.M. Brady, P.M. Matthews,
selection principle, IEEE Transactions on Evolutionary Computation 6 (2002) Advances in functional and structural MR image analysis and implementation
239–251. as FSL, NeuroImage 23 (2004) S208–S219.