Abstract
We introduce an algorithm for segmenting brain magnetic resonance (MR) images into anatomical compartments such as the major tissue classes and neuro-anatomical structures of the gray matter. The algorithm is guided by prior information represented within a tree structure. The tree mirrors the hierarchy of anatomical structures and the sub-trees correspond to limited segmentation problems. The solution to each problem is estimated via a conventional classifier. Our algorithm can be adapted to a wide range of segmentation problems by modifying the tree structure or replacing the classifier. We evaluate the performance of our new segmentation approach by revisiting a previously published statistical group comparison between first-episode schizophrenia patients, first-episode affective psychosis patients, and comparison subjects. The original study is based on 50 MR volumes in which an expert identified the brain tissue classes as well as the superior temporal gyrus, amygdala, and hippocampus. We generate analogous segmentations using our new method and repeat the statistical group comparison. The results of our analysis are similar to the original findings, except for one structure (the left superior temporal gyrus) in which a trend-level statistical significance (p=0.07) was observed instead of statistical significance.
Keywords: Automatic Segmentation, Data Tree, Expectation-Maximization, Parcellation, Statistical Group Comparison Study, MRI
I. Introduction
NEUROSCIENCE studies frequently use geometric models of brain structures for the detection of morphological differences between patient groups [1], [2]. For example, in a recent review of the literature, the most robust MR findings in schizophrenia are: enlarged lateral ventricles (77% of studies); medial temporal lobe (amygdala-hippocampal complex and/or parahippocampal gyrus) volume reduction (77% of studies); and gray matter volume reduction of the superior temporal gyrus (100% of studies) [3], [4]. These models are often based on manual segmentations made by experts who outline the structures of interest in MR images [5]. Generally, this process is not only time consuming, but inter- and intra-operator variability negatively impacts the reliability of such studies [6]. We address this issue by proposing a fully automatic, hierarchical segmentation algorithm that robustly parcellates images generated through standard clinical MRI acquisition into neuroanatomical structures.
Commonly used automatic segmenters for brain MR images identify gray matter, white matter, and cerebrospinal fluid with acceptable performance [7]-[17]. Nevertheless, neuroscientists are in great need of reliable segmentations of substructures of major tissue compartments for analyzing group differences in anatomy. Unfortunately, identifying these structures poses a serious challenge as their boundaries do not always coincide with tissue boundaries and may, therefore, not be visible in MR images (Figure 1). Automatic segmenters typically rely on prior information [18] in order to delineate these “invisible” boundaries. However, the use of prior information is not without risk as it can bias the automatic segmentation results [19]. Some successful attempts have been made to solve this problem, although current techniques are tailored and tuned to specific segmentation problems [20]-[23]. Moreover, the tuning results in assumptions making the implementations often difficult to adjust to other segmentation problems that deviate from the specific scenario. For example, the segmentation of compartments with large spatial variations within a population, such as lesions in elderly patients, are difficult to segment with methods based on label propagation via image registration of a template [24]-[29]. Furthermore, many of these methods are restricted to MR images from a certain acquisition protocol (e.g., high band width multiecho FLASH [21]).
This paper makes the following original contributions: We describe a segmentation algorithm guided by prior information represented within a tree structure. The tree captures the hierarchical relationship between anatomical structures and each sub-tree corresponds to a limited segmentation problem with a solution estimated through an EM implementation. We evaluate the accuracy of our algorithm by revisiting the clinical study by [30] segmenting 50 cases into the major brain compartments and the superior temporal gyrus, amygdala, and hippocampus. Based on our automatic segmentations, we detect similar group differences as in [30] between first-episode schizophrenia patients, first-episode affective psychosis patients, and comparison subjects with the exception of the left superior temporal gyrus in which only a trend was observed (p=0.07) but no significant difference.
We relate the segmentation of medical images to a tree representing the hierarchical relationship between anatomical structures. Unlike [31]-[33], where the tree structure contains the image at different resolutions, the nodes of our tree represent anatomical structures and the edges of the tree capture the hierarchy between different regions of interest. For example, the structure “brain” is a parent node of “gray matter”, “white matter”, and “cerebrospinal fluid”. The key idea is that prior information and segmentation parameters can be stored at each node and standard classification algorithms can be used to perform the segmentation. The process starts at the root of the tree, segmenting the image into the children of the root. A recursive process follows where each child becomes a root and the Region of Interest (ROI) associated with the new root is segmented into its children.
One advantage of this technique is its flexibility. For example, designing a new segmentation framework only requires the modification of the tree structure and its associated priors and parameters.
We show how an Expectation-Maximization (EM) segmentation algorithm can make full use of the tree structure. Unlike [7], [9], [13], [17], the observed data of our EM model is composed of image data and the tree structure. This results in an algorithm that can, for example, parcellate gray matter into its sub-structures.
We provide a validation of our algorithm using clinical data. We automatically segment 50 MR volumes into gray matter, white matter, and cerebrospinal fluid and further parcellate the gray matter into the superior temporal gyrus, the amygdala, and the hippocampus. The data set was previously manually segmented by a human expert and analyzed to study morphometric differences between first-episode schizophrenia patients, first-episode affective psychosis patients, and comparison subjects [30]. We repeat the statistical group comparison with our automated parcellations and find similar group differences for all structures except the left superior temporal gyrus, where we do not reach significance (p=0.07). To our knowledge, this is the first time that a fully automatic parcellator has been evaluated by revisiting a previously published statistical group comparison study based on manual segmentations.
The remainder of this paper is organized as follows. In Section II, we introduce the parcellation framework that is guided by the tree structure. The tree describes each anatomical structure of the segmentation problem in terms of its relation to other structures and structure-specific prior information. We modify a class of EM segmenters [7], [9], [13], [17] to be guided by the tree structure. We provide an example of an EM implementation in which the influence of prior and image information is varied throughout the tree. These modifications allow these segmenters to partition the major brain compartments into their sub-structures as defined by the segmentation tasks. In Section III, we revisit the previously published statistical group comparison between first-episode schizophrenia patients, first-episode affective psychosis patients, and comparison subjects [30] to evaluate the performance of our new segmentation approach.
II. Methods
Automatic segmentation algorithms for MR images usually treat every anatomical structure as an independent object or at best model local dependencies. For example, algorithms modeling the segmentation problem via Markov Random fields [11], [13], [34], [35] enforce spatial consistency within an anatomical region but do not explicitly define large-range dependencies across anatomical structures. We propose to model the anatomy with a hierarchical data structure (tree) that defines the substructure relations and organizes structure-specific atlas information. The approach provides a systematic and flexible framework that can be easily adapted to many different segmentation problems. It also subdivides the segmentation process into subproblems that are easier to solve than trying to parcellate all structures at once. In this article we use this principle to design a robust and flexible segmentation algorithm, where a solution to each subproblem is determined via an instance of the EM algorithm. However, this type of hierarchical method is not restricted to EM implementations.
A. Tree Representation for Anatomical Regions
As described above, for the purpose of segmentation, we represent anatomical information with a tree data structure. The root of the tree describes the region to segment, the leaves represent the final structures of interests, and the inner nodes are intermediate coarser anatomical ROIs. A node X is a child of another node Y if the structure associated with X is a substructure of the structure associated with Y. Figure 2 shows an example of a tree where an image is to be segmented into background (BG), cerebrospinal fluid (CSF), white matter (WM), and gray matter (GM). The root represents the whole image (IMAGE) and the four structures (BG, GM, WM, CSF) are described by the leaves of the tree. The intra-cranial cavity (ICC) is an intermediate node with the children GM, WM, and CSF. Note that the depth of the leaves does not need to be constant.
Typically, a segmentation process has two types of inputs: one is the region to segment and the other is the set of information associated with each structure of interest. Common structure-specific information for MR segmentation includes class-conditional intensity models and space-conditioned label probabilities. In our framework, the set of structure-specific information is stored at the leaves of the tree. The information is then propagated from the leaves to the root in order to provide structure-specific information at each node of the tree. Section II-B will show how to combine the structure-specific information of children nodes to define meaningful structure-specific information of the parent.
The segmentation process, on the other hand, is achieved from top to bottom. The root is segmented into its children using the propagated structure-specific information, then each subtree is further segmented using the output of the higher-level segmentation as its input. The segmentation of each subtree is constrained to a unique ROI that does not overlap with the ROIs associated with the subtrees of the other children. The process is repeated until all leaves have been reached.
This technique has some convenient properties. First, when segmenting a subtree, only a subregion of the image is considered and a few structures are segmented at a time, which simplifies the segmentation problem. Second, the structure-specific information is only stored at the leaves, as the structure-specific information of an inner node is the combination of its children’s structure-specific information. The design of our segmentation framework is also flexible and reduces storage cost.
One drawback of the approach, however, is that it cannot recover from errors made in higher-level segmentations. One might address this issue by using the tree to specify a graphical model for statistical inference, but this is outside of the scope of this article.
Figure 3 shows a schematic representation of how information is propagated in the brain tissue classification example of Figure 2. Our algorithm first defines the task of segmenting the entire MR image into BG and ICC. The method produces the ROIs for ICC (shown in red), and BG (shown in blue). The second segmentation task is defined by the subtree rooted at ICC, thus the ROI of ICC is further segmented into CSF, GM, and WM. Once all leaves have been reached by this recursive process, the segmentation results associated with the leaves separate the entire image into BG, CSF, GM and WM.
Algorithm 1 presents a synoptic view of our tree-based segmentation process. The algorithm takes as its inputs the image I, the root of a tree , the region of interest , and the current label map . By default, the of the initial invocation is the entire image. The algorithm assesses the children of the root, , and the leaves of the tree, . Note, that if is a leaf then . The algorithm segments image I into the set of children over an via SEGMENT(·). SEGMENT(·) is a placeholder for a class of conventional segmenters. These classifiers segment an image into the anatomical structures based on the structure-specific information , which in our case depends on the leaves .
In order to map the tree structure into SEGMENT(·), we now define the function that maps a node of the tree to an index that conforms to the framework of SEGMENT(·). For example in Figure 2, the node BG might be mapped to index 1 and the node ICC to index 2. If is applied to a set of nodes it will return the set of corresponding indices. In the next section, we provide an example for such an algorithm.
After SEGMENT(·) determines a label map for the , a recursive call is made, where each child becomes a root of a sub-tree with a new region of interest defined by the results of the segmentation of the parent. The process stops once all leaves have been visited.
In summary, our algorithm segments the image into the structures of interests by propagating the structure-specific information upwards and the segmentation results downwards.
Algorithm 1.
define ←set of children of root |
define ←set of leaves of tree with root |
define
←set of structure-specific information defined by for nodes in |
update
in with results of Segment(I,,, ) |
for each node in that is not a leaf define ← all voxels x with TreeSegment(I ,,,) |
B. An Anatomically-Guided EM Approach
EM segmentation algorithms have become a popular tool to perform MR image segmentation [7], [9], [13], [17]. They not only segment the image into a label map, which is the unknown data in the EM formulation, but also incorporate an estimation of parameters related to either the image acquisition (e.g., intensity inhomogeneities [7]), or the segmentation process (e.g., atlas registration parameters [36]). To achieve this, the EM algorithm basically alternates between computing the unknown data (its expectation) given the parameters and observed data and refining the estimation of the parameters based on the observed data and the newly computed expected value of the unknown data [37]. We modify the underlying structure of these techniques by incorporating the tree structure as part of the structure-specific information associated with the segmentation problem.
In most voxel-based EM segmenters, the class assignments of the voxels, , are considered to be hidden data, while the image I is observed data, and the parameters θ encompass the image acquisition parameters, usually the effect of the intensity inhomogeneity. At each iteration i, the method improves the estimate θi- of the Maximum A Posteriori (MAP) probability solution by solving the following estimation problem
(1) |
We modify this MAP estimation problem with the data tree structure resulting in an algorithm that can be used for SEGMENT(·), the segmenter in the earlier defined Algorithm 1. Based on Algorithm 1, the input to the algorithm SEGMENT(·) is the image I, the region of interest , the set of indices into which the should be segmented, and a set of structure-specific information that is defined by the tree structure. We incorporate in the probabilistic model of Eq. (1) by expanding the underlying incomplete data model. The observed data is now composed of the image I and the structure-specific data so that Eq. (1) becomes:
(2) |
The voxel class assignments, , are represented by a space-indexed collection of indicator random vectors, , where x represents one of the voxels in the and N stands for the number of structures to be segmented. The vector ej is equal to one at position j, and zero everywhere else. If we assume voxel-wise independence of then the MAP estimation problem changes to
(3) |
where we abbreviate with Σx the sum over all voxels x in the domain .
The expected value in Eq. (3) depends on structure-specific information associated with each child (e.g., a Gaussian intensity model or a spatial probability atlas). As we described in Section II-A, only the leaves contain this information. Thus, the expected value needs to be expressed as the sum over all the indices associated with the leaves of the tree, which we name . The MAP estimation problem then expands to
(4) |
The EM algorithm determines a solution to Eq. (4) in two steps. The Expectation-Step (E-Step) computes the “weight”, which is the posterior probability of an anatomical structure associated with index j being present at a specific voxel x, given the estimate of the parameters θi-1 and the image I. Using Bayes’ rule, the weights are defined as
(5) |
In the class-conditional model on image intensities, represents the intensity model (often defined to be a Gaussian distribution ) and represents space-conditioned probabilities (i.e. a probabilistic atlas) associated with each structure [9]. We provide examples for the two conditional probabilities in the next section.
The second step of the EM algorithm is the Maximization-Step (M-Step), which improves the estimate θi-1 based on the weights :
(6) |
Once the EM process has converged, we need to extract the labeling of the defined at into its substructure. This is achieved by first computing the weight of each child, j ∈ CHILD based on the weights of its leaves:
(7) |
We call hierarchical Weights. We then assign each voxel in the to the index of the child with maximum hierarchical weight:
(8) |
The label map is returned to the hierarchical algorithm as described in Section II-A.
If we now define the structure-specific parameters as - the set of all leaves and the leaves of all c children of the root - then we can replace the function call SEGMENT(·) in Algorithm 1 with the previously developed EM implementation, whose schematic description is given below:
Algorithm 2.
C. Segmenting Different Types of Boundaries
A robust and automatic parcellator for MR images has to accurately model different types of boundaries. For example, the definition of boundaries often depends on the MR acquisition pulse sequence. In Figure 1, the boundary between dura (blue in the label map) and CSF (green) is shown in the T2-weighted image, and the T1-weighted image visualizes the boundary between white matter (red) and the cortical substructures (gray). A segmentation problem is simplified in the existing segmentation framework by restricting each partial segmentation task towards one type of boundary.
However, the current framework does not capture the relationship between the boundaries and their appearances in the observed image data. For example, in the images of Figure 1, the segmentation algorithm guided by the tree structure of Figure 2 first detects the boundary between air and CSF, and subsequently identifies the remaining structures. For both segmentation tasks, the algorithm considers the T1- and T2-weighted images as equally important, which is clearly not the case. This deficiency can negatively bias the results due to image artifacts, such as partial voluming and noise. We address this issue by expanding the hierarchical structure-specific information with “influence parameters” that control the impact of different components of the observed data on the segmentation result.
The choice of influence parameters is closely linked to the specific EM implementation. We confine our discussion to a model similar to Wells et al. [7]. This model is easily adapted to our problem of brain tissue parcellation. We note, however, that the concept of influence parameters can also be integrated into the voxel-based segmenter such as [9], [13].
In [7], the parameter θ captures the image inhomogeneity. Based on this model, the conditional probability is defined to be independent of the parameters and the likelihood only depends on the intensity Ix of image I at voxel x so that Eq. (5) simplifies to
(9) |
If we now ignore the hierarchical parameter then we can define Eq. (9) according to already existing EM models. Using the intensity model by [7], the likelihood is defined as a Gaussian distribution of the intensity Ix with the mean intensity μj and variance Υj of label j, and being the image inhomogeneity at voxel x. Unlike in [7], the prior is spatially varying over the image domain as originally suggested in [9]. This distribution over space is captured by the probabilistic atlas of index j enabling the algorithm to distinguish anatomical structures with similar intensity patterns.
In the remainder of this section we extend the previous discussed distributions to our hierarchical concept within the EM framework, which is summarized by the maximization problem of Eq. (6). We do so by including “influence parameters” controlling the impact of structure-specific information on the segmentation results into and .
1) Intensity-based Confidence Parameters
In general, each input channel in an MR acquisition sequence provides contrast for a different set of boundaries (see Section I). We incorporate this observation into our hierarchical model by controlling the impact of the input channels at each segmentation task. We add to the structure-specific information the vector of intensity based influence-parameters , with defining the influence of input channel k in the segmentation task. We can then extend the original structure-specific Gaussian intensity distribution with by creating the following distribution in a lower dimensional space
(10) |
This model makes the assumption that is of the form , which is equivalent to ignoring all input channels except the kth one. We note that it is straightforward to extend this model to multiple input channels.
We now return to our previous example to show how is adjusted to the two different segmentation tasks described by Figure 2. We define the T1-weighted as the first and the T2-weighted as the second input channel. For the first segmentation task the boundary between background and ICC is clearly defined by the T2-weighted, but not the T1-weighted input channel, which results in ζIMAGE = e2. For the second segmentation task, the boundary between WM, GM, and CSF is clearly outlined by the T1-weighted images, so that the influence parameter is altered to ζICC=e1.
We have now extended the hierarchical framework by the influence parameters that define the influence of the input channels in a given segmentation task.
2) Regulating the Influence of Spatial Priors
Some boundaries are not visible in any of the input channels (see Section I). Our method identifies these boundaries via spatial priors. Spatial priors are also important for distinguishing ROIs with similar intensity patterns. However, they increase the risk of introducing biases in the segmentation results. We address this issue by carefully tailoring the use of spatial prior information to each segmentation task.
We control the impact of spatial priors by altering the definition of in a similar fashion to the conditional intensity probability of the previous section. We add the parameter to the hierarchical parameter definition , where defines the influence of the spatial prior in . The conditional probability for each structure j ∈ Leaf is defined as the convex combination of a stationary prior and the probabilistic atlas
(11) |
where d are the number of indices in Leaf.
In the example of Figure 2, the atlas information is of great importance for the first task because BG and ICC have similar intensity patterns. We therefore set λIMAGE to 1. For the second task, λICC is set close to 0 as the boundaries are clearly defined by the input channels. In addition, the atlas fails to fully capture the relatively large and complex spatial inter-subject variations of each of the three tissue major compartments and therefore would bias the results.
After defining the conditional intensity distribution and the spatial prior, we revisit the definition of the weights. The E-Step, which calculates the weights for each structure j ∈ Leaf defined by Eq. (9), is modified with respect to Eq. (10) and Eq. (11) to
Here, , |·| is the determinant, and Zx is the normalization term, which is the sum over all structures of the products of the conditional intensity probabilities and the conditional spatial probabilities. The impact of these modified distributions on the estimation of the parameters in the M-Step is straightforward.
We complete the discussion of the influence parameters by specifying the structure-specific information of Algorithm 1 to reflect the developments of this section.
is now defined by the sets of leaves {LEAF,LEAF1, . . . ,LEAFc}, the structure-specific intensity parameters {(μ1,Υ1), . . . (μd,Υd)}, the spatial priors for all d leaves, and the influence parameters and .
In summary, we have defined a hierarchical segmentation framework that is guided by structure-specific information arranged as a tree. The tree is organized according to the relationships between anatomical regions. We then integrated a class of EM segmenters into the proposed framework. We further adopted one implementation [7] to increase the robustness of the method by extending the underlying EM model with influence parameters. Our implementation with corresponding source code of the algorithm is publicly available through the 3D Slicer [38], a software tool targeted towards medical imaging. In the remainder of this article we will show that this framework can accurately segment the major compartments as well as certain cortical structures from brain MR images.
III. Results: Revisiting a Schizophrenia Study
Hirayasu et al. [30] performed a brain morphometry study to compare gray matter volumes of ROIs between first-episode schizophrenia patients, first-episode affective psychosis patients, and healthy comparison subjects. First, a semiautomatic process classified the brain MR images into GM, WM, and CSF [39]. These three compartments defined the volume of the ICC that provided an approximate correction factor for global head size. An expert then manually delineated the posterior and anterior region of the superior temporal gyrus, amygdala, hippocampus, and parahippocampal gyrus inside the GM. The volumes of each anatomical structure were computed from the segmentations and used to detect possible morphometric differences between the three groups. The major finding of the analysis was a statistically significant difference in the volume of the left posterior superior temporal gyrus in the schizophrenic group compared to the other two groups.
In order to attempt to evaluate the performance of our hierarchical EM segmentation algorithm, we repeated the entire study using parcellations automatically generated by our new framework. We automatically segment the brain into CSF, WM, GM, superior temporal gyrus, amygdala, and hippocampus on all but one case, whose original data could not be retrieved. We then performed a statistical analysis similar to the one in [30] to detect possible volume differences between groups. The original study divided each anatomical structure into posterior and anterior region. However, this information was not available for the STG.
The study by [30] also included the parahippocampal gyrus, which we did not consider. This decision was made after detecting a low degree of spatial overlap in the data set used for inter-rater reliability in [30]. We measured the overlap through the Dice score [40] of the segmentations of two experts. The parahippocampal gyrus received a mean score of 68%, which was 8% lower than the average score of any other structure.
A. Study Data
The data set consists of 50 subjects: 16 schizophrenia (SZ) patients (13 male, 3 female), 17 affective (AFF) patients (14 male, 3 female; 12 bipolar, manic, 2 bipolar, mixed, 2 major depressive disorder), and 17 comparison (NC) subjects (15 male, 2 female). The acquisition protocol included two MR pulse sequences acquired on a 1.5 Tesla General Electric Scanner (GE Medical Systems, Milwaukee, WI). First, a SPoiled Gradient-Recalled (SPGR) sequence yielded a coronal MR volume of size 256 × 256 × 124 with voxel dimensions 0.9375 × 0.9375 × 1.5 mm3. Second, a double-echo spinecho sequence gave two axial MR volumes (proton density and T2-weighted) of size 256 × 256 × 54 with voxel dimensions 0.9375 × 0.9375 × 3 mm3. For each subject, both axial volumes were co-registered and resampled to the SPGR volume coordinate space using a mutual information rigid registration algorithm [7].
B. Configuring the Hierarchical EM algorithm
1) Designing the Hierarchical Tree
As we have seen in section II-B, the key component to our segmentation technique is the organization of the structure-specific information and segmentation parameters into a tree structure. For our current problem, we describe the segmentation problem using the following hierarchy (Figure 4). First, the root (IMAGE) is separated into BG and ICC. Second, the ICC is partitioned into CSF, GM and WM. Third, GM is subdivided into the right and left superior temporal gyrus (rSTG/lSTG), the right and left amygdala-hippocampus region (rAM-HI/lAM-HI), and “all GM except STG and AM-HI” (GM-other). Finally, rAM-HI is further parcellated into right hippocampus (rHIP) and amygdala (rAMY), and lAM-HI into left hippocampus (lHIP) and amygdala (lAMY).
Next, we populate the tree with the structure-specific information (intensity model and spatial prior, see section II-B) and parameters (confidence in input type and spatial priors, see section II-C) necessary for the segmentation. Following [9] the intensity model is a Gaussian distribution whose mean and variance is learned from the data. The confidence parameters are organized as follows: The segmentation of IMAGE into CSF and ICC relies on the T2-weighted image to better detect the boundary between CSF and dura mater. It makes use of the spatial prior (λIMAGE = 1 in Eq. (11)) so that structures outside the brain with similar intensities of brain tissues do not get included in the ICC. After this step all subsequent segmentations only make use of the SPGR image, as SPGR acquired according to the protocol of Section III-A offers better contrast between GM, WM and CSF. The spatial priors are largely ignored (λICC ≈ 0) in the segmentation of ICC into GM, WM and CSF, because the SPGR images show enough contrast between these structures. The spatial priors, if not perfectly aligned, might also decrease the performance of the segmenter. However, our hierarchical approach relies on the spatial priors for all the deeper levels of the tree as there is very little, if any, contrast between GM substructures in a SPGR and T2-weighted images.
We now have a full description of the algorithm through our tree representation. Unfortunately, the spatial priors needed for our problem are not readily available. We thus build structure-specific information for the specific segmentation problem at hand.
2) Building the Spatial Priors
A spatial prior represents the probability of a structure to be present at a certain location in an image, independent of the input images, intensity model or segmentation parameters. A popular approach to create a prior is to (i) build a probabilistic atlas based on many individual segmentations and (ii) warp this atlas into subject space. The warped atlas is then used as the spatial priors for segmenting the subject’s MR images [19], [41].
The null-hypothesis of the study, which we would like to reject, is that the volumes of the anatomical structures do not significantly differ between the three groups. In this spirit, we generate the atlas only from the manual segmentations associated with the NC group. The atlas is built by first choosing a subject at random within the set of data. This subject is called the template. Second, all subjects from the NC group are individually registered to the template using an affine registration algorithm [42]. The resulting affine transformations are applied to the corresponding manual segmentations. The label specific atlas is then defined by the ratio at each voxel location of the presence of the label within the set of aligned segmentations.
The spatial priors specific to each subject are created by warping the atlas to the subject. The warp is obtained using a B-splines algorithm [27] (based on the original work by Rueckert et al. [25]), which aligns the SPGR image of the template to the SPGR of the subject. Furthermore, we explicitly define the posterior and anterior boundaries across structures via the label maps of [30] as this boundary is defined by anatomical landmarks that were not provided in the training data set. An expert can quickly perform this task by identifying the first slice and the last slice showing the fornix along the border of the lateral ventricle.
As we are trying to reproduce the original study [30], using its manual segmentations to create an atlas for the automatic segmentation clearly introduces a bias with respect to the NC and may lead to overly optimistic evaluation results. Our solution was for subjects belonging to the NC group to remove the associated manual data from the atlas when segmenting the subject. This “leave-one-out” process is commonly used in machine learning to evaluate classification algorithms. Another approach would be to randomly pick a subset of subjects from the group and create an atlas only using these subjects. Unfortunately, our sample size does not permit us to perform this more conservative approach.
We have completed the description of the implementation, whose results for the STG and AM-HI are shown in Figure 5, and we turn to the analysis of its performance.
C. Manual vs. Automatic Segmentations
In order to compare our automatic segmentations to the manual tracings of [30], we performed three types of analysis on the segmentations of all 50 subjects. First, we computed Pearson’s correlation between the manual and automatic methods based on the absolute volume of each structure. Second, we compared manual (MAN) and automatic (AUT) segmentations by computing the volume difference (VD)
where |A| represents the volume of A. VD is scaled between -1 and 1. A negative score corresponds to the automatic segmentation being larger. Third, we measured the spatial overlap between the manual and automatic segmentations using the Dice score [40]. The results of these three metrics applied to our study are shown in Table I.
TABLE I.
Region | Voxel Overlap | Volume Overlap | |
---|---|---|---|
Mean Dice±SD | Mean VD | Pearson (N = 50) | |
lSTG | 0.702 ± 0.035 | -0.022 ± 0.061 | r=0.664, p <0.001 |
| |||
rSTG | 0.693 ± 0.033 | 0.040 ± 0.061 | r=0.620, p <0.001 |
| |||
lAMY | 0.867 ± 0.028 | 0.010 ± 0.065 | r=0.881, p <0.001 |
| |||
rAMY | 0.852 ± 0.030 | -0.021 ± 0.070 | r=0.811, p <0.001 |
| |||
lHIP | 0.808 ± 0.029 | -0.016 ± 0.069 | r=0.724, p <0.001 |
rHIP | 0.813 ± 0.043 | 0.037 ± 0.073 | r=0.618, p<0.001 |
| |||
ICC | - | -0.056 ± 0.005 | r=0.993, p<0.001 |
To help interpret the mean Dice score, we also analyzed the four cases used for inter-rater reliability in [30]. These cases were segmented by the rater of this study as well as two additional experts (see Figure 6). As in the case of the automatic segmentations, we computed the mean Dice score for the two additional experts by comparing their segmentations to the label maps of the rater of this study. The combined score of the two experts as well as the mean score of our automatic method in those four cases are shown in Table II. For each structure, the results of our implementation received slightly lower scores than the manual ones. If we now interpret the Dice score of the experts as an indication for the ambiguity of the boundary location of a structure then the discrepancy between the two types of segmentations is directly linked to this ambiguity. The discrepancy is highest for the left and right STG (6.6% and 4.8%), where the manual raters received the lowest Dice scores (76.7 % and 76.2 %). The discrepancy is lowest for the left amygdala (2.4%), where the experts receive the highest score (87.7%).
TABLE II.
Method | lSTG | rSTG | lAMY | rAMY | lHIP | rHIP |
---|---|---|---|---|---|---|
Manual | 0.767 | 0.762 | 0.877 | 0.873 | 0.862 | 0.857 |
Automatic | 0.701 | 0.714 | 0.853 | 0.830 | 0.826 | 0.828 |
If we now return to Table I, we are pleased to report that the average Dice score ranges quite high from 70% (for STG) to 86% (AMY). The volumes of all structures are highly correlated between manual and automatic groups as VD is, on average, very small, and the p-values of the Pearson’s Correlation for all volumes indicate high correlation between manual and automatic segmentations.
D. Detecting Group Differences from Automatic Segmentations
We saw that the automatic segmentations are highly correlated with the ones used in [30]. We further evaluate our method by performing a statistical analysis on our data to compare diagnostic groups. In the next section, we follow the experimental statistical design of [30] to compare the volumes of our anatomical structures of interest between the schizophrenic (SZ), first-episode affective psychosis (AFF), and normal control (NC) groups.
Statistical Analysis
In order to correct for brain size, the relative volume of each segmented structure was computed by dividing its absolute volume by the ICC volume. We then studied these volumes in a hierarchical statistical framework. First, a mixed-model MANCOVA (Hotelling-Lawley trace) of the relative volumes was performed. The diagnostic (SZ, AFF, NC) was used as the between-subject factor, and side (left and right hemispheres) and region (STG, AMY, HIP) as the within-subject factors. The covariates were age of the subject at the time of the MR acquisition and parental socioeconomic status. This analysis was followed by a one-way ANOVA and post-hoc Least Square Difference (LSD) for each structure individually. Results were considered “significant” for p-values smaller than 0.05 and a “trend” for p-values smaller than 0.1. Table III and Figure 7 summarize the comparison.
TABLE III.
Region | Schizophrenic | Affective | Controlled | One-Factor ANOVA1 | |
---|---|---|---|---|---|
left superior temporal gyrus automatic manual |
0.56 ±0.07%2 0.52 ±0.05% |
0.58 ±0.07% 0.57 ±0.09% |
0.60 ±0.05% 0.58 ±0.07% |
F2,47 = 1.76 F2,47 = 4.183 |
n.s. p = 0.021 |
right superior temporal gyrus automatic manual |
0.55 ±0.08% 0.58 ±0.07% |
0.55 ±0.04% 0.61 ±0.06% |
0.56 ±0.05% 0.62 ±0.09% |
F2,47 = 0.4 F2,47 = 1.337 |
n.s. n.s. |
left amygdala automatic manual |
0.14 ±0.02% 0.15 ±0.03% |
0.13 ±0.02% 0.13 ±0.03% |
0.13 ±0.03% 0.14 ±0.04% |
F2,47 = 2.033 F2,47 = 1.066 |
n.s. n.s. |
right amygdala automatic manual |
0.13 ±0.02%3 0.13 ±0.03% |
0.14 ±0.03% 0.13 ±0.03% |
0.16 ±0.03% 0.15 ±0.03% |
F2,47 = 3.443 F2,47 = 3.253 |
p = 0.040 p = 0.048 |
left hippocampus automatic4 manual |
0.24 ±0.03% 0.23 ±0.03% |
0.27 ±0.03% 0.25 ±0.05% |
0.28 ±0.04% 0.28 ±0.03% |
F2,47 = 5.567 F2,47 = 5.935 |
p = 0.007 p = 0.005 |
right hippocampus automatic manual |
0.26 ±0.03% 0.28 ±0.03% |
0.26 ±0.05% 0.28 ±0.05% |
0.25 ±0.03% 0.28 ±0.03% |
F2,47 = 0.024 F2,47 = 0.099 |
n.s. n.s. |
covariates were the age of the subject at the time of the MR acquisition and the parental socioeconomic status.
A trend for smaller volume in schizophrenic compared to control group (post-hoc test: p = 0.07)
Significantly smaller volume in schizophrenics compared to controls (post-hoc test: p = 0.018)
Significantly smaller volume in schizophrenics compared to controls (post-hoc test: p = 0.002) and affective (post-hoc test: p = 0.024)
The MANCOVA comparison revealed an almost significant group × hemisphere × region interaction (F4,86 = 2.44, p = 0.052). The One-Factor ANOVA showed a significant group difference in the right amygdala (F2,47 = 3.44, p = 0.04) and the LSD revealed a significantly smaller volume in first-episode schizophrenics compared to controls (p = 0.04). The One-Factor ANOVA also revealed a significant group difference in the left hippocampus (F2,47 = 5.567, p = 0.0007) and the LSD revealed a significant smaller volume in first-episode schizophrenics compared to controls (p = 0.002) and first-episode affective psychosis group (p = 0.024). Although no significant results were found for the STG, the LSD test showed a trend of decrease in volume in first-episode schizophrenic compared to controls (p = 0.07).
E. Discussion of the Results
In our comparison study, we observed:
a significantly smaller right AMY in SZ compared to NC,
a significantly smaller left HIP in the SZ group compared to the other two groups,
a trend of smaller left STG in the SZ group than in the NC group.
Our statistical analysis based on automatic segmentations agreed with the manual segmentation results except for the left superior temporal gyrus. This analysis is also consistent with reports in the literature, as the superior temporal gyrus and medial temporal regions (e.g., amygdala-hippocampal complex) are among the most consistently reported regions where schizophrenic patients exhibit volume deficits using both manual ROI methods [3] and Voxel-Based Morphometry (VBM) [43]. Of further note, hippocampal volume deficits are consistently reported in schizophrenia [3], [44]. Functionally, the amygdala is more related to emotional processing, and anatomically the amygdala has substantial neuronal connections with the subgenual anterior cingulate cortex that has been reported to be specifically altered in affective psychosis [45].
Our failure to reproduce the left STG results shows that the framework can still be improved. The STG is a highly convoluted structure, especially in schizophrenia [46], and the spatial prior atlas may contain too much uncertainty to accurately define the boundary. We also note that human raters have more difficulty segmenting this structure than the amygdala-hippocampal complex (see II). We are hopeful that with more data to define the spatial priors and a different tuning of the parameters we will be able to better segment this structure.
One interesting question about using automatic segmenters for this type of study is the impact of the atlas on the results. On the one hand, if one uses one atlas per population in order to get optimal segmentation results, this introduces a bias when performing statistical analysis. On the other hand, if one chooses the conservative approach of building a single atlas based on the segmentations of the NC group (as we did), one risks not properly capturing information specific to a population. One might address this problem by building an atlas based on the 50 subjects via leave-one-out validation. However, this still makes the assumption that a unimodal atlas properly represents the variations across the three groups. Blezek et al. [47] pointed out that populations are often better represented by multiple atlases.
We therefore re-ran the experiment using a separate atlas for each group (see Appendix). The study showed much lower p-values for five of the six structures previously reported in [30] and led to additional discoveries not discussed in [30]. These results, however, cannot be considered unbiased as having a separate atlas for each group can distort the statistics.
We further investigated this hypothesis by segmenting the NC group once with each atlas. If the three atlases did not bias the results then the study should not report any significant differences between the three types of segmentations. This, however, was not the case in this study: with the exception of the left STG, we found significant group differences for five of the six structures. In conclusion, neither using a single atlas nor multiple atlases seemed to properly represent the variations within the data set. This area may benefit from additional research.
In summary, we revisited the study of [30] in order to evaluate the accuracy of our fully automatic parcellator. We recorded similar findings between groups but could not reproduce the result of a smaller left STG in SZ.
IV. Conclusion
We introduced a parcellation algorithm for brain MR images that can be adapted to a wide variety of segmentation scenarios. The algorithm is guided by a tree-structured representation of data that organizes the structure-specific anatomical information. The tree also defines the set of segmentation tasks that are solved by a voxel-based segmenter. The tree structure can be modified and the segmenter can be replaced to adapt our algorithm to other segmentation problems.
We provided an implementation of our parcellation approach using an EM segmenter for brain tissue classification. We modified the approach by expanding its observed data model with our tree structure. In addition, we introduced influence parameters that control the impact of spatial priors and image information at each segmentation subproblem. These new features enabled the brain tissue classifier to further partition the tissue classes into their substructures
We evaluated the accuracy of the implementation by revisiting the study of [30]. The study consists of 50 subjects separated into first-episode schizophrenia, first-episode affective psychosis, and the normal controls. Our study finds similar results for all structures except the left STG, where we detected a trend for a smaller volume in SZ but no statistically significant difference (p=0.07). We discussed how choosing the correct atlas can impact the performance of the algorithm and statistical analysis. We are hopeful that with more training data some of the challenges faced in this study can be overcome. To aid in this effort, we plan on investigating robust ways of computing accurate atlases without biasing the statistical analysis.
V. Acknowledgments
This study was supported, in part, by grants from the National Institute of Health (K05 MH 01110, K02 MH 01110 and R01 MH 50747 to MES, R01 MH 40799 to RWM, and an NIH Roadmap for Medical Research Grant U54 EB005149, MES PI on Core 3, NCRR NAC P41-RR13218,NCRR mBIRN U24-RR021382, NINDS R01-NS051826, NIAAA R01 AA016748-01), the MIND foundation (Albuquerque, NM, RWM), the Brain Science Foundation, and from the Department of Veterans Affairs Merit Awards (MES, RWM), a Research Enhancement Award Program (RWM, MES), and a Middleton Award (RWM) from the Department of Veterans Affairs. T. Rohlfing was supported by the National Institute on Alcohol Abuse and Alcoholism, Grants No. AA05965 and AA13521.
Appendix
We repeated the study of Section III automatically segmenting each case with an atlas associated with the corresponding group. The group-specific atlases were created by applying the instructions of Section III-B.2 to the data set of each group. For example, the atlas for the first-episode schizophrenic was based on segmentations assigned to that group. The results of this study are shown in Table IV.
TABLE IV.
Region | Schizophrenic | Affective | Controlled | One-Factor ANOVA1 | |
---|---|---|---|---|---|
left superior temporal gyrus | 0.55 ±0.07% | 0.61 ±0.07% | 0.62 ±0.04% | F2,47 = 4.64 | p = 0.015 |
right superior temporal gyrus | 0.59 ±0.09% | 0.61 ±0.05% | 0.57 ±0.04% | F2,47 = 0.99 | n.s. |
left amygdala | 0.14 ±0.02% | 0.12 ±0.01%2 | 0.14 ±0.01% | F2,47 = 11.69 | p = 0.0001 |
right amygdala3 | 0.12 ±0.01% | 0.12 ±0.01% | 0.15 ±0.02% | F2,47 = 17.66 | p < 0.0001 |
left hippocampus | 0.21 ±0.02%4 | 0.25 ±0.02% | 0.27 ±0.02% | F2,47 = 35.17 | p < 0.0001 |
right hippocampus | 0.26 ±0.02%5 | 0.28 ±0.02% | 0.27 ±0.02% | F2,47 = 4.04 | p = 0.024 |
covariates were the age of the subject at the time of the MR acquisition and the parental socioeconomic status.
Significantly smaller (post-hoc test: for schizophrenics p < 0.001, control groups p = 0.004).
Significantly smaller in both patient groups compared to the controlled group (post-hoc test: p < 0.001).
Significantly smaller (post-hoc test: affective psychosis p < 0.001, control groups p < 0.001).
Significantly smaller compared to affective psychosis group (post-hoc test: p = 0.016).
The table shows much lower p-values in the One-Factor ANOVA in every structure but the right superior temporal gyrus compared to the manual segmentations reported in Table III. This is coupled with additional findings in the post-hoc analysis. These additional findings are properly due to the bias introduced by segmenting the subjects with group specific atlases.
References
- [1].Styner M, Lieberman JA, McClure RK, Weinberger DR, Jones DW, Gerig G. Morphometric analysis of lateral ventricles in schizophrenia and healthy controls regarding genetic and disease-specific factors. National Academy of Science. 2005;102(13):4872–4877. doi: 10.1073/pnas.0501117102. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [2].Kubicki M, Shenton M, Salisbury D, Hirayusu Y, Kasai K, Kikinis R, Jolesz FA, McCarley RW. Voxel-based morphometric analysis of gray matter in first episode schizophrenia. NeuroImage. 2002;17(4):1711–1719. doi: 10.1006/nimg.2002.1296. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [3].Shenton M, Dickey C, Frumin M, McCarley R. A review of MRI findings in schizophrenia. Schizophrenia Research. 2001;49(1-2):1–52. doi: 10.1016/s0920-9964(01)00163-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [4].McCarley R, Wible C, Frumin M, Fischer I, Shenton M. MRI anatomy of schizophrenia. Biological Psychiatry. 1999;45(9):1099–1119. doi: 10.1016/s0006-3223(99)00018-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [5].Sullivan E, Rose J, Pfefferbaum A. Effect of vision, touch and stance on cerebellar vermian-related sway and tremor: A quantitative physiological and MRI study. Cerebral Cortex. 2006;16:1077–86. doi: 10.1093/cercor/bhj048. [DOI] [PubMed] [Google Scholar]
- [6].Kikinis R, Shenton ME, Gering G, Martin J, Anderson M, Metcalf D, Guttmann C, McCarley RW, Lorensen W, Line H, Jolesz FA. Routine quantitative analysis of brain and cerebrospinal fluid spaces with MR imaging. Magnetic Resonance Imaging. 1992;2(6):619–629. doi: 10.1002/jmri.1880020603. [DOI] [PubMed] [Google Scholar]
- [7].Wells W, Grimson W, Kikinis R, Jolesz F. Adaptive segmentation of MRI data. IEEE Transactions on Medical Imaging. 1996;15:429–442. doi: 10.1109/42.511747. [DOI] [PubMed] [Google Scholar]
- [8].Ballester MG, Zisserman A, Brady M. IEEE Workshop on Biomedical Image Analysis. 1998. Combined statistical and geometrical 3D segmentation and measurement of brain structures; pp. 14–23. [Google Scholar]
- [9].Van Leemput K, Maes F, Vandermeulen D, Suetens P. Automated model-based tissue classification of MR images of the brain. IEEE Transactions on Medical Imaging. 1999;18(10):897–908. doi: 10.1109/42.811270. [DOI] [PubMed] [Google Scholar]
- [10].Warfield S, Rexilius J, Kaus M, Jolesz F, Kikinis R. Adaptive, template moderated, spatial varying statistical classification. Medical Image Analysis. 2000;4(1):43–55. doi: 10.1016/s1361-8415(00)00003-7. [DOI] [PubMed] [Google Scholar]
- [11].Zhang Y, Brady M, Smith S. Segmentation of brain MR images through a hidden Markov random field model and the expectation-maximization algorithm. IEEE Transactions on Medical Imaging. 2001;20(1):45–57. doi: 10.1109/42.906424. [DOI] [PubMed] [Google Scholar]
- [12].Zijdenbos A, Foghani R, Evans A. Automatic ‘pipeline’ analysis of 3D MRI data for clinical trials: Application to multiple sclerosis. IEEE Transactions on Medical Imaging. 2002;21(10):1280–1291. doi: 10.1109/TMI.2002.806283. [DOI] [PubMed] [Google Scholar]
- [13].Marroquin J, Santana E, Botello S. Hidden Markov measure field models for image segmentation. IEEE Transactions on Pattern Analysis and Machine Intelligence. 2003;25:1380–1387. [Google Scholar]
- [14].Grau V, Mewes A, Alcaniz M, Kikinis R, Warfield S. Improved watershed transform for medical image segmentation using prior information. IEEE Transactions on Medical Imaging. 2004;23(4):447–458. doi: 10.1109/TMI.2004.824224. [DOI] [PubMed] [Google Scholar]
- [15].Yang J, Staib LH, Duncan JS. Neighbor-constrained segmentation with level set based 3D deformable models. IEEE Transactions on Medical Imaging. 2004;23(8):940–948. doi: 10.1109/TMI.2004.830802. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [16].Prastawa M, Gilmore J, Lin W, Gerig G. Automatic segmentation of MR images of the developing newborn brain. Medical Image Analysis. 2005;9:457–466. doi: 10.1016/j.media.2005.05.007. [DOI] [PubMed] [Google Scholar]
- [17].Ashburner J, Friston K. Unified segmentation. NeuroImage. 2005;26(3):839–851. doi: 10.1016/j.neuroimage.2005.02.018. [DOI] [PubMed] [Google Scholar]
- [18].Miller MI, Christensen GE, Amit Y, Grenander U. Mathematical textbook of deformable neuroanatomies. Proceedings of the National Academy of Science. 1993;90(24):11 944–11 948. doi: 10.1073/pnas.90.24.11944. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [19].Srivastava S, Maes F, Vandermeulen D, Paesschen WV, Dupont P, Suetens P. Effects of anatomical asymmetry in spatial priors on model-based segmentation of the brain MRI: A validation study. Medical Image Computing and Computer-Assisted Intervention; ser. Lecture Notes in Computer Science; Springer-Verlag. 2004.pp. 327–334. [Google Scholar]
- [20].Collins D, Zijdenbos A, Barre W, Evans A. ANIMAL+INSECT: Improved cortical structure segmentation. Information Processing in Medical Imaging. 1999;1613 [Google Scholar]
- [21].Fischl B, van der Kouwe A, Destrieux C, Halgren E, Segonne F, Salat D, Busa E, Seidman L, Goldstein J, Kennedy D, Caviness V, Makris N, Rosen B, Dale A. Automatically parcellating the human cerebral cortex. Cerebral Cortex. 2004;14:11–22. doi: 10.1093/cercor/bhg087. [DOI] [PubMed] [Google Scholar]
- [22].Thompson P, Hayashi K, Sowell E, Gogtay N, Giedd J, Rapoport J, de Zubicaray G, Janke A, Rose S, Semple J, Doddrell D, Wang Y, van Erp T, Cannon T, Toga T. Mapping cortical change in alzheimer’s disease, brain development, and schizophrenia. NeuroImage. 2004;23:2–18. doi: 10.1016/j.neuroimage.2004.07.071. [DOI] [PubMed] [Google Scholar]
- [23].Tosun D, Rettmann M, Han X, Tao X, Xu C, Resnick S, Pham D, Prince J. Cortical surface segmentation and mapping. NeuroImage. 2004;23:108–118. doi: 10.1016/j.neuroimage.2004.07.042. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [24].Woods R, Grafton S, Holmes C, Cherry S, Mazziotta J. Automated image registration: I. general methods and intrasubject, intramodality validation. Journal of Computer Assisted Tomography. 1998;22:139–152. doi: 10.1097/00004728-199801000-00027. [DOI] [PubMed] [Google Scholar]
- [25].Rueckert D, Sonoda L, Hayes C, Hill D, Leach M, Hawkes D. Non-rigid registration using free-form deformations: Application to breast MR images. IEEE Transactions on Medical Imaging. 1999;18(8):712–721. doi: 10.1109/42.796284. [DOI] [PubMed] [Google Scholar]
- [26].Chen M, Kanade T, Pomerleau D, Schneider JG. 3-D deformable registration of medical images using a statistical atlas. Medical Image Computing and Computer-Assisted Intervention; ser. Lecture Notes in Computer Science; 1999.pp. 621–630. [Google Scholar]
- [27].Rohlfing T, Maurer CR., Jr. Nonrigid image registration in shared-memory multiprocessor environments with application to brains, breasts, and bees. IEEE Transactions on Information Technology in Biomedicine. 2003;7(1):16–25. doi: 10.1109/titb.2003.808506. [DOI] [PubMed] [Google Scholar]
- [28].Carmichael OT, Aizenstein HA, Davis SW, Becker JT, Thompson PM, Meltzer CC, Liu Y. Atlas-based hippocampus segmentation in alzheimer’s disease and mild cognitive impairment. NeuroImage. 2005;27(4):979–990. doi: 10.1016/j.neuroimage.2005.05.005. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [29].Heckemann RA, Hajnal J, Aljabar P, Rueckert D, Hammers A. Automatic anatomical brain MRI segmentation combining label propagation and decision fusion. NeuroImage. 2006;33(1):115–126. doi: 10.1016/j.neuroimage.2006.05.061. [DOI] [PubMed] [Google Scholar]
- [30].Hirayasu Y, Shenton ME, Salisbury D, Dickey C, Fischer IA, Mazzoni P, Kisler T, Arakaki H, Kwon JS, Anderson JE, Yurgelun-Todd D, Tohen M, McCarley RW. Lower left temporal lobe MRI volumes in patients with first-episode schizophrenia compared with psychotic patients with first-episode affective disorder and normal subjects. The American Journal of Psychiatry. 1998;155(10):1384–1391. doi: 10.1176/ajp.155.10.1384. [DOI] [PubMed] [Google Scholar]
- [31].Vincken K, Viergever M. Probabilistic multiscale image segmentation. IEEE Transactions on Pattern Analysis and Machine Intelligence. 1997;19(2):109–120. A.S.E. [Google Scholar]
- [32].Vanhamel I, Pratikakis I, Sahli H. Multiscale gradient watersheds of color images. IEEE Transactions on Image Processing. 2003;12(6):617–626. doi: 10.1109/TIP.2003.811490. [DOI] [PubMed] [Google Scholar]
- [33].Bresson X, Vandergheynst P, Thiran J. Multiscale active contours. International Journal of Computer Vision. 2006;70(3):197–211. [Google Scholar]
- [34].Held K, Kops E, Krause B, Wells W, Kikinis R, Müller-Gärtner H. Markov random field segmentation of brain MR images. IEEE Transactions on Medical Imaging. 1997;16(6):878–86. doi: 10.1109/42.650883. [DOI] [PubMed] [Google Scholar]
- [35].Pham D, Prince J. A generalized EM algorithm for robust segmentation of magnetic resonance images; Conference on Information Sciences and Systems (CISS); 1999.pp. 558–563. [Google Scholar]
- [36].Pohl KM, Fisher J, Grimson W, Kikinis R, Wells W. A Bayesian model for joint segmentation and registration. NeuroImage. 2006;31(1):228–239. doi: 10.1016/j.neuroimage.2005.11.044. [DOI] [PubMed] [Google Scholar]
- [37].McLachlan GJ, Krishnan T. The EM Algorithm and Extensions. John Wiley and Sons, Inc.; 1997. [Google Scholar]
- [38].The 3D Slicer http://www.slicer.org.
- [39].Shenton M, Kikinis R, Jolesz F, Pollak S, LeMay M, Wible C, Hokama H, Martin J, Metcalf D, Coleman M, McCarley R. Abnormalities of the left temporal lobe and thought disorder in schizophrenia. a quantitative magnetic resonance imaging study. New England Journal of Medicine. 1992;327:604–612. doi: 10.1056/NEJM199208273270905. [DOI] [PubMed] [Google Scholar]
- [40].Dice L. Measure of the amount of ecological association between species. Ecology. 1945;26(3):297–302. [Google Scholar]
- [41].Pohl K, Wells W, Guimond A, Kasai K, Shenton M, Kikinis R, Grimson W, Warfield S. Incorporating non-rigid registration into expectation maximization algorithm to segment MR images. Medical Image Computing and Computer-Assisted Intervention; ser. Lecture Notes in Computer Science; Tokyo, Japan: Springer-Verlag. 2002; pp. 564–572. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [42].Warfield S, Rexilius J, Huppi P, Inder T, Miller E, Wells W, Zientara G, Jolesz F, Kikinis R. A binary entropy measure to assess nonrigid registration algorithm. Medical Image Computing and Computer-Assisted Intervention; ser. Lecture Notes in Computer Science; 2001.pp. 266–274. [Google Scholar]
- [43].Honea R, Crow T, Passingham D, Mackay C. Regional deficits in brain volume in schizophrenia: a meta-analysis of voxel-based morphometry studies. American Journal of Psychiatry. 2005;162(12):2233–2245. doi: 10.1176/appi.ajp.162.12.2233. [DOI] [PubMed] [Google Scholar]
- [44].Murray R, Sham P, Os JV, Zanelli J, Cannon M, McDonald C. A developmental model for similarities and dissimilarities between schizophrenia and bipolar disorder. Schizophrenia Research. 2004;71(2-3):405–416. doi: 10.1016/j.schres.2004.03.002. [DOI] [PubMed] [Google Scholar]
- [45].Drevets W, Price J, Simpson J, Todd R, Reich T, Vannier M, Raichle M. Subgenual prefrontal cortex abnormalities in mood disorders. Nature. 1997;386(6627):824–827. doi: 10.1038/386824a0. [DOI] [PubMed] [Google Scholar]
- [46].Park H, Levitt J, Shenton M, Salisbury D, Kubicki M, Kikinis R, Jolesz F, McCarley R. An MRI study of spatial probability brain map differences between first-episode schizophrenia and normal controls. NeuroImage. 2004;22:1231–1246. doi: 10.1016/j.neuroimage.2004.03.009. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [47].Blezek D, Miller J. Atlas stratification. Medical Image Computing and Computer-Assisted Intervention; ser. Lecture Notes in Computer Science; 2006; pp. 712–719. [DOI] [PubMed] [Google Scholar]