<<

An Exposition of

Mathematics 634: Harmonic Analysis

David Nahmias [email protected]

Abstract

Recent developments have led to an interest to characterize signals on connected graphs to better understand their harmonic and geometric properties. This paper explores spectral graph theory and some of its applications. We show how the 1-D Graph Laplacian, ∆D, can be related to the by its eigenfunctions which motivates a natural way of analyzing the spectrum of a graph. We begin by stating the Laplace-Beltrami Operator, ∆, in a general case on a Riemann manifold. The setting is then discretized to allow for formulation of the graph setting and the corresponding Graph Laplacian, ∆G. Further, an exposition on the Graph Fourier Transform is presented. Operations on the Graph Fourier Transform, including , modulation, and translation are presented. Special attention is given to the equivalences and differences of the classical translation operation and the translation operation on graphs. Finally, an alternate formulation of the Graph Laplacian on meshes, ∆M, is presented, with application to multi-sensor signal analysis.

December, 2017 Department of Mathematics, University of Maryland-College Park Spectral Graph Theory • David Nahmias

1. Background and Motivation

lassical Fourier analysis has found many important results and applications in signal analysis. Traditionally, Fourier analysis is defined on continuous, R, or discrete, Z, domains. CRecent developments have led to an interest in analyzing signals which originate from sources that can be modeled as connected graphs. In this setting the domain also contains geometric information that may be useful in analysis. In this paper we analyze methods of Fourier analysis on graphs and results in this setting motivated by classical results. We begin with the classical Fourier Transform,

Definition 1.1. For a function f (t), t ∈ R, we let the Fourier Transform, fb(γ), be defined as, Z fb(γ) = f (t)e−2πiγtdt = h f , e−2πiγti. (1) R Further, in the discrete setting,

Definition 1.2. For a function f [n], n ∈ Z, we let the Discrete Fourier Transform (DFT), fb[n], be defined as, N − i n fb[γ] = ∑ f [n]e 2π γ /N = h f , e−2πiγti (2) n=1 where we let [·] denote a function with discrete indices. We now note the following relationship between the DFT and spectral analysis via the Laplacian, the DFT basis functions form a set of eigenvectors of the 1-D discrete Laplace Operator, ∆D. For some x ∈ RN of finite length we say, 1 1 ∆ x = (x − − x ) + (x + − x ) (3) D 2 i 1 i 2 i 1 i where the indices are incremented and decremented modulo N, the number of elements. This can be written in matrix form such that ∆Dx = −LDx (4) where  1 1  1 − 2 0 ...... 0 − 2 − 1 − 1   2 1 2 0 ...... 0   ......  L =  ......  . (5) D  ......   1 1   0 ...... 0 − 2 1 − 2  1 1 − 2 0 ...... 0 − 2 1 So, Lemma 1.1. The basis vectors of the unitary DFT are orthonormal eigenvectors of any circulant matrix. Moreover, the eigenvalues of a circulant matrix are given by the DFT of its first column. n o Proof. Let W = e−2πi/N and F = √1 Wkn, 0 ≤ k, n ≤ N − 1 be the N × N unitary DFT matrix. N N N Let H be an N × N circulant matrix. Therefore, its elements satisfy

[H]m,n = h[(m − n)] = h[(m − n) modulo N], 0 ≤ m, n ≤ N − 1 (6)

T The basis vectors of the unitary DFT are columns of F∗ = F∗, where (·)∗ denotes the complex conjugate. So,   1 2πikn/N φk = √ e , 0 ≤ n ≤ N − 1 , k = 0, . . . , N − 1. (7) N

1 Spectral Graph Theory • David Nahmias

Now consider, N−1 1 2πikn/N [Hφk]m = √ ∑ h[m − n]e . (8) N n=0 Writing l = m − n and rearranging we have,

"N−1 −1 N−1 # 1 2πikm/N −2πikl/N −2πikl/N −2πikl/N [Hφk]m = √ e ∑ h[l]e + ∑ h[l]e + ∑ h[l]e . (9) N l=0 l=−N+m+1 l=m+1

Using equation6 and that e2πil/N = e−2πi(N−l)/N, since e2πiN/N = 1, the second and third terms in the brackets in equation9 cancel, thus we obtain the eigenvalue equation

[Hφk]m = λkφk[m] (10) or Hφk = λkφk (11) where λk, the eigenvalues of H, are defined as

N−1 −2πikl/N λk , ∑ h[l]e , 0 ≤ k ≤ N − 1 (12) l=0 This is simply the DFT of the first column of H.[5]

We note that a matrix is circulant if each row can be obtained as a shift, with circular wrap- around, of the previous row. It is clear that LD is circulant, thus establishing a relationship between Fourier analysis and the Laplacian.

2. Laplacian Operator

With this connection between Fourier analysis and the Laplacian, we now consider the Laplacian Operator in a general setting.

2.1 Continuous Laplace-Beltrami Operator We assume a compact Riemannian manifold (M, g) of dimension m, where M is a connected manifold and real-differentiable in C∞. The function g defines for each point p ∈ M the inner S product of the tangent space TpM. The union of all tangent spaces, p∈M TpM = TM. An m-dimensional manifold is a topological space, that locally resembles the Euclidean space Rm. If the manifold M has a boundary B = ∂M, it is assumed that M is oriented and that C∞ also applies boundary B. Further, the outward unit normal vector field on B is denoted by un. We consider the real-valued function f with f ∈ L2(M, g) and f ∈ Ck with k ≥ 2. The directional derivative of f at p ∈ M for each ζ ∈ TpM is denoted by ζ f . The gradient of f is the vector field on M with grad f = ζ f , ∀ζ ∈ TM. (13) k Now, let X, Y be a vector fields, which are in C , with k ≥ 1, and let ∇ζ X be the covariant derivatives of X with respect to ζ for all p ∈ M and ζ ∈ TpM. ∇ζ satisfies ∇ζ (X + Y) = ∇ζ X + ∇ζY and ∇ζ ( f X) = (ζ f )X(p) + f (p)∇ζ X. So, the divergence of X is defined by

divX = trace(∇ζ X), (14) where ζ ranges over TpM. Thus,

2 Spectral Graph Theory • David Nahmias

Definition 2.1. The Laplace-Beltrami Operator, ∆, is defined as ∆ f = div(grad f ). (15) If the manifold M possesses a boundary B, the following Boundary Conditions (BC) can be applied: The Dirichlet BC: f = 0, on ∂M (16) which imposes that the Laplacian acts on those functions which vanish on the boundary. ∂ f The Neumann BC: = un · ∆ f = 0, on ∂M (17) ∂un which for manifolds correspond to the normal derivatives vanishing on the boundary. The ∆ operator has a number of properties that allow for analyzing harmonic basis functions by solving the Laplacian eigenvalue problem ∆φi = λiφi which include ∆ f = 0 for constant f , symmetry, local support, linear precision, maximum principle, and positive semi-definiteness.[3] ∞ Further, the set of all eigenvalues {λi}i=1 defines the spectrum of M, ∞ spec(M) = {λi}i=1 = {0 ≤ λ1 < λ2 < ··· < λ∞} (18) ∞ with limi→∞ λ → ∞. The set of eigenfunctions {φi}i=1 forms an orthonormal basis and spectral analysis of functions defined on M. As shown in Lemma 1.1, the eigensystem of the Laplace- Beltrami Operator can be considered as a basis of a generalized Fourier analysis on M. So, for any point pi on M, an approximation for ∆ can be given be the curvilinear integral, 1 Z ∆ f (pi) = ( f (pi) − f (p)dp (19) |Γ| p∈Γ where Γ is a closed simple curve on M surrounding points pi, and |Γ| is the length of Γ. Further, specifically for a function f : R → R, it is precisely the second derivative, for which we have the difference formula f (x + h) − 2 f (x) + f (x − h) f 00(x) = lim . (20) h→0 h2 If we discretize the real line by dyadic points that can be written as k/2n, for k ∈ Z, n ∈ N, 1 1 f [x + n ] − 2 f [x] + f [x − n ] f 00[x] = lim 2 2 . (21) n→∞ 1 2 ( 2n )

2.2 Discrete Graph Laplacian

We now define the graph setting where we let G = G(V, E) denote a graph. V = {xi} denotes the vertex set where we assume a finite graph, that is, the size of the vertex set is finite, |V| = N < ∞. The edge set, E, consists of ordered pairs where if there is an edge between points x, y ∈ V we write x ∼ y. So, E = {(x, y) : x, y ∈ V and x ∼ y}. Further, we define the degree of x ∈ V, dx, to be the number of edges connected to point x. We consider functions defined on the vertex set f : V → R, xn 7→ f [xn]. If we consider equation 21, each vertex having an edge connecting it to its two closets neighbors, then we see it is the sum of all the differences of f (x) with f evaluated at all it’s neighbors. So, we write the Laplacian on a graph point-wise on a function f : V → R as

∆G f (x) = ∑ f [x] − f [y] (22) x∼y For finite graphs, |V| < ∞, we can express the Laplace Operator as a matrix.

3 Spectral Graph Theory • David Nahmias

Definition 2.2. Let D be the degree matrix, a diagonal N × N matrix, be defined as

D = diag(dx). Let A be the adjacency matrix, an N × N matrix, be defined as ( 1, if x ∼ x A(i, j) = i j 0, otherwise. So, the unnormalized Graph Laplacian is defined as

LG = D − A (23) or  d , if i = j  xi LG(i, j) = −1, if xi ∼ xj (24)  0, otherwise. Further, the normalized Graph Laplacian is defined as −1/2 1/2 −1/2 1/2 LG = IN − D AD = D LG D (25)

where IN is the N × N identity matrix.

3. Graph Fourier Transform

With the graph setting and LG defined, we now combine this with classical Fourier analysis to analyze the Graph Fourier Transform. We let functions f defined on a graph G to be written as N vectors f ∈ R , where f [i] for i = {0, ... , N − 1}, is the value of function f evaluated at vertex vi. 1/2 2  N−1 2 Further, we let f ∈ ` (G) and say k f k`2 = ∑i=0 | f [i]| . So, ( ) = { }N−1 Definition 3.1. Given graph, G, and its Laplacian, LG, with spectrum σ LG λk k=0 and { }N−1 → C ∈ `2( ) eigenvectors ϕk k=0 , the Graph Fourier Transform of f : V and f G is defined by N ∗ fb[λk] = h f , ϕki = ∑ f [n]ϕk [n]. (26) n=1

We note that the Graph Fourier Transform is only defined on values of the spectrum of LG, σ(LG). So fb will not be well-defined when λk has multiplicities greater than one. Further, Definition 3.2. The Graph Inverse Fourier Transform is defined by N−1 fb[n] = ∑ fb[λk]ϕk[n]. (27) n=0 If we consider a function f and its Graph Fourier Transform fb as N × 1 vectors, then equations 26 and 27 can be written as fb = Φ∗ f and f = Φ fb, respectively. We now see, Proposition 3.1. For any f , g : V → R, then Parseval’s relation holds for the Graph Fourier Transform. That is, h f , gi = h fb, gbi. Further, this implies, N N−1 2 2 2 2 k f k = | f [xn]| = | fb[λl]| = fb . (28) `2 ∑ ∑ `2 n=1 `=0 Proof. If we consider Φ, the unitary matrix, then we see ∗ ∗ ∗ ∗ ∗ ∗ ∗ h fb, gbi = fb gb = (Φ f ) Φ g = f ΦΦ g = f g = h f , gi. (29) 2 From this it is clear that k f k2 = fb .[7] `2 `2

4 Spectral Graph Theory • David Nahmias

4. Operations on the Graph Fourier Transform

4.1 Graph Convolution In the classical setting we have,

Definition 4.1. For f , g ∈ L2(R), we define convolution as Z ( f ∗ g)(t) = f (u)g(t − u)du. (30) R However, without a clear analogue of translation in the graph setting we make note of the convolution property (\f ∗ g)(γ) = fb(γ)gb(γ). So by equation 27 we have, Definition 4.2. For f , g : V → R, we define the Graph Convolution of f and g as

N−1 ( f ∗ g)[n] = ∑ fb[λl]gb[λl]ϕl[n]. (31) l=0

So we see the following properties,

Proposition 4.1. For f , g, h : V → R and α ∈ R,

1. [f ∗ g = fbgb 2. α( f ∗ g) = (α f ) ∗ g = f ∗ (αg)

3.f ∗ g = g ∗ f

4.f ∗ (g + h) = f ∗ g + f ∗ h

5. ( f ∗ g) ∗ h = f ∗ (g ∗ h) ∈ R [ ] = N−1 [ ] 6. Defining g0 by g0 n ∑l=0 ϕl n . Then g0 is an identity for the Graph Convolution such that f ∗ g0 = f

7. LG( f ∗ g) = (LG f ) ∗ g = f ∗ (LG g) √ h i h i 8. N ( f ∗ g)[n] = N fb[0]g[0] = √1 N f [n] N g[n] ∑n=1 b N ∑n=1 ∑n=1 The proof of these properties are direct results of Definition 4.2.[7] Further, we can express Graph Convolution as a matrix operation,   gb(λ0) . . . 0  . . .  ∗ f ∗ g = gb(LG) f = Φ  . .. .  Φ f . (32) 0 . . . gb(λN−1)

4.2 Graph Modulation Using the Euclidean space setting, where modulation of a function is multiplication of a Laplacian eigenfunction, we have

N N Definition 4.3. For any k = 0, 1, ... , N − 1, the Graph Modulation Operator, Mk : R → R , is defined as √ (Mk f )[n] = N f [n]ϕk[n]. (33)

5 Spectral Graph Theory • David Nahmias

Further, we can express the Graph Modulation Operator as a matrix,   ϕk[1] . . . 0  . . .  Mk =  . .. .  . (34) 0 . . . ϕk[N]

We see that M is the identity operator, ϕ [n] ≡ √1 , for all n. In the continuous setting, a 0 0 N modulation represents a translation in the Fourier domain, [Mτ f (γ) = fb(γ − τ), ∀γ ∈ R. However, this property does not hold true in the graph setting because of the discrete nature. Instead we have that if gb(l) = δ0(λl), then

N ∗ [Mτ g[λ ] = ∑ (Mτ g)[n])Φ [n] l n=√l = N NΦ[n] √1 Φ∗[n] ∑n=l N = δ0[λl − λτ] ( 1, if λ = λτ = l (35) 0, otherwise.

So, Mτ maps the constant component of f ∈ R to fb(0)ϕτ.

4.3 Graph Translation In the continuous setting we have,

2 Definition 4.4. For f ∈ L (R), the Translation Operator, τu, is defined as Z Z ∗ (τu f )(t) = f (t − u) = ( f ∗ δu)(t) = fb(k)δb(k)ϕk(t)dk = fb(k)ϕk (u)ϕk(t)dk (36) R R ( R ∗ 1, if x = u since δbu(k) = δu(x)ϕ (x)dxϕk(u), where δu(x) = R k 0, if x 6= u.

So, in the graph setting,

N N Definition 4.5. For any f : V → R we define the Graph Translation Operator, Ti : R → R , as

√ √ N−1 ∗ (Ti f )[n] = N( f ∗ δi)[n] = N ∑ fb[λl]ϕl [i]ϕl[n] (37) l=0 that is, the graph convolution of the Dirac delta centered at the ith vertex.

Further, we can express the Graph Translation Operator as a matrix operation,

 ϕ∗[i]ϕ [1] ϕ∗[i]ϕ [1] ... ϕ∗ [i]ϕ [1]   f [λ ]  √ 0 0 1 1 N−1 N−1 b 0 √  . . . .   .  ∗ Ti f = N  . . .. .   .  = NAiΦ f (38) ∗ ∗ ∗ ϕ0[i]ϕ0[N] ϕ1[i]ϕ1[N] ... ϕN−1[i]ϕN−1[N] fb[λN−1]

Thus,

Proposition 4.2. For any f , g : V → R and i, j ∈ {1, 2, . . . , N},

1. Ti( f ∗ g) = (Ti f ) ∗ g = f ∗ (Ti g)

6 Spectral Graph Theory • David Nahmias

2. TiTj f = TjTi f √ N N 3. ∑n=1(Ti f )[n] = N fb[0] = ∑n=1 f [n] Proof. Property 1 is clear from Definition 4.2. For Property 2, we see, √ [ ] = N−1 [ ] ∗[ ] [ ] TiTj f n N ∑l=0 Tcj f λl ϕl i ϕl n = N−1 N ( )[ ] ∗[ ] ∗[ ] [ ] N ∑l=0 ∑m=1 Tj f m ϕl m ϕl i ϕl n = N−1 N N−1 [ ] ∗[ ] ∗[ ] ∗[ ] ∗[ ] [ ] N ∑l=0 ∑m=1 ∑k=0 fb λk ϕk j ϕk m ϕl m ϕl i ϕl n = N−1 N N−1 [ ] ∗[ ] ( ) ∗[ ] [ ] N ∑l=0 ∑m=1 ∑k=0 fb λk ϕk j δk l ϕl i ϕl n = N−1 N−1 [ ] ∗[ ] ( ) ∗[ ] [ ] N ∑l=0 ∑k=0 fb λk ϕk j δk l ϕl i ϕl n = N−1 [ ] ∗[ ] ∗[ ] [ ] N ∑l=0 fb λl ϕl j ϕl i ϕl n = N−1 [ ] ∗[ ] ∗[ ] [ ] N ∑l=0 fb λl ϕl i ϕl j ϕl n N−1 ∗ = N ∑ ( [f ∗ δi)[λ ]ϕ [j]ϕ [n] l=0√ l l l = NTj( f ∗ δi)[n]

= TjTi f [n]. (39) Finally, Property 3 is clear from Definitions 4.2 and 4.5.[1,7]

Further, Corollary 4.3. For any f : V → R and i, n ∈ {1, 2, . . . , N},

Ti f [n] = (Tn f )[i] (40) Proof. Beginning from Definition 4.5 we have, √ ( )[ ] = N−1 [ ] ∗[ ] [ ] Ti f n N ∑l=0 fb λl ϕl i ϕl n √ ( )[ ] = N−1 [ ] ∗[ ] [ ] Ti f n N ∑l=0 fb λl ϕl i ϕl n √ = N−1 b[ ] [ ] ∗[ ] N ∑l=0 f λl ϕl i ϕl n = (Tn f )[i]

(Ti f )[n] = (Tn f )[i] (41)

{ }N−1 We note then that if the eigenvectors ϕl l=0 are real-valued that,

(Ti f )[n] = (Tn f )[i] (42) From these properties we see that the Graph Translation Operator is distributive with convolution and that the translation operator commutes among other translation operators. However, many other properties that hold for the classical translation operator do not hold for the Graph Transla- tion Operator. For example, in general, TiTj 6= Ti+j. This is only true for shift-invariant graphs, that is, when the DFT basis vectors are exactly the the Graph Laplacian eigenvectors. Then, = ∀ ∈ { } TiTj T[((i−1)+(j−1)) mod N]+1, i, j 1, 2, . . . , N . (43)

Further, the Graph Translation Operator is not isometric, that is, kTi f k2 6= k f k2. However, we can state the following bounds on kTi f k2,

7 Spectral Graph Theory • David Nahmias

Theorem 4.4. For any f : V → R, √ √ | fb(0)| ≤ kTi f k2 ≤ N max |ϕl[i]| k f k2 ≤ N max kϕlk∞ k f k2 (44) l∈{0,1,...,N−1} l∈{0,1,...,N−1}

Proof. Beginning with Definition 4.5,

 2 2 = N N−1 [ ] ∗[ ] [ ] kTi f k2 N ∑n=1 ∑l=0 fb λl ϕl i ϕl n = N−1 N−1 [ ] [ ] ∗[ ] ∗[ ] N [ ] [ ] N ∑l=0 ∑k=0 fb λl fb λk ϕl i ϕk i ∑n=1 ϕl n ϕk n = N−1 N−1 [ ] [ ] ∗[ ] ∗[ ] N ( ) N ∑l=0 ∑k=0 fb λl fb λk ϕl i ϕk i ∑n=1 δk l (45) = N−1 | [ ]|2| ∗[ ]|2 N ∑l=0 fb λl ϕl i 2 2 ≤ N maxl∈{0,1,...,N−1} |ϕl[i]| k f k2 (46) 2 2 ≤ N maxl∈{0,1,...,N−1} kϕlk∞ k f k2 (47)

{ }N−1 where equality in equation 45 comes from the fact that ϕl l=0 is an orthonormal basis and can choose the eigenvectors to be real-valued. Further,

2 = N−1 | [ ]|2| ∗[ ]|2 kTi f k2 N ∑l=0 fb λl ϕl i 2 ∗ 2 ≥ N| fb[λ0]| |ϕ0[i]| 2 = N| fb[0]|2 √1 (48) N = | fb[0]|2 (49) √ where equation 48 comes from the fact that ϕ0[n] = 1/ N. Taking the square-roots of equations 46, 47, and 49 we obtain our bounds.[7]

In addition we have,

Proposition 4.5. In general, the Graph Translation Operator, Ti, is not injective and therefore invertible. Proof. Let us suppose that there exists some k ∈ {1, 2, ... , N − 1} and 1 ∈ {1, 2, ... , N}, for which ϕk[i] = 0. Then if f = ϕk, we have fb[λl] = δk(l) and

√ N−1 √ ∗ ∗ ∗ ∗ Ti f [n] = N ∑ fb[λl]ϕl [i]ϕl [n] = Nϕl [i]ϕl [n] = 0 (50) l=0 for all n = 1, 2, ... , N. Therefore, there exists a nonzero f : V → R such that Ti f = 0. So, we see Ti is not injective and therefore not invertible.[1] However,

Theorem 4.6. If ϕk[i] 6= 0 for all k = 1, ... , N − 1, then for f : V → R, the Graph Translation Operator Ti is invertible and its inverse is given by

 ∗ −1 ∗ −1 ∗ −1    ϕ0[1]ϕ0[i] ϕ0[2]ϕ0[i] ... ϕ0[N]ϕ0[i] f [0] 1 1 −1 = √  . . .. .   .  = √ −1 Ti f Φ  . . . .   .  ΦA f . N ∗ −1 ∗ −1 ∗ −1 N ϕN−1[1]ϕN−1[i] ϕN−1[2]ϕN−1[i] ... ϕN−1[N]ϕN−1[i] f [N − 1] (51)

8 Spectral Graph Theory • David Nahmias

Proof. Using A and A−1 given by equations 38 and 51, respectively, we see −1 N −1 Ai Ai (n, m) = ∑k=1 Ai(n, k)Ai (k, m) = N−1 ∗[ ] [ ] ∗[ ] ∗[ ]−1 ∑k=0 ϕk i ϕk n ϕk m ϕk i = N−1 [ ] ∗[ ] ∑k=0 ϕk n ϕk m = δn[m] (52) and −1 N −1 Ai Ai(n, m) = ∑k=1 Ai (n, k)Ai(k, m) = N−1 ∗ [ ] ∗ [ ]−1 [ ] ∗ [ ] ∑k=0 ϕn−1 k ϕn−1 i ϕm−1 k ϕm−1 i ∗ −1 ∗ N ∗ = ϕn−1[i] ϕm−1[i] ∑k=1 ϕn−1[k]ϕm−1[k] ∗ −1 ∗ = ϕn−1[i] ϕm−1[i]δn[m] (53) −1 −1 so we have that Ai Ai = Ai Ai = IN. Thus, −1 ∗ −1 −1 ∗ −1 TiTi = AiΦ ΦAi = IN = ΦAi AiΦ = Ti Ti (54) by the orthonormality of Φ.[1]

5. Mesh Formulation and Application

We now consider an alternative formulation of the Laplacian on meshes where, in application, sensors located on an arbitrary surface, can be discretely represented as a triangular mesh in R3. A mesh M = {V, E, T}, consists of vertices v ∈ V, edges e ∈ E, and triangles t ∈ T 3 where each vi ∈ R represents a sensor. The neighborhood Ni for vertex vi ∈ V is defined as Ni = {vx ∈ V : eix ∈ E}. In this formulation we note angles αij and βij are located opposed to edge eij, connecting vertices vi and Vj. Further, triangles ta and tb are defined by vertices (vi, vj, vk) and (vi, vj, vl), respectively, that share the edge eij. These mesh components are shown in Figure1.

Figure 1: Discrete representation of multi-sensor arrays on an arbitrary surface as a mesh with its components.[3]

So, extending the approximation from equation 19, N Definition 5.1. For a function f ∈ R defined over all vi ∈ V, f : vi → R, with i = {1, ... , |V|}, a discretization of the continuous Laplace-Beltrami Operator on a mesh is defined as, −1 ∆M fi = bi ∑ w(i, x)( fi − fx) (55) x∈Ni

9 Spectral Graph Theory • David Nahmias

with weighing function w(i, x) for edges eix ∈ E and normalization coefficient bi for vertex vi. This can be expressed in matrix form such that

∆M f = −LM f (56) where the LM can be expressed as

−1 LM = B S (57) where ( b−1, if i = j B−1 = i (58) 0, otherwise and  ∑ w(i, x), if i = j  x∈Ni S = −w(i, x), if eix ∈ E (59)  0, otherwise. We call B and S the mass and stiffness matrices, respectively. −1 In a graph-theoretic approach, using w(i, x) = bi = 1 we obtain LD from equation5. Alterna- tively, using a geometric discretization through the Finite Element Method (FEM), we can compute B from equation 60 by,  (∑t∈T |t|)/6, if i = j  i (| |+| |) B(i, j) = ta tb /12, if eij ∈ E (60)  0, otherwise where Ti = {tx ∈ T : vi ∈ tx}, the set of triangles sharing the vertex vi. Further, using a geometric discretization derived by minimizing the Dirichlet energy for a triangu- lated mesh, we can compute S from equation 59 with

1 w(i, x) = (cot (α ) + cot (β )). (61) 2 ix ix

Note that for edges on the boundary of the mesh, the cot (βix)) term is omitted, leading to the Neumann BC. This formulation allows for the geometric relationship between sensors to be taken into consider- ation. This has found application in analyzing electroencephalograms (EEG), a neuro-imaging method that places an array of electrodes at different positions on the scalp. Being able to consider the geometric relationship between sensors and their data may lead to better spatial understanding of the EEG signal and their physiological representation of neurological activity.[3,6]

6. Conclusion

We have presented several extensions of classical Fourier analysis techniques in a graph setting noting some properties and operations that are equivalent and others that differ. Further analysis and exposition on the Graph Convolution, Modulation, and Translation Operators have been done but are not presented here.[1, 7] Finally, other classical Fourier analysis results have been studied and extended to the graph setting including the Uncertainty Principle [2], the Wavelet Transform [4], and Fourier Frames [7].

10 Spectral Graph Theory • David Nahmias

References

[1] Matthew Begué. Expedition in Data and Harmonic Analysis on Graphs. PhD thesis, University of Maryland.

[2] John Benedetto and Paul Koprowski. Graph Theoretic Uncertainty Principles. International Conference on Sampling Theory and Applications (SampTA), 2015.

[3] Uwe Graichen, Roland Eichardt, Patrique Fiedler, Daniel Strohmeier, Frank Zanow, and Jena Haueisen. SPHARA - A Generalized Spatial Fourier Analysis for Multi-Sensor Systems with Non-Uniformly Arranged Sensors: Application to EEG. PLoS ONE, 10(4), 2015.

[4] David Hammond, Pierre Vandergheynst, and Rémi Gribonval. Wavelets on Graphs via Spectral Graph Theory. Applied and Computational Harmonic Analysis, 30(2):129–150, 2011.

[5] Anil Jain. Fundamentals of Digital Image Processing. Prentice Hall Information And System Sciences Series. Prentice Hall, 1st edition, 1989.

[6] Bruno Lévy and Hao Zhang. Spectral Mesh Processing. SIGGRAPH, 2009. Course 32.

[7] David Shuman, Benjamin Ricaud, and Pierre Vandergheynst. Vertex-Frequency Analysis on Graphs. Preprint, 2013.