The FFT Via Matrix Factorizations

Total Page:16

File Type:pdf, Size:1020Kb

The FFT Via Matrix Factorizations The FFT Via Matrix Factorizations A Key to Designing High Performance Implementations Charles Van Loan Department of Computer Science Cornell University A High Level Perspective... Blocking For Performance A11 A12 A1q n ··· } 1 A21 A22 A2q n A = ··· } 2 . ... Ap1 Ap2 Apq nq ··· } n1 n2 nq |{z} |{z} |{z} A well known strategy for high-performance Ax = b and Ax = λx solvers. Factoring for Performance One way to execute a matrix-vector product y = Fnx when Fn = At A A is as follows: ··· 2 1 y = x for k = 1:t y = Akx end ˜ ˜ A different factorization Fn = At˜ A1 would yield a different algorithm. ··· The Discrete Fourier Transform (n = 8) 0 0 0 0 0 0 0 0 ω8 ω8 ω8 ω8 ω8 ω8 ω8 ω8 0 1 2 3 4 5 6 7 ω8 ω8 ω8 ω8 ω8 ω8 ω8 ω8 ω0 ω2 ω4 ω6 ω8 ω10 ω12 ω14 8 8 8 8 8 8 8 8 ω0 ω3 ω6 ω9 ω12 ω15 ω18 ω21 8 8 8 8 8 8 8 8 y = F8x = x ω0 ω4 ω8 ω12 ω16 ω20 ω24 ω28 8 8 8 8 8 8 8 8 ω0 ω5 ω10 ω15 ω20 ω25 ω30 ω35 8 8 8 8 8 8 8 8 ω0 ω6 ω12 ω18 ω24 ω30 ω36 ω42 8 8 8 8 8 8 8 8 ω0 ω7 ω14 ω21 ω28 ω35 ω42 ω49 8 8 8 8 8 8 8 8 ω = cos(2π/8) i sin(2π/8) 8 − · The DFT Matrix In General... If ωn = cos(2π/n) i sin(2π/n) then − · pq [Fn]pq = ωn = (cos(2π/n) i sin(2π/n))pq − · = cos(2pqπ/n) i sin(2pqπ/n) − · Fact: H Fn Fn = nIn Thus, Fn/√n is unitary. Data Sparse Matrices An n-by-n matrix A is data sparse if it can be represented with many fewer than n2 numbers. Example 1. A has lots of zeros. (“Traditional Sparse”) Example 2. A is Toeplitz... abcd ea bc A = feab gf ea More Examples of Data Sparse Matrices A is a Kronecker Product B C, e.g., ⊗ b C b C A = 11 12 " b21C b22C # m1 m1 m2 m2 2 2 If B IR × and C IR × then A = B C has m1m2 ∈ ∈ 2 2 ⊗ entries but is parameterized by just m1 + m2 numbers. Extreme Data Sparsity n n n n A = S(i,j,k,`) (2-by-2) (2-by-2) · ⊗ ··· ⊗ i=1 j=1 k=1 `=1 X X X X d times | {z } A is 2d -by-2d but is parameterized by O(dn4) numbers. Factorization of Fn The DFT matrix can be factored into a short product of sparse matrices, e.g., F = A A A P 1024 10 ··· 2 1 1024 where each A-matrix has 2 nonzeros per row and P1024 is a per- mutation. From Factorization to Algorithm If n = 210 and Fn = A A A Pn 10 ··· 2 1 then y = Pnx for k = 1:10 y = A x 2n flops. k ← end computes y = Fnx and requires O(n log n) flops. Recursive Block Structure F8(:, [02461357]) = 1 00 0 1 0 0 0 0 100 0 ω8 0 0 2 0 010 0 0 ω8 0 3 0 001 0 0 0 ω8 F4 0 1 00 0 10 0 0 0 F4 − 0 100 0 ω8 0 0 − 2 0 010 0 0 ω8 0 − 3 0 001 0 0 0 ω − 8 Fn/2 “shows up” when you permute the columns of Fn so that the odd-indexed columns come first. Recursion... We build an 8-point DFT from two 4-point DFTs... 1 00 0 1 0 0 0 0 100 0 ω8 0 0 2 0 010 0 0 ω8 0 3 F x(0:2:7) 0 001 0 0 0 ω8 4 F8 x = 1 00 0 10 0 0 " F x(1:2:7) # − 4 0 100 0 ω8 0 0 − 2 0 010 0 0 ω8 0 − 3 0 001 0 0 0 ω − 8 Radix-2 FFT: Recursive Implementation function y =fft(x, n) if n = 1 y = x else m = n/2; ω = exp( 2πi/n) − m 1 Ω = diag(1,ω,...,ω − ) z = fft(x(0:2:n 1), m) T − z = Ω fft(x(1:2:n 1), m) B · − I I z y = m m T Overall: 5n log n flops. Im Im zB − end The Divide-and-Conquer Picture (0:1:15) ¨¨HH ¨ H ¨ H ¨¨ HH ¨ H ¨ H (0:2:15) (1:2:15) Q Q Q Q Q Q Q Q (0:4:15) (2:4:15) (1:4:15) (3:4:15) @ @ @ @ @ @ @ @ (0:8:15) (4:8:15) (2:8:15) (6:8:15) (1:8:15) (5:8:15) (3:8:15) (7:8:15) ¡A ¡A ¡A ¡A ¡A ¡A ¡A ¡A ¡ A ¡ A ¡ A ¡ A ¡ A ¡ A ¡ A ¡ A [0] [8] [4] [12] [2] [10] [6] [14] [1] [9] [5] [13] [3] [11] [7] [15] Towards a Nonrecursive Implementation The Radix-2 Factorization... If n = 2m and m 1 Ωm = diag(1,ωn,...,ωn − ), then Fm ΩmFm Im Ωm FnΠn = = (I2 Fm). " Fm ΩmFm # " Im Ωm # ⊗ − − where Πn = In(:, [0:2:n 1:2:n]). Fm 0 Note: I2 Fm = . ⊗ 0 Fm The Cooley-Tukey Factorization n = 2t Fn = At A Pn ··· 1 Pn = the n-by-n “bit reversal ” permutation matrix I Ω L/2 L/2 q Aq = Ir L = 2 , r = n/L ⊗ " IL/2 ΩL/2 # − L/2 1 Ω = diag(1,ω ,...,ω − ) ω = exp( 2πi/L) L/2 L L L − The Bit Reversal Permutation (0:1:15) ¨¨HH ¨ H ¨ H ¨¨ HH ¨ H ¨ H (0:2:15) (1:2:15) Q Q Q Q Q Q Q Q (0:4:15) (2:4:15) (1:4:15) (3:4:15) @ @ @ @ @ @ @ @ (0:8:15) (4:8:15) (2:8:15) (6:8:15) (1:8:15) (5:8:15) (3:8:15) (7:8:15) ¡A ¡A ¡A ¡A ¡A ¡A ¡A ¡A ¡ A ¡ A ¡ A ¡ A ¡ A ¡ A ¡ A ¡ A [0] [8] [4] [12] [2] [10] [6] [14] [1] [9] [5] [13] [3] [11] [7] [15] Bit Reversal x(0) x(0000) x(0000) x(0) x(1) x(0001) x(1000) x(8) x(2) x(0010) x(0100) x(4) x(3) x(0011) x(1100) x(12) x(4) x(0100) x(0010) x(2) x(5) x(0101) x(1010) x(10) x(6) x(0110) x(0110) x(6) x(7) x(0111) x(1110) x(14) = = x(8) x(1000) → x(0001) x(1) x(9) x(1001) x(1001) x(9) x(10) x(1010) x(0101) x(5) x(11) x(1011) x(1101) x(13) x(12) x(1100) x(0011) x(3) x(13) x(1101) x(1011) x(11) x(14) x(1110) x(0111) x(7) x(15) x(1111) x(1111) x(15) Butterfly Operations This matrix is block diagonal... I Ω L/2 L/2 q Aq = Ir L = 2 , r = n/L ⊗ " IL/2 ΩL/2 # − r copies of things like this 1 1 × × 1 × 1 × 1 × 1 × 1 × 1 × At the Scalar Level... a Hs ¨s a + ωb H ¨ H ¨ ω ¨¨ HH b s¨ Hs a ωb − Signal Flow Graph (n = 8) x0 Hs ¨s s s y0 HH ¨¨ @ A ¡ @ A ¡ ω0 ¨ 8 H @ A ¡ ¨ H @ ¨ H 0 A ¡ x4 s s ω s s y1 @ 8 A A ¡ ¡ @ @ @ A A ¡ ¡ @ @ A A ¡ ¡ @ A A ¡ ¡ x s s 2 @s 0 s y 2 HH ¨¨ ω8 A A ω8 ¡ ¡ 2 H ¨ @ A ¡ A ¡ 0 @ A ¡ A ¡ ω8 A A ¡ ¡ ¨¨ HH @ ¡ A ¡ A ¨ H @ A 1 ¡ x6 s s s ¡ ω A s y3 A ¡A 8 ¡A ¡ A ¡ A ¡ A¡ ¡ A A¡ A A ¡ ¡ ¡ ¡ A ¡ A A ¡ A 2 ¡ A x1 Hs ¨s s ¡ ω A s y4 H ¨ @ A 8 ¡ H ¨ ¡ A @ A ¡ A ¡ ω0 ¡ ¡ A A ¨ 8 H @ ¡ A ¡ A ¨ H @ ¡ A ¡ A x s¨ Hs 0 s¡ ¡ 3 A As y 5 @ ω8 ω8 5 @ ¡ ¡ A A @ @ ¡ ¡ A A @ @ @ ¡ ¡ A A 2 @¡ A x3 Hs ¨s ω s ¡ A s y6 H ¨ 8 H ¨ @ ¡ A ω0 @ ¡ A ¨ 8 H @ ¡ A ¨ H ¨ H @¡ A x7 s s s s y7 The Transposed Stockham Factorization If n = 2t, then Fn = S S S , t ··· 2 1 where for q = 1:t the factor Sq = AqΓq 1 is defined by − A = I B , L = 2q, r = n/L, q r ⊗ L Γq 1 = Πr IL , L = L/2, r = 2r, − ∗ ⊗ ∗ ∗ ∗ IL ΩL BL = ∗ ∗ , IL ΩL ∗ − ∗ L 1 ΩL = diag(1, ωL,...,ωL∗− ). ∗ Perfect Shuffle x0 x0 x1 x1 x2 x4 x x (Π I ) 3 = 5 4 ⊗ 2 x x 4 2 x x 5 3 x x 6 6 x x 7 7 Cooley-Tukey Array Interpretation Step q: k 2k 2k+1 − 8 =2q 1 q L∗ <> L=2 −→ :> r∗ =n/L∗ | {z } r=n/L | {z } Reshaping × × × × x = x = ×××× × → 2 4 × ×××× × × × × Transposed Stockham Array Interp k k+r (q−1) T 9 q−1 = = L∗=2 . xL∗×r∗ FL∗ xr∗×L∗ => ;> r∗ =n/L∗ (q) (q 1) x = Sqx − | k {z } 9 > > > (q) = T = > =2q xL×r FLxr×L => L > > > > ;> r=n/L | {z } 2 2 2 Basic Radix-2 Versions × × Store intermediate DFTs by row or column Intermediate DFTs adjacent or not. How the two butterfly loops are ordered. I Ω L/2 L/2 q x = Ir x L = 2 , r = n/L ⊗ " IL/2 ΩL/2 #! − The Gentleman-Sande Idea T It can be shown that Fn = Fn and so if T Fn = At A P ··· 1 n then T T T Fn = F = PnA A n 1 ··· t and we can compute y = Fnx as follows..
Recommended publications
  • Arxiv:2105.00793V3 [Math.NA] 14 Jun 2021 Tubal Matrices
    Tubal Matrices Liqun Qi∗ and ZiyanLuo† June 15, 2021 Abstract It was shown recently that the f-diagonal tensor in the T-SVD factorization must satisfy some special properties. Such f-diagonal tensors are called s-diagonal tensors. In this paper, we show that such a discussion can be extended to any real invertible linear transformation. We show that two Eckart-Young like theo- rems hold for a third order real tensor, under any doubly real-preserving unitary transformation. The normalized Discrete Fourier Transformation (DFT) matrix, an arbitrary orthogonal matrix, the product of the normalized DFT matrix and an arbitrary orthogonal matrix are examples of doubly real-preserving unitary transformations. We use tubal matrices as a tool for our study. We feel that the tubal matrix language makes this approach more natural. Key words. Tubal matrix, tensor, T-SVD factorization, tubal rank, B-rank, Eckart-Young like theorems AMS subject classifications. 15A69, 15A18 1 Introduction arXiv:2105.00793v3 [math.NA] 14 Jun 2021 Tensor decompositions have wide applications in engineering and data science [11]. The most popular tensor decompositions include CP decomposition and Tucker decompo- sition as well as tensor train decomposition [11, 3, 17]. The tensor-tensor product (t-product) approach, developed by Kilmer, Martin, Bra- man and others [10, 1, 9, 8], is somewhat different. They defined T-product opera- tion such that a third order tensor can be regarded as a linear operator applied on ∗Department of Applied Mathematics, The Hong Kong Polytechnic University, Hung Hom, Kowloon, Hong Kong, China; ([email protected]). †Department of Mathematics, Beijing Jiaotong University, Beijing 100044, China.
    [Show full text]
  • Fourier Transform, Convolution Theorem, and Linear Dynamical Systems April 28, 2016
    Mathematical Tools for Neuroscience (NEU 314) Princeton University, Spring 2016 Jonathan Pillow Lecture 23: Fourier Transform, Convolution Theorem, and Linear Dynamical Systems April 28, 2016. Discrete Fourier Transform (DFT) We will focus on the discrete Fourier transform, which applies to discretely sampled signals (i.e., vectors). Linear algebra provides a simple way to think about the Fourier transform: it is simply a change of basis, specifically a mapping from the time domain to a representation in terms of a weighted combination of sinusoids of different frequencies. The discrete Fourier transform is therefore equiv- alent to multiplying by an orthogonal (or \unitary", which is the same concept when the entries are complex-valued) matrix1. For a vector of length N, the matrix that performs the DFT (i.e., that maps it to a basis of sinusoids) is an N × N matrix. The k'th row of this matrix is given by exp(−2πikt), for k 2 [0; :::; N − 1] (where we assume indexing starts at 0 instead of 1), and t is a row vector t=0:N-1;. Recall that exp(iθ) = cos(θ) + i sin(θ), so this gives us a compact way to represent the signal with a linear superposition of sines and cosines. The first row of the DFT matrix is all ones (since exp(0) = 1), and so the first element of the DFT corresponds to the sum of the elements of the signal. It is often known as the \DC component". The next row is a complex sinusoid that completes one cycle over the length of the signal, and each subsequent row has a frequency that is an integer multiple of this \fundamental" frequency.
    [Show full text]
  • The Discrete Fourier Transform
    Tutorial 2 - Learning about the Discrete Fourier Transform This tutorial will be about the Discrete Fourier Transform basis, or the DFT basis in short. What is a basis? If we google define `basis', we get: \the underlying support or foundation for an idea, argument, or process". In mathematics, a basis is similar. It is an underlying structure of how we look at something. It is similar to a coordinate system, where we can choose to describe a sphere in either the Cartesian system, the cylindrical system, or the spherical system. They will all describe the same thing, but in different ways. And the reason why we have different systems is because doing things in specific basis is easier than in others. For exam- ple, calculating the volume of a sphere is very hard in the Cartesian system, but easy in the spherical system. When working with discrete signals, we can treat each consecutive element of the vector of values as a consecutive measurement. This is the most obvious basis to look at a signal. Where if we have the vector [1, 2, 3, 4], then at time 0 the value was 1, at the next sampling time the value was 2, and so on, giving us a ramp signal. This is called a time series vector. However, there are also other basis for representing discrete signals, and one of the most useful of these is to use the DFT of the original vector, and to express our data not by the individual values of the data, but by the summation of different frequencies of sinusoids, which make up the data.
    [Show full text]
  • Quantum Fourier Transform Revisited
    Quantum Fourier Transform Revisited Daan Camps1,∗, Roel Van Beeumen1, Chao Yang1, 1Computational Research Division, Lawrence Berkeley National Laboratory, CA, United States Abstract The fast Fourier transform (FFT) is one of the most successful numerical algorithms of the 20th century and has found numerous applications in many branches of computational science and engineering. The FFT algorithm can be derived from a particular matrix decomposition of the discrete Fourier transform (DFT) matrix. In this paper, we show that the quantum Fourier transform (QFT) can be derived by further decomposing the diagonal factors of the FFT matrix decomposition into products of matrices with Kronecker product structure. We analyze the implication of this Kronecker product structure on the discrete Fourier transform of rank-1 tensors on a classical computer. We also explain why such a structure can take advantage of an important quantum computer feature that enables the QFT algorithm to attain an exponential speedup on a quantum computer over the FFT algorithm on a classical computer. Further, the connection between the matrix decomposition of the DFT matrix and a quantum circuit is made. We also discuss a natural extension of a radix-2 QFT decomposition to a radix-d QFT decomposition. No prior knowledge of quantum computing is required to understand what is presented in this paper. Yet, we believe this paper may help readers to gain some rudimentary understanding of the nature of quantum computing from a matrix computation point of view. 1 Introduction The fast Fourier transform (FFT) [3] is a widely celebrated algorithmic innovation of the 20th century [19]. The algorithm allows us to perform a discrete Fourier transform (DFT) of a vector of size N in (N log N) O operations.
    [Show full text]
  • Circulant Matrix Constructed by the Elements of One of the Signals and a Vector Constructed by the Elements of the Other Signal
    Digital Image Processing Filtering in the Frequency Domain (Circulant Matrices and Convolution) Christophoros Nikou [email protected] University of Ioannina - Department of Computer Science and Engineering 2 Toeplitz matrices • Elements with constant value along the main diagonal and sub-diagonals. • For a NxN matrix, its elements are determined by a (2N-1)-length sequence tn | (N 1) n N 1 T(,)m n t mn t0 t 1 t 2 t(N 1) t t t 1 0 1 T tt22 t1 t t t t N 1 2 1 0 NN C. Nikou – Digital Image Processing (E12) 3 Toeplitz matrices (cont.) • Each row (column) is generated by a shift of the previous row (column). − The last element disappears. − A new element appears. T(,)m n t mn t0 t 1 t 2 t(N 1) t t t 1 0 1 T tt22 t1 t t t t N 1 2 1 0 NN C. Nikou – Digital Image Processing (E12) 4 Circulant matrices • Elements with constant value along the main diagonal and sub-diagonals. • For a NxN matrix, its elements are determined by a N-length sequence cn | 01nN C(,)m n c(m n )mod N c0 cNN 1 c 2 c1 c c c 1 01N C c21 c c02 cN cN 1 c c c c NN1 21 0 NN C. Nikou – Digital Image Processing (E12) 5 Circulant matrices (cont.) • Special case of a Toeplitz matrix. • Each row (column) is generated by a circular shift (modulo N) of the previous row (column). C(,)m n c(m n )mod N c0 cNN 1 c 2 c1 c c c 1 01N C c21 c c02 cN cN 1 c c c c NN1 21 0 NN C.
    [Show full text]
  • Pre- and Post-Processing for Optimal Noise Reduction in Cyclic Prefix
    Pre- and Post-Processing for Optimal Noise Reduction in Cyclic Prefix Based Channel Equalizers Bojan Vrcelj and P. P. Vaidyanathan Dept. of Electrical Engineering 136-93 California Institute of Technology Pasadena, CA 91125-0001 Abstract— Cyclic prefix based equalizers are widely used for It is preceded (followed) by the optimal precoder (equalizer) high-speed data transmission over frequency selective channels. for the given input and noise statistics. These blocks are real- Their use in conjunction with DFT filterbanks is especially attrac- ized by constant matrix multiplication, so that the overall com- tive, given the low complexity of implementation. Some examples munications system remains of low complexity. include the DFT-based DMT systems. In this paper we consider In the following we first give a brief overview of the cyclic a general cyclic prefix based system for communication and show prefix system with DFT matrices used as the basic ISI can- that the equalization performance can be improved by simple pre- celer. Then, we introduce a way to deal with noise suppres- and post-processing aimed at reducing the noise at the receiver. This processing is done independently of the ISI cancellation per- sion separately and derive the optimal constrained pair pre- formed by the frequency domain equalizer.1 coder/equalizer for this purpose. The constraint is that in the absence of noise the overall system is still ISI-free. The per- formance of the proposed method is evaluated through com- I. INTRODUCTION puter simulations and a significant improvement with respect to There has been considerable interest in applying the eq– the original system without pre- and post-processing is demon- ualization techniques based on cyclic prefix to high speed data strated.
    [Show full text]
  • Spectral Analysis of the Adjacency Matrix of Random Geometric Graphs
    Spectral Analysis of the Adjacency Matrix of Random Geometric Graphs Mounia Hamidouche?, Laura Cottatellucciy, Konstantin Avrachenkov ? Departement of Communication Systems, EURECOM, Campus SophiaTech, 06410 Biot, France y Department of Electrical, Electronics, and Communication Engineering, FAU, 51098 Erlangen, Germany Inria, 2004 Route des Lucioles, 06902 Valbonne, France [email protected], [email protected], [email protected]. Abstract—In this article, we analyze the limiting eigen- multivariate statistics of high-dimensional data. In this case, value distribution (LED) of random geometric graphs the coordinates of the nodes can represent the attributes of (RGGs). The RGG is constructed by uniformly distribut- the data. Then, the metric imposed by the RGG depicts the ing n nodes on the d-dimensional torus Td ≡ [0; 1]d and similarity between the data. connecting two nodes if their `p-distance, p 2 [1; 1] is at In this work, the RGG is constructed by considering a most rn. In particular, we study the LED of the adjacency finite set Xn of n nodes, x1; :::; xn; distributed uniformly and matrix of RGGs in the connectivity regime, in which independently on the d-dimensional torus Td ≡ [0; 1]d. We the average vertex degree scales as log (n) or faster, i.e., choose a torus instead of a cube in order to avoid boundary Ω (log(n)). In the connectivity regime and under some effects. Given a geographical distance, rn > 0, we form conditions on the radius rn, we show that the LED of a graph by connecting two nodes xi; xj 2 Xn if their `p- the adjacency matrix of RGGs converges to the LED of distance, p 2 [1; 1] is at most rn, i.e., kxi − xjkp ≤ rn, the adjacency matrix of a deterministic geometric graph where k:kp is the `p-metric defined as (DGG) with nodes in a grid as n goes to infinity.
    [Show full text]
  • 1 1.1. the DFT Matrix
    FFT January 20, 2016 1 1.1. The DFT matrix. The DFT matrix. By definition, the sequence f(τ)(τ = 0; 1; 2;:::;N − 1), posesses a discrete Fourier transform F (ν)(ν = 0; 1; 2;:::;N − 1), given by − 1 NX1 F (ν) = f(τ)e−i2π(ν=N)τ : (1.1) N τ=0 Of course, this definition can be immediately rewritten in the matrix form as follows 2 3 2 3 F (1) f(1) 6 7 6 7 6 7 6 7 6 F (2) 7 1 6 f(2) 7 6 . 7 = p F 6 . 7 ; (1.2) 4 . 5 N 4 . 5 F (N − 1) f(N − 1) where the DFT (i.e., the discrete Fourier transform) matrix is defined by 2 3 1 1 1 1 · 1 6 − 7 6 1 w w2 w3 ··· wN 1 7 6 7 h i 6 1 w2 w4 w6 ··· w2(N−1) 7 1 − − 1 6 7 F = p w(k 1)(j 1) = p 6 3 6 9 ··· 3(N−1) 7 N 1≤k;j≤N N 6 1 w w w w 7 6 . 7 4 . 5 1 wN−1 w2(N−1) w3(N−1) ··· w(N−1)(N−1) (1.3) 2πi with w = e N being the primitive N-th root of unity. 1.2. The IDFT matrix. To recover N values of the function from its discrete Fourier transform we simply have to invert the DFT matrix to obtain 2 3 2 3 f(1) F (1) 6 7 6 7 6 f(2) 7 p 6 F (2) 7 6 7 −1 6 7 6 .
    [Show full text]
  • Exact Recovery of Tensor Robust Principal Component Analysis Under Linear Transforms
    1 Exact Recovery of Tensor Robust Principal Component Analysis under Linear Transforms Canyi Lu and Pan Zhou This work studies the Tensor Robust Principal Component low-rank and sparse tensors decomposition from their sum. Analysis (TRPCA) problem, which aims to exactly recover More specifically, assume that a tensor X can be decomposed the low-rank and sparse components from their sum. Our as X = L + E where L is a low-rank tensor and E is model is motivated by the recently proposed linear transforms 0 0 0 0 based tensor-tensor product and tensor SVD. We define a new a sparse tensor. TRPCA aims to recover L0 and E0 from X . transforms depended tensor rank and the corresponding tensor We focus on the convex model which can be solved exactly nuclear norm. Then we solve the TRPCA problem by convex and efficiently, and the solutions own the theoretical guarantee. optimization whose objective is a weighted combination of the TRPCA extends the well known Robust PCA [1] model, i.e., new tensor nuclear norm and the `1-norm. In theory, we show that under certain incoherence conditions, the convex program min kLk∗ + λkEk1; s.t. X = L + E; (1) exactly recovers the underlying low-rank and sparse components. L;E It is of great interest that our new TRPCA model generalizes existing works. In particular, if the studied tensor reduces to where kLk∗ denotes the matrix nuclear norm, kEk1 denotes a matrix, our TRPCA model reduces to the known matrix the `1-norm and λ > 0. Under certain incoherence conditions, RPCA [1].
    [Show full text]
  • Basic Vector Space Methods in Signal and Systems Theory
    Basic Vector Space Methods in Signal and Systems Theory By: C. Sidney Burrus Basic Vector Space Methods in Signal and Systems Theory By: C. Sidney Burrus Online: < http://cnx.org/content/col10636/1.5/ > CONNEXIONS Rice University, Houston, Texas This selection and arrangement of content as a collection is copyrighted by C. Sidney Burrus. It is licensed under the Creative Commons Attribution 3.0 license (http://creativecommons.org/licenses/by/3.0/). Collection structure revised: December 19, 2012 PDF generated: January 10, 2013 For copyright and attribution information for the modules contained in this collection, see p. 35. Table of Contents 1 Introduction .......................................................................................1 2 A Matrix Times a Vector ..................................................... ...................3 3 General Solutions of Simultaneous Equations .................................................11 4 Approximation with Other Norms and Error Measures ......................................19 5 Constructing the Operator (Design) ...........................................................27 Bibliography ........................................................................................29 Index ................................................................................................34 Attributions .........................................................................................35 iv Available for free at Connexions <http://cnx.org/content/col10636/1.5> Chapter 1 Introduction1 1.1
    [Show full text]
  • Cayley Graphs and the Discrete Fourier Transform
    Cayley Graphs and the Discrete Fourier Transform Alan Mackey Advisor: Klaus Lux May 15, 2008 Abstract Given a group G, we can construct a graph relating the elements of G to each other, called the Cayley graph. Using Fourier analysis on a group allows us to apply our knowledge of the group to gain insight into problems about various properties of the graph. Ideas from representation theory are powerful tools for analysis of groups and their Cayley graphs, but we start with some simpler theory to motivate the use of group representations. 1 Z/nZ and L2(Z=nZ) Before we can define what the discrete Fourier transform (or DFT) is, we have to know what exactly it transforms. To introduce the ideas behind the use of the DFT, we will use G = Z/nZ as an example. The DFT doesn't actually operate on the elements of Z/nZ themselves, but rather on certain functions with Z/nZ as their domain. Definition. The set ff : G ! Cg of all functions from a finite group G to the complex numbers is denoted L2(G). Let's start with an example. The group (Z/nZ; +n) has n elements, and so any function from Z/nZ to C is determined exactly by the finite set of values ff(a): a 2 Z/nZg. Thus, we can define a vector space isomorphism φ : L2(Z/nZ) ! Cn by 1 φ(f) = (f(0); f(1); : : : ; f(n − 1)): From here, it isn't hard to see that L2(Z=nZ)) is an n-dimensional vector space over C.
    [Show full text]
  • COMPARISON on DIFFERENT DISCRETE FRACTIONAL FOURIER TRANSFORM (DFRFT) APPROACHES Ishwor Bhatta
    University of New Mexico UNM Digital Repository Electrical and Computer Engineering ETDs Engineering ETDs 1-28-2015 COMPARISON ON DIFFERENT DISCRETE FRACTIONAL FOURIER TRANSFORM (DFRFT) APPROACHES Ishwor Bhatta Follow this and additional works at: https://digitalrepository.unm.edu/ece_etds Recommended Citation Bhatta, Ishwor. "COMPARISON ON DIFFERENT DISCRETE FRACTIONAL FOURIER TRANSFORM (DFRFT) APPROACHES." (2015). https://digitalrepository.unm.edu/ece_etds/32 This Thesis is brought to you for free and open access by the Engineering ETDs at UNM Digital Repository. It has been accepted for inclusion in Electrical and Computer Engineering ETDs by an authorized administrator of UNM Digital Repository. For more information, please contact [email protected]. Candidate Department This thesis is approved, and it is acceptable in quality and form for publication: Approved by the Thesis Committee: , Chairperson by THESIS Submitted in Partial Fulfillment of the Requirements for the Degree of The University of New Mexico Albuquerque, New Mexico Dedication I dedicate this work to my parents for their support and encouragement. ’I am a slow walker, but I never walk back’ – Abraham Lincoln iii Acknowledgments First of all, I heartily appreciate Dr. Balu Santhanam, my advisor and thesis chair, for continuing to encourage me through the years of classroom teachings and the long number of months writing and rewriting these chapters. I hope to emmulate his professional style as I continue my career. I also want to thank the members of my thesis committee, Dr. Maria Cristina Pereyra and Dr. Majeed Hayat. I want to thank Dr. Mark Gilmore, Ex-director of the ECE Graduate Program and Dr. Sudharman Jayaweera, Director of the ECE Graduate Program, for ap- pointing me as a Project Assistant at the Electrical and Computer Engineering Department for several semesters.
    [Show full text]