iBet uBet web content aggregator. Adding the entire web to your favor.
iBet uBet web content aggregator. Adding the entire web to your favor.



Link to original content: https://unpaywall.org/10.1109/ICIP.2016.7532680
ACCELERATED DYNAMIC MRI USING STRUCTURED LOW RANK MATRIX COMPLETION - PMC Skip to main content
NIHPA Author Manuscripts logoLink to NIHPA Author Manuscripts
. Author manuscript; available in PMC: 2021 Feb 16.
Published in final edited form as: Proc Int Conf Image Proc. 2016 Aug 19;2016:1858–1862. doi: 10.1109/icip.2016.7532680

ACCELERATED DYNAMIC MRI USING STRUCTURED LOW RANK MATRIX COMPLETION

Arvind Balachandrasekaran , Greg Ongie *, Mathews Jacob
PMCID: PMC7885618  NIHMSID: NIHMS1667948  PMID: 33597830

Abstract

We introduce a fast structured low-rank matrix completion algorithm with low memory & computational demand to recover the dynamic MRI data from undersampled measurements. The 3-D dataset is modeled as a piecewise smooth signal, whose discontinuities are localized to the zero sets of a bandlimited function. We show that a structured matrix corresponding to convolution with the Fourier coefficients of the signal derivatives is highly low-rank. This property enables us to recover the signal from undersampled measurements. The application of this scheme in dynamic MRI shows significant improvement over state of the art methods.

Keywords: dynamic MRI, structured low rank, smoothness regularization

1. INTRODUCTION

Obtaining high spatial & temporal resolution is challenging in dynamic MRI, mainly due to the slow nature of acquisition. A common approach to speed up the acquisition is to acquire undersampled Fourier data and to regularize the recovery problem using appropriate priors. Common regularization penalties include 1 sparsity prior in the Fourier/wavelet domain and smoothness priors (e.g. total variation regularization).

Recently, structured low rank matrix priors are emerging as powerful alternatives for classical 1 regularization [1-4]. For example, we have modeled a 2-D image as a piecewise smooth signal, whose partial derivatives are localized to zero-crossings of a band limited trigonometric polynomial [3, 4]; this work is inspired by [5]. We have shown that such a signal can be annihilated by a large set of finite impulse response filters in the Fourier domain. These annihilation relations imply that a matrix with convolutional structure derived from the uniform Fourier samples of the signal is low-rank. We have exploited this property to recover the image from uniform [6] and non-uniform samples [7]. Since these methods can exploit the additional structure in many multidimensional problems (e.g. smoothness of the edges), on top of sparsity, they are demonstrated to yield better reconstruction performance than classical total variation methods. These methods are generalization of classical 1-D FRI methods [8, 9] to the multidimensional setting with non-uniform sampling.

Despite improved performance, structured low rank methods suffer from high memory demand and computational complexity, both resulting from the lifting of the original 2-D problem to a dense high-dimensional structured matrix. Since the dimension of the matrix is atleast two to three orders of magnitude greater than the size of the original data, it results in computationally expensive algorithms. Various methods have been explored to make the computational complexity manageable. For example, greedy multi-scale approximations to sequentially recover the image [1] and factorization of the matrix to two low-dimensional matrices have been explored [1, 2]. Despite these approximations, it is still challenging to extend the above scheme to three dimensions and beyond. Current methods recover 2-D slices of the 3D datasets independently [1], which is suboptimal and requires Cartesian undersampling; this approach is not as efficient as more general non-Cartesian acquisition schemes. Another challenge with most of the current methods is that they are only designed for one derivative operator. [1, 2]. When multiple derivative operators are desired (e.g. directional derivatives), the problems are solved in a sequential fashion; the data recovered using one weighting is then used to recover the image with the other weighting.

Recently, we have introduced a fast and memory efficient structured low-rank matrix recovery algorithm called Generic Iteratively Reweighted Annihilating Filter (GIRAF) [10]. This approach works in the unlifted domain & exploits the convolutional structure of the structured matrix using Fast Fourier Transforms (FFT), which quite significantly reduces the computational complexity and memory demand of the algorithm. In addition, the algorithm is also general enough to handle arbitrary number of k-space weightings at the same time. In this paper, we extend the GIRAF algorithm to recover signals that can be modeled as piecewise smooth functions in three dimensions. We demonstrate the improvement offered by this algorithm on breath held cine data over spatio-temporal total variation (TV) & temporal Fourier sparsity regularized reconstruction schemes.

2. THEORY

Consider the general class of piecewise smooth functions g of degree n in d dimensions:

g(r)=i=1Ngi(r)χΩ1(r),r=(x,y)[0,1]d, (1)

where χΩi is a characteristic function of the region Ωi and gi are smooth polynomial functions of degree at most n. We assume that the edge set Ω=i=1NΩi coincides with the zero level sets of a d dimensional bandlimited function:

μ(r)=kΔc[k]ej2πk,r,r=(x,y)[0,1]d (2)

where c[k]C are the Fourier coefficients of μ and Δ is any finite subset of Z2. We have shown that such signals satisfy

(x1n1xdndg)ϕ=0;n1+nd=n+1, (3)

where ϕ = μ · η is any function bandlimited to Λ1 ⊇ Δ, with a factor μ. The above conditions (3) translates into a convolution relation in the Fourier domain.

((jω1)n1(jωd)ndg^)c=0;n1++nd=n+1 (4)

We consider the recovery of the the Fourier coefficients on a rectangular region ΓZd. When n = 0 in (3), we obtain a piecewise constant signal model with conditions similar to the assumptions in classical total variation regularization. The annihilation relations in this case can be compactly written in matrix form as

T(g^)h=[T1(g^)Td(g^)]h=0 (5)

Here, Ti(g^)CΛ2×Λ1 is a Toeplitz/Hankel matrix whose entries are derived from jωig^;Ti(g^)h corresponds to the convolution of jωig^ with h. Here, hFϕ is a d dimensional filter, supported in Λ1. We have shown that the dimension of the space of filters h that satisfy (5) is given by the size of the set Λ1∣Δ — the valid shifts of the set Δ within Λ1. Λ2 ∈ Γ indicates the set of indices over which the convolutions between the samples of g^ and h are valid. See Fig. 1 for an illustration of the structure of the lifted matrix T(g^). Since the annihilation conditions are satisfied for filters h that live in a large subspace, we can conclude that T(g^) is low rank. We use this property to recover g^ from non-uniform samples.

Fig. 1:

Fig. 1:

Illustration of the lifted matrix T(G): The rows of the matrix are cube shape neighborhoods of the weighted Fourier samples corresponding to the partial derivatives. We use the structure of the low-rank matrix to recover it from few measurements as in (9).

3. PROPOSED FORMULATION

3.1. Measurement Model

Let G~CP×T denote the Casoratti matrix structure of the dynamic MRI dataset, where each column G~i represents a vectorized image at a time point ti. We consider the recovery of the 3-D discrete Fourier coefficients of G~, denoted by G. The Fourier measurements b can be modeled as:

b=SFtG+η; (6)

where S and η are the sampling matrix and zero mean white Gaussian noise vector respectively. Ft is the 1-D discrete inverse Fourier transform (DFT) matrix along the time direction. (6) can be compactly written as

b=A(G)+η (7)

where A is the measurement operator.

3.2. Problem formulation

We assume that the time series of MR images can be modeled as three dimensional piecewise constant functions and consider its recovery from few Fourier measurements. We formulate the problem in the Fourier domain and pose the recovery of G as the solution to the following structured low rank matrix completion problem.

minGrank[T(G)]s.tb=A(G)+η (8)

Here G is the data to be recovered. T(G)CM×N is a structured Toeplitz matrix in the lifted domain. Since (8) is NP hard, we relax the rank function with a Schatten p(0 ≤ p ≤ 1) norm:

G=argminGT(G)p+λ2A(G)b22 (9)

where λ is a regularization parameter. Here, ∥Xp is the Schatten p norm, defined as Xp1pTr[(XX)p2]=1piσip, where σi are the singular values of X. p = 1 results in a convex nuclear norm penalty and when (0 ≤ p < 1), the Schatten norm is non-convex. When p → 0, ∥X0 ≔ ∑i log σi.

Note that we lift the original problem involving a 3-D signal to a large matrix T(G), whose number of rows is around three times the total number of pixels in the 3-D volume. The number of columns is equal to the size of the filter. The explicit use of such a matrix requires a lot of memory for storage and also increases the computational complexity of the problem. Even for a data set of dimension 128 × 128 × 15 and filter size of 21 × 21 × 3, the memory demand is 1323 times the memory needed to store the original signal, which makes the application of the scheme to even modest sized datasets intractable.

4. OPTIMIZATION ALGORITHM

We use an iterative re-weighted least squares (IRLS) algorithm [11] to solve (9), which relies on the property Xp=XH12F2, where H=(XX)p21. Setting X=T(G), we obtain the iterative algorithm that alternates between the following steps:

Hn=[T(Gn1)T(Gn1)+ϵnI]p21 (10)
Gn=argminGT(G)Hn12F2+λ2A(G)b22 (11)

where ϵn → 0 is added to stabilize the inverse. We now show how the above steps can be modified to avoid the explicit evaluation and storage of the large lifted matrix T(G).

4.1. Update of Gn

Denoting H = [h1, .., hN], we rewrite (11) as

G=argminG12i=1NT(G)hiF2+λ2A(G)b22 (12)

By exploiting the structure of T(G) and from the commutative property of convolution we have,

T(G)hi=PΛ2(Q(G)hi)=PΛ2(hiQ(G))=PCiQ(G) (13)

Here, * denotes 3-D convolution. Q is a linear operator specified by Q=[Qx,Qy,αQz]. Here, Q(G) represents element wise multiplication of G by Fourier derivatives j2πkx, j2πky and j2πkz where k = (kx, ky, kz). Ci represents the 3-D linear convolution by hi. PΛ2 is the projection of the convolution onto a valid k space index set Λ2 and is represented by the matrix P.

We approximate Ci by a 3-D circular convolution by hi, which is valid if the convolution grid is sufficiently large. This allows us to evaluate Ci as FDiF, where F is the 3-D DFT matrix and Di is a diagonal matrix corresponding to the 3-D inverse DFT of hi. We also assume PPI, which is valid if the projection set Λ2 is large compared to the filter size. Substituting (13) in (12) and then taking the gradient, we obtain

(QF(i=1NDiDi)D(μ¯)FQ+λAA)RG=λAb (14)

where D(μ¯) is a diagonal matrix with entries

μ¯(r)=i=1Nμi(r)2,(r)[0,1]3 (15)

Here, μi(r) is a trigonometric polynomial corresponding to the inverse fourier transform of hi. With these approximations, forming matrix vector products with R only requires 2 FFT’s after precomputing μ¯.

4.2. Updating μ¯(r) using (10)

Using the convoution relation mentioned in (13), the correlation matrix R=T(G)T(G) can be computed as

RPΛ1[C(Q(G))C(Q(G))]PΛ1 (16)

where PΛ1 is the projection onto the set Λ1, C is applied to each block of Q(G) and represents circular convolution. By expressing C in terms of the DFT matrix F, we can simplify (16) further and obtain RPΛ1[FDF]PΛ1 where D is a diagonal matrix whose entries correspond to 2(G~x2+G~y2+G~z2). Hence the entries of R are obtained from the Fourier coefficients of ∣∇∣2; specifically every row of R is obtained by vectorizing a brick shaped region of size equal to the dimensions of the filter from the black cuboid region of dimension twice the size of the filter. See Fig. 2 which depicts the construction of R.

Fig. 2:

Fig. 2:

Illustration of the direct evaluation of T(G)T(G) that does not require the lifting. This direct computation, as well as the update step (14) that does not require the lifted matrix, results in the fast and memory efficient algorithm for (9).

Next the weight matrix H can be efficiently computed from the eigen decomposition of R. Let (V, Λ) be the eigen decomposition of T(G)T(G), where V is the orthogonal basis of eigen vectors vi and Λ is a diagonal matrix containing the eigen values λi. Substituting the eigen decomposition in (10) and simplifying further we obtain,

H=[V(Λ+ϵI)V]p21=V(Λ+ϵI)p21V.

Hence, one choice of the matrix square root H12 is

H12=V(Λ+ϵI)p412=[α112v1,,αN12vN].

where αi=(λi+ϵ)p21. The spatial domain trigonometric polynomial μi and vi are related as μi=αi12γi(r) where γi(r) is the inverse fourier transform of the eigen vector vi. Hence using this relation, the SOS polynomial is updated as

μ¯(r)=i=1Nαiγi(r)2,(r)[0,1]3 (17)

which can be efficiently computed using N FFT’s. Note that the weights αi are only high for vectors vi close to the null space.

5. EXPERIMENTS AND RESULTS

In Fig 3, we compare the recovery of the proposed method (single weighting and multiple weighting) with the spatio-temporal TV (S-TV) and temporal Fourier Sparsity (FS) regularized reconstruction methods on a Breath Held Cine Data of dimension (224 × 256 × 16 × 5) (coil compressed) at an acceleration factor of four and seven respectively. The data was acquired using a SSFP sequence using the following parameters: TE/TR= 2.0/4.1 ms and flip angle=45°. For the proposed method, a filter size of (21 × 21 × 3) was used in the recovery.

Fig. 3:

Fig. 3:

Comparison of the proposed scheme (single weighting and multiple weighting) with temporal Fourier Sparsity and Spatio-temporal TV methods at an acceleration factor of four (top row) and seven (bottom Row).

Q is defined as (jωx)2+(jωy)2+(αjωz)2 for the proposed method with single kspace weighting. As this is an isotropic operator, at an acceleration factor of seven, it results in a recovery with some edges blurred, compared to the proposed method with multiple weightings and TV. The reconstructions from the proposed method with multiple weightings are more accurate with a lot of details faithfully captured. Specifically, the errors corresponding to it are scattered as opposed to being concentrated along the edges, which is the case with TV and Fourier sparsity based methods.

6. CONCLUSION

We introduced a fast & memory efficient algorithm to recover piecewise smooth three dimensional signals from few of their measurements. The algorithm is similar in concept to iterative reweighted algorithm for total variation regularization, with the exception that the weights are derived using a novel Fourier domain strategy involving singular value decomposition. The ability of the scheme to additionally regularize the smoothness of the edges enables it to provide improved results over total variation regularization. The comparison of the proposed scheme against state of the art methods in the context of cine MRI demonstrates its ability to provide more accurate reconstructions with better edge details.

Acknowledgments

This work is supported by NIH 1R01EB019961-01A1

7. REFERENCES

  • [1].Jin KH, Lee D, and Ye JC, “A general framework for compressed sensing and parallel MRI using annihilating filter based low-rank hankel matrix,” arXiv preprint arXiv:1504.00532, 2015. [Google Scholar]
  • [2].Haldar JP, “Low-rank modeling of local k-space neighborhoods (loraks) for constrained mri.” Medical Imaging, IEEE Transactions on, vol. 33, no. 3, pp. 668–681, 2014. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [3].Ongie G and Jacob M, “Super-resolution MRI using finite rate of innovation curves,” IEEE International Symposium on Biomedical Imaging (ISBI), April 2015. [Google Scholar]
  • [4].—, “Recovery of piecewise smooth images from few fourier samples,” in Sampling Theory and Applications (SampTA), May 2015, pp. 543–547. [Google Scholar]
  • [5].Pan H, Blu T, and Dragotti PL, “Sampling curves with finite rate of innovation,” Signal Processing, IEEE Transactions on, vol. 62, no. 2, 2014. [Google Scholar]
  • [6].Ongie G and Jacob M, “A fast algorithm for stuctured low rank matrix recovery with applications to undersampled MRI reconstruction,” ISBI, 2016. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [7].—, “Recovery of piecewise smooth images from few Fourier samples,” SampTA, 2015. [Google Scholar]
  • [8].Vetterli M, Marziliano P, and Blu T, “Sampling signals with finite rate of innovation,” Signal Processing, IEEE Transactions on, vol. 50, no. 6, pp. 1417–1428, 2002. [Google Scholar]
  • [9].Liang Z-P, Haacke E, and Thomas C, “High-resolution inversion of finite fourier transform data through a localised polynomial approximation,” Inverse Problems, vol. 5, no. 5, p. 831, 1989. [Google Scholar]
  • [10].Ongie G and Jacob M, “A fast algorithm for structured low-rank matrix recovery,” IEEE International Symposium on Biomedical Imaging (ISBI), April 2016. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [11].Mohan K and Fazel M, “Iterative reweighted algorithms for matrix rank minimization,” The Journal of Machine Learning Research, vol. 13, no. 1, pp. 3441–3473, 2012. [Google Scholar]

RESOURCES