Skip to main content
Advertisement
Browse Subject Areas
?

Click through the PLOS taxonomy to find articles in your field.

For more information about PLOS Subject Areas, click here.

  • Loading metrics

Low rank and sparsity constrained method for identifying overlapping functional brain networks

  • Priya Aggarwal ,

    Roles Conceptualization, Data curation, Formal analysis, Investigation, Methodology, Resources, Software, Validation, Visualization, Writing – original draft, Writing – review & editing

    priyaa@iiitd.ac.in

    Affiliation Signal Processing and Bio-medical Imaging Lab (SBILab), Indraprastha Institute of Information Technology-Delhi (IIIT-D), New Delhi, India

  • Anubha Gupta

    Roles Conceptualization, Formal analysis, Funding acquisition, Investigation, Methodology, Project administration, Resources, Supervision, Validation, Visualization, Writing – original draft, Writing – review & editing

    Affiliation Signal Processing and Bio-medical Imaging Lab (SBILab), Indraprastha Institute of Information Technology-Delhi (IIIT-D), New Delhi, India

Abstract

Analysis of functional magnetic resonance imaging (fMRI) data has revealed that brain regions can be grouped into functional brain networks (fBNs) or communities. A community in fMRI analysis signifies a group of brain regions coupled functionally with one another. In neuroimaging, functional connectivity (FC) measure can be utilized to quantify such functionally connected regions for disease diagnosis and hence, signifies the need of devising novel FC estimation methods. In this paper, we propose a novel method of learning FC by constraining its rank and the sum of non-zero coefficients. The underlying idea is that fBNs are sparse and can be embedded in a relatively lower dimension space. In addition, we propose to extract overlapping networks. In many instances, communities are characterized as combinations of disjoint brain regions, although recent studies indicate that brain regions may participate in more than one community. In this paper, large-scale overlapping fBNs are identified on resting state fMRI data by employing non-negative matrix factorization. Our findings support the existence of overlapping brain networks.

Introduction

Functional Connectivity (FC) is a widely used measure to quantify relationship between pairs of brain regions [1, 2]. It is utilized to identify functional brain networks (fBNs) and is useful for understanding intrinsic functional organization of human brain [3, 4]. Therefore, accurate construction of FC is one of the most essential tasks to understand the functioning of complex human brain.

Various analytical methods have been proposed for FC modeling from fMRI data such as Pearson correlation (CORR) [1, 5] and the partial correlation (PCORR) [6, 7]. Pearson correlation (CORR) is the most-widely used method for characterizing FC between different brain regions [1, 5]. Despite its popularity, this method is limited because it reveals the pair-wise relationship between two regions without accounting for the influences of other brain regions [8]. Similarly, PCORR method, i.e., the maximum likelihood estimation (MLE) of the inverse covariance matrix, only captures the pairwise information and therefore, does not fully reflect the interactions among multiple brain regions. To solve this problem, recent methods of estimating FC rely on linear relationships between all brain regions and delineate functional relationships by representing one region’s representative time-series as a linear combination of other regions’ time-series. These methods generally impose sparsity on FC coefficients because a brain region may directly interact with only a fewer other brain regions and thus, force insignificant connections to zero using the sparsity constraint [810]. However, this solution may yield too sparse fBNs owing to division of actual fBNs into smaller communities and hence, does not guarantee extraction of accurate communities or fBNs. Thus, sparsity constraint alone may not capture the modular structure of brain regions belonging to the same community. To address this problem, some previous studies employed both sparse and dense constraints to characterize FC [8, 9]. It is observed that sparsity constraint helps in extracting sparse inter-network connections and denseness helps in extracting dense intra-network connections.

Apart from considering sparsity and denseness constraints, an informative FC graph is essentially low rank [1113], which implies that columns and rows of FC are lying in the lower dimensional space, where rows and columns signify brain regions. Low rank constraint provides a modular structure to fBNs, which is closer to the actual real fBNs [3, 13]. However, none of the existing methods of estimating FC utilize low-rank assumption in the formulation. Inspired by this insight, we propose a new multivariate method for learning FC matrix with an assumption that this matrix is reasonably low rank. In addition, we also impose sparsity constraint to learn sparse fBNs as has been explored in the previous studies [810].

The proposed method is formulated as a convex minimization problem with l1-norm (via sparsity convex surrogate) and nuclear norm (via low rank convex surrogate) constraints. We name the proposed method as Low-Rank Multivariate Vector Regression-based Connectivity (LR-MVRC). We utilize popular Alternating Direction Method of Multipliers (ADMM) for solving the newly proposed objective function because it is widely used for solving joint l1 and nuclear norm problems in different functional magnetic resonance imaging (fMRI) experiments [14, 15].

Second contribution of the proposed work is the identification of overlapping communities. In specific, communities are a group of tightly interconnected brain regions forming functional brain networks. Overlapping communities imply that one brain region might be involved in multiple communities. This sounds plausible because one stimulus, say auditory, may stimulate memory and other functional networks apart from the auditory network. This indicates a need for identifying overlapping communities compared to the commonly identified disjoint communities [16, 17]. A few recent studies in fMRI have indicated the existence of overlapping brain communities, for example, popular Independent Component Analysis (ICA) method in fMRI results in overlapping set of clusters [18]. In addition, a few recent studies based on functional connectivity indeed indicate overlap among various functional brain networks and suggest that brain regions may belong to several communities simultaneously [16, 17, 19, 20]. Although several efforts have been made in this direction, the overlapping community structure of brain networks are still largely unclear. Most of these studies are based on matrix factorization approaches to represent FC matrix into lower dimensional space of size K (i.e. number of communities), where each one of the K dimensions of this space represents association of various brain regions to the corresponding community. Existing methods largely impose external sparsity constraint on this lower dimension space so as to make community inference easy from the perspective of fBNs. However, it is still unclear whether this type of network inference is actually sparse or dense.

Another issue of the existing methods is the utilization of CORR method to build FC, followed by, thresholding on CORR values to retain only a few top connections of FC matrix. This may not be a reasonable assumption. In this work, we utilize full FC matrix to detect overlapping community structure without using any predefined threshold value. In addition, we utilize conventional matrix factorization approach to obtain overlapping fBNs.

Owing to non-negative FC matrix obtained with LR-MVRC, we utilize non-negative matrix factorization (NMF) approach without imposing any external sparsity constraint. NMF is a popular unsupervised machine learning matrix factorization approach [21]. It has been widely used to obtain overlapping communities, especially, in the social networks [2224]. This method has also been applied to neuroimaging data to localize co-varying structural brain regions [25], to characterize brain tumor heterogeneity [26], and to reveal altered default mode network in Attention Deficit Hyperactivity Disorder (ADHD) [27]. In this paper, NMF is used to obtain overlapping communities or fBNs using fMRI data. The non-negativity property retained in NMF is crucial since the interpretation of results becomes straightforward. We utilize publicly available 1000 Functional Connectomes Project resting state fMRI data to show the effectiveness of the proposed method in extracting fBNs on a group of subjects. Please note that fBNs and communities words are used interchangeably from now onwards.

Salient contributions of the proposed work are as follows:

  1. We propose a novel multivariate method for computing FC with sparsity and low-rank constraints.
  2. We extract overlapping communities in contrast to non-overlapping communities extracted in general.

To validate the proposed work, it is compared with two state-of-the-art network-based community detection methods: modularity optimization and independent component analysis (ICA). This paper is organized as follows. Data description, proposed LR-MVRC method, its implementation and framework for detecting overlapping communities are presented in Section 2. Section 3 presents results. In the end, discussion and conclusions are presented in Sections 4 and 5, respectively.

Materials and methods

Data description and preprocessing

Beijing_Zang resting state fMRI data from 1000 Functional Connectomes Project (http://fcon_1000.projects.nitrc.org/) is utilized in this paper. This data was collected by Beijing Normal University and consists of normal subjects (age range: 18-26 years old) scanned for a duration of 7.5 minutes resulting in 225 brain volumes. Each brain volume consists of an acquisition of 33 axial brain slices with dimension 64 × 64. This data has Echo Time (TE) equal to 30 ms and Repetition Time (TR) equal to 2000 ms. We considered all 198 subjects of this dataset in this manuscript.

We carried out standard preprocessing using SPM12 (http://www.fil.ion.ucl.ac.uk/spm/software/spm12/) toolbox as specified in [8]. Preprocessing starts with the removal of first 10 volumes. This initial step is necessary to allow the magnetization to reach the steady state. After this step, other remaining brain volumes are slice time corrected using the middle slice as a reference followed by motion correction. Motion correction ensures reduction of head motion artifact from the signal. Further, spatial normalization onto the Montreal Neurological Institute (MNI) space is performed to facilitate group-level comparisons, followed by, smoothing with a Gaussian kernel with 4 mm full width half maximum (FWHM). Finally, we regressed out nuisance variables (6 head motion parameters, average cerebrospinal fluid (CSF) signal from ventricular masks, and average white matter signal from white matter mask) from each voxel’s time series and performed bandpass filtering in the frequency range of 0.01 to 0.1 Hz to reduce low frequency drift and high frequency noise.

After preprocessing, the whole brain data is parcellated into 90 anatomical regions of interests (ROIs) via automated anatomical labeling (AAL) atlas [28]. In order to find the region-representative time series for every ROI, we averaged time-series of all voxels belonging to the same ROI. This resulted into a matrix X of dimension T × 90, where T denotes the number of time points (or the number of brain volumes) such as 215 for the given fMRI data. Next, we normalized each column of X to obtain unit normalized time-series.

Proposed LR-MVRC

Consider a matrix X of dimension T × N, where T denotes the number of time points and N denotes the number of region of interests (ROIs). Each column of X signifies unit normalized time-series of one brain region. Given this matrix, we require to compute the functional connectivity matrix of dimension N × N. Recently proposed Multivariate Vector Regression-based Connectivity (MVRC) method of identifying FC regresses time series of all regions (i.e. columns of X) onto the time series of other regions multiplied by an FC matrix as [8]. In addition, this method employs elastic-net penalty onto the FC matrix comprising of both l1 and l2 norms. However, to incorporate modular structure of fBNs into FC formulation, we consider nuclear norm constraint along with l1 norm constraint in the computation of this matrix and name the propose method as Low-Rank Multivariate Vector Regression-based Connectivity (LR-MVRC). We formulate the proposed LR-MVRC objective function as: (1) where μ1 and μ2 are the regularization parameters associated with l1 and nuclear norms terms, respectively. Nuclear norm minimization implies l1 penalty on singular values of matrix that supports this matrix to be low-rank. term ensures no self connections in the matrix . Finally, symmetric adjacency matrix from is computed as .

Implementation of LR-MVRC

Next, we introduce the algorithm to solve LR-MVRC problem. We utilize ADMM [29] that splits Eq (1) into multiple subproblems that are easier to solve. We introduce two auxiliary variables Z1 and Z2 for the l1-norm and nuclear norm terms in Eq (1) as: (2)

The augmented Lagrange function for Eq (2) can be written as: (3) where β1, β2 > 0 are the penalty parameters and Y1, Y2 are the Lagrangian multiplier matrices. The above equation consists of three variables , Z1 and Z2. This is to note that during the iterative learning for the solution of in Eq (3), is kept to zero.

ADMM splits Eq (3) into three subproblems as described below. Each subproblem may be treated as minimization over one variable while fixing the other two variables.

Subproblem 1: Solving : (4)

Update of , while other variables are fixed, is performed by solving the above equation as below: (5) where I is an identity matrix. The diagonal elements of obtained from Eq (4) are replaced with zeros.

Subproblem 2: Solving Z1: (6)

Update of Z1, while other variables are fixed, can be done using soft thresholding as: (7) where Soft is the shrinkage thresholding operator defined as [30]: (8) where sgn denotes the signum value and max denotes the maximum value.

Subproblem 3: Solving Z2: (9)

Global minimum of convex nuclear norm minimization is obtained by soft thresholding on singular values, known as singular value thresholding (SVT) [31]. Hence, update of Z2 while other variables are fixed, can be carried out using soft thresholding on singular values of Z2 as: (10) where SVT is defined as: (11) and singular value decomposition of Z2 is defined as U × diag(ν) × VT.

The iterations of LR-MVRC, with update of variables, is described in Algorithm 1.

Algorithm 1. LR-MVRC problem

Input: Data matrix X and parameters μ1, μ2.

Initialize: β1 = β2 = 0.1, βmax = 1010, ρ = 1.1, .

while convergence criteria not met do

 1: Fix the other variables and update by Eq (4)

 2: Fix the other variables and update Z1 by Eq (6)

 3: Fix the other variables and update Z2 by Eq (9)

 4: Update the multipliers by

 5: Update β1 = min(βmax, ρβ1) and β2 = min(βmax, ρβ2).

end while

Output: .

Functional brain network identification

After computing the adjacency matrix, next task is to identify communities or fBNs. Various methods have been proposed to detect communities from FC matrix [32]. Among them, modularity is one of the most popular methods [33]. The widely used modularity method implemented in Brain Connectivity Toolbox [33] yields disjoint communities, i.e., one brain region is part of only one community, although recent studies in fMRI [16] demonstrate that one brain region may participate in multiple communities. Thus, we identify overlapping communities of ROIs. In the next section, we describe the method for detecting overlapping communities.

Detection of overlapping communities.

In this work, we utilize NMF technique to obtain overlapping communities. NMF is a feature extraction and dimensionality reduction method of machine learning, which has been adapted to community detection recently [2224]. This technique factorizes a non-negative input FC matrix A, approximately, into a product of two non-negative matrices as: (12)

The above factorization is carried out with a particular rank K so that P is of dimension N × K and Q is of dimension K × N. This factorization can be viewed as a representation of data in a lower (K) dimensional space. In NMF, matrices P and Q are updated iteratively to improve the approximation to A, while maintaining non-negative matrix entries throughout. For a given K, the algorithm runs iteratively until it finds a good approximate factorization or the stop criterion is met. For a symmetric data matrix A, the factors P and Q can be considered as Q = PT.

In particular, NMF algorithm minimizes the cost function, representing the approximation error between the actual data A and the reduced dimension reconstruction of the data, i.e., PQ. One of the popular cost function is the squared Euclidean distance as described below: (13)

The minimization of the above cost function w.r.t. P ≥ 0 and Q ≥ 0 is a nonconvex problem. This approach can be interpreted as a maximum likelihood estimation with additional non-negativity constraints. However, the implementation details which are necessary to ensure decreasing cost function under the non-negativity constraints seem to be rather complex [34]. In addition, without any other constraint or prior to this problem, solution may lead to unstable convergence, and therefore, good initial values are necessary for more sophisticated NMF algorithms [35, 36]. Different iterative algorithms have been proposed to solve this problem [35]. In general, at each iteration of these algorithms, one matrix is considered to be fixed and the other one is estimated. This process continues until the convergence is achieved. The main idea behind these approaches is that by fixing one matrix, the estimation of the other matrix becomes a convex problem that can be solved easily.

Since NMF, in general, has no unique solution, it is necessary to introduce some additional constraints reflecting some prior knowledge. To this end, recently a Bayesian approach of NMF is proposed that imposes prior distributions on the matrices and leads to unique convergence to solution [37]. In recent overlapping communities detection work [22], it is assumed that the pairwise interaction Aij is generated by a Poisson distribution with rate and shrinkage prior on Pik and Qkj with hyper-parameter βk. These additional constraints help to induce some kind of uniqueness to the NMF solution. Further, this Bayesian NMF approach maximizes posterior density under non-negative constraints. Keeping in view the success of this Bayesian NMF approach for overlapping communities detection, we have utilized algorithm presented in [22] to solve for NMF in this work. This algorithm starts with random initial matrices P and Q, with non-negative weights chosen from a uniform random distribution on the interval [0, 1]. In brief, these matrices are updated iteratively as (14) where is a matrix with hyper-parameters βk on the diagonal. For more details of this algorithm, one may refer to [22]. Code of this algorithm is available online at https://github.com/ipsorakis/commDetNMF. We have set the number of maximum iterations to 100 as has been done in [22]. This is to note that we ran the algorithm ten times with random initial matrices. The solution converged to the same output matrices with some columns exchanged.

Most experiments show that the matrix P represents the final clustering partition. In our work, we mainly utilized matrix P to determine overlapping communities of the input FC matrix. This is to note that each column of matrix P defines one community and hence, K denotes the total number of communities. Each column of P indicates the extent to which any brain region i belongs to that community. Thus, we compared each column of P with a threshold and if the value of region i is more than the threshold, region i is considered to be a part of that community. Similarly, if a region’s value is less than the threshold, we delete that region from the corresponding community. Further details about selection of this threshold is provided in the Results Section.

Thresholding of each column of P independently allows brain regions to be a part of multiple communities simultaneously and hence, detects overlapping communities. The NMF approach of detecting communities is already used in the literature of social networks. However, their use in brain networks is limited so far.

Choosing number of K communities.

NMF algorithm requires a given value of dimensionality K that is an important input used in matrix factorization. However, determining the value of K is a challenge in most community discovery algorithms because the number of communities K is not known in advance. If K is too small, some communities will be very large (in terms of more number of regions) with random grouping of ROIs. On the contrary, if K is too large, communities will be randomly scattered and will be very small.

To determine the number of communities K, we used NMF for two different numbers of communities 8 and 15. We chose 8 number of communities because, in general, the following eight brain networks are observed in the resting state fMRI data: Visual Network (VN), Somato-motor Network (SMN), Auditory Network (AN), Cognitive Control Network (CCN), Bilateral Limbic Network (BLN), Language Network (LN), Subcortical Network (SCN), and Default Mode Network (DMN). We chose to extract 15 number of communities because we would like to ascertain if choosing a number larger than the expected number of communities yields scattered networks.

Results

We utilized X and computed adjacency matrix using Eq (1) for all subjects. We used μ1 = 0.25 in Eq (1) as was utilized previously in [8] and the value of μ2 is decided empirically to be equal to 0.1. This value is decided based on the correspondence of identified fBNs with the ground truth atlas labels. We averaged LR-MVRC FC matrices of all subjects and utilized NMF to obtain communities.

Comparison of FC methods

In this section, we evaluate the feasibility and the robustness of the proposed LR-MVRC method w.r.t. traditional methods discussed below.

  • Pearson correlation (CORR): This is simply a pairwise correlation between two brain regions’ time series. Pearson correlation coefficients are computed between all 90 ROIs (extracted from AAL atlas), resulting in a 90 × 90 FC matrix. All negative values are flipped to positive values and all diagonal entries are set to zeros, as is usually done in fMRI FC analysis using CORR [38].
  • Partial correlation (PCORR): Partial correlation values are assumed to be equivalent to the inverse of covariance matrix and also known as the precision matrix. Thus, first the covariance matrix is computed. Next, inverse of this matrix provides partial correlation values. However, computation of inverse is itself challenging because of low rank nature of the covariance matrix. Generalized inverse or pseudo-inverse methods have been generally used to compute partial correlation.
  • MVRC method [8]: MVRC method has been explained in methods section and is implemented as specified in [8].

We averaged each method’s FC matrices across all subjects and compared them w.r.t. various graph theoretical measures [39]. Degree was calculated as the sum of weighted edges connecting to a node i as Di = ∑j Aij. Similarly, participation coefficient (PC) arising from modularity community assignment was computed as , where Dis is the number of edges of node i to nodes in module s, Di is the degree of node i, and Nm is the total number of modules in the graph. We also computed another graph theoretical measure, i.e., betweenness centrality (BC), averaged over all 90 AAL brain regions, whose high value signifies the network to be highly central or modular. In fact, it is a network centrality measure that represents the fraction of all shortest paths in the network that pass through a given node [33].

LR-MVRC matrix in this study is extracted using l1 and low rank constraints, while MVRC FC matrix in [8] was extracted using l1 and l2 constraints. As a result, we noticed that while MVRC had more connections due to the denseness imposed by l2 norm constraint, LR-MVRC had fewer higher magnitude connections compared to MVRC due to the low rank constraint. However, these fewer connections of LR-MVRC weighed higher than those of MVRC. In addition, we observed same degree in both the matrices, LR-MVRC FC and MVRC FC, since we did not apply any thresholding on FC matrices. Participation coefficients (of size 90 that is equal to the number of AAL brain regions) arising from the modularity community assignment using both the methods are statistically compared using the two-sample t-test with significance level of 0.05. Altered PC were observed between both the matrices (p<0.05). Further, we observed BC of LR-MVRC to be more (=128) compared to that of MVRC (=96). In conclusion, these findings indicate that the LR-MVRC FC matrix is more modular or central compared to MVRC FC.

Further, on comparing LR-MVRC method with the CORR and PCORR methods, we observed same degree with both the matrices, since we did not apply any thresholding on FC matrices. In addition, we observed PC using CORR and PCORR methods to be statistically different w.r.t. the proposed LR-MVRC method, suggesting that the FC matrices obtained by the three methods are statistically different (p<0.05). These results are consistent with the findings on LR-MVRC and MVRC methods as discussed previously, although this is to note that we obtained fewer number of communities using modularity with CORR and PCORR methods with no community signifying any functional brain network structure. Further details regarding this comparison is presented in the next section. Furthermore, analysis of the average BC showed lesser values among the CORR and PCORR methods compared to the proposed LR-MVRC method. These results indicated that there are structural differences among the networks constructed by the three methods.

Competing methods.

Modularity optimization is a leading method aimed at finding optimal non-overlapping partitions of fBNs based on modularity function [40]. Unlike NMF that finds overlapping communities, modularity optimization results in non-overlapping communities. We performed modularity optimization on the averaged LR-MVRC adjacency matrices by using the Louvain method implemented in the Brain Connectivity Toolbox [33].

Principal and independent component analysis (PCA, ICA) are some other matrix factorization methods commonly used for projecting data into lower dimensional representation, from which the overlapping communities structure could be identified [41]. These factorization methods impose different constraints or priors in order to obtain a solution, e.g., components must be orthogonal in PCA and must be independent in ICA. The ICA method is being extensively used in fMRI and it computes independent components directly on fMRI time-series and identifies overlapping communities. In this paper, fMRI time-series of all subjects are concatenated temporally and the dimensionality is reduced by using PCA [18]. PCA is generally used before ICA for dimensionality reduction. The resulting fMRI time-series data is fed into the fastICA algorithm [42] implemented by the FastICA software (https://research.ics.aalto.fi/ica/fastica/).

To further test the performance of the proposed LR-MVRC FC identification method, all fBNs identification methods, i.e., NMF and modularity optimization are also carried out on the FC matrix constructed using the Pearson correlation (CORR). Specifically, for each pair of ROIs, Pearson correlation is used as a metric to compute the FC. Next, we averaged CORR adjacency matrices of all subjects and utilized it to obtain communities.

Results on fMRI dataset.

Based on the analyses of LR-MVRC and CORR FC matrices, the overall community structure obtained by NMF and modularity are shown in Fig 1. The matrices P obtained using LR-MVRC and CORR matrices with K = 8 and 15 in NMF are shown in first two columns of Fig 1. Visually, LR-MVRC matrices yield sparse overlapping community structures, while the ones derived using CORR matrices are also overlapping but are extremely dense. More sparsity, or in other words, fewer high valued coefficients in each column of matrix P results in accurate fBN identification by applying thresholding as described in the previous section. We considered mean plus standard deviation of each column of matrix P as a threshold value for that column or community. Modularity optimization method (refer to third column of Fig 1) achieves greatest sparsity among all methods, but this method results in non-overlapping communities. This is to note that this method does not require pre-defined number of communities unlike the NMF method. Using this method, CORR based FC matrix could identify only 4 communities compared to 10 communities detected with LR-MVRC based FC matrix.

thumbnail
Fig 1.

First row: Community structure obtained using LR-MVRC and CORR matrices with NMF and modularity optimization methods. Second row: Community structure obtained using ICA with K = 8 and 15 in the first and second columns, respectively. In the first row, first two columns represent the matrix P obtained from LR-MVRC and CORR with K = 8 and 15 in NMF, respectively. The third column represents modularity optimization results on both LR-MVRC and CORR based adjacency matrices.

https://doi.org/10.1371/journal.pone.0208068.g001

In the second row of Fig 1, we show the community structure derived by ICA. The first and the second columns of this row display the overall community structures identified with K = 8 and 15, respectively. For ICA method, group-level community structure is derived by concatenating fMRI time-series of all subjects. Here, the number of communities K for ICA methods were set according to the values chosen for NMF method in this paper. Visually, the communities derived by ICA show an overlapping structure, but they tend to produce a much denser result with only a few high or negative coefficients values. It reveals that ICA method achieves a moderate similarity to NMF method since this method works directly on the time-series instead of first extracting FC matrix as is done in the NMF method.

To depict sparsity differences between NMF results of LR-MVRC, CORR and PCORR more accurately, we plot sorted coefficients of matrix P in Fig 2. We plot results for both 8 and 15 value of K in NMF. From this figure, we observe that for each value of K, LR-MVRC based results are more sparse with only a few non zero coefficients compared to those extracted from CORR and PCORR FC matrices.

thumbnail
Fig 2. Illustration of sparsity of matrix P obtained with NMF.

Plot of sorted coefficients of matrix P, obtained using LR-MVRC, CORR and PCORR matrices with different values of K in NMF.

https://doi.org/10.1371/journal.pone.0208068.g002

Further, to explore the neuro-physiological interpretations of identified communities with LR-MVRC (refer to Table 1) and CORR, we mapped the identified communities corresponding to K = 8 onto the human brain, as shown in Figs 3 and 4. Fig 3 displays the communities derived by LR-MVRC based on the thresholding on matrix P. Eight communities derived by LR-MVRC shown in this figure refer to default mode and subcortical (C1), visual (C2), bilateral limbic (C3), cognitive control and default mode (C4), default mode and visual (C5), auditory and motor (C6), subcortical (C7), and default mode and bilateral limbic (C8) networks. These networks are highly consistent with several well-recognized resting state fBNs discovered by previous studies [4346]. In essence, two communities (C2, C5) are related to the visual information processing, one community (C6) is related to the auditory information processing, four communities (C1, C4, C5 and C8) are associated with the well-known default mode network (DMN), and one (C6) is associated with the motor network. C1 and C7 correspond to the subcortical network. In addition, bilateral limbic network (C3 and C8) and cognitive control network (C4), associated with high-order brain functions are readily identified. Whereas, it is noted from Fig 4 that ROIs associated with different fBNs are clubbed in a single community, showing random grouping of ROIs. This causes difficulty in the interpretation of identified communities as valid fBNs.

thumbnail
Table 1. Brain networks identified using LR-MVRC with K = 8 in NMF.

Fourth column represent AAL atlas ROI indices belonging to the community K, whereas second and third columns represent the associated brain networks and number of ROIs in that community, respectively.

https://doi.org/10.1371/journal.pone.0208068.t001

thumbnail
Fig 3. Overlapping communities derived from LR-MVRC.

This figure displays the communities derived from the LR-MVRC based adjacency matrix via thresholding of matrix P obtained with NMF (K = 8). Eight communities derived from LR-MVRC matrix shown in this figure refer to default mode and subcortical (C1), visual (C2), bilateral limbic (C3), cognitive control and default mode (C4), default mode and visual (C5), auditory and motor (C6), subcortical (C7), and default mode and bilateral limbic (C8) networks.

https://doi.org/10.1371/journal.pone.0208068.g003

thumbnail
Fig 4. Overlapping communities derived from CORR.

This figure displays the communities derived using CORR based matrix via thresholding of matrix P obtained with NMF (K = 8).

https://doi.org/10.1371/journal.pone.0208068.g004

Non overlapping communities derived from LR-MVRC (see Fig 5) refer to motor (C1), visual (C2), default mode and cognitive control (C3), default mode (C4), subcortical (C5), bilateral limbic (C6), default mode and bilateral limbic (C7), cognitive control (C8), subcortical (C9) and auditory networks, which are consistent with the overlapping communities detected with LR-MVRC method (see Fig 3).

thumbnail
Fig 5. Non overlapping communities derived from LR-MVRC.

This figure displays the communities derived using LR-MVRC based matrix via modularity optimization. Ten communities derived by LR-MVRC shown in this figure refer to motor (C1), visual (C2), default mode and cognitive control (C3), default mode (C4), subcortical (C5), bilateral limbic (C6), default mode and bilateral limbic (C7), cognitive control (C8), subcortical (C9) and auditory networks.

https://doi.org/10.1371/journal.pone.0208068.g005

Apart from considering K = 8 in NMF with LR-MVRC, we also present results with K = 15 in Table 2. Fifteen communities derived by LR-MVRC shown here refer to default mode and subcortical (C1), default mode and bilateral limbic (C2), bilateral limbic and subcortical (C3), default mode and subcortical (C4), motor and auditory (C5), motor and subcortical (C6), default mode and subcortical (C7), default mode and subcortical (C8), coginitive control, bilateral limbic and default mode (C9), default mode and subcortical (C10), default mode (C11), bilateral limbic (C12), cognitive control and default mode (C13), visual (C14), and default mode and subcortical (C15) networks, which are consistent with several well-recognized fBNs discovered by previous studies. This is to note that the similarity observed in the four communities (C4, C7, C10 and C15) in Table 2 points to the fact that lesser value of K should have been used in the method. A value larger than required shows repeated communities, signifying that no better partitioning can happen. This observation can work as an initial criterion to decide the parameter K in the NMF method.

thumbnail
Table 2. Brain networks identified using LR-MVRC with K = 15 in NMF.

Fourth column represent AAL atlas ROI indices belonging to the community K, whereas second and third columns represent their corresponding associated brain networks and number of ROIs in one community, respectively.

https://doi.org/10.1371/journal.pone.0208068.t002

We further looked regions belonging to more than one community in LR-MVRC based NMF results. It reveals that regions involved in more than one community span over default mode, subcortical, bilateral limbic and visual networks. By contrast, regions related to sensori-motor and auditory participate in fewer communities.

Effect of community number K

Parameter K is the number of communities in the NMF method. On varying the value of K, different fBN structures/communities are observed. Increasing the number K allows us to represent more and more functional communities formed in the brain (refer to Table 2 with K = 15). However, as the number of communities increases, we move from underfitting to overfitting community structures, i.e., we face the trade-off between approximating complex brain structures and overfitting them, potentially capturing noise or redundant brain networks.

By starting with a large K (say 15, which is possibly double the number of communities in human brain), the effect of considering a higher number of communities can be accounted by ignoring redundant number of communities that correspond to similar fBNs. For example, four communities in Table 2 are identical and correspond to default mode and subcortical networks.

Discussion

In this paper, we propose LR-MVRC method to build functional connectivity using sparsity and low rank constraints. It is a multivariate FC estimation method that has attracted great attention in the brain fMRI literature recently [810]. As a matter of fact, CORR method which exists for FC estimation for almost two decades, considers a pair of two regions while studying functional connection between them. However, this pairwise relationships only reflects the second-order relationships between brain regions without accounting for high-order relationships which is crucial for understanding complex brain networks architecture. To this end, the proposed multivariate method considers all regions simultaneously and regresses one region’s time series onto all other regions’ time series and hence, is named as multivariate regression framework. In addition, besides identifying non-overlapping fBNs, we have used NMF in this work to identify overlapping functional community structure using the resting-state fMRI data.

Experimental results show that the proposed framework is capable of identifying underlying overlapping fBN organization of the human brain. We observe that the proposed method results in multiple fBNs such as Visual Network (VN), Somato-motor Network (SMN), Auditory Network (AN), Cognitive Control Network (CCN), Motor Network (MN), Subcortical Network (SCN), and Default Mode Network (DMN). These networks in resting state fMRI have been consistently identified in previous studies ([46, 47] and references within).

In this paper, we adopted region parcellation and numbering corresponding to the 90 AAL ROIs for the definition of nodes and subsequent construction of fBNs. Multiple studies in fMRI have utilized different node definitions by using clustering or ICA-based methods. The nodes in these studies mainly include the default mode, cognitive control, visual, auditory, subcortical and bilateral limbic networks, which are largely in accordance with the communities identified by LR-MVRC method in this paper.

More importantly, the overlapping communities derived by LR-MVRC with NMF are neuro-physiologically meaningful and comparable to the communities derived using the other most famous modularity optimization methods in the fMRI literature. On visualizing results, we observe that most communities detected by NMF on LR-MVRC FC matrix also appear in the results derived by modularity optimization. However, the most prominent difference is that NMF is able to capture more realistic communities because it allows overlapping communities, say, in default mode, subcortical, bilateral limbic and visual networks. In particular, the identified overlapping regions are mostly found to be the part of frontal, parietal, and temporal brain regions. Similar findings have been previously reported in a few recent studies [48, 49]. On the other hand, the sensory-motor and auditory networks are observed to be formed as disjoint communities as regions associated with these networks are being reported to have high within connectivity [5052].

ICA method works directly on fMRI time series and produces independent components or activation maps. ICA based analysis requires expertise for rejecting components corrupted with ventricle effects, movement artifacts and sparsely-distributed noises. For example, if K or the number of ICA components is large, it requires to discard extra noisy components (components that may not be relevant to contain fBNs). In general, the findings can be contested, particularly, if these are to be used in clinical applications because one may reject wrong components. In this context, LR-MVRC with NMF provides a complementary method to investigate overlapping community structure of the human brain without going through such a dilemma.

Limitation and future work

The overlapping community structure explored by the proposed method can result in a better understanding of the group-level functional brain networks. However, capturing and analysis of individual subject’s differences could be more useful in understanding individual brain architecture.

A limitation of NMF method is that the performance of NMF depends on its initialization of K to some extent. In this paper, the value of K in NMF algorithm is initialized based on our prior knowledge of the number of fBNs. Although this is the most popular and simple initialization strategy for NMF methods, it is still a constraint of this algorithm compared to the conventional community detection methods, such as modularity optimization, that do not require any pre-specified K. These alternative strategies may lead to faster convergence of the algorithm. Thus, there should be an attempt to auto-detect the number of communities K in NMF algorithm.

In this work, thresholded membership value of nodes is used as a deciding factor for the consideration of nodes in the corresponding community. However, this approach does not provide a clear node membership to each overlapping community. Therefore, methods accounting for crisp partitions, allowing each nodes’ contribution to multiple communities are required to be considered in the future works. A few studies have attempted to consider this [53, 54], although these methods do not provide information about nodes’ membership to each community. Owing to this, more sophisticated methods that combine the advantages of both the above mentioned approaches can provide more useful information about the fBNs architecture [24].

Finally, the functional brain imaging data alone may not be sufficient to gain a comprehensive understanding of the brain’s functional organization. A multimodal data combination and analysis of human brain may provide better knowledge about the underlying networks’ organization and guide us to a deeper understanding of the human brain.

Conclusions

In this work, we propose a Low Rank Multivariate Vector Regression-based Connectivity (LR-MVRC) method for estimating FC matrix. Proposed method utilizes both sparsity and low rank constraints while estimating the FC matrix. Most of the previous studies extract disjoint communities or functional brain networks, we extract overlapping communities via NMF that may be biologically more correct for understanding human brain’s functional organization. Experimental results suggest that the proposed framework can better characterize the brain networks’ organization at the group level. In conclusion, we believe that the proposed method and its potential applications could provide new insights into the functional networks’ organization of the human brain.

References

  1. 1. Smith SM, Miller KL, Salimi-Khorshidi G, Webster M, Beckmann CF, Nichols TE, et al. Network modelling methods for FMRI. NeuroImage. 2011;54(2):875–891. http://dx.doi.org/10.1016/j.neuroimage.2010.08.063. pmid:20817103
  2. 2. Biswal B, Zerrin Yetkin F, Haughton VM, Hyde JS. Functional connectivity in the motor cortex of resting human brain using echo-planar MRI. Magn Reson Med. 1995;34(4):537–541. pmid:8524021
  3. 3. Sporns O. Networks of the Brain. MIT press; 2010.
  4. 4. Friston KJ. Functional and Effective Connectivity: A Review. Brain Connectivity. 2011;1(1):13–36. pmid:22432952
  5. 5. Hampson M, Peterson BS, Skudlarski P, Gatenby JC, Gore JC. Detection of functional connectivity using temporal correlations in MR images. Human Brain Mapping. 2002;15(4):247–262. pmid:11835612
  6. 6. Marrelec G, Horwitz B, Kim J, Pélégrini-Issac M, Benali H, Doyon J. Using partial correlation to enhance structural equation modeling of functional MRI data. Magnetic Resonance Imaging. 2007;25(8):1181–1189. https://doi.org/10.1016/j.mri.2007.02.012. pmid:17475433
  7. 7. Salvador R, Suckling J, Coleman MR, Pickard JD, Menon D, Bullmore E. Neurophysiological Architecture of Functional Magnetic Resonance Images of Human Brain. Cerebral Cortex. 2005;15(9):1332–1342. pmid:15635061
  8. 8. Aggarwal P, Gupta A, Garg A. Multivariate brain network graph identification in functional MRI. Medical Image Analysis. 2017;42:228–240. https://doi.org/10.1016/j.media.2017.08.007. pmid:28866433
  9. 9. Li X, Wang H. Identification of functional networks in resting state fMRI data using adaptive sparse representation and affinity propagation clustering. Frontiers in Neuroscience. 2015;9:383. pmid:26528123
  10. 10. Yu R, Zhang H, An L, Chen X, Wei Z, Shen D. Connectivity strength-weighted sparse group representation-based brain network construction for MCI classification. Human Brain Mapping. 2017;38(5):2370–2383. pmid:28150897
  11. 11. Hirayama Ji, Hyvärinen A, Ishii S. Sparse and low-rank matrix regularization for learning time-varying Markov networks. Machine Learning. 2016;105(3):335–366.
  12. 12. Precup D, Bachman P. Improved Estimation in Time Varying Models. In: Proceedings of the 29th International Conference on Machine Learning. ACM; 2012. p. 1459–1466.
  13. 13. Qiao L, Zhang H, Kim M, Teng S, Zhang L, Shen D. Estimating functional brain networks by incorporating a modularity prior. NeuroImage. 2016;141:399–407. https://doi.org/10.1016/j.neuroimage.2016.07.058. pmid:27485752
  14. 14. Aggarwal P, Gupta A. Accelerated fMRI reconstruction using Matrix Completion with Sparse Recovery via Split Bregman. Neurocomputing. 2016;216:319–330. https://doi.org/10.1016/j.neucom.2016.08.016.
  15. 15. Song X, Lu H. Multilinear Regression for Embedded Feature Selection with Application to fMRI Analysis. In: AAAI; 2017. p. 2562–2568.
  16. 16. Najafi M, McMenamin BW, Simon JZ, Pessoa L. Overlapping communities reveal rich structure in large-scale brain networks during rest and task conditions. NeuroImage. 2016;135:92–106. https://doi.org/10.1016/j.neuroimage.2016.04.054. pmid:27129758
  17. 17. Pessoa L. Understanding brain networks and brain organization. Physics of Life Reviews. 2014;11(3):400—435. https://doi.org/10.1016/j.plrev.2014.03.005. pmid:24819881
  18. 18. Smith SM, Miller KL, Moeller S, Xu J, Auerbach EJ, Woolrich MW, et al. Temporally-independent functional modes of spontaneous brain activity. Proceedings of the National Academy of Sciences. 2012;109(8):3131–3136.
  19. 19. Eavani H, Satterthwaite TD, Filipovych R, Gur RE, Gur RC, Davatzikos C. Identifying Sparse Connectivity Patterns in the brain using resting-state fMRI. NeuroImage. 2015;105:286–299. https://doi.org/10.1016/j.neuroimage.2014.09.058. pmid:25284301
  20. 20. Li X, Gan JQ, Wang H. Collective sparse symmetric non-negative matrix factorization for identifying overlapping communities in resting-state brain functional networks. NeuroImage. 2018;166:259–275. https://doi.org/10.1016/j.neuroimage.2017.11.003. pmid:29117581
  21. 21. Lee DD, Seung HS. Learning the parts of objects by non-negative matrix factorization. Nature. 1999;401:788. pmid:10548103
  22. 22. Psorakis I, Roberts S, Ebden M, Sheldon B. Overlapping community detection using bayesian non-negative matrix factorization. Physical Review E. 2011;83(6):066114.
  23. 23. Yang J, Leskovec J. Overlapping Community Detection at Scale: A Nonnegative Matrix Factorization Approach. In: Proceedings of the Sixth ACM International Conference on Web Search and Data Mining; 2013. p. 587–596.
  24. 24. Zhang ZY, Wang Y, Ahn YY. Overlapping community detection in complex networks using symmetric binary matrix factorization. Phys Rev E. 2013;87:062803.
  25. 25. Sotiras A, Resnick SM, Davatzikos C. Finding imaging patterns of structural covariance via Non-Negative Matrix Factorization. NeuroImage. 2015;108:1–16. https://doi.org/10.1016/j.neuroimage.2014.11.045. pmid:25497684
  26. 26. Sauwen N, Sima DM, Van Cauter S, Veraart J, Leemans A, Maes F, et al. Hierarchical non-negative matrix factorization to characterize brain tumor heterogeneity using multi-parametric MRI. NMR in Biomedicine;28(12):1599–1624. pmid:26458729
  27. 27. Anderson A, Douglas PK, Kerr WT, Haynes VS, Yuille AL, Xie J, et al. Non-negative matrix factorization of multimodal MRI, fMRI and phenotypic data reveals differential changes in default mode subnetworks in ADHD. NeuroImage. 2014;102:207–219. https://doi.org/10.1016/j.neuroimage.2013.12.015. pmid:24361664
  28. 28. Tzourio-Mazoyer N, Landeau B, Papathanassiou D, Crivello F, Etard O, Delcroix N, et al. Automated Anatomical Labeling of Activations in SPM Using a Macroscopic Anatomical Parcellation of the MNI MRI Single-Subject Brain. NeuroImage. 2002;15(1):273–289. pmid:11771995
  29. 29. Boyd S, Parikh N, Chu E, Peleato B, Eckstein J. Distributed optimization and statistical learning via the alternating direction method of multipliers. Foundations and Trends® in Machine Learning. 2011;3(1):1–122.
  30. 30. Selesnick IW. Sparse Signal Restoration; 2010.
  31. 31. Cai JF, Candès EJ, Shen Z. A Singular Value Thresholding Algorithm for Matrix Completion. SIAM J on Optimization. 2010;20(4):1956–1982.
  32. 32. Sporns O, Betzel RF. Modular brain networks. Annual review of psychology. 2016;67:613–640. pmid:26393868
  33. 33. Rubinov M, Sporns O. Complex network measures of brain connectivity: Uses and interpretations. NeuroImage. 2010;52(3):1059–1069. http://dx.doi.org/10.1016/j.neuroimage.2009.10.003. pmid:19819337
  34. 34. Sra S, Dhillon IS. Nonnegative matrix approximation: Algorithms and applications. Computer Science Department, University of Texas at Austin; 2006.
  35. 35. Cichocki A, Zdunek R, Phan AH, Amari SI. Nonnegative Matrix and Tensor Factorizations: Applications to Exploratory Multi-Way Data Analysis and Blind Source Separation. John Wiley & Sons, Ltd; 2009.
  36. 36. Zheng Z, Yang J, Zhu Y. Initialization enhancer for non-negative matrix factorization. Engineering Applications of Artificial Intelligence. 2007;20(1):101–110. https://doi.org/10.1016/j.engappai.2006.03.001.
  37. 37. Schmidt MN, Winther O, Hansen LK. Bayesian non-negative matrix factorization. In: International Conference on Independent Component Analysis and Signal Separation. Springer; 2009. p. 540–547.
  38. 38. Power J, Cohen A, Nelson S, Wig G, Barnes K, Church J, et al. Functional Network Organization of the Human Brain. Neuron. 2011;72(4):665–678. pmid:22099467
  39. 39. Rubinov M, Sporns O. Weight-conserving characterization of complex functional brain networks. NeuroImage. 2011;56(4):2068–2079. https://doi.org/10.1016/j.neuroimage.2011.03.069. pmid:21459148
  40. 40. Newman MEJ, Girvan M. Finding and evaluating community structure in networks. Phys Rev E. 2004;69(2):026113.
  41. 41. Calhoun VD, Adali T, Pearlson GD, Pekar J. A method for making group inferences from functional MRI data using independent component analysis. Human brain mapping. 2001;14(3):140–151. pmid:11559959
  42. 42. Hyvarinen A. Fast and robust fixed-point algorithms for independent component analysis. IEEE Transactions on Neural Networks. 1999;10(3):626–634. pmid:18252563
  43. 43. Barkhof F, Haller S, Rombouts SARB. Resting-State Functional MR Imaging: A New Window to the Brain. Radiology. 2014;272(1):29–49. pmid:24956047
  44. 44. Zuo XN, Kelly C, Adelstein JS, Klein DF, Castellanos FX, Milham MP. Reliable intrinsic connectivity networks: Test retest evaluation using ICA and dual regression approach. NeuroImage. 2010;49(3):2163–2177. https://doi.org/10.1016/j.neuroimage.2009.10.080. pmid:19896537
  45. 45. Smith SM, Fox PT, Miller KL, Glahn DC, Fox PM, Mackay CE, et al. Correspondence of the brain’s functional architecture during activation and rest. Proceedings of the National Academy of Sciences. 2009;106(31):13040–13045.
  46. 46. van den Heuvel MP, Pol HEH. Exploring the brain network: A review on resting-state fMRI functional connectivity. European Neuropsychopharmacology. 2010;20(8):519–534. http://dx.doi.org/10.1016/j.euroneuro.2010.03.008. pmid:20471808
  47. 47. Rosazza C, Minati L. Resting-state brain networks: literature review and clinical applications. Neurological Sciences. 2011;32(5):773–785. pmid:21667095
  48. 48. Cole MW, Reynolds JR, Power JD, Repovs G, Anticevic A, Braver TS. Multi-task connectivity reveals flexible hubs for adaptive task control. Nature Neuroscience. 2013;16:1348–1355. pmid:23892552
  49. 49. Van Den Heuvel MP, Sporns O. Network hubs in the human brain. Trends in Cognitive Sciences. 2013;17(12):683–696. pmid:24231140
  50. 50. Buckner RL, Krienen FM. The evolution of distributed association networks in the human brain. Trends in Cognitive Sciences. 2013;17(12):648–665. pmid:24210963
  51. 51. Yeo BTT, Krienen FM, Eickhoff SB, Yaakub SN, Fox PT, Buckner RL, et al. Functional Specialization and Flexibility in Human Association Cortex. Cerebral Cortex. 2015;25(10):3654–3672. pmid:25249407
  52. 52. Nicolini C, Bordier C, Bifone A. Community detection in weighted brain connectivity networks beyond the resolution limit. NeuroImage. 2017;146:28–39. https://doi.org/10.1016/j.neuroimage.2016.11.026. pmid:27865921
  53. 53. Ahn YY, Bagrow JP, Lehmann S. Link communities reveal multiscale complexity in networks. Nature. 2010;466:761. pmid:20562860
  54. 54. Li HJ, Zhang J, Liu ZP, Chen L, Zhang XS. Identifying overlapping communities in social networks using multi-scale local information expansion. The European Physical Journal B. 2012;85(6):190.