Approximate Fekete points and discrete Leja points based on equal area partitions of the unit sphere

Size: px
Start display at page:

Download "Approximate Fekete points and discrete Leja points based on equal area partitions of the unit sphere"

Transcription

1 Approximate Fekete points and discrete Leja points based on equal area partitions of the unit sphere Paul Leopardi Mathematical Sciences Institute, Australian National University. For presentation at Computational Techniques and Applications Conference Joint work with Alvise Sommariva and Marco Vianello. Made possible by donations from 31 supporters via Pozible. 2 December 2014

2 Acknowledgements My collaborators: Alvise Sommariva and Marco Vianello. Rob Womersley. Program on Minimal Energy Point Sets, Lattices, and Designs at the Erwin Schrödinger International Institute for Mathematical Physics, Australian National University.

3 Pozible supporters $32+ SvA, AD, CF, OF, KM, JP, AHR, RR, ES, MT. $50+ Yvonne Barrett, Angela M. Fearon, Sally Greenaway, Dennis Pritchard, Susan Shaw, Bronny Wright. $64+ Naomi Cole. $100+ Russell family, Jonno Zilber. $128+ Jennifer Lanspeary, Vikram.... and others, who did not want acknowledgement.

4 Outline of talk The EQ spherical codes Approximately optimal interpolating sets Results for the EQ spherical codes

5 The partition EQ(2,33) on S 2 R 3 EQ partitions: Recursive Zonal Equal Area partitions of the sphere, EQ(d, N ) = S d, with EQ(d, N ) = N.

6 The spherical code EQP(2,33) on S 2 EQ codes: The Recursive Zonal Equal Area spherical codes, EQP(d, N ) S d, with EQP(d, N ) = N.

7 Equal-area partitions of S d R d An equal area partition of S d R d is a finite set P of Lebesgue measurable subsets of S d, such that R = S d, and for each R P, R P λ d (R) = λ d(s d ), P where λ d is the Lebesgue area measure on S d.

8 Diameter bounded sets of partitions The diameter of a region R R d+1 is defined by diam R := sup{ x y x, y R}. A set Ξ of partitions of S d R d+1 is diameter-bounded with diameter bound K R + if for all P Ξ, for each R P, diam R K P 1/d.

9 Key properties of the EQ partition of S d EQ(d, N ) is the recursive zonal equal area partition of S d into N regions. The set of partitions EQ(d) := {EQ(d, N ) N N + }. The EQ partition satisfies: Theorem 1 For d 1, N 1, EQ(d, N ) is an equal-area partition. Theorem 2 For d 1, EQ(d) is diameter-bounded.

10 Geometric properties For EQP(d, N ) Good: Centre points of regions of diameter = O(N 1/d ), Mesh norm (covering radius) = O(N 1/d ), Minimum distance and packing radius = Ω(N 1/d ). Bad: Mesh ratio = Ω( d), Packing density π d/2 2 d Γ(d/2+1) as N.

11 Approximation properties Not so bad? Normalized spherical cap discrepancy = O(N 1/d ), Ugly: Normalized s -energy I s ± O(N 1/d ) 0 < s < d 1 I s ± O(N 1/d log N ) s = d 1 E s = I s ± O(N s/d 1 ) d 1 < s < d O(log N ) s = d O(N s/d 1 ) s > d. Cannot be used for polynomial interpolation: proven for large enough N, conjectured for small N.

12 EQ(3,99) Steps 1 to 2 EQ(3,99) Steps 3 to 5 θ F,1 θ c I y 1 = θ F,2 V(θ c ) = V R = σ(s 3 )/99 I = V R 1/3 y 2 = y 3 = F F F F θ F,3 y 4 = θ F,4 θ F,5 EQ(3,99) Steps 6 to 7 θ 1 m 1 = 15 θ 2 m 2 = 34 m 3 = θ 3 m 4 = 15 θ 4 θ 5

13 Admissible meshes Definition 3 For compact D R d, and C(D) the space of continuous functions on D, given a sequence of finite dimensional subspaces P t (D) C(D), a P t -norming mesh is a sequence (Z t ) of finite subsets of D such that p c sup z Z t p(z) for all p P t. For a P t -admissible mesh, P t (D) is the space of polynomials of maximum degree t on D, and the cardinality Z t = O(t s ) for some s 1. (Calvi and Levenberg 2008, Vianello 2013)

14 Approximate Fekete points Given a P t -admissible mesh with n t := Z t d t := dim(p t (D)), points z 1,..., z nt Z t, and a basis {p 1,..., p dt } of P t (D), the approximate Fekete points of order t are a subset of Z t with cardinality d t, obtained from the Vandermonde matrix A t := [p i (z j )] via QR decomposition with column pivoting. They approximate the maximal determinant Fekete points by having a large Vandermonde determinant and a small Lebesgue constant of interpolation. (Sommariva and Vianello 2009)

15 Approximate Fekete points The approximate Fekete points z af are obtained from the points z and corresponding Vandermonde matrix A as dim = rows(a); y = zeros(dim, 1); y(1) = 1; [Q, R, P] = qr(a); w = P(:, 1:dim) * (R(:, 1:dim) \ (Q * y)); z af = z(:, abs(w) > tol); where w is the optimal quadrature weight vector and tol is a small tolerance. Here all elements of w are non-zero, but z af may have dimension less than dim. (Sommariva and Vianello 2009)

16 Discrete Leja points For the Discrete Leja points, LU decomposition with partial row pivoting is used instead. dim = rows(a); y = zeros(dim, 1); y(1) = 1; [L, U, p] = lu(a, vector ); w = zeros(n, 1); w(p(1:dim)) = L(1:dim, :) \ (U \ y); z dl = z(:, p(1:dim)); Here z dl has dimension dim, but some elements of w may be zero. (Bos, De Marchi, Sommariva and Vianello 2010)

17 Non-negative least squares points We can also use non-negative least squares instead of either QR or LU decomposition. dim = rows(a); y = zeros(dim, 1); y(1) = 1; w = lsqnonneg(a, y); z nn = z(:, abs(w) > tol); Here all elements of w are positive, but z nn may have dimension less than dim. (Sommariva and Vianello 2014)

18 The EQ codes form an admissible mesh Theorem 4 The EQ codes form a P t -admissible mesh. Proof. Any finite point set on the unit sphere S d with mesh norm at most (1 c)/t generates a norming set with constant c for P t. The EQ spherical codes have mesh norm at most C d N 1/d. Thus if N (C d /(1 c)) d t d, then EQP(d, N ) is a norming set with constant c for P t. (Jetter, Stöckler and Ward, 1998; L and Vianello 2014)

19 The Fekete points on the sphere S 2 The Fekete (maximal determinant) points on the sphere S 2 are the points that maximize the determinant of the Vandermonde-type matrix A t := [p t,i (x j )], where i, j {1,..., (t + 1) 2 }, the p t,i form an orthonormal basis of the spherical polynomials of degree at most t, and x j S 2. Rob Womersley has (approximately) computed these points up to degree t = 165, and their corresponding optimal quadrature weights, as well as the log of the determinant of the Gram matrix G t := A T t A t. (Sloan and Womersley 2004; Womersley 2007)

20 The search algorithm For each type of point set (approximate Fekete points, discrete Leja points, non-negative least squares points), for t from 1 to 15, I used Octave with the EQ codes EQP(2, N ) for N from (t + 1) 2 to (t + 1) 3 to find: The smallest N such that the matrix A has full rank, and the point set has all corresponding weights non-zero. The smallest N such that the matrix A has full rank, and the point set has all corresponding weights positive. The value of N such that the matrix A has full rank, the point set has all corresponding weights positive, and the Gram determinant is maximal.

21 Approximate Fekete points Log of Gram determinant Non-zero wt Positive wt Maximum det Womersley Degree t

22 Discrete Leja points Log of Gram determinant Non-zero wt Positive wt Maximum det Womersley Degree t

23 Non-negative least squares points Log of Gram determinant Positive wt Maximum det Womersley Degree t

24 Maximum determinant positive weight points Relative log of Gram determinant Degree t Approx Fekete Discrete Leja NNLS

25 Left to do Numerical examples for larger degree t. Searching can be done in parallel. Prove that for some T > 0, for all t > T, for sufficiently large N, the EQ codes EQP(2, N ) yield positive weights for each of the 3 types of points. Estimate the N required. Investigate properties (mesh norm, discrepancy, energy) of the resulting point sets.

Applications of equal area partitions of the unit sphere

Applications of equal area partitions of the unit sphere Applications of equal area partitions of the unit sphere Paul Leopardi Mathematical Sciences Institute, Australian National University. For presentation at Oak Ridge National Laboratory. Based on PhD thesis

More information

On Multivariate Newton Interpolation at Discrete Leja Points

On Multivariate Newton Interpolation at Discrete Leja Points On Multivariate Newton Interpolation at Discrete Leja Points L. Bos 1, S. De Marchi 2, A. Sommariva 2, M. Vianello 2 September 25, 2011 Abstract The basic LU factorization with row pivoting, applied to

More information

Optimal Polynomial Admissible Meshes on the Closure of C 1,1 Bounded Domains

Optimal Polynomial Admissible Meshes on the Closure of C 1,1 Bounded Domains Optimal Polynomial Admissible Meshes on the Closure of C 1,1 Bounded Domains Constructive Theory of Functions Sozopol, June 9-15, 2013 F. Piazzon, joint work with M. Vianello Department of Mathematics.

More information

into regions of equal measure and small diameter p. 1/2

into regions of equal measure and small diameter p. 1/2 into regions of equal measure and small diameter Paul Leopardi paulleopardi@unsweduau School of Mathematics, University of New South Wales For presentation at Vanderbilt University, Nashville, November

More information

Constructing optimal polynomial meshes on planar starlike domains

Constructing optimal polynomial meshes on planar starlike domains Constructing optimal polynomial meshes on planar starlike domains F. Piazzon and M. Vianello 1 Dept. of Mathematics, University of Padova (Italy) October 13, 2014 Abstract We construct polynomial norming

More information

Trivariate polynomial approximation on Lissajous curves 1

Trivariate polynomial approximation on Lissajous curves 1 Trivariate polynomial approximation on Lissajous curves 1 Stefano De Marchi DMV2015, Minisymposium on Mathematical Methods for MPI 22 September 2015 1 Joint work with Len Bos (Verona) and Marco Vianello

More information

Polynomial approximation and cubature at approximate Fekete and Leja points of the cylinder

Polynomial approximation and cubature at approximate Fekete and Leja points of the cylinder Polynomial approximation and cubature at approximate Fekete and Leja points of the cylinder Stefano De Marchi, Martina Marchioro and Alvise Sommariva May 18, 2018 arxiv:1110.5513v1 [math.na] 25 Oct 2011

More information

Application of modified Leja sequences to polynomial interpolation

Application of modified Leja sequences to polynomial interpolation Special Issue for the years of the Padua points, Volume 8 5 Pages 66 74 Application of modified Leja sequences to polynomial interpolation L. P. Bos a M. Caliari a Abstract We discuss several applications

More information

Polynomial Meshes: Computation and Approximation

Polynomial Meshes: Computation and Approximation Proceedings of the 15th International Conference on Computational and Mathematical Methods in Science and Engineering, CMMSE 215 6 1 July, 215. Polynomial Meshes: Computation and Approximation S. De Marchi

More information

Polynomial interpolation on the sphere, reproducing kernels and random matrices

Polynomial interpolation on the sphere, reproducing kernels and random matrices Polynomial interpolation on the sphere, reproducing kernels and random matrices Paul Leopardi Mathematical Sciences Institute, Australian National University. For presentation at MASCOS Workshop on Stochastics

More information

Efficient Spherical Designs with Good Geometric Properties

Efficient Spherical Designs with Good Geometric Properties Efficient Spherical Designs with Good Geometric Properties Rob Womersley, R.Womersley@unsw.edu.au School of Mathematics and Statistics, University of New South Wales 45-design with N = 1059 and symmetrtic

More information

Computing multivariate Fekete and Leja points by numerical linear algebra

Computing multivariate Fekete and Leja points by numerical linear algebra Computing multivariate Fekete and Leja points by numerical linear algebra L. Bos 1, S. De Marchi 2, A.Sommariva 2 and M.Vianello 2 July 26, 2010 Abstract We discuss and compare two greedy algorithms, that

More information

Dubiner distance and stability of Lebesgue constants

Dubiner distance and stability of Lebesgue constants Dubiner distance and stability of Lebesgue constants Marco Vianello 1 March 15, 2018 Abstract Some elementary inequalities, based on the non-elementary notion of Dubiner distance, show that norming sets

More information

Global polynomial optimization by norming sets on sphere and torus

Global polynomial optimization by norming sets on sphere and torus Global polynomial optimization by norming sets on sphere and torus Marco Vianello 1 February 12, 2018 Abstract Using the approximation theoretic notion of norming set, we compute (1 ε)-approximations to

More information

QMC designs and covering of spheres by spherical caps

QMC designs and covering of spheres by spherical caps QMC designs and covering of spheres by spherical caps Ian H. Sloan University of New South Wales, Sydney, Australia Joint work with Johann Brauchart, Josef Dick, Ed Saff (Vanderbilt), Rob Womersley and

More information

Quadrature using sparse grids on products of spheres

Quadrature using sparse grids on products of spheres Quadrature using sparse grids on products of spheres Paul Leopardi Mathematical Sciences Institute, Australian National University. For presentation at ANZIAM NSW/ACT Annual Meeting, Batemans Bay. Joint

More information

Stability inequalities for Lebesgue constants via Markov-like inequalities

Stability inequalities for Lebesgue constants via Markov-like inequalities Stability inequalities for Lebesgue constants via Markov-like inequalities F. Piazzon and M. Vianello Department of Mathematics, University of Padova (Italy) February, 208 Abstract We prove that L -norming

More information

WHY SHOULD PEOPLE IN APPROXIMATION THEORY CARE ABOUT (PLURI-)POTENTIAL THEORY? 1. One variable case

WHY SHOULD PEOPLE IN APPROXIMATION THEORY CARE ABOUT (PLURI-)POTENTIAL THEORY? 1. One variable case WHY SHOULD PEOPLE IN APPROXIMATION THEORY CARE ABOUT (PLURI-)POTENTIAL THEORY? SEMINARIO DOTTORATO DIPARTIMENTO DI MATEMATICA UNIVERSITÁ DI PADOVA FEDERICO PIAZZON Abstract. We give a summary of results

More information

Computing approximate Fekete points by QR factorizations of Vandermonde matrices

Computing approximate Fekete points by QR factorizations of Vandermonde matrices Computing approximate Fekete points by QR factorizations of Vandermonde matrices Alvise Sommariva and Marco Vianello Dept. of Pure and Applied Mathematics, University of Padova (Italy) Abstract We propose

More information

PRACTICE FINAL EXAM. why. If they are dependent, exhibit a linear dependence relation among them.

PRACTICE FINAL EXAM. why. If they are dependent, exhibit a linear dependence relation among them. Prof A Suciu MTH U37 LINEAR ALGEBRA Spring 2005 PRACTICE FINAL EXAM Are the following vectors independent or dependent? If they are independent, say why If they are dependent, exhibit a linear dependence

More information

Quadrature using sparse grids on products of spheres

Quadrature using sparse grids on products of spheres Quadrature using sparse grids on products of spheres Paul Leopardi Mathematical Sciences Institute, Australian National University. For presentation at 3rd Workshop on High-Dimensional Approximation UNSW,

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

A PARTITION OF THE UNIT SPHERE INTO REGIONS OF EQUAL AREA AND SMALL DIAMETER

A PARTITION OF THE UNIT SPHERE INTO REGIONS OF EQUAL AREA AND SMALL DIAMETER A PARTITION OF THE UNIT SPHERE INTO REGIONS OF EQUAL AREA AND SMALL DIAMETER PAUL LEOPARDI Abstract. The recursive zonal equal area (EQ) sphere partitioning algorithm is a practical algorithm for partitioning

More information

235 Final exam review questions

235 Final exam review questions 5 Final exam review questions Paul Hacking December 4, 0 () Let A be an n n matrix and T : R n R n, T (x) = Ax the linear transformation with matrix A. What does it mean to say that a vector v R n is an

More information

Numerical hyperinterpolation over. nonstandard planar regions.

Numerical hyperinterpolation over. nonstandard planar regions. Numerical hyperinterpolation over nonstandard planar regions Alvise Sommariva and Marco Vianello 1 August 3, 2016 Abstract We discuss an algorithm (implemented in Matlab) that computes numerically total-degree

More information

FEKETE TYPE POINTS FOR RIDGE FUNCTION INTERPOLATION AND HYPERBOLIC POTENTIAL THEORY. Len Bos, Stefano De Marchi, and Norm Levenberg

FEKETE TYPE POINTS FOR RIDGE FUNCTION INTERPOLATION AND HYPERBOLIC POTENTIAL THEORY. Len Bos, Stefano De Marchi, and Norm Levenberg PUBLICATIONS DE L INSTITUT MATHÉMATIQUE Nouvelle série, tome 96 110) 2014), 41 48 DOI: 10.2298/PIM1410041B FEETE TYPE POINTS FOR RIDGE FUNCTION INTERPOLATION AND HYPERBOLIC POTENTIAL THEORY Len Bos, Stefano

More information

Spherical designs with close to the minimal number of points 1

Spherical designs with close to the minimal number of points 1 Spherical designs with close to the minimal number of points Robert S. Womersley School of Mathematics and Statistics, University of New South Wales, Sydney, NSW, 05, Australia Abstract In this paper we

More information

DISCRETE MINIMAL ENERGY PROBLEMS

DISCRETE MINIMAL ENERGY PROBLEMS DISCRETE MINIMAL ENERGY PROBLEMS Lecture III E. B. Saff Center for Constructive Approximation Vanderbilt University University of Crete, Heraklion May, 2017 Random configurations ΩN = {X1, X2,..., XN }:

More information

Low-discrepancy point sets lifted to the unit sphere

Low-discrepancy point sets lifted to the unit sphere Low-discrepancy point sets lifted to the unit sphere Johann S. Brauchart School of Mathematics and Statistics, UNSW MCQMC 2012 (UNSW) February 17 based on joint work with Ed Saff (Vanderbilt) and Josef

More information

Downloaded 06/07/18 to Redistribution subject to SIAM license or copyright; see

Downloaded 06/07/18 to Redistribution subject to SIAM license or copyright; see SIAM J. SCI. COMPUT. Vol. 40, No. 1, pp. A366 A387 c 2018 Society for Industrial and Applied Mathematics WEIGHTED APPROXIMATE FEKETE POINTS: SAMPLING FOR LEAST-SQUARES POLYNOMIAL APPROXIMATION LING GUO,

More information

Hyperuniformity on the Sphere

Hyperuniformity on the Sphere Hyperuniformity on the Sphere Johann S. Brauchart j.brauchart@tugraz.at 14. June 2018 Week 2 Workshop MATRIX Research Program "On the Frontiers of High Dimensional Computation" MATRIX, Creswick [ 1 / 56

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Lecture 4 Orthonormal vectors and QR factorization

Lecture 4 Orthonormal vectors and QR factorization Orthonormal vectors and QR factorization 4 1 Lecture 4 Orthonormal vectors and QR factorization EE263 Autumn 2004 orthonormal vectors Gram-Schmidt procedure, QR factorization orthogonal decomposition induced

More information

for all subintervals I J. If the same is true for the dyadic subintervals I D J only, we will write ϕ BMO d (J). In fact, the following is true

for all subintervals I J. If the same is true for the dyadic subintervals I D J only, we will write ϕ BMO d (J). In fact, the following is true 3 ohn Nirenberg inequality, Part I A function ϕ L () belongs to the space BMO() if sup ϕ(s) ϕ I I I < for all subintervals I If the same is true for the dyadic subintervals I D only, we will write ϕ BMO

More information

BIVARIATE LAGRANGE INTERPOLATION AT THE PADUA POINTS: THE IDEAL THEORY APPROACH

BIVARIATE LAGRANGE INTERPOLATION AT THE PADUA POINTS: THE IDEAL THEORY APPROACH BIVARIATE LAGRANGE INTERPOLATION AT THE PADUA POINTS: THE IDEAL THEORY APPROACH LEN BOS, STEFANO DE MARCHI, MARCO VIANELLO, AND YUAN XU Abstract The Padua points are a family of points on the square [,

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 37, pp. -,. Copyright,. ISSN 68-963. ETNA APPROXIMATE FEKETE POINTS FOR WEIGHTED POLYNOMIAL INTERPOLATION A. SOMMARIVA AND M. VIANELLO. Abstract. We

More information

Class notes: Approximation

Class notes: Approximation Class notes: Approximation Introduction Vector spaces, linear independence, subspace The goal of Numerical Analysis is to compute approximations We want to approximate eg numbers in R or C vectors in R

More information

which arises when we compute the orthogonal projection of a vector y in a subspace with an orthogonal basis. Hence assume that P y = A ij = x j, x i

which arises when we compute the orthogonal projection of a vector y in a subspace with an orthogonal basis. Hence assume that P y = A ij = x j, x i MODULE 6 Topics: Gram-Schmidt orthogonalization process We begin by observing that if the vectors {x j } N are mutually orthogonal in an inner product space V then they are necessarily linearly independent.

More information

Sparse Legendre expansions via l 1 minimization

Sparse Legendre expansions via l 1 minimization Sparse Legendre expansions via l 1 minimization Rachel Ward, Courant Institute, NYU Joint work with Holger Rauhut, Hausdorff Center for Mathematics, Bonn, Germany. June 8, 2010 Outline Sparse recovery

More information

Discrete Minimum Energy Problems

Discrete Minimum Energy Problems Discrete Minimum Energy Problems D.P. Hardin Department of Mathematics Vanderbilt University TU Graz, July 3, 2009 Reisz s energy The Riesz s-energy of ω N = {x 1, x 2,..., x N } R p is, for s > 0, E s(ω

More information

Numerical Integration over unit sphere by using spherical t-designs

Numerical Integration over unit sphere by using spherical t-designs Numerical Integration over unit sphere by using spherical t-designs Congpei An 1 1,Institute of Computational Sciences, Department of Mathematics, Jinan University Spherical Design and Numerical Analysis

More information

Solving the 3D Laplace Equation by Meshless Collocation via Harmonic Kernels

Solving the 3D Laplace Equation by Meshless Collocation via Harmonic Kernels Solving the 3D Laplace Equation by Meshless Collocation via Harmonic Kernels Y.C. Hon and R. Schaback April 9, Abstract This paper solves the Laplace equation u = on domains Ω R 3 by meshless collocation

More information

On the Generalised Hermite Constants

On the Generalised Hermite Constants On the Generalised Hermite Constants NTU SPMS-MAS Seminar Bertrand MEYER IMB Bordeaux Singapore, July 10th, 2009 B. Meyer (IMB) Hermite constants Jul 10th 2009 1 / 35 Outline 1 Introduction 2 The generalised

More information

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination Math 0, Winter 07 Final Exam Review Chapter. Matrices and Gaussian Elimination { x + x =,. Different forms of a system of linear equations. Example: The x + 4x = 4. [ ] [ ] [ ] vector form (or the column

More information

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 Instructions Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 The exam consists of four problems, each having multiple parts. You should attempt to solve all four problems. 1.

More information

Functional Analysis Exercise Class

Functional Analysis Exercise Class Functional Analysis Exercise Class Week: December 4 8 Deadline to hand in the homework: your exercise class on week January 5. Exercises with solutions ) Let H, K be Hilbert spaces, and A : H K be a linear

More information

7. Symmetric Matrices and Quadratic Forms

7. Symmetric Matrices and Quadratic Forms Linear Algebra 7. Symmetric Matrices and Quadratic Forms CSIE NCU 1 7. Symmetric Matrices and Quadratic Forms 7.1 Diagonalization of symmetric matrices 2 7.2 Quadratic forms.. 9 7.4 The singular value

More information

On the Lebesgue constant of subperiodic trigonometric interpolation

On the Lebesgue constant of subperiodic trigonometric interpolation On the Lebesgue constant of subperiodic trigonometric interpolation Gaspare Da Fies and Marco Vianello November 4, 202 Abstract We solve a recent conjecture, proving that the Lebesgue constant of Chebyshev-like

More information

Uniformly bounded sets of orthonormal polynomials on the sphere

Uniformly bounded sets of orthonormal polynomials on the sphere Uniformly bounded sets of orthonormal polynomials on the sphere J. Marzo & J. Ortega-Cerdà Universitat de Barcelona October 13, 2014 Some previous results W. Rudin (80), Inner function Conjecture : There

More information

arxiv: v1 [math.na] 13 Feb 2015

arxiv: v1 [math.na] 13 Feb 2015 Trivariate polynomial approximation on Lissajous curves arxiv:152.4114v1 [math.na] 13 Feb 215 L. Bos 1, S. De Marchi 2 and M. Vianello 2 February 19, 215 Abstract We study Lissajous curves in the 3-cube,

More information

Boundary Integral Equations on the Sphere with Radial Basis Functions: Error Analysis

Boundary Integral Equations on the Sphere with Radial Basis Functions: Error Analysis Boundary Integral Equations on the Sphere with Radial Basis Functions: Error Analysis T. Tran Q. T. Le Gia I. H. Sloan E. P. Stephan Abstract Radial basis functions are used to define approximate solutions

More information

Recall that any inner product space V has an associated norm defined by

Recall that any inner product space V has an associated norm defined by Hilbert Spaces Recall that any inner product space V has an associated norm defined by v = v v. Thus an inner product space can be viewed as a special kind of normed vector space. In particular every inner

More information

Math 54. Selected Solutions for Week 5

Math 54. Selected Solutions for Week 5 Math 54. Selected Solutions for Week 5 Section 4. (Page 94) 8. Consider the following two systems of equations: 5x + x 3x 3 = 5x + x 3x 3 = 9x + x + 5x 3 = 4x + x 6x 3 = 9 9x + x + 5x 3 = 5 4x + x 6x 3

More information

NEEDLET APPROXIMATION FOR ISOTROPIC RANDOM FIELDS ON THE SPHERE

NEEDLET APPROXIMATION FOR ISOTROPIC RANDOM FIELDS ON THE SPHERE NEEDLET APPROXIMATION FOR ISOTROPIC RANDOM FIELDS ON THE SPHERE Quoc T. Le Gia Ian H. Sloan Yu Guang Wang Robert S. Womersley School of Mathematics and Statistics University of New South Wales, Australia

More information

Interpolation. Escuela de Ingeniería Informática de Oviedo. (Dpto. de Matemáticas-UniOvi) Numerical Computation Interpolation 1 / 34

Interpolation. Escuela de Ingeniería Informática de Oviedo. (Dpto. de Matemáticas-UniOvi) Numerical Computation Interpolation 1 / 34 Interpolation Escuela de Ingeniería Informática de Oviedo (Dpto. de Matemáticas-UniOvi) Numerical Computation Interpolation 1 / 34 Outline 1 Introduction 2 Lagrange interpolation 3 Piecewise polynomial

More information

Solutions to Final Practice Problems Written by Victoria Kala Last updated 12/5/2015

Solutions to Final Practice Problems Written by Victoria Kala Last updated 12/5/2015 Solutions to Final Practice Problems Written by Victoria Kala vtkala@math.ucsb.edu Last updated /5/05 Answers This page contains answers only. See the following pages for detailed solutions. (. (a x. See

More information

Porting a sphere optimization program from LAPACK to ScaLAPACK

Porting a sphere optimization program from LAPACK to ScaLAPACK Porting a sphere optimization program from LAPACK to ScaLAPACK Mathematical Sciences Institute, Australian National University. For presentation at Computational Techniques and Applications Conference

More information

Multi-normed spaces and multi-banach algebras. H. G. Dales. Leeds Semester

Multi-normed spaces and multi-banach algebras. H. G. Dales. Leeds Semester Multi-normed spaces and multi-banach algebras H. G. Dales Leeds Semester Leeds, 2 June 2010 1 Motivating problem Let G be a locally compact group, with group algebra L 1 (G). Theorem - B. E. Johnson, 1972

More information

Greedy control. Martin Lazar University of Dubrovnik. Opatija, th Najman Conference. Joint work with E: Zuazua, UAM, Madrid

Greedy control. Martin Lazar University of Dubrovnik. Opatija, th Najman Conference. Joint work with E: Zuazua, UAM, Madrid Greedy control Martin Lazar University of Dubrovnik Opatija, 2015 4th Najman Conference Joint work with E: Zuazua, UAM, Madrid Outline Parametric dependent systems Reduced basis methods Greedy control

More information

Bivariate Lagrange interpolation at the Padua points: The generating curve approach

Bivariate Lagrange interpolation at the Padua points: The generating curve approach Journal of Approximation Theory 43 (6) 5 5 www.elsevier.com/locate/jat Bivariate Lagrange interpolation at the Padua points: The generating curve approach Len Bos a, Marco Caliari b, Stefano De Marchi

More information

Spring, 2012 CIS 515. Fundamentals of Linear Algebra and Optimization Jean Gallier

Spring, 2012 CIS 515. Fundamentals of Linear Algebra and Optimization Jean Gallier Spring 0 CIS 55 Fundamentals of Linear Algebra and Optimization Jean Gallier Homework 5 & 6 + Project 3 & 4 Note: Problems B and B6 are for extra credit April 7 0; Due May 7 0 Problem B (0 pts) Let A be

More information

Sparse grid quadrature on products of spheres

Sparse grid quadrature on products of spheres Sparse grid quadrature on products of spheres Markus Hegland a, Paul Leopardi a, a Centre for Mathematics and its Applications, Australian National University. Abstract This paper examines sparse grid

More information

Numerical Quadrature on the Intersection of Planar Disks

Numerical Quadrature on the Intersection of Planar Disks Filomat 3:3 (27), 45 45 https://doi.org/.2298/fil735s Published by Faculty of Sciences and Mathematics, University of Niš, Serbia Available at: http://www.pmf.ni.ac.rs/filomat Numerical Quadrature on the

More information

A Review of Linear Algebra

A Review of Linear Algebra A Review of Linear Algebra Mohammad Emtiyaz Khan CS,UBC A Review of Linear Algebra p.1/13 Basics Column vector x R n, Row vector x T, Matrix A R m n. Matrix Multiplication, (m n)(n k) m k, AB BA. Transpose

More information

Spherical t ɛ -Design for Numerical Approximations on the Sphere, I

Spherical t ɛ -Design for Numerical Approximations on the Sphere, I Spherical t ɛ -Design for Numerical Approximations on the Sphere, I Xiaojun Chen Department of Applied Mathematics The Hong Kong Polytechnic University April 2015, Shanghai Jiaotong University X. Chen

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

Ph.D. Katarína Bellová Page 1 Mathematics 2 (10-PHY-BIPMA2) EXAM - Solutions, 20 July 2017, 10:00 12:00 All answers to be justified.

Ph.D. Katarína Bellová Page 1 Mathematics 2 (10-PHY-BIPMA2) EXAM - Solutions, 20 July 2017, 10:00 12:00 All answers to be justified. PhD Katarína Bellová Page 1 Mathematics 2 (10-PHY-BIPMA2 EXAM - Solutions, 20 July 2017, 10:00 12:00 All answers to be justified Problem 1 [ points]: For which parameters λ R does the following system

More information

33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM

33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM 33AH, WINTER 2018: STUDY GUIDE FOR FINAL EXAM (UPDATED MARCH 17, 2018) The final exam will be cumulative, with a bit more weight on more recent material. This outline covers the what we ve done since the

More information

(i) [7 points] Compute the determinant of the following matrix using cofactor expansion.

(i) [7 points] Compute the determinant of the following matrix using cofactor expansion. Question (i) 7 points] Compute the determinant of the following matrix using cofactor expansion 2 4 2 4 2 Solution: Expand down the second column, since it has the most zeros We get 2 4 determinant = +det

More information

Quasi-Monte Carlo Methods for Applications in Statistics

Quasi-Monte Carlo Methods for Applications in Statistics Quasi-Monte Carlo Methods for Applications in Statistics Weights for QMC in Statistics Vasile Sinescu (UNSW) Weights for QMC in Statistics MCQMC February 2012 1 / 24 Quasi-Monte Carlo Methods for Applications

More information

Research in Mathematical Analysis Some Concrete Directions

Research in Mathematical Analysis Some Concrete Directions Research in Mathematical Analysis Some Concrete Directions Anthony Carbery School of Mathematics University of Edinburgh Prospects in Mathematics, Durham, 9th January 2009 Anthony Carbery (U. of Edinburgh)

More information

A Brief Outline of Math 355

A Brief Outline of Math 355 A Brief Outline of Math 355 Lecture 1 The geometry of linear equations; elimination with matrices A system of m linear equations with n unknowns can be thought of geometrically as m hyperplanes intersecting

More information

Cheat Sheet for MATH461

Cheat Sheet for MATH461 Cheat Sheet for MATH46 Here is the stuff you really need to remember for the exams Linear systems Ax = b Problem: We consider a linear system of m equations for n unknowns x,,x n : For a given matrix A

More information

A numerical study of the Xu polynomial interpolation formula in two variables

A numerical study of the Xu polynomial interpolation formula in two variables A numerical study of the Xu polynomial interpolation formula in two variables Len Bos Dept. of Mathematics and Statistics, University of Calgary (Canada) Marco Caliari, Stefano De Marchi Dept. of Computer

More information

Miderm II Solutions To find the inverse we row-reduce the augumented matrix [I A]. In our case, we row reduce

Miderm II Solutions To find the inverse we row-reduce the augumented matrix [I A]. In our case, we row reduce Miderm II Solutions Problem. [8 points] (i) [4] Find the inverse of the matrix A = To find the inverse we row-reduce the augumented matrix [I A]. In our case, we row reduce We have A = 2 2 (ii) [2] Possibly

More information

ANALYSIS QUALIFYING EXAM FALL 2016: SOLUTIONS. = lim. F n

ANALYSIS QUALIFYING EXAM FALL 2016: SOLUTIONS. = lim. F n ANALYSIS QUALIFYING EXAM FALL 206: SOLUTIONS Problem. Let m be Lebesgue measure on R. For a subset E R and r (0, ), define E r = { x R: dist(x, E) < r}. Let E R be compact. Prove that m(e) = lim m(e /n).

More information

Uniform approximation on the sphere by least squares polynomials

Uniform approximation on the sphere by least squares polynomials Uniform approximation on the sphere by least squares polynomials Woula Themistoclakis Marc Van Barel August 7, 8 Abstract The paper concerns the uniform polynomial approximation of a function f, continuous

More information

MATH 369 Linear Algebra

MATH 369 Linear Algebra Assignment # Problem # A father and his two sons are together 00 years old. The father is twice as old as his older son and 30 years older than his younger son. How old is each person? Problem # 2 Determine

More information

MATH 31 - ADDITIONAL PRACTICE PROBLEMS FOR FINAL

MATH 31 - ADDITIONAL PRACTICE PROBLEMS FOR FINAL MATH 3 - ADDITIONAL PRACTICE PROBLEMS FOR FINAL MAIN TOPICS FOR THE FINAL EXAM:. Vectors. Dot product. Cross product. Geometric applications. 2. Row reduction. Null space, column space, row space, left

More information

PLURIPOTENTIAL NUMERICS

PLURIPOTENTIAL NUMERICS PLURIPOTNTIAL NUMRICS FDRICO PIAZZON Abstract. We introduce numerical methods for the approximation of the main (global) quantities in Pluripotential Theory as the extremal plurisubharmonic function V

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

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

EXISTENCE OF SOLUTIONS TO ASYMPTOTICALLY PERIODIC SCHRÖDINGER EQUATIONS

EXISTENCE OF SOLUTIONS TO ASYMPTOTICALLY PERIODIC SCHRÖDINGER EQUATIONS Electronic Journal of Differential Equations, Vol. 017 (017), No. 15, pp. 1 7. ISSN: 107-6691. URL: http://ejde.math.txstate.edu or http://ejde.math.unt.edu EXISTENCE OF SOLUTIONS TO ASYMPTOTICALLY PERIODIC

More information

MATH 167: APPLIED LINEAR ALGEBRA Least-Squares

MATH 167: APPLIED LINEAR ALGEBRA Least-Squares MATH 167: APPLIED LINEAR ALGEBRA Least-Squares October 30, 2014 Least Squares We do a series of experiments, collecting data. We wish to see patterns!! We expect the output b to be a linear function of

More information

A Comparison of Popular Point Configurations on 2

A Comparison of Popular Point Configurations on 2 Volume 9 016 Pages 16 49 A Comparison of Popular Point Configurations on D. P. Hardin a T. Michaels ab E.B. Saff a Abstract There are many ways to generate a set of nodes on the sphere for use in a variety

More information

7. Dimension and Structure.

7. Dimension and Structure. 7. Dimension and Structure 7.1. Basis and Dimension Bases for Subspaces Example 2 The standard unit vectors e 1, e 2,, e n are linearly independent, for if we write (2) in component form, then we obtain

More information

Whitney s Extension Problem for C m

Whitney s Extension Problem for C m Whitney s Extension Problem for C m by Charles Fefferman Department of Mathematics Princeton University Fine Hall Washington Road Princeton, New Jersey 08544 Email: cf@math.princeton.edu Supported by Grant

More information

homogeneous 71 hyperplane 10 hyperplane 34 hyperplane 69 identity map 171 identity map 186 identity map 206 identity matrix 110 identity matrix 45

homogeneous 71 hyperplane 10 hyperplane 34 hyperplane 69 identity map 171 identity map 186 identity map 206 identity matrix 110 identity matrix 45 address 12 adjoint matrix 118 alternating 112 alternating 203 angle 159 angle 33 angle 60 area 120 associative 180 augmented matrix 11 axes 5 Axiom of Choice 153 basis 178 basis 210 basis 74 basis test

More information

Ill-Posedness of Backward Heat Conduction Problem 1

Ill-Posedness of Backward Heat Conduction Problem 1 Ill-Posedness of Backward Heat Conduction Problem 1 M.THAMBAN NAIR Department of Mathematics, IIT Madras Chennai-600 036, INDIA, E-Mail mtnair@iitm.ac.in 1. Ill-Posedness of Inverse Problems Problems that

More information

AN ASYMPTOTIC BEHAVIOR OF QR DECOMPOSITION

AN ASYMPTOTIC BEHAVIOR OF QR DECOMPOSITION Unspecified Journal Volume 00, Number 0, Pages 000 000 S????-????(XX)0000-0 AN ASYMPTOTIC BEHAVIOR OF QR DECOMPOSITION HUAJUN HUANG AND TIN-YAU TAM Abstract. The m-th root of the diagonal of the upper

More information

Stability constants for kernel-based interpolation processes

Stability constants for kernel-based interpolation processes Dipartimento di Informatica Università degli Studi di Verona Rapporto di ricerca Research report 59 Stability constants for kernel-based interpolation processes Stefano De Marchi Robert Schaback Dipartimento

More information

Proof: The coding of T (x) is the left shift of the coding of x. φ(t x) n = L if T n+1 (x) L

Proof: The coding of T (x) is the left shift of the coding of x. φ(t x) n = L if T n+1 (x) L Lecture 24: Defn: Topological conjugacy: Given Z + d (resp, Zd ), actions T, S a topological conjugacy from T to S is a homeomorphism φ : M N s.t. φ T = S φ i.e., φ T n = S n φ for all n Z + d (resp, Zd

More information

BASIC ALGORITHMS IN LINEAR ALGEBRA. Matrices and Applications of Gaussian Elimination. A 2 x. A T m x. A 1 x A T 1. A m x

BASIC ALGORITHMS IN LINEAR ALGEBRA. Matrices and Applications of Gaussian Elimination. A 2 x. A T m x. A 1 x A T 1. A m x BASIC ALGORITHMS IN LINEAR ALGEBRA STEVEN DALE CUTKOSKY Matrices and Applications of Gaussian Elimination Systems of Equations Suppose that A is an n n matrix with coefficents in a field F, and x = (x,,

More information

Matrix decompositions

Matrix decompositions Matrix decompositions Zdeněk Dvořák May 19, 2015 Lemma 1 (Schur decomposition). If A is a symmetric real matrix, then there exists an orthogonal matrix Q and a diagonal matrix D such that A = QDQ T. The

More information

Elementary linear algebra

Elementary linear algebra Chapter 1 Elementary linear algebra 1.1 Vector spaces Vector spaces owe their importance to the fact that so many models arising in the solutions of specific problems turn out to be vector spaces. The

More information

Linear Algebra Massoud Malek

Linear Algebra Massoud Malek CSUEB Linear Algebra Massoud Malek Inner Product and Normed Space In all that follows, the n n identity matrix is denoted by I n, the n n zero matrix by Z n, and the zero vector by θ n An inner product

More information

Local radial basis function approximation on the sphere

Local radial basis function approximation on the sphere Local radial basis function approximation on the sphere Kerstin Hesse and Q. T. Le Gia School of Mathematics and Statistics, The University of New South Wales, Sydney NSW 05, Australia April 30, 007 Abstract

More information

A fast randomized algorithm for approximating an SVD of a matrix

A fast randomized algorithm for approximating an SVD of a matrix A fast randomized algorithm for approximating an SVD of a matrix Joint work with Franco Woolfe, Edo Liberty, and Vladimir Rokhlin Mark Tygert Program in Applied Mathematics Yale University Place July 17,

More information

MATH 20F: LINEAR ALGEBRA LECTURE B00 (T. KEMP)

MATH 20F: LINEAR ALGEBRA LECTURE B00 (T. KEMP) MATH 20F: LINEAR ALGEBRA LECTURE B00 (T KEMP) Definition 01 If T (x) = Ax is a linear transformation from R n to R m then Nul (T ) = {x R n : T (x) = 0} = Nul (A) Ran (T ) = {Ax R m : x R n } = {b R m

More information