Computing with Functions on the Sphere and Disk Heather Wilber | Boise State University ◦ Dr

Total Page:16

File Type:pdf, Size:1020Kb

Computing with Functions on the Sphere and Disk Heather Wilber | Boise State University ◦ Dr Computing with Functions on the Sphere and Disk Heather Wilber j Boise State University ◦ Dr. Alex Townsend j MIT ◦ Dr. Grady Wright j Boise State University Overview Low rank approximation of BMC functions The Double Fourier Sphere Method Synthesizing a classic technique known as the double Fourier sphere (DFS) method [4, 5, 6] together with The function ~f (λ, θ) is said to be Let f (x; y; z) be defined on the surface of the unit sphere. f is periodic along the ~ new algorithmic techniques in low rank function approximation [2,8], we develop a new method of I rank 1 if it is nonzero and can be written as f (λ, θ) = c(θ)r(λ). great circles passing through its poles, but this feature is lost transforming f to a approximation for computation with functions on the sphere and disk. This approximation method preserves I rank at most K if it can be expressed as a sum of K rank 1 functions. rectangular grid: T := f (x; y; z) −! f (λ, θ), (λ, θ) 2 [−π; π] × [0; π]. The function ~f , the bi-periodicity of the sphere, maintains smoothness over the poles in every procedure, and is Most functions are of infinite rank, but smooth functions can often be approximated A doubled-up extension of f , recovers this periodicity. near-optimal in its underlying interpolation. It resolves many drawbacks encountered by previous methods, well by a finite, low rank function: (a) and powers a suite of fast, scalable algorithms for computing with functions on the sphere and disk. (c) 0 K 30 ~ ~ X The continuous SVD (Karhunen-Loeve` (2) f (λ, θ) ≈ fk(λ, θ) = djcj(θ)rj(λ): 60 expansion) is an optimal way to derive j=1 90 such an approximation [7], but it is computationally expensive. Our method gives a 120 near-optimal approximation with near-optimal computational complexity. (b) 150 Constructing an approximation: (a) The function 0 θ/π 180 f (x; y; z) = cos(xz − sin y) on the sphere, constructed 30 180 Iterative Gaussian elimination (GE) 210 with spherefun. (b) The “skeleton” used to 60 240 approximate f . Samples of f are only taken along the θ/π 90 270 Iterative GE is a near-optimal method for deriving a low-rank approximation [8]. It 180 blue lines. The underlying tensor grid (in gray) shows the 120 proceeds by choosing a maximal value ~f (λ ; θ ), which serves as a pivot. Performing 300 sample points required without low rank techniques. ∗ ∗ 150 ~ 330 a GE-step with the pivot results in a reduced-rank update of f : 180 0 30 60 90 120 150 180 210 240 270 300 330 360 360 (a) (b) 180λ/π 0 30 60 90 120 150 180 210 240 270 300 330 360 180λ/π ~f (λ ; θ)~f (λ, θ ) (3) ~f (λ, θ) − ~f (λ, θ)− ∗ ∗ : The DFS method applied to the world atlas. (a) Outline of the land masses plotted on the surface of ~ Computing with functions on the sphere: spherefun software f (λ∗; θ∗) the sphere. (b) The projection of the land masses using latitude-longitude coordinates. (c) Land | {z } masses after applying the DFS method. The result is a “function” that is periodic in both longitude A rank 1 approx. to ~f and latitude. We implement our methods in Chebfun, which is an open-source software package in MATLAB. These libraries make function evaluation, integration, differentiation, vector calculus, root-finding, plotting and Running the algorithm forward K steps ~ Preservation of symmetry = Smoothness over poles many other computations easy, accurate, and fast. subtracts a series of K rank 1 terms from f . This series of terms, when added together, The transformation T also creates artificial singularities at the poles of f . The reproduces a rank K approximation to ~f . extended function ~f exhibits a particular form of symmetry, which we call Problematically, this method does not ~ block-mirror-centrosymmetric (BMC). Preserving this BMC symmetry in our R preserve the BMC structure of f . Integration: 2 f dΩ −! sum2(f) approximation techniques enforces ~f is smooth over the poles. S f = spherefun(@(x,y,z) Structure-preserving GE (a) (b) 1+x+y.ˆ2+x.ˆ2.*y+x.ˆ4+y.ˆ5+ (x.*y.*z).ˆ2); To preserve BMC structure, we must simultaneously eliminate intf = sum2(f); symmetric pairs of rows and columns, as shown in the figure (left). A @f cos λ @f @f exact = 216 pi/35; f = + sin λ cos θ ; * @y sin θ @λ @θ block-pivoting strategy with a 2 × 2 matrix accomplishes this. error = intf-exact Differentiation: @ ; @ ; @ −! diff 3.552713678800501e-15 @x @y @z f = spherefun(@(lam,th) Define a matrix M based on the BMC-symmetric values: " # " # cos(1+2*pi*(cos(lam-0.2).*sin(th)) ~f (λ∗ − π; θ∗) ~f (λ∗; θ∗) ~f (λ∗ − π; θ∗) ~f (λ∗; θ∗) a b M = = = : Vector calculus: div, grad, curl (and all that) +pi*sin(pi*cos(th)))); ~f (λ∗ − π; −θ∗) ~f (λ∗; −θ∗) ~f (λ∗; θ∗) ~f (λ∗ − π; θ∗) b a dfdy = diff(f, 2); Our structure-preserving GE step, analogous to (3), is given by Poisson’s Equation: ∆ 2u = f −! Poisson(f) " # S h i ~f (λ, θ∗) exact = spherefun.sphharm(6,0) ~f (λ, θ) − ~f (λ, θ) − ~f (λ∗ − π; θ) ~f (λ∗; θ) M+ ; ~f (λ, −θ∗) The definition of a BMC function. (a) The function f (λ, θ) written in terms of a quadrant I function + sqrt(14/11)*spherefun.sphharm(6,5); ~ + h(λ, θ), and a quadrant II function g(λ, θ). The double Fourier extension of f gives a BMC function, f , f = -42*exact; where M is the -pseudoinverse of M. that is defined by extending f to quadrants III and IV as described in the figure. (b) Illustration of a u = spherefun.Poisson(f,0,16); surf(v) BMC function. err = norm(u-exact,2) Algorithm: Structure-preserving GE on BMC functions 3.794084381686475e-14 Pseudocode for our Set ~f = 0 and e~ = ~f Why not use spherical harmonics? f = spherefun( @(l,t) u = curl(f); 0 0 structure-preserving The spherical harmonic expansion of f is cos(4*l).*cos(t).*sin(t).ˆ4 v = vort(u); for k = 1; 2; 3;:::; GE procedure on -cos(t).ˆ2); quiver(u) 1 ` BMC functions. This X X m surf(f) surf(v) a b Find (λ ; θ ) such that M = , where a = e~ (λ − π; θ ) and is a continuous f (λ, θ) = c`;mY` (λ, θ); (1) k k b a k−1 k−1 k−1 `=0 m=−` idealization and in m b = e~k−1(λk−1; θk−1) maximizes σ1(M), the largest singular value of M where Y` is the spherical harmonic function with degree ` and order m. Analogous practice we use a + e~k−1(λ, θk) discretization of this to trigonometric expansions, spherical harmonics are the instinctive mathematical Computing with functions on the disk: diskfun software e~ = e~ − e~ (λ − π; θ) e~ (λ ; θ) M k k−1 k−1 k k−1 k e~ (λ, −θ ) choice for representing functions on the surface of the sphere [1]. However, highly A variant of the double Fourier method extends functions on the disk to BMC functions. We apply a similar k−1 k procedure and e~ (λ, θ ) adaptive discretizations are computationally unfeasible using such methods. Our ~f = ~f − e~ (λ − π; θ) e~ (λ ; θ) M+ k−1 k terminate it after a GE algorithm for constructing approximants. k k−1 k−1 k k−1 k e~ (λ, −θ ) alternative setting enables fast algorithms via the FFT. k−1 k finite number of end steps. Algebra with disk harmonics: diskharm The sum of six eigenfunctions of the References: [1] K. Atkinson and W. Han, Spherical Harmonics and Approximations on the Unit Sphere: An Laplacian produce a rank 6 function. Introduction, Lecture Notes in Mathematics, Springer Berlin Heidelberg, 2012. [2] M. Bebendorf, Approximation of Geometric convergence for sufficiently analytic functions nu = [1, 1, 2, 3, 5, 8]; boundary element matrices, Numerische Mathematik, 86 (2000), pp. 565–589. [3] G. J. Boer and L. Steinberg, ~ Fourier series on spheres, Atmosphere, 13 (1975), pp. 180–191. [4] B. Fornberg, A pseudospectral approach for w = (-1).ˆ(1:6).*(0:5); Theorem: Let f :[−π; π] × [−π; π] ! R be a BMC function such that f (λ, ·) is polar and spherical geometries, SIAM J. Sci. Comput., 16 (1995), pp. 1071–1081. [5] P. E. Merilees, The G = diskfun(); continuous for any λ 2 [−π; π] and f (·; θ) is analytic and uniformly bounded in a pseudospectral approximation applied to the shallow water equations on a sphere, Atmosphere, 11 (1973), pp. 13–20. for j=1:6 [6] S. A. Orszag, Fourier series on spheres, Monthly Weather Review, 102 (1974), pp. 56–75. [7] E. Schmidt, Zur stadium S of radius (1 + α)ρπ, ρ > 1, for θ 2 [−π; π]. theorie der linearen und nichtlinearen integralgleichungen. iii. teil, Mathematische Annalen, 65 (1908), pp. 370–399. G = G + contour(h) surf(h) diskfun.diskharm(w(j),nu(j)); [8] A. Townsend and L. N. Trefethen, An extension of Chebfun to two dimensions, SIAM Journal on Scientific roots Then, as k ! 1, jje~ jj ! 0. That is, the BMC preserving GE procedure converges. Computing, 35 (2013), pp. C495–C518. end Rootfinding: k 1 The zero contour of h = 2− cos 4x + sin(7πx sin(y − :1)) Furthermore, this convergences is geometric. Acknowledgements: This work is generously supported by NASA’s Idaho Space Grant Consortium.
Recommended publications
  • Quaternion Zernike Spherical Polynomials
    MATHEMATICS OF COMPUTATION Volume 84, Number 293, May 2015, Pages 1317–1337 S 0025-5718(2014)02888-3 Article electronically published on August 29, 2014 QUATERNION ZERNIKE SPHERICAL POLYNOMIALS J. MORAIS AND I. CAC¸ AO˜ Abstract. Over the past few years considerable attention has been given to the role played by the Zernike polynomials (ZPs) in many different fields of geometrical optics, optical engineering, and astronomy. The ZPs and their applications to corneal surface modeling played a key role in this develop- ment. These polynomials are a complete set of orthogonal functions over the unit circle and are commonly used to describe balanced aberrations. In the present paper we introduce the Zernike spherical polynomials within quater- nionic analysis ((R)QZSPs), which refine and extend the Zernike moments (defined through their polynomial counterparts). In particular, the underlying functions are of three real variables and take on either values in the reduced and full quaternions (identified, respectively, with R3 and R4). (R)QZSPs are orthonormal in the unit ball. The representation of these functions in terms of spherical monogenics over the unit sphere are explicitly given, from which several recurrence formulae for fast computer implementations can be derived. A summary of their fundamental properties and a further second or- der homogeneous differential equation are also discussed. As an application, we provide the reader with plot simulations that demonstrate the effectiveness of our approach. (R)QZSPs are new in literature and have some consequences that are now under investigation. 1. Introduction 1.1. The Zernike spherical polynomials. The complex Zernike polynomials (ZPs) have long been successfully used in many different fields of optics.
    [Show full text]
  • Laplacian Eigenmodes for the Three Sphere
    Laplacian eigenmodes for the three sphere M. Lachi`eze-Rey Service d’Astrophysique, C. E. Saclay 91191 Gif sur Yvette cedex, France October 10, 2018 Abstract The vector space k of the eigenfunctions of the Laplacian on the 3 V three sphere S , corresponding to the same eigenvalue λk = k (k + 2 − k 2), has dimension (k + 1) . After recalling the standard bases for , V we introduce a new basis B3, constructed from the reductions to S3 of peculiar homogeneous harmonic polynomia involving null vectors. We give the transformation laws between this basis and the usual hyper-spherical harmonics. Thanks to the quaternionic representations of S3 and SO(4), we are able to write explicitely the transformation properties of B3, and thus of any eigenmode, under an arbitrary rotation of SO(4). This offers the possibility to select those functions of k which remain invariant under V a chosen rotation of SO(4). When the rotation is an holonomy transfor- mation of a spherical space S3/Γ, this gives a method to calculates the eigenmodes of S3/Γ, which remains an open probleme in general. We illustrate our method by (re-)deriving the eigenmodes of lens and prism space. In a forthcoming paper, we present the derivation for dodecahedral space. 1 Introduction 3 The eigenvalues of the Laplacian ∆ of S are of the form λk = k (k + 2), + − k where k IN . For a given value of k, they span the eigenspace of ∈ 2 2 V dimension (k +1) . This vector space constitutes the (k +1) dimensional irreductible representation of SO(4), the isometry group of S3.
    [Show full text]
  • A User's Guide to Spherical Harmonics
    A User's Guide to Spherical Harmonics Martin J. Mohlenkamp∗ Version: October 18, 2016 This pamphlet is intended for the scientist who is considering using Spherical Harmonics for some appli- cation. It is designed to introduce the Spherical Harmonics from a theoretical perspective and then discuss those practical issues necessary for their use in applications. I expect great variability in the backgrounds of the readers. In order to be informative to those who know less, without insulting those who know more, I have adopted the strategy \State even basic facts, but briefly." My dissertation work was a fast transform for Spherical Harmonics [6]. After its publication, I started receiving questions about Spherical Harmonics in general, rather than about my work specifically. This pamphlet aims to answer such general questions. If you find mistakes, or feel that important material is unclear or missing, please inform me. 1 A Theory of Spherical Harmonics In this section we give a development of Spherical Harmonics. There are other developments from other perspectives. The one chosen here has the benefit of being very concrete. 1.1 Mathematical Preliminaries We define the L2 inner product of two functions to be Z hf; gi = f(s)¯g(s)ds (1) R 2π whereg ¯ denotes complex conjugation and the integral is over the space of interest, for example 0 dθ on the R 2π R π 2 p 2 circle or 0 0 sin φdφdθ on the sphere. We define the L norm by jjfjj = hf; fi. The space L consists of all functions such that jjfjj < 1.
    [Show full text]
  • Spherical-Harmonic Tensors Jm
    Spherical-harmonic tensors Francisco Gonzalez Ledesma1 and Matthew Mewes2 1Department of Physics, Florida State University, Tallahassee, Florida 32306, USA 2Physics Department, California Polytechnic State University, San Luis Obispo, California 93407, USA The connection between spherical harmonics and symmetric tensors is explored. For each spher- ical harmonic, a corresponding traceless symmetric tensor is constructed. These tensors are then extended to include nonzero traces, providing an orthonormal angular-momentum eigenbasis for symmetric tensors of any rank. The relationship between the spherical-harmonic tensors and spin- weighted spherical harmonics is derived. The results facilitate the spherical-harmonic expansion of a large class of tensor-valued functions. Several simple illustrative examples are discussed, and the formalism is used to derive the leading-order effects of violations of Lorentz invariance in Newtonian gravity. I. INTRODUCTION Spherical harmonics Yjm provide an orthonormal basis for scalar functions on the 2-sphere and have numerous applications in physics and related fields. While they are commonly written in terms of the spherical-coordinate polar angle θ and azimuthal angle φ, spherical harmonics can be expressed in terms of cartesian coordinates, which is convenient in certain applications. The cartesian versions involve rank-j symmetric trace-free tensors jm [1–5]. These form a basis for traceless tensors and provide a link between functions on the sphere and symmetricY traceless tensors in three dimensions. This work builds on the above understanding in several ways. We first develop a new method for calculating the scalar spherical harmonics Yjm in terms of components of the direction unit vector n = sin θ cos φ ex + sin θ sin φ ey + cos θ ez .
    [Show full text]
  • Electrodynamic Spherical Harmonic: Defi- Nition and Properties
    Electrodynamic spherical harmonic A V Novitsky Department of Theoretical Physics, Belarusian State University, Nezavisimosti Avenue 4, 220050 Minsk, Belarus [email protected] Abstract Electrodynamic spherical harmonic is a second rank tensor in three- dimensional space. It allows to separate the radial and angle variables in vector solutions of Maxwell’s equations. Using the orthonormaliza- tion for electrodynamic spherical harmonic, a boundary problem on a sphere can be easily solved. 1 Introduction In this paper we introduce new function — electrodynamic spherical har- monic. It is represented as a second rank tensor in three-dimensional space. But the function differs from tensor spherical harmonic [1–5]. By its defini- tion the electrodynamic spherical function possesses a number of properties of usual scalar and vector harmonics and includes them as component parts. Why electrodynamic spherical harmonic? The word “electrodynamic” im- arXiv:0803.4093v1 [math-ph] 28 Mar 2008 plies that the function is applied for solution of vector field problems. We use it in electrodynamics, however one can apply the function for description of spin fields in quantum field theory. Electrodynamic spherical harmonic is not a simple designation of the well- known functions. It satisfies the Maxwell equations and describes the angular dependence of vector fields. The introduced function separates the variables (radial coordinate and angles) in the fields. Moreover, the notation of the fields in terms of electrodynamic spherical harmonic noticeably simplifies the solution of a boundary problem on spherical interface. Just application of 1 the ortonormalization condition allows to find the coefficients of spherical function expansion (e.g. scattering field amplitudes).
    [Show full text]
  • Computation of Real-Valued Basis Functions Which Transform As Irreducible Representations of the Polyhedral Groups
    COMPUTATION OF REAL-VALUED BASIS FUNCTIONS WHICH TRANSFORM AS IRREDUCIBLE REPRESENTATIONS OF THE POLYHEDRAL GROUPS NAN XU∗ AND PETER C. DOERSCHUKy Abstract. Basis functions which are invariant under the operations of a rotational point group G are able to describe any 3-D object which exhibits the rotational point group symmetry. However, in order to characterize the spatial statistics of an ensemble of objects in which each object is different but the statistics exhibit the symmetry, a complete set of basis functions is required. In particular, for each irreducible representation (irrep) of G, it is necessary to include basis functions that transform according to that irrep. This complete set of basis functions is a basis for square- integrable functions on the surface of the sphere in 3-D. Because the objects are real-valued, it is convenient to have real-valued basis functions. In this paper the existence of such real-valued bases is proven and an algorithm for their computation is provided for the icosahedral I and the octahedral O symmetries. Furthermore, it is proven that such a real-valued basis does not exist for the tetrahedral T symmetry because some irreps of T are essentially complex. The importance of these basis functions to computations in single-particle cryo electron microscopy is described. Key words. polyhedral groups, real-valued matrix irreducible representations, numerical com- putation of similarity transformations, basis functions that transform as a row of an irreducible representation of a rotation group, Classical groups (02.20.Hj), Special functions (02.30.Gp). AMS subject classifications. 2604, 2004, 57S17, 57S25 1.
    [Show full text]
  • Spherical Harmonics and Homogeneous Har- Monic Polynomials
    SPHERICAL HARMONICS AND HOMOGENEOUS HAR- MONIC POLYNOMIALS 1. The spherical Laplacean. Denote by S ½ R3 the unit sphere. For a function f(!) de¯ned on S, let f~ denote its extension to an open neighborhood N of S, constant along normals to S (i.e., constant along rays from the origin). We say f 2 C2(S) if f~ is a C2 function in N , and for such functions de¯ne a di®erential operator ¢S by: ¢Sf := ¢f;~ where ¢ on the right-hand side is the usual Laplace operator in R3. With a little work (omitted here) one may derive the expression for ¢ in polar coordinates (r; !) in R2 (r > 0;! 2 S): 2 1 ¢u = u + u + ¢ u: rr r r r2 S (Here ¢Su(r; !) is the operator ¢S acting on the function u(r; :) in S, for each ¯xed r.) A homogeneous polynomial of degree n ¸ 0 in three variables (x; y; z) is a linear combination of `monomials of degree n': d1 d2 d3 x y z ; di ¸ 0; d1 + d2 + d3 = n: This de¯nes a vector space (over R) denoted Pn. A simple combinatorial argument (involving balls and separators, as most of them do), seen in class, yields the dimension: 1 d := dim(P ) = (n + 1)(n + 2): n n 2 Writing a polynomial p 2 Pn in polar coordinates, we necessarily have: n p(r; !) = r f(!); f = pjS; where f is the restriction of p to S. This is an injective linear map p 7! f, but the functions on S so obtained are rather special (a dn-dimensional subspace of the in¯nite-dimensional space C(S) of continuous functions-let's call it Pn(S)) We are interested in the subspace Hn ½ Pn of homogeneous harmonic polynomials of degree n (¢p = 0).
    [Show full text]
  • Arxiv:1805.12125V2 [Quant-Ph] 27 Sep 2018 Calculations in Quantum Mechanics? Even Quantum Experts Will find Something New in the Way We Compute the Spherical Harmonics
    Condensed MatTER Physics, 2018, Vol. 21, No 3, 33002: 1–12 DOI: 10.5488/CMP.21.33002 HTtp://www.icmp.lviv.ua/journal Calculating SPHERICAL HARMONICS WITHOUT DERIVATIVES M. WEITZMAN1, J.K. Freericks2 1 3515 E. Rochelle Ave., Las Vegas, NV 89121, USA 2 Department OF Physics, GeorGETOWN University, 37th AND O Sts. NW, Washington, DC 20057, USA Received May 30, 2018 The DERIVATION OF SPHERICAL HARMONICS IS THE SAME IN NEARLY EVERY QUANTUM MECHANICS TEXTBOOK AND classroom. It IS FOUND TO BE DIffiCULT TO follow, HARD TO understand, AND CHALLENGING TO REPRODUCE BY MOST students. In THIS work, WE SHOW HOW ONE CAN DETERMINE SPHERICAL HARMONICS IN A MORE NATURAL WAY BASED ON OPERATORS AND A POWERFUL IDENTITY CALLED THE EXPONENTIAL DISENTANGLING OPERATOR IDENTITY (known IN QUANTUM optics, BUT LITTLE USED elsewhere). This NEW STRATEGY FOLLOWS NATURALLY AFTER ONE HAS INTRODUCED DirAC notation, COMPUTED THE ANGULAR MOMENTUM ALGEBRa, AND DETERMINED THE ACTION OF THE ANGULAR MOMENTUM RAISING AND LOWERING 2 OPERATORS ON THE SIMULTANEOUS ANGULAR MOMENTUM EIGENSTATES (under Lˆ AND Lˆ z). Key words: ANGULAR momentum, SPHERICAL harmonics, OPERATOR METHODS PACS: 01.40.gb, 02.20.Qs, 03.65.Fd, 31.15.-p 1. Introduction One of us (JKF), first met Prof. Stasyuk in the early 2000s when visiting Ukraine for a conference and then subsequently became involved in a long-standing collaboration with Andrij Shvaika, who is also at the Institute for Condensed Matter Physics in Lviv. It is always a pleasure to meet Prof. Stasyuk on subsequent trips to Lviv as his friendly smile and enthusiasm for physics is contagious.
    [Show full text]
  • Appendix A. Angular Momentum and Spherical Harmonics
    Appendix A. Angular Momentum and Spherical Harmonics The total angular momentum of an isolated system is conserved; it is a constant of the motion. If we change to a new, perhaps more convenient, coordinate system related to the old by a rotation, the wave function for the system trans- forms in a defmite way depending upon the value of the angular momentum. If the system is made up of two or more parts, each of them may have angular momentum, and we need to know the quantum rules for combining these to a resultant. We cannot do more here than introduce and summarise a few salient points about these matters. More detailed discussions of the quantum theory of angular momentum are available in several treatises (for example, Brink and Satchler, 1968; see also Messiah, 1962). A general word of caution is in order. The literature on this subject presents a wide variety of conventions for notation, normalisation and phase of the various quantities which occur. Sometimes these conventions represent largely arbitrary choices, sometimes they emphasise different aspects of the quantities involved. If the reader is aware of this possibility, and if he adopts a consistent set of formulae, little difficulty should be encountered. AI ANGULAR MOMENTUM IN QUANTUM THEORY An isolated system will have a total angular momentum whose square has a discrete value given by j(j + 1)1i 2 , where1i is Planck's constant divided by 21T and where j is an integer or integer-plus-one-half according to whether the 283 284 INTRODUCTION TO NUCLEAR REACTIONS system as a whole is a boson or a fermion.* That is to say, the wave function of the system will be an eigenfunction of 12 , the operator for the square of the angular momentum J2 lj) = j(j + l)lj) (AI) (Henceforth, we shall use natural units so that1i = 1.) Note that we often speak of 'the angular momentum j' when strictly we mean that the square of the angu- lar momentum isj(j + 1).
    [Show full text]
  • Spherical Harmonics
    B Spherical Harmonics PHERICAL harmonics are a frequency-space basis for representing functions defined over S the sphere. They are the spherical analogue of the 1D Fourier series. Spherical harmonics arise in many physical problems ranging from the computation of atomic electron configurations to the representation of gravitational and magnetic fields of planetary bodies. They also appear in the solutions of the Schrödinger equation in spherical coordinates. Spherical harmonics are therefore often covered in textbooks from these fields [MacRobert and Sneddon, 1967; Tinkham, 2003]. Spherical harmonics also have direct applicability in computer graphics. Light transport involves many quantities defined over the spherical and hemispherical domains, making spherical harmonics a natural basis for representing these functions. Early applications of spherical har- monics to computer graphics include the work by Cabral et al.[1987] and Sillion et al.[1991]. More recently, several in-depth introductions have appeared in the graphics literature [Ramamoorthi, 2002; Green, 2003; Wyman, 2004; Sloan, 2008]. In this appendix, we briefly review the spherical harmonics as they relate to computer graphics. We define the basis and examine several important properties arising from this defini- tion. 167 168 B.1 Definition A harmonic is a function that satisfies Laplace’s equation: 2 f 0. (B.1) r Æ As their name suggests, the spherical harmonics are an infinite set of harmonic functions defined on the sphere. They arise from solving the angular portion of Laplace’s equation in spherical coordinates using separation of variables. The spherical harmonic basis functions derived in this fashion take on complex values, but a complementary, strictly real-valued, set of harmonics can also be defined.
    [Show full text]
  • Spectral Geometry Processing with Manifold Harmonics Bruno Vallet, Bruno Lévy
    Spectral Geometry Processing with Manifold Harmonics Bruno Vallet, Bruno Lévy To cite this version: Bruno Vallet, Bruno Lévy. Spectral Geometry Processing with Manifold Harmonics. [Technical Report] 2007. inria-00186931 HAL Id: inria-00186931 https://hal.inria.fr/inria-00186931 Submitted on 13 Nov 2007 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. Spectral Geometry Processing with Manifold Harmonics Bruno Vallet and Bruno Levy´ Tech Report ALICE-2007-001 Figure 1: Processing pipeline of our method: A: Compute the Manifold Harmonic Basis (MHB) of the input triangulated mesh. B: Transform the geometry into frequency space by computing the Manifold Harmonic Transform (MHT). C: Apply the frequency space filter on the transformed geometry. D: Transform back into geometric space by computing the inverse MHT. Abstract Introduction We present a new method to convert the geometry of a mesh into frequency space. The eigenfunctions of the Laplace-Beltrami op- 3D scanning technology easily produces computer representations erator are used to define Fourier-like function basis and transform. from real objects. However, the acquired geometry often presents Since this generalizes the classical Spherical Harmonics to arbitrary some noise that needs to be filtered out.
    [Show full text]
  • * Appendix A: Spherical Tensor Formalism
    * Appendix A: Spherical Tensor Formalism The geometrical aspects of the quantum-mechanical properties of molecular systems are described in terms of quantities familiar from angular momentum theory and the reader is referred to the text books existing on this subject. 1- 3 In this appendix we collect together the quantities and relations most fre­ quently used in calculations concerning the properties of solid hydrogen and other systems of interacting molecules. A.1 Spherical Harmonics The spherical harmonics Y,m(O,<jJ) are defined as the angular parts of the simultaneous eigenfunctions of the square and the :: component of the orbital angular momentum of a single particle, measured in units h (A.1) where m = I, I - 1, ... , -I and I = 0, 1,2, .... These functions are mu­ tually orthogonal and normalized on the unit sphere, (1m I I'm') == SOh S: Y;';" Y,'m,sine de d<jJ = ()ll'()mm' (A.2) The Y,m are determined uniquely by eqs. (A.1)-(A.2) up to arbitrary phase factors which we fix by choosing the so-called Condon and Shortley phases defined by the conditions that the nonvanishing matrix elements of the operators L, ± iLy and the values of the Y,o at 0 = °are real and positive (Lx ± iL)Y,m = [(I ± m + 1)(1 =+= m)]1'2y,.m±1 (A.3) and 21 + 1)1.12 Y,o(O,<jJ) = ( ~ (AA) 277 278 Appendix A • Spherical Tensor Formalism F or this choice of phases Y'tr,(8,c/J) = (-lrr;m(8,c/J) (A.5) where m == -m.
    [Show full text]