Problem descriptions: Non-uniform fast Fourier transform

Size: px
Start display at page:

Download "Problem descriptions: Non-uniform fast Fourier transform"

Transcription

1 Problem descriptions: Non-uniform fast Fourier transform Lukas Exl 1 1 University of Vienna, Institut für Mathematik, Oskar-Morgenstern-Platz 1, A-1090 Wien, Austria December 11, 2015 Contents 0.1 Software for NUFFT Notation and setting NUDFT - Non-uniform discrete Fourier transform NUFFT Matrix form Window functions Gridding Type NUFFT in micromagnetic computation List of Algorithms 1 Type-1 NUFFT Type-2 NUFFT Corresponding author, lukas.exl@univie.ac.at 1

2 NUFFT - Non-uniform FFT Non-uniform fast Fourier transform (NUFFT) dates back to the 90 s [1, 2]. It is a fast computational scheme for non-equispaced/uniform discrete Fourier transforms (NDFT), like fast Fourier transform (FFT) is a fast scheme for (ordinary) discrete Fourier transform (DFT). According to a distinction of the input/output objects, there are three main types of non-uniform discrete Fourier transform. One that gets non-uniformly located data points as input and creates a multi-index object 1. This type is often referred to as type-1 NUFFT [3] (or transposed NUFFT [4 6]). Another one (type-2) gets a multi-index object and creates a vector with indices related to non-equispaced locations in physical space. Finally, if both input and output data are non-equispaced, a combination of the type-1 and type-2 NUFFT leads to the so-called type-3 NUFFT [4, 7]. One possible application for NUFFT is the so-called discrete convolution with non-equispaced data, which appears for example in particle physics in the context of the computation of potentials or non-local (force-)fields. The reason for this application is the fact that the convolution theorem for discrete convolution 2 of equispaced data with radial kernels generalizes to nonequispaced data [5]. This makes this fast convolution method a quasi-linearly scaling method (N log N). Consider a discrete convolution of non-equispaced data, i.e. φ(x i ) = M α j K(x i y j ), α j R, x i, y j ( 1, )3, j = 1... M, i = 1... N, (1) j=1 where K is some radial kernel function like, for example, the Newtonian kernel N(x) := 1/ x. Approximation of (a smoothed version of) the kernel by a Fourier series leads to a computational scheme similar to that derived from the convolution theorem for equispaced data, where (inverse) Fourier transform is replaced by the (type-2) discrete Fourier transform, i.e. there is the following analogy F 1( F (α) F (k) ) NUFFT H( NUFFT(α) F (k) ), (2) where NUFFT and NUFFT H denotes the type-1 and type-2 NUFFT, respectively, and the symbol means element-wise multiplication, cf. Sec. 0.2 for notations. Such a method uses NUFFT for the so-called far-field part of the computation 3 in Fourier space, while the near field part (correction for the smoothing step) is computed in physical space. 1 tensor. 2 Convolution is inverse Fourier transform of the product of the Fourier transforms. 3 The vector/tensor k consists of equidistant samples of some smoothed version of the kernel function K. 2

3 Another application arises in the numerical treatment of higher dimensional integrals, where one typically has to deal with the so-called curse of dimensionality, i.e. the computations scale exponentially with the dimension in the exponent, e.g. S 3 for three dimensions and S grid (or quadrature) points in each principal direction. NUFFT was successfully applied for the efficient and highly accurate (higher dimensional) quadrature of Fourier integrals related to the computation of potentials/fields [8]. Such methods split the Fourier formulation of the potential problem into a near and a far field part, where NUFFT is used for the computation of the near field part in Fourier space. Further applications can be found in [3, 7, 9, 10] and references therein, which include fast image reconstruction in magnetic resonance imaging (MRI), fast summation, fast Gaussian transform, polar FFT, CT/Radon transform, quadrature on manifolds, etc. 0.1 Software for NUFFT Courant Mathematics and Computing Laboratory: [10] TU Chemnitz: [9] University of Michigan Image reconstruction toolbox: [11] Air Force Research Laboratories via Matlab Central: [12] 0.2 Notation and setting For the description we use three dimensions, generalization to arbitrary dimension is readily possible. We basically need two ingredients: Non-equispaced data points: M arbitrarily located data points (scaled because of technical reason), i.e. y j ( 1 2, 1 2 )3 =: T, j = 1... M. Multi-index set: For the grid size n = (n 1, n 2, n 3 ) with n i 2N, we define the multi-index set I n := {k Z 3 n/2 c k c n/2 1}, where c means that the relation holds for each component. The indices k I n label the grid points of a Cartesian grid (tensor grid) with size I n = n 1 n 2 n 3. 3

4 Vectors are understood as columns, the symbol (.) T means transpose, i.e. the vector k = (k 1, k 2, k 3 ) T is a transposed row. We also use the short notation k T y := k 1 y 1 + k 2 y 2 + k 3 y 3 for the inner product. For component-wise multiplication we use the notation k y := (k 1 y 1, k 2 y 2, k 3 y 3 ) T ; for componentwise inversion simply k 1 := (1/k 1, 1/k 2, 1/k 3 ) T. 0.3 NUDFT - Non-uniform discrete Fourier transform The sums f k = M f j e 2πikT y j, f j C, y j T j=1 g j = f k e 2πikT y j, f k C, y j T k I n (type-1), (type-2), are analogues of the discrete Fourier transform (DFT), so-called non-uniform discrete Fourier transforms (NUDFT). Observe, however, that a big difference to ordinary discrete Fourier transform makes the fact that these sums are not inverse or unitary transformations to each other in general. An exception is the case where the data y j, j = 1... M j n 1, j I n are equispaced on a tensor grid with I n ( M) grid points, which makes it a discrete Fourier transform. (3) 0.4 NUFFT Fast approximate methods have been invented, which break down the quadratic computational complexity O(M I n ) of the sums (3) to only O( I n log I n + M) in the case of non-uniform fast Fourier transform (NUFFT). The basic idea 4 is to smear the data over a tensor grid by a gridding process and then apply FFT. The data-smearing is undone afterwards (deconvolution). In the case of convolution with, e.g., a Gaussian heat kernel as gridding procedure, this deconvolution step is a simple scalar division in Fourier space. Type-2 NUFFT consists of the transposed operations. For a complete derivation the reader is referred to e.g. [4]. We consider the problem of computing type-1 NUFFT, i.e. f k = M f j e 2πikT y j, f j C, y j T, (4) j=1 and briefly give an algorithmic description (again dimension d = 3 is easily adapted to any other): 4 In the case of type-1 NUFFT; type-2 NUFFT is the transposed operation of type-1 NUFFT, see. Sec

5 Algorithm 1 Type-1 NUFFT Given n 2N 3, α, M N (e.g. α = 2), data y j T, j = 1... M, sources f j C, j = 1... M. Define N = αn. 1. Gridding/ Sparse convolution : For l I N compute g l = f j ψ(y j l N 1 ), (5) by exploiting the locality of the window function ψ. j 2. FFT: For k I n compute DFT (utilizing multivariate FFT) ĝ k := g l e 2πikT (l N 1). (6) l I N 3. Deconvolution: For k I n compute f k := ĝ k I N c k (ψ), (7) where c k (ψ) are the precomputed Fourier coefficients of the window function ψ. The first part in Alg. 1 scales linearly in M (see Sec. 0.7), where the constant depends on the accuracy of the sparse approximation of the sum in (5). The scaling of the FFT part in Alg. 1 is O( I N log I N ). The deconvolution scales linearly in the size of the tensor grid. Overall Alg. 1 scales like O( I N log I N + M). 0.5 Matrix form The three steps in Alg. 1 can be summarized in matrix vector notation as f = D F G f, (8) where G is the (sparse) gridding matrix of size I N M, F denotes the Fourier transform and D the diagonal matrix which realizes step 3 in Alg. 1. The vectors f and f consist of entries f j and f k, respectively. The sparsity of the matrix G is discussed in Sec. 0.6 and Window functions The sum in (5) is too complex to be calculated exactly (would yield O( I N M) complexity). Hence, approximations have to be considered which yield truncation errors and aliasing errors 5

6 (cf. Eqn. (5) and (7), respectively). In order to keep those errors small, common window functions are local in time and frequency space. Moreover, tensor products of 1-dimensional functions are used to construct higher-dimensional functions. Typical examples for window functions are so-called (dilated) Gaussian functions, i.e. ψ(x) = c 1 e c 2 (nx)2 m, c1, c 2 > 0, m N, (9) with known Fourier transform (also Gaussian) which is used in step 3 of Alg. 1. The higher dimensional function is simply constructed as tensor product, i.e. ψ(x) = ψ 1 (x 1 )ψ 2 (x 2 )ψ 3 (x 3 ). Possible are also so-called (dilated) cardinal central B-splines, (dilated) sinc functions or (dilated) Kaiser-Bessel functions, cf. D. Potts [13] where also exponential error decay w.r.t. the truncation parameter m is shown. As mentioned before the gridding step (cf. step 1 in Alg. 1 and Sec. 0.7) includes truncation, which yields a sparse approximation for the matrix G in the matrix-vector multiplication G f in (8). The non-zeros of the matrix G are contributions of the window function which are numerically significant. There are a few different ways to deal with this matrix-vector evaluation, depending on whether the matrix is fully precomputed or some compressed storage variant is used. Fully precomputed window functions All the values ψ(y j l N 1 ) for j = 1... M and l I N,m (y j ) 5 are precomputed. These are at most (2m + 1) 3 M real numbers, where m is a small number (about 4 20) depending on the desired accuracy and the used type of window function. The complexity of the matrix-vector evaluation is O ( (2m + 1) 3 M ) too. Tensor product precomputation If the window functions are tensor products 6 it is also possible to only precompute the values ( ) ψ q (y j ) q l q /N q for all components q. In three dimensions this strategy yields a storage demand of 3(2m + 1)M, where the complexity for the matrix-vector product increases by 2(2m + 1) 3 extra multiplications (for each of the M nodes y j ) for the construction of the multivariate function from its product structure. The overall asymptotic complexity of the matrix-vector evaluation is still O ( (2m + 1) 3 M ). 5 A certain subset of I N, cf. Sec This is the case for all above mentioned types of window functions, but not for those used in [14]. 6

7 Table interpolation While the tensor product structure decreases the storage costs for the rows of G, (linear) interpolation of the window functions can reduce costs for the columns. This is especially useful if M is very large. A large amount of equidistant samples of the components ψ q are precomputed and stored. During the NUFFT algorithm these precomputed samples are used for the ( ) approximation of the desired values ψ q (y j ) q l q /N q by linear interpolation (two neighbors of (y j ) q ). See e.g. [15] for a paper on that topic. 7 Of course, higher order interpolation is also possible. In any case, storage requirements are drastically reduces because only the equidistant samples have to be kept in memory, i.e. 3S in three dimensions for S equidistant samples in each direction (independent of M and n). These approaches require a multiple of (2m + 1) 3 extra multiplications per node y j. Fast Gaussian gridding Fast Gaussian gridding was introduced in [3] for the case of Gaussian window functions. It uses the tensor structure of the window function and, especially, a certain splitting of the exponential function for Gaussian window functions. Storage is reduced to 2dM + d(2m + 1) (d dimensions) without any approximation. The splitting (in d = 1 dimension) which is used for the evaluation of the values ψ(y j l/n), l I n,m (y j ) 8 for fixed node y j reads e c(ny j l) 2 = e c ((ny j u) l ) 2 = e c(ny j u) 2 (e 2c(ny j u) ) l e cl 2, (10) where u := min I n,m (y j ), l = m and c = c(m) > 0 is some constant depending on m. The first two factors on the r.h.s. of (10) are constant for fixed y j. The last factor is even independent of the node y j, which simply allows precomputing those 2m + 1 values in the beginning of the NUFFT. The l -powers in the second term (brackets) can be calculated successively by 2m 1 multiplications from the l = 1 value. Hence, it is enough to store only 2M + (2m + 1) values (d = 1) and 2dM + d(2m + 1) (d dimensions) in general. 0.7 Gridding In the gridding step in Alg. 1 the summation is only over those indices j where ψ(y j l N 1 ) contributes. So, one way to realize this would be to identify, for all l in the multi-index set individually, all corresponding j where ψ(y j l N 1 ) is essentially zero. Afterwards simply restrict summation to those indices j. But, since I N is typically much larger than M a transposed strategy is useful: Consider the window function to be (numerically) zero outside the hypercube 3 q=1[ m/n q, m/n q ] 7 In reference [15] the term gridding is used for the whole type-1 NUFFT. 8 See Sec. 0.7 for the description of the index set I n,m (y j ). 7

8 for m N. For fixed j we collect those indices l for which y j l N 1 lies inside the hypercube 3 q=1[ m/n q, m/n q ] and call this set I N,m (y j ), i.e. I N,m (y j ) := {l I N mn 1 c N 1 l y j c mn 1 } (11) = {l I N y j N m1 c l c y j N + m1}. (12) This set has at most (2m + 1) 3 elements if y j T. As a result the computation of the convolution in (0.7) is realized as follows: Initialize all g l with zeros For j = 1... M calculate the vector ( f j ψ(y l N 1 ) ) and add it to (g l I N,m l) l IN,m (y (y j ) j ), which scales linearly in M, i.e. at most µm operations are needed, with a constant µ which is smaller or equal a uniform bound for the sizes of the sets I N,m (y j ), j = 1... M, i.e. µ (2m+1) Type-2 The type-2 NUFFT, cf. formula (3), is the adjoint of the type-1 NUFFT, i.e. in matrix form we have g = G T F H D f. (13) An algorithm to efficiently compute the sum g j = f k e 2πikT y j, f k C, y j T, (14) k I n is given in Alg. 2. The scaling is also O( N log N + M) like for type-1 NUFFT. 0.9 NUFFT in micromagnetic computation In computational micromagnetics a large community uses fast Fourier transform (FFT) methods for the computation of the non-local stray field on rectangular domains [16]. Such a method strongly relies on a uniform Cartesian grid, since only for uniform data the computationally beneficial FFT applies. Even adaption to curved geometries by local corrections was considered [17] in order to maintain the core of the method. However, ordinary FFT algorithms do not apply anymore for non-uniformly distributed sources (magnetic moments), like due to a finite element discretization of the magnet. Quadrature approximation of the Green s function form of the magnetic scalar potential yields discrete convolution with non-equidistantly distributed sources similar to that in (1). This approach was reported in [18] for a P1-FE discretization (in 8

9 Algorithm 2 Type-2 NUFFT Given n 2N 3, α, M N (e.g. α = 2), data y j T, j = 1... M, sources f k C, k I n. Define N = αn. 1. For k I n compute ĝ k := f k I N c k (ψ), (15) where c k (ψ) are the precomputed Fourier coefficients of the window function ψ. 2. For l I n compute DFT (utilizing multivariate FFT) g l := ĝ k e 2πikT (l N 1). (16) k I N 3. For j = 1... M compute g j = g l ψ(y j l N 1 ), (17) l by exploiting the locality of the window function ψ. two dimensions). The method applies NUFFT as in algorithm 1 and 2. A different method was introduced in [14, 19]. Here, the type-1 NUFFT is modified in a way that the window functions already incorporate the geometry of the finite element mesh. As a consequence, the number of non-uniform sources (M) is greatly reduced. On the other hand, the window functions lose the convenient tensor product property, and hence, only a full storage scheme is possible, cf. Sec Further approximation was considered, e.g. compression for tensors, like TT-format, etc., see [14] and related references therein. Due to the FFT on the auxiliary tensor grid, both approaches are not well suited/efficient for very inhomogeneous distributions of sources, as it would arise for instance for local FE-mesh refinement. For such cases the linearly scaling fast multipole method (FMM) is widely used. However, in the case of reasonably uniformly distributed sources, the rather large constant in the O(M)-scaling of the FMM makes a NUFFT method more favorable (see remark of Greengard himself in [8]). References [1] A. Dutt and V. Rokhlin. Fast Fourier transforms for nonequispaced data. SIAM Journal on Scientific computing, 14(6): ,

10 [2] G. Beylkin. On the fast Fourier transform of functions with singularities. Applied and Computational Harmonic Analysis, 2(4): , [3] L. Greengard and J.-Y. Lee. Accelerating the nonuniform fast Fourier transform. SIAM review, 46(3): , [4] D. Potts, G. Steidl, and M. Tasche. Fast Fourier transforms for nonequispaced data: A tutorial. In Modern sampling theory, pages Springer, [5] D. Potts and G. Steidl. Fast summation at nonequispaced knots by NFFT. SIAM Journal on Scientific Computing, 24(6): , [6] D. Potts, G. Steidl, and A. Nieslony. Fast convolution with radial kernels at nonequispaced knots. Numerische Mathematik, 98(2): , [7] J.-Y. Lee and L. Greengard. The type 3 nonuniform FFT and its applications. Journal of Computational Physics, 206(1):1 5, [8] S. Jiang, L. Greengard, and W. Bao. Fast and accurate evaluation of nonlocal Coulomb and dipole-dipole interactions via the nonuniform FFT. SIAM J. Sci. Comput., 36(5): B777 B794, [9] J. Keiner, S. Kunis, and D. Potts. NFFT from TU Chemnitz. URL tu-chemnitz.de/~potts/nfft/. [10] CMCL. NUFFT software from CMCL. URL nufft/nufft.html. [11] J. Fressler. Image reconstruction toolbox. URL ~fessler/code/. [12] M. Ferrara. NUFFT software via Matlab Central. URL matlabcentral/fileexchange/25135-nufft--nfft--usfft. [13] D. Potts. Schnelle Fourier Transformationen für nichtäquidistante Daten und Anwendungen. Habilitationsschrift, Universität zu Lübeck, [14] L. Exl and T. Schrefl. Non-uniform FFT for the finite element computation of the micromagnetic scalar potential. Journal of Computational Physics, 270: , [15] P. J Beatty, D. G. Nishimura, and J. M. Pauly. Rapid gridding reconstruction with a minimal oversampling ratio. Medical Imaging, IEEE Transactions on, 24(6): ,

11 [16] M. J. Donahue and D. G. Porter. OOMMF User s Guide, Version 1.0. Interagency Report, NISTIR 6376, sep [17] M. J. Donahue and R. D. McMichael. Micromagnetics on curved geometries using rectangular cells: Error correction and analysis. IEEE Trans. Magn., 43(6): , June doi: /TMAG [18] E. Kritsikis, J.-C. Toussaint, O. Fruchart, H. Szambolics, and L. Buda-Prejbeanu. Fast computation of magnetostatic fields by nonuniform fast Fourier transforms. Applied Physics Letters, 93(13): , [19] L. Exl. Tensor grid methods for micromagnetic simulations. PhD thesis, Vienna UT,

Introduction to Practical FFT and NFFT

Introduction to Practical FFT and NFFT Introduction to Practical FFT and NFFT Michael Pippig and Daniel Potts Department of Mathematics Chemnitz University of Technology September 14, 211 supported by BMBF grant 1IH81B Table of Contents 1 Serial

More information

Introduction to Practical FFT and NFFT

Introduction to Practical FFT and NFFT Introduction to Practical FFT and NFFT Michael Pippig and Daniel Potts Faculty of Mathematics Chemnitz University of Technology 07.09.2010 supported by BMBF grant 01IH08001B Table of Contents 1 Serial

More information

Numerical stability of nonequispaced fast Fourier transforms

Numerical stability of nonequispaced fast Fourier transforms Numerical stability of nonequispaced fast Fourier transforms Daniel Potts and Manfred Tasche Dedicated to Franz Locher in honor of his 65th birthday This paper presents some new results on numerical stability

More information

Recent Results for Moving Least Squares Approximation

Recent Results for Moving Least Squares Approximation Recent Results for Moving Least Squares Approximation Gregory E. Fasshauer and Jack G. Zhang Abstract. We describe two experiments recently conducted with the approximate moving least squares (MLS) approximation

More information

Particle Simulation Based on Nonequispaced Fast Fourier Transforms

Particle Simulation Based on Nonequispaced Fast Fourier Transforms Particle Simulation Based on Nonequispaced Fast Fourier Transforms Michael Pippig and Daniel Potts Chemnitz University of Technology Department of Mathematics 0907 Chemnitz, Germany E-mail: {michael.pippig,

More information

Direct Methods for Reconstruction of Functions and their Edges from Non-Uniform Fourier Data

Direct Methods for Reconstruction of Functions and their Edges from Non-Uniform Fourier Data Direct Methods for Reconstruction of Functions and their Edges from Non-Uniform Fourier Data Aditya Viswanathan aditya@math.msu.edu ICERM Research Cluster Computational Challenges in Sparse and Redundant

More information

Numerical Approximation Methods for Non-Uniform Fourier Data

Numerical Approximation Methods for Non-Uniform Fourier Data Numerical Approximation Methods for Non-Uniform Fourier Data Aditya Viswanathan aditya@math.msu.edu 2014 Joint Mathematics Meetings January 18 2014 0 / 16 Joint work with Anne Gelb (Arizona State) Guohui

More information

Non-Uniform Fast Fourier Transformation (NUFFT) and Magnetic Resonace Imaging 2008 년 11 월 27 일. Lee, June-Yub (Ewha Womans University)

Non-Uniform Fast Fourier Transformation (NUFFT) and Magnetic Resonace Imaging 2008 년 11 월 27 일. Lee, June-Yub (Ewha Womans University) Non-Uniform Fast Fourier Transformation (NUFFT) and Magnetic Resonace Imaging 2008 년 11 월 27 일 Lee, June-Yub (Ewha Womans University) 1 NUFFT and MRI Nonuniform Fast Fourier Transformation (NUFFT) Basics

More information

A Fast Algorithm for Spherical Grid Rotations and its Application to Singular Quadrature

A Fast Algorithm for Spherical Grid Rotations and its Application to Singular Quadrature A Fast Algorithm for Spherical Grid Rotations and its Application to Singular Quadrature Zydrunas Gimbutas Shravan Veerapaneni September 11, 2013 Abstract We present a fast and accurate algorithm for evaluating

More information

Sparse Fourier Transform via Butterfly Algorithm

Sparse Fourier Transform via Butterfly Algorithm Sparse Fourier Transform via Butterfly Algorithm Lexing Ying Department of Mathematics, University of Texas, Austin, TX 78712 December 2007, revised June 2008 Abstract This paper introduces a fast algorithm

More information

Using NFFT 3 a software library for various nonequispaced fast Fourier transforms

Using NFFT 3 a software library for various nonequispaced fast Fourier transforms Using NFFT 3 a software library for various nonequispaced fast Fourier transforms Jens Keiner University of Lübeck 23560 Lübeck, Germany keiner@math.uni-luebeck.de and Stefan Kunis Chemnitz University

More information

Constructing Approximation Kernels for Non-Harmonic Fourier Data

Constructing Approximation Kernels for Non-Harmonic Fourier Data Constructing Approximation Kernels for Non-Harmonic Fourier Data Aditya Viswanathan aditya.v@caltech.edu California Institute of Technology SIAM Annual Meeting 2013 July 10 2013 0 / 19 Joint work with

More information

Math 671: Tensor Train decomposition methods

Math 671: Tensor Train decomposition methods Math 671: Eduardo Corona 1 1 University of Michigan at Ann Arbor December 8, 2016 Table of Contents 1 Preliminaries and goal 2 Unfolding matrices for tensorized arrays The Tensor Train decomposition 3

More information

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation A Fast N-Body Solver for the Poisson(-Boltzmann) Equation Robert D. Skeel Departments of Computer Science (and Mathematics) Purdue University http://bionum.cs.purdue.edu/2008december.pdf 1 Thesis Poisson(-Boltzmann)

More information

Fast Multipole Methods

Fast Multipole Methods An Introduction to Fast Multipole Methods Ramani Duraiswami Institute for Advanced Computer Studies University of Maryland, College Park http://www.umiacs.umd.edu/~ramani Joint work with Nail A. Gumerov

More information

arxiv: v1 [physics.comp-ph] 19 Jan 2015

arxiv: v1 [physics.comp-ph] 19 Jan 2015 ACCURATE AND EFFICIENT COMPUTATION OF NONLOCAL POTENTIALS BASED ON GAUSSIAN-SUM APPROXIMATION LUKAS EXL, NORBERT J. MAUSER, AND YONG ZHANG arxiv:1501.04438v1 [physics.comp-ph] 19 Jan 2015 Abstract. We

More information

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov Fast Multipole Methods: Fundamentals & Applications Ramani Duraiswami Nail A. Gumerov Week 1. Introduction. What are multipole methods and what is this course about. Problems from physics, mathematics,

More information

Sparse and Fast Fourier Transforms in Biomedical Imaging

Sparse and Fast Fourier Transforms in Biomedical Imaging Sparse and Fast Fourier Transforms in Biomedical Imaging Stefan Kunis 1 1 joint work with Ines Melzer, TU Chemnitz and Helmholtz Center Munich, supported by DFG and Helmholtz association Outline 1 Trigonometric

More information

arxiv: v2 [math.na] 12 Feb 2013

arxiv: v2 [math.na] 12 Feb 2013 FAST SIMULATION OF GAUSSIAN RANDOM FIELDS ANNIKA LANG AND JÜRGEN POTTHOFF Abstract. Fast Fourier transforms are used to develop algorithms for the fast generation of correlated Gaussian random fields on

More information

A Fast Spherical Filter with Uniform Resolution

A Fast Spherical Filter with Uniform Resolution JOURNAL OF COMPUTATIONAL PHYSICS 136, 580 584 (1997) ARTICLE NO. CP975782 A Fast Spherical Filter with Uniform Resolution Rüdiger Jakob-Chien*, and Bradley K. Alpert *Department of Computer Science & Engineering,

More information

Supplementary Figures

Supplementary Figures Supplementary Figures Supplementary Figure 1: Bloch point formation during skyrmion annihilation. Skyrmion number in layers with different z-coordinate during the annihilation of a skyrmion. As the skyrmion

More information

Fourier extension and sampling on the sphere

Fourier extension and sampling on the sphere Fourier extension and sampling on the sphere Daniel Potts Technische Universität Chemnitz Faculty of Mathematics 97 Chemnitz, Germany Email: potts@mathematiktu-chemnitzde iel Van Buggenhout KU Leuven Faculty

More information

Improved Fast Gauss Transform. Fast Gauss Transform (FGT)

Improved Fast Gauss Transform. Fast Gauss Transform (FGT) 10/11/011 Improved Fast Gauss Transform Based on work by Changjiang Yang (00), Vikas Raykar (005), and Vlad Morariu (007) Fast Gauss Transform (FGT) Originally proposed by Greengard and Strain (1991) to

More information

The spectral transform method

The spectral transform method The spectral transform method by Nils Wedi European Centre for Medium-Range Weather Forecasts wedi@ecmwf.int Advanced Numerical Methods for Earth-System Modelling Slide 1 Advanced Numerical Methods for

More information

HIGHLY EFFECTIVE STABLE EVALUATION OF BANDLIMITED FUNCTIONS ON THE SPHERE

HIGHLY EFFECTIVE STABLE EVALUATION OF BANDLIMITED FUNCTIONS ON THE SPHERE HIGHLY EFFECTIVE STABLE EVALUATION OF BANDLIMITED FUNCTIONS ON THE SPHERE KAMEN IVANOV AND PENCHO PETRUSHEV Abstract. An algorithm for fast and accurate evaluation of band-limited functions at many scattered

More information

Fast Ewald Summation based on NFFT with Mixed Periodicity

Fast Ewald Summation based on NFFT with Mixed Periodicity Fast Ewald Summation based on NFFT with Mixed Periodicity Franziska Nestler, Michael Pippig and Daniel Potts In this paper we develop new fast Fourier-based methods for the Coulomb problem. We combine

More information

arxiv: v1 [cs.lg] 26 Jul 2017

arxiv: v1 [cs.lg] 26 Jul 2017 Updating Singular Value Decomposition for Rank One Matrix Perturbation Ratnik Gandhi, Amoli Rajgor School of Engineering & Applied Science, Ahmedabad University, Ahmedabad-380009, India arxiv:70708369v

More information

Fast Poisson solvers on nonequispaced grids: Multigrid and Fourier Methods compared

Fast Poisson solvers on nonequispaced grids: Multigrid and Fourier Methods compared Fast Poisson solvers on nonequispaced grids: Multigrid and Fourier Methods compared Gisela Pöplau a and Daniel Potts b a Institute of General Electrical Engineering, Rostock University, D 805 Rostock,

More information

WEAK FORM NONUNIFORM FAST FOURIER TRANSFORM METHOD FOR SOLVING VOLUME INTEGRAL EQUATIONS

WEAK FORM NONUNIFORM FAST FOURIER TRANSFORM METHOD FOR SOLVING VOLUME INTEGRAL EQUATIONS Progress In Electromagnetics Research, PIER 89, 275 289, 2009 WEAK FORM NONUNIFORM FAST FOURIER TRANSFORM METHOD FOR SOLING OLUME INTEGRAL EQUATIONS Z. H. Fan, R. S. Chen, H. Chen, and D. Z. Ding Department

More information

Recurrence Relations and Fast Algorithms

Recurrence Relations and Fast Algorithms Recurrence Relations and Fast Algorithms Mark Tygert Research Report YALEU/DCS/RR-343 December 29, 2005 Abstract We construct fast algorithms for decomposing into and reconstructing from linear combinations

More information

Numerical Minimization of Potential Energies on Specific Manifolds

Numerical Minimization of Potential Energies on Specific Manifolds Numerical Minimization of Potential Energies on Specific Manifolds SIAM Conference on Applied Linear Algebra 2012 22 June 2012, Valencia Manuel Gra f 1 1 Chemnitz University of Technology, Germany, supported

More information

Math 671: Tensor Train decomposition methods II

Math 671: Tensor Train decomposition methods II Math 671: Tensor Train decomposition methods II Eduardo Corona 1 1 University of Michigan at Ann Arbor December 13, 2016 Table of Contents 1 What we ve talked about so far: 2 The Tensor Train decomposition

More information

Stability of Kernel Based Interpolation

Stability of Kernel Based Interpolation Stability of Kernel Based Interpolation Stefano De Marchi Department of Computer Science, University of Verona (Italy) Robert Schaback Institut für Numerische und Angewandte Mathematik, University of Göttingen

More information

Fast Algorithms for the Computation of Oscillatory Integrals

Fast Algorithms for the Computation of Oscillatory Integrals Fast Algorithms for the Computation of Oscillatory Integrals Emmanuel Candès California Institute of Technology EPSRC Symposium Capstone Conference Warwick Mathematics Institute, July 2009 Collaborators

More information

NUFFT-ACCELERATED PLANE-POLAR (ALSO PHASE- LESS) NEAR-FIELD/FAR-FIELD TRANSFORMATION

NUFFT-ACCELERATED PLANE-POLAR (ALSO PHASE- LESS) NEAR-FIELD/FAR-FIELD TRANSFORMATION Progress In Electromagnetics Research M, Vol. 27, 59 73, 2012 NUFFT-ACCELERATED PLANE-POLAR (ALSO PHASE- LESS) NEAR-FIELD/FAR-FIELD TRANSFORMATION Amedeo Capozzoli *, Claudio Curcio, and Angelo Liseno

More information

A Banach Gelfand Triple Framework for Regularization and App

A Banach Gelfand Triple Framework for Regularization and App A Banach Gelfand Triple Framework for Regularization and Hans G. Feichtinger 1 hans.feichtinger@univie.ac.at December 5, 2008 1 Work partially supported by EUCETIFA and MOHAWI Hans G. Feichtinger hans.feichtinger@univie.ac.at

More information

Generated sets as sampling schemes for hyperbolic cross trigonometric polynomials

Generated sets as sampling schemes for hyperbolic cross trigonometric polynomials Generated sets as sampling schemes for hyperbolic cross trigonometric polynomials Lutz Kämmerer Chemnitz University of Technology joint work with S. Kunis and D. Potts supported by DFG-SPP 1324 1 / 16

More information

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Institut für Numerische Mathematik und Optimierung Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Oliver Ernst Computational Methods with Applications Harrachov, CR,

More information

NFFT Tutorial. potts/nfft

NFFT Tutorial.  potts/nfft NFFT 3.0 - Tutorial Jens Keiner Stefan Kunis Daniel Potts http://www.tu-chemnitz.de/ potts/nfft keiner@math.uni-luebeck.de,university of Lübeck, Institute of Mathematics, 23560 Lübeck kunis@mathematik.tu-chemnitz.de,

More information

APPLICATION OF THE SPARSE CARDINAL SINE DECOMPOSITION TO 3D STOKES FLOWS

APPLICATION OF THE SPARSE CARDINAL SINE DECOMPOSITION TO 3D STOKES FLOWS F. Alouges, et al., Int. J. Comp. Meth. and Ep. Meas., Vol. 5, No. 3 (07) 387 394 APPLICATION OF THE SPARSE CARDINAL SINE DECOMPOSITION TO 3D STOKES FLOWS F. ALOUGES, M. AUSSAL, A. LEFEBVRE-LEPOT, F. PIGEONNEAU

More information

Research Statement. James Bremer Department of Mathematics, University of California, Davis

Research Statement. James Bremer Department of Mathematics, University of California, Davis Research Statement James Bremer Department of Mathematics, University of California, Davis Email: bremer@math.ucdavis.edu Webpage: https.math.ucdavis.edu/ bremer I work in the field of numerical analysis,

More information

arxiv: v1 [cs.it] 26 Sep 2018

arxiv: v1 [cs.it] 26 Sep 2018 SAPLING THEORY FOR GRAPH SIGNALS ON PRODUCT GRAPHS Rohan A. Varma, Carnegie ellon University rohanv@andrew.cmu.edu Jelena Kovačević, NYU Tandon School of Engineering jelenak@nyu.edu arxiv:809.009v [cs.it]

More information

SPARSE SIGNAL RESTORATION. 1. Introduction

SPARSE SIGNAL RESTORATION. 1. Introduction SPARSE SIGNAL RESTORATION IVAN W. SELESNICK 1. Introduction These notes describe an approach for the restoration of degraded signals using sparsity. This approach, which has become quite popular, is useful

More information

Robotics I. February 6, 2014

Robotics I. February 6, 2014 Robotics I February 6, 214 Exercise 1 A pan-tilt 1 camera sensor, such as the commercial webcams in Fig. 1, is mounted on the fixed base of a robot manipulator and is used for pointing at a (point-wise)

More information

Split Algorithms and ZW-Factorization for Toeplitz and Toeplitz-plus-Hankel Matrices

Split Algorithms and ZW-Factorization for Toeplitz and Toeplitz-plus-Hankel Matrices Split Algorithms and ZW-Factorization for Toeplitz and Toeplitz-plus-Hanel Matrices Georg Heinig Dept of Math& CompSci Kuwait University POBox 5969 Safat 13060, Kuwait Karla Rost Faultät für Mathemati

More information

Slow Exponential Growth for Clenshaw Curtis Sparse Grids

Slow Exponential Growth for Clenshaw Curtis Sparse Grids Slow Exponential Growth for Clenshaw Curtis Sparse Grids John Burkardt Interdisciplinary Center for Applied Mathematics & Information Technology Department Virginia Tech... http://people.sc.fsu.edu/ burkardt/presentations/sgmga

More information

Numerical Methods for the Stray-Field Calculation: A Comparison of recently developed Algorithms

Numerical Methods for the Stray-Field Calculation: A Comparison of recently developed Algorithms Numerical Methods for the Stray-Field Calculation: A Comparison of recently developed Algorithms Claas Abert Fachbereich Mathematik, Universität Hamburg, Bundesstr. 55, 20146 Hamburg, Germany email: cabert@physnet.uni-hamburg.de,

More information

An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples

An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples Lars Grasedyck and Wolfgang Hackbusch Bericht Nr. 329 August 2011 Key words: MSC: hierarchical Tucker tensor rank tensor approximation

More information

Fast Multipole BEM for Structural Acoustics Simulation

Fast Multipole BEM for Structural Acoustics Simulation Fast Boundary Element Methods in Industrial Applications Fast Multipole BEM for Structural Acoustics Simulation Matthias Fischer and Lothar Gaul Institut A für Mechanik, Universität Stuttgart, Germany

More information

Efficient Evaluation of the Rokhlin Translator in Multilevel Fast Multipole Algorithm

Efficient Evaluation of the Rokhlin Translator in Multilevel Fast Multipole Algorithm Ilari Hänninen and Jukka Sarvas, Efficient evaluation of the Rokhlin translator in multilevel fast multipole algorithm, Helsinki University of Technology, Electromagnetics Laboratory Report Series, Report

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (997) 76: 479 488 Numerische Mathematik c Springer-Verlag 997 Electronic Edition Exponential decay of C cubic splines vanishing at two symmetric points in each knot interval Sang Dong Kim,,

More information

Uniqueness Conditions for A Class of l 0 -Minimization Problems

Uniqueness Conditions for A Class of l 0 -Minimization Problems Uniqueness Conditions for A Class of l 0 -Minimization Problems Chunlei Xu and Yun-Bin Zhao October, 03, Revised January 04 Abstract. We consider a class of l 0 -minimization problems, which is to search

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

A Framework for Discrete Integral Transformations I the Pseudo-polar Fourier transform

A Framework for Discrete Integral Transformations I the Pseudo-polar Fourier transform A Framework for Discrete Integral Transformations I the Pseudo-polar Fourier transform A. Averbuch, R.R. Coifman, D.L. Donoho, M. Israeli, and Y. Shkolnisky June 26, 2007 This paper is dedicated to the

More information

Strengthened Sobolev inequalities for a random subspace of functions

Strengthened Sobolev inequalities for a random subspace of functions Strengthened Sobolev inequalities for a random subspace of functions Rachel Ward University of Texas at Austin April 2013 2 Discrete Sobolev inequalities Proposition (Sobolev inequality for discrete images)

More information

Improved Fast Gauss Transform. (based on work by Changjiang Yang and Vikas Raykar)

Improved Fast Gauss Transform. (based on work by Changjiang Yang and Vikas Raykar) Improved Fast Gauss Transform (based on work by Changjiang Yang and Vikas Raykar) Fast Gauss Transform (FGT) Originally proposed by Greengard and Strain (1991) to efficiently evaluate the weighted sum

More information

Accelerated MRI Image Reconstruction

Accelerated MRI Image Reconstruction IMAGING DATA EVALUATION AND ANALYTICS LAB (IDEAL) CS5540: Computational Techniques for Analyzing Clinical Data Lecture 15: Accelerated MRI Image Reconstruction Ashish Raj, PhD Image Data Evaluation and

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 12 Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction permitted for noncommercial,

More information

Fast algorithms for dimensionality reduction and data visualization

Fast algorithms for dimensionality reduction and data visualization Fast algorithms for dimensionality reduction and data visualization Manas Rachh Yale University 1/33 Acknowledgements George Linderman (Yale) Jeremy Hoskins (Yale) Stefan Steinerberger (Yale) Yuval Kluger

More information

ON INTERPOLATION AND INTEGRATION IN FINITE-DIMENSIONAL SPACES OF BOUNDED FUNCTIONS

ON INTERPOLATION AND INTEGRATION IN FINITE-DIMENSIONAL SPACES OF BOUNDED FUNCTIONS COMM. APP. MATH. AND COMP. SCI. Vol., No., ON INTERPOLATION AND INTEGRATION IN FINITE-DIMENSIONAL SPACES OF BOUNDED FUNCTIONS PER-GUNNAR MARTINSSON, VLADIMIR ROKHLIN AND MARK TYGERT We observe that, under

More information

Parametrische Modellreduktion mit dünnen Gittern

Parametrische Modellreduktion mit dünnen Gittern Parametrische Modellreduktion mit dünnen Gittern (Parametric model reduction with sparse grids) Ulrike Baur Peter Benner Mathematik in Industrie und Technik, Fakultät für Mathematik Technische Universität

More information

Computational tractability of machine learning algorithms for tall fat data

Computational tractability of machine learning algorithms for tall fat data Computational tractability of machine learning algorithms for tall fat data Getting good enough solutions as fast as possible Vikas Chandrakant Raykar vikas@cs.umd.edu University of Maryland, CollegePark

More information

Max-Planck-Institut fur Mathematik in den Naturwissenschaften Leipzig H 2 -matrix approximation of integral operators by interpolation by Wolfgang Hackbusch and Steen Borm Preprint no.: 04 200 H 2 -Matrix

More information

Lecture 8: Boundary Integral Equations

Lecture 8: Boundary Integral Equations CBMS Conference on Fast Direct Solvers Dartmouth College June 23 June 27, 2014 Lecture 8: Boundary Integral Equations Gunnar Martinsson The University of Colorado at Boulder Research support by: Consider

More information

A COUNTEREXAMPLE TO AN ENDPOINT BILINEAR STRICHARTZ INEQUALITY TERENCE TAO. t L x (R R2 ) f L 2 x (R2 )

A COUNTEREXAMPLE TO AN ENDPOINT BILINEAR STRICHARTZ INEQUALITY TERENCE TAO. t L x (R R2 ) f L 2 x (R2 ) Electronic Journal of Differential Equations, Vol. 2006(2006), No. 5, pp. 6. ISSN: 072-669. URL: http://ejde.math.txstate.edu or http://ejde.math.unt.edu ftp ejde.math.txstate.edu (login: ftp) A COUNTEREXAMPLE

More information

A Randomized Algorithm for the Approximation of Matrices

A Randomized Algorithm for the Approximation of Matrices A Randomized Algorithm for the Approximation of Matrices Per-Gunnar Martinsson, Vladimir Rokhlin, and Mark Tygert Technical Report YALEU/DCS/TR-36 June 29, 2006 Abstract Given an m n matrix A and a positive

More information

Poisson Solver, Pseudopotentials, Atomic Forces in the BigDFT code

Poisson Solver, Pseudopotentials, Atomic Forces in the BigDFT code CECAM Tutorial on Wavelets in DFT, CECAM - LYON,, in the BigDFT code Kernel Luigi Genovese L_Sim - CEA Grenoble 28 November 2007 Outline, Kernel 1 The with Interpolating Scaling Functions in DFT for Interpolating

More information

Wavelet Analysis. Willy Hereman. Department of Mathematical and Computer Sciences Colorado School of Mines Golden, CO Sandia Laboratories

Wavelet Analysis. Willy Hereman. Department of Mathematical and Computer Sciences Colorado School of Mines Golden, CO Sandia Laboratories Wavelet Analysis Willy Hereman Department of Mathematical and Computer Sciences Colorado School of Mines Golden, CO 8040-887 Sandia Laboratories December 0, 998 Coordinate-Coordinate Formulations CC and

More information

LAB 5. INTRODUCTION Finite Difference Method

LAB 5. INTRODUCTION Finite Difference Method LAB 5 In previous two computer labs, you have seen how the analytical techniques for solving electrostatic problems can be approximately solved using numerical methods. For example, you have approximated

More information

Machine Learning: Basis and Wavelet 김화평 (CSE ) Medical Image computing lab 서진근교수연구실 Haar DWT in 2 levels

Machine Learning: Basis and Wavelet 김화평 (CSE ) Medical Image computing lab 서진근교수연구실 Haar DWT in 2 levels Machine Learning: Basis and Wavelet 32 157 146 204 + + + + + - + - 김화평 (CSE ) Medical Image computing lab 서진근교수연구실 7 22 38 191 17 83 188 211 71 167 194 207 135 46 40-17 18 42 20 44 31 7 13-32 + + - - +

More information

Parameter estimation for exponential sums by approximate Prony method

Parameter estimation for exponential sums by approximate Prony method Parameter estimation for exponential sums by approximate Prony method Daniel Potts a, Manfred Tasche b a Chemnitz University of Technology, Department of Mathematics, D 09107 Chemnitz, Germany b University

More information

ADAPTIVE MULTISCALE MOMENT METHOD FOR SOLVING TWO-DIMENSIONAL FREDHOLM INTEGRAL EQUATION OF THE FIRST KIND

ADAPTIVE MULTISCALE MOMENT METHOD FOR SOLVING TWO-DIMENSIONAL FREDHOLM INTEGRAL EQUATION OF THE FIRST KIND Progress In Electromagnetics Research, PIER 21, 173 201, 1999 ADAPTIVE MULTISCALE MOMENT METHOD FOR SOLVING TWO-DIMENSIONAL FREDHOLM INTEGRAL EQUATION OF THE FIRST KIND C. Su Dept. of Applied Math. Northwestern

More information

Fast Multipole Methods for The Laplace Equation. Outline

Fast Multipole Methods for The Laplace Equation. Outline Fast Multipole Methods for The Laplace Equation Ramani Duraiswami Nail Gumerov Outline 3D Laplace equation and Coulomb potentials Multipole and local expansions Special functions Legendre polynomials Associated

More information

Postgraduate Course Signal Processing for Big Data (MSc)

Postgraduate Course Signal Processing for Big Data (MSc) Postgraduate Course Signal Processing for Big Data (MSc) Jesús Gustavo Cuevas del Río E-mail: gustavo.cuevas@upm.es Work Phone: +34 91 549 57 00 Ext: 4039 Course Description Instructor Information Course

More information

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017 A Fast Fourier transform based direct solver for the Helmholtz problem Jari Toivanen Monika Wolfmayr AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017 Content 1 Model problem 2 Discretization 3 Fast solver

More information

CANONICAL LOSSLESS STATE-SPACE SYSTEMS: STAIRCASE FORMS AND THE SCHUR ALGORITHM

CANONICAL LOSSLESS STATE-SPACE SYSTEMS: STAIRCASE FORMS AND THE SCHUR ALGORITHM CANONICAL LOSSLESS STATE-SPACE SYSTEMS: STAIRCASE FORMS AND THE SCHUR ALGORITHM Ralf L.M. Peeters Bernard Hanzon Martine Olivi Dept. Mathematics, Universiteit Maastricht, P.O. Box 616, 6200 MD Maastricht,

More information

User Guide for Hermir version 0.9: Toolbox for Synthesis of Multivariate Stationary Gaussian and non-gaussian Series

User Guide for Hermir version 0.9: Toolbox for Synthesis of Multivariate Stationary Gaussian and non-gaussian Series User Guide for Hermir version 0.9: Toolbox for Synthesis of Multivariate Stationary Gaussian and non-gaussian Series Hannes Helgason, Vladas Pipiras, and Patrice Abry June 2, 2011 Contents 1 Organization

More information

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2 Index advection equation, 29 in three dimensions, 446 advection-diffusion equation, 31 aluminum, 200 angle between two vectors, 58 area integral, 439 automatic step control, 119 back substitution, 604

More information

Deep Learning: Approximation of Functions by Composition

Deep Learning: Approximation of Functions by Composition Deep Learning: Approximation of Functions by Composition Zuowei Shen Department of Mathematics National University of Singapore Outline 1 A brief introduction of approximation theory 2 Deep learning: approximation

More information

Ordinary Least Squares and its applications

Ordinary Least Squares and its applications Ordinary Least Squares and its applications Dr. Mauro Zucchelli University Of Verona December 5, 2016 Dr. Mauro Zucchelli Ordinary Least Squares and its applications December 5, 2016 1 / 48 Contents 1

More information

An Introduction to Wavelets and some Applications

An Introduction to Wavelets and some Applications An Introduction to Wavelets and some Applications Milan, May 2003 Anestis Antoniadis Laboratoire IMAG-LMC University Joseph Fourier Grenoble, France An Introduction to Wavelets and some Applications p.1/54

More information

B553 Lecture 5: Matrix Algebra Review

B553 Lecture 5: Matrix Algebra Review B553 Lecture 5: Matrix Algebra Review Kris Hauser January 19, 2012 We have seen in prior lectures how vectors represent points in R n and gradients of functions. Matrices represent linear transformations

More information

We use the overhead arrow to denote a column vector, i.e., a number with a direction. For example, in three-space, we write

We use the overhead arrow to denote a column vector, i.e., a number with a direction. For example, in three-space, we write 1 MATH FACTS 11 Vectors 111 Definition We use the overhead arrow to denote a column vector, ie, a number with a direction For example, in three-space, we write The elements of a vector have a graphical

More information

Class Averaging in Cryo-Electron Microscopy

Class Averaging in Cryo-Electron Microscopy Class Averaging in Cryo-Electron Microscopy Zhizhen Jane Zhao Courant Institute of Mathematical Sciences, NYU Mathematics in Data Sciences ICERM, Brown University July 30 2015 Single Particle Reconstruction

More information

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2.

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2. APPENDIX A Background Mathematics A. Linear Algebra A.. Vector algebra Let x denote the n-dimensional column vector with components 0 x x 2 B C @. A x n Definition 6 (scalar product). The scalar product

More information

A fast adaptive numerical solver for nonseparable elliptic partial differential equations

A fast adaptive numerical solver for nonseparable elliptic partial differential equations J. KSIAM Vol.2. No.1. 27-39, 1998 27 A fast adaptive numerical solver for nonseparable elliptic partial differential equations June-Yub Lee Dept of Math, Ewha Womans Univ, Seoul 120-750, KOREA jylee@math.ewha.ac.kr

More information

Representation: Fractional Splines, Wavelets and related Basis Function Expansions. Felix Herrmann and Jonathan Kane, ERL-MIT

Representation: Fractional Splines, Wavelets and related Basis Function Expansions. Felix Herrmann and Jonathan Kane, ERL-MIT Representation: Fractional Splines, Wavelets and related Basis Function Expansions Felix Herrmann and Jonathan Kane, ERL-MIT Objective: Build a representation with a regularity that is consistent with

More information

H 2 -matrices with adaptive bases

H 2 -matrices with adaptive bases 1 H 2 -matrices with adaptive bases Steffen Börm MPI für Mathematik in den Naturwissenschaften Inselstraße 22 26, 04103 Leipzig http://www.mis.mpg.de/ Problem 2 Goal: Treat certain large dense matrices

More information

Orthogonal Polynomials, Quadratures & Sparse-Grid Methods for Probability Integrals

Orthogonal Polynomials, Quadratures & Sparse-Grid Methods for Probability Integrals 1/33 Orthogonal Polynomials, Quadratures & Sparse-Grid Methods for Probability Integrals Dr. Abebe Geletu May, 2010 Technische Universität Ilmenau, Institut für Automatisierungs- und Systemtechnik Fachgebiet

More information

Introduction to the Tensor Train Decomposition and Its Applications in Machine Learning

Introduction to the Tensor Train Decomposition and Its Applications in Machine Learning Introduction to the Tensor Train Decomposition and Its Applications in Machine Learning Anton Rodomanov Higher School of Economics, Russia Bayesian methods research group (http://bayesgroup.ru) 14 March

More information

Principles of Electron Optics

Principles of Electron Optics Principles of Electron Optics Volume 1 Basic Geometrical Optics by P. W. HAWKES CNRS Laboratory of Electron Optics, Toulouse, France and E. KASPER Institut für Angewandte Physik Universität Tübingen, Federal

More information

A Plane Wave Expansion of Spherical Wave Functions for Modal Analysis of Guided Wave Structures and Scatterers

A Plane Wave Expansion of Spherical Wave Functions for Modal Analysis of Guided Wave Structures and Scatterers IEEE TRANSACTIONS ON ANTENNAS AND PROPAGATION, VOL. 51, NO. 10, OCTOBER 2003 2801 A Plane Wave Expansion of Spherical Wave Functions for Modal Analysis of Guided Wave Structures and Scatterers Robert H.

More information

Overview of Spatial Statistics with Applications to fmri

Overview of Spatial Statistics with Applications to fmri with Applications to fmri School of Mathematics & Statistics Newcastle University April 8 th, 2016 Outline Why spatial statistics? Basic results Nonstationary models Inference for large data sets An example

More information

On the fast algorithm for multiplication of functions in the wavelet bases

On the fast algorithm for multiplication of functions in the wavelet bases Published in Proceedings of the International Conference Wavelets and Applications, Toulouse, 1992; Y. Meyer and S. Roques, edt., Editions Frontieres, 1993 On the fast algorithm for multiplication of functions

More information

Black Box Linear Algebra

Black Box Linear Algebra Black Box Linear Algebra An Introduction to Wiedemann s Approach William J. Turner Department of Mathematics & Computer Science Wabash College Symbolic Computation Sometimes called Computer Algebra Symbols

More information

APPROXIMATING THE INVERSE FRAME OPERATOR FROM LOCALIZED FRAMES

APPROXIMATING THE INVERSE FRAME OPERATOR FROM LOCALIZED FRAMES APPROXIMATING THE INVERSE FRAME OPERATOR FROM LOCALIZED FRAMES GUOHUI SONG AND ANNE GELB Abstract. This investigation seeks to establish the practicality of numerical frame approximations. Specifically,

More information

PARAMETER ESTIMATION FOR MULTIVARIATE EXPONENTIAL SUMS

PARAMETER ESTIMATION FOR MULTIVARIATE EXPONENTIAL SUMS PARAMETER ESTIMATION FOR MULTIVARIATE EXPONENTIAL SUMS DANIEL POTTS AND MANFRED TASCHE Abstract. The recovery of signal parameters from noisy sampled data is an essential problem in digital signal processing.

More information

Lecture 6. Numerical methods. Approximation of functions

Lecture 6. Numerical methods. Approximation of functions Lecture 6 Numerical methods Approximation of functions Lecture 6 OUTLINE 1. Approximation and interpolation 2. Least-square method basis functions design matrix residual weighted least squares normal equation

More information

Orthogonality of hat functions in Sobolev spaces

Orthogonality of hat functions in Sobolev spaces 1 Orthogonality of hat functions in Sobolev spaces Ulrich Reif Technische Universität Darmstadt A Strobl, September 18, 27 2 3 Outline: Recap: quasi interpolation Recap: orthogonality of uniform B-splines

More information