A Appendix A: Jacobi Polynomials and Beyond

Total Page:16

File Type:pdf, Size:1020Kb

A Appendix A: Jacobi Polynomials and Beyond A Appendix A: Jacobi polynomials and beyond In the following we review a few properties of classical orthogonal polynomials, Gauss quadratures, and the extension of these ideas to simplices. We make no attempt to be complete and refer to the many excellent texts on classical polynomials for more details (e.g., [89, 111, 197, 296]). (α,β) The classical Jacobi polynomial, Pn (x), of order n is a solution to the singular Sturm-Liouville eigenvalue problem d d (1 − x2)w(x) P (α,β)(x)+n(n + α + β +1)w(x)P (α,β)(x)=0, (A.1) dx dx n n for x ∈ [−1, 1], where the weight function, w(x)=(1−x)α(1+x)β. w-Weighted orthogonality of the polynomials is a direct consequence of Eq. (A.1). The polynomials are normalized to be orthonormal: 1 (α,β) (α,β) Pi (x)Pj (x)w(x) dx = δij . −1 An important property of the Jacobi polynomials is [296] " d α ,β P (α,β)(x)= n(n + α + β +1)P ( +1 +1)(x). (A.2) dx n n−1 (0,0) Also, recall the special case of Pn (x), known as the Legendre polynomials. While there is no known simple expression to evaluate the Jacobi polyno- mials, it is conveniently done using the recurrence relation (α,β) (α,β) (α,β) (α,β) xPn (x)=anPn−1 (x)+bnPn (x)+an+1Pn+1 (x), (A.3) where the coefficients are given as 2 n(n + α + β)(n + α)(n + β) an = , 2n + α + β (2n + α + β − 1)(2n + α + β +1) 446 A Appendix A: Jacobi polynomials and beyond α2 − β2 bn = − . (2n + α + β)(2n + α + β +2) To get the recurrence started, we need the initial values α,β Γ (α + β +2) P ( )(x)= 2−α−β−1 , 0 Γ (α +1)Γ (β +1) α,β 1 α,β α + β +3 P ( )(x)= P ( )(x) ((α + β +2)x +(α − β)) . 1 2 0 (α +1)(β +1) Here, Γ (x) is the classic Gamma function [4]. A Matlab script for evaluating Jacobi polynomials using the above procedure is given in JacobiP.m. JacobiP.m function [P] = JacobiP(x,alpha,beta,N); % function [P] = JacobiP(x,alpha,beta,N) % Purpose: Evaluate Jacobi Polynomial of type (alpha,beta) > -1 % (alpha+beta <> -1) at points x for order N and returns % P[1:length(xp))] % Note : They are normalized to be orthonormal. % Turn points into row if needed. xp = x; dims = size(xp); if (dims(2)==1) xp = xp’; end; PL = zeros(N+1,length(xp)); % Initial values P_0(x) and P_1(x) gamma0 = 2^(alpha+beta+1)/(alpha+beta+1)*gamma(alpha+1)*... gamma(beta+1)/gamma(alpha+beta+1); PL(1,:) = 1.0/sqrt(gamma0); if (N==0) P=PL’; return; end; gamma1 = (alpha+1)*(beta+1)/(alpha+beta+3)*gamma0; PL(2,:) = ((alpha+beta+2)*xp/2 + (alpha-beta)/2)/sqrt(gamma1); if (N==1) P=PL(N+1,:)’; return; end; % Repeat value in recurrence. aold = 2/(2+alpha+beta)*sqrt((alpha+1)*(beta+1)/(alpha+beta+3)); % Forward recurrence using the symmetry of the recurrence. for i=1:N-1 h1 = 2*i+alpha+beta; anew = 2/(h1+2)*sqrt( (i+1)*(i+1+alpha+beta)*(i+1+alpha)*... (i+1+beta)/(h1+1)/(h1+3)); A Appendix A: Jacobi polynomials and beyond 447 bnew = - (alpha^2-beta^2)/h1/(h1+2); PL(i+2,:) = 1/anew*( -aold*PL(i,:) + (xp-bnew).*PL(i+1,:)); aold =anew; end; P = PL(N+1,:)’; return As is well known (see, e.g., [89]), there is a close connection between Jacobi polynomials and Gaussian quadratures for the approximation of integrals as 1 N f(x)w(x) dx = f(xi)wi. − 1 i=0 Here, (xi,wi) are the quadrature nodes and weights. It can be shown that if (α,β) one chooses xi as the roots of PN+1 (x) and the weights, wi,byrequiringthe integration to be exact for polynomials up to order N, the above summation is in fact exact for f being a polynomial of order 2N +1 – this is the celebrated Gaussian quadrature. Finding the nodes and weights can be done in several ways, with perhaps the most elegant and numerically stable one being based on the recurrence, Eq. (α,β) (A.3). Inspection reveals that setting PN+1 (xi) = 0 truncates the recurrence and the nodes, xi, are the eigenvalues of a symmetric tridiagonal eigenvalue problem. The weights can be recovered from the elements of the eigenvectors; for the details, we refer to [131]. In JacobiGQ.m, an implementation of this algorithm is offered. JacobiGQ.m function [x,w] = JacobiGQ(alpha,beta,N); % function [x,w] = JacobiGQ(alpha,beta,N) % Purpose: Compute the N’th order Gauss quadrature points, x, % and weights, w, associated with the Jacobi % polynomial, of type (alpha,beta) > -1 ( <> -0.5). if (N==0) x(1)=(alpha-beta)/(alpha+beta+2); w(1) = 2; return; end; % Form symmetric matrix from recurrence. J = zeros(N+1); h1 = 2*(0:N)+alpha+beta; J = diag(-1/2*(alpha^2-beta^2)./(h1+2)./h1) + ... diag(2./(h1(1:N)+2).*sqrt((1:N).*((1:N)+alpha+beta).*... ((1:N)+alpha).*((1:N)+beta)./(h1(1:N)+1)./(h1(1:N)+3)),1); if (alpha+beta<10*eps) J(1,1)=0.0;end; J=J+J’; 448 A Appendix A: Jacobi polynomials and beyond % Compute quadrature by eigenvalue solve [V,D] = eig(J); x = diag(D); w = (V(1,:)’).^2*2^(alpha+beta+1)/(alpha+beta+1)*gamma(alpha+1)*... gamma(beta+1)/gamma(alpha+beta+1); return; When solving partial differential equations using high-order and spectral methods, one often uses nodes based on Gauss-like quadrature points, as they are known to allow for high-order accurate interpolation (see Chapter 3). How- ever, the pure Gauss points, computable with JacobiGQ.m, are less favorable since they do not include grid points at the end of the intervals. While not a major obstacle, it is often convenient to include these end points to impose boundary conditions. One often uses Gauss-Lobatto points, given as the roots of (1 − x2) × d (α,β) dx PN (x). Using Eq. (A.2), it is easily realized that the interior Gauss- − (α+1,β+1) Lobatto points are the (N 2)-th-order Gauss points of PN−2 (x) with the end points added. A simple routine utilizing this is shown as JacobiGL.m. JacobiGL.m function [x] = JacobiGL(alpha,beta,N); % function [x] = JacobiGL(alpha,beta,N) % Purpose: Compute the N’th order Gauss Lobatto quadrature % points, x, associated with the Jacobi polynomial, % of type (alpha,beta) > -1 ( <> -0.5). x = zeros(N+1,1); if (N==1) x(1)=-1.0; x(2)=1.0; return; end; [xint,w] = JacobiGQ(alpha+1,beta+1,N-2); x = [-1, xint’, 1]’; return; A.1 Orthonormal polynomials beyond one dimension The extension of polynomial modal expansions to the multidimensional case is a bit more complicated, mainly due to the added geometric variation of the domain (e.g., quadrilaterals/hexahedrals or triangles/tetrahedra). In the case of domains/elements that are logically cubic, a simple dimension-by-dimension approach suffices – this approach is known as ten- sor products and is used widely; for example, to represent a function u(x, y) on [−1, 1]2, one can use a Legendre expansion A.1 Orthonormal polynomials beyond one dimension 449 N uh(x, y)= uˆijPi(x)Pj(y). i,j=0 2 1 Note that this basis has (N +1) terms, while only 2 (N +1)(N +2) terms are needed for completeness in two dimensions. Orthonormality is clearly main- tained in a dimension-by-dimension fashion. For more complex elements (e.g., simplices), the construction of an ortho- normal basis of order N is a bit more complicated. To ensure good approxi- mation properties in finite domains, the polynomials should be orthonormal eigensolutions to a multidimensional singular Sturm-Liouville problem. The construction of such polynomials has been pursued by several authors [103, 201, 261]. For the two-dimensional simplex T2 = {(r, s)|r, s ≥−1; r + s ≤ 0}, the N-th-order orthonormal basis is given as √ (0,0) (2i+1,0) i ∀(i, j) ≥ 0; i + j ≤ N : ψij(r, s)= 2Pi (a)Pj (b)(1 − b) , where the extended coordinates (a, b) ∈ [−1, 1]2 relates to (r, s) ∈ T2 as 1+r a =2 − 1,b= s. 1 − s 1 Note that there are exactly 2 (N +1)(N + 2) terms in the polynomial basis of order N. A script to evaluate the basis in the (a, b) coordinates is shown in Simplex2DP.m. Simplex2DP.m function [P] = Simplex2DP(a,b,i,j); % function [P] = Simplex2DP(a,b,i,j); % Purpose : Evaluate 2D orthonormal polynomial % on simplex at (a,b) of order (i,j). h1 = JacobiP(a,0,0,i); h2 = JacobiP(b,2*i+1,0,j); P = sqrt(2.0)*h1.*h2.*(1-b).^i; return; Similarly, one can derive an orthonormal basis for the three-dimensional simplex, T3 = {(r, s, t)|r, s, t ≥−1; r + s + t ≤−1}, with the N-th-order orthonormal basis being ∀(i, j, k) ≥ 0; i + j + k ≤ N : √ (0,0) (2i+1,0) (2i+2j+2,0) i i+j ψijk(r, s, t)=2 2Pi (a)Pj (b)Pk (b)(1 − b) (1 − c) , 450 A Appendix A: Jacobi polynomials and beyond where the extended coordinates (a, b, c) ∈ [−1, 1]3 relates to (r, s, t) ∈ T3 as 1+r 1+r a = −2 − 1,b=2 − 1,c= t.
Recommended publications
  • New Formulae of Squares of Some Jacobi Polynomials Via Hypergeometric Functions
    Hacettepe Journal of Mathematics and Statistics Volume 46 (2) (2017), 165 176 New formulae of squares of some Jacobi polynomials via hypergeometric functions W.M. Abd- Elhameed∗ y Abstract In this article, a new formula expressing explicitly the squares of Jacobi polynomials of certain parameters in terms of Jacobi polynomials of ar- bitrary parameters is derived. The derived formula is given in terms of ceratin terminating hypergeometric function of the type 4F3(1). In some cases, this 4F3(1) can be reduced by using some well-known re- duction formulae in literature such as Watson's and Pfa-Saalschütz's identities. In some other cases, this 4F3(1) can be reduced by means of symbolic computation, and in particular Zeilberger's, Petkovsek's and van Hoeij's algorithms. Hence, some new squares formulae for Jacobi polynomials of special parameters can be deduced in reduced forms which are free of any hypergeometric functions. Keywords: Jacobi polynomials; linearization coecients; generalized hypergeo- metric functions; computer algebra, standard reduction formulae 2000 AMS Classication: 33F10; 33C20; 33Cxx; 68W30 Received : 23.02.2016 Accepted : 19.05.2016 Doi : 10.15672/HJMS.20164518618 1. Introduction The Jacobi polynomials are of fundamental importance in theoretical and applied mathematical analysis. The class of Jacobi polynomials contains six well-known fami- lies of orthogonal polynomials, they are, ultraspherical, Legendre and the four kinds of Chebyshev polynomials. The Jacobi polynomials in general and their six special polyno- mials in particular are extensively employed in obtaining numerical solutions of ordinary, fractional and partial dierential equations. In this respect, these polynomials are em- ployed for the sake of obtaining spectral solutions for various kinds of dierential equa- tions.
    [Show full text]
  • Some Classical Multiple Orthogonal Polynomials
    Some classical multiple orthogonal polynomials ∗ Walter Van Assche and Els Coussement Department of Mathematics, Katholieke Universiteit Leuven 1 Classical orthogonal polynomials One aspect in the theory of orthogonal polynomials is their study as special functions. Most important orthogonal polynomials can be written as terminating hypergeometric series and during the twentieth century people have been working on a classification of all such hypergeometric orthogonal polynomial and their characterizations. The very classical orthogonal polynomials are those named after Jacobi, Laguerre, and Hermite. In this paper we will always be considering monic polynomials, but in the literature one often uses a different normalization. Jacobi polynomials are (monic) polynomials of degree n which are orthogonal to all lower degree polynomials with respect to the weight function (1 x)α(1+x)β on [ 1, 1], where α,β > 1. The change of variables x 2x 1 gives Jacobi polynomials− on [0, 1]− for the weight function− w(x) = xβ(1 x)α, and we7→ will− denote (α,β) − these (monic) polynomials by Pn (x). They are defined by the orthogonality conditions 1 P (α,β)(x)xβ(1 x)αxk dx =0, k =0, 1,...,n 1. (1.1) n − − Z0 (α) The monic Laguerre polynomials Ln (x) (with α > 1) are orthogonal on [0, ) to all − α x ∞ polynomials of degree less than n with respect to the weight w(x)= x e− and hence satisfy the orthogonality conditions ∞ (α) α x k Ln (x)x e− x dx =0, k =0, 1,...,n 1. (1.2) 0 − arXiv:math/0103131v1 [math.CA] 21 Mar 2001 Z Finally, the (monic) Hermite polynomials Hn(x) are orthogonal to all lower degree polyno- x2 mials with respect to the weight function w(x)= e− on ( , ), so that −∞ ∞ ∞ x2 k H (x)e− x dx =0, k =0, 1,...,n 1.
    [Show full text]
  • Q-Special Functions, a Tutorial
    q-Special functions, a tutorial TOM H. KOORNWINDER Abstract A tutorial introduction is given to q-special functions and to q-analogues of the classical orthogonal polynomials, up to the level of Askey-Wilson polynomials. 0. Introduction It is the purpose of this paper to give a tutorial introduction to q-hypergeometric functions and to orthogonal polynomials expressible in terms of such functions. An earlier version of this paper was written for an intensive course on special functions aimed at Dutch graduate students, it was elaborated during seminar lectures at Delft University of Technology, and later it was part of the lecture notes of my course on “Quantum groups and q-special functions” at the European School of Group Theory 1993, Trento, Italy. I now describe the various sections in some more detail. Section 1 gives an introduction to q-hypergeometric functions. The more elementary q-special functions like q-exponential and q-binomial series are treated in a rather self-contained way, but for the higher q- hypergeometric functions some identities are given without proof. The reader is referred, for instance, to the encyclopedic treatise by Gasper & Rahman [15]. Hopefully, this section succeeds to give the reader some feeling for the subject and some impression of general techniques and ideas. Section 2 gives an overview of the classical orthogonal polynomials, where “classical” now means “up to the level of Askey-Wilson polynomials” [8]. The section starts with the “very classical” situation of Jacobi, Laguerre and Hermite polynomials and next discusses the Askey tableau of classical orthogonal polynomials (still for q = 1).
    [Show full text]
  • Orthogonal Polynomials and Classical Orthogonal Polynomials
    International Journal of Mechanical Engineering and Technology (IJMET) Volume 9, Issue 10, October 2018, pp. 1613–1630, Article ID: IJMET_09_10_164 Available online at http://iaeme.com/Home/issue/IJMET?Volume=9&Issue=10 ISSN Print: 0976-6340 and ISSN Online: 0976-6359 © IAEME Publication Scopus Indexed ORTHOGONAL POLYNOMIALS AND CLASSICAL ORTHOGONAL POLYNOMIALS DUNIA ALAWAI JARWAN Education for Girls College, Al-Anbar University, Ministry of Higher Education and Scientific Research, Iraq ABSTRACT The focus of this project is to clarify the concept of orthogonal polynomials in the case of continuous internal and discrete points on R and the Gram – Schmidt orthogonalization process of conversion to many orthogonal limits and the characteristics of this method. We have highlighted the classical orthogonal polynomials as an example of orthogonal polynomials because of they are great importance in physical practical applications. In this project, we present 3 types (Hermite – Laguerre – Jacobi) of classical orthogonal polynomials by clarifying the different formulas of each type and how to reach some formulas, especially the form of the orthogonality relation of each. Keywords: Polynomials, Classical Orthogonal, Monic Polynomial, Gram – Schmidt Cite this Article Dunia Alawai Jarwan, Orthogonal Polynomials and Classical Orthogonal Polynomials, International Journal of Mechanical Engineering and Technology, 9(10), 2018, pp. 1613–1630. http://iaeme.com/Home/issue/IJMET?Volume=9&Issue=10 1. INTRODUCTION The mathematics is the branch where the lots of concepts are included. An orthogonality is the one of the concept among them. Here we focuse on the orthogonal polynomial sequence. The orthogonal polynomial are divided in two classes i.e. classical orthogonal polynomials, Discrete orthogonal polynomials and Sieved orthogonal polynomials .There are different types of classical orthogonal polynomials such that Jacobi polynomials, Associated Laguerre polynomials and Hermite polynomials.
    [Show full text]
  • Rodrigues Formula for Jacobi Polynomials on the Unit Circle
    RODRIGUES FORMULA FOR JACOBI POLYNOMIALS ON THE UNIT CIRCLE MASTERS THESIS Presented in Partial Fulfillment of the Requirements for the Degree Master of Science in the Graduate School of the Ohio State University By Griffin Alexander Reiner-Roth Graduate Program in Mathematics The Ohio State University 2013 Master's Examination Committe: Professor Rodica Costin, Advisor Professor Barbara Keyfitz c Copyright by Griffin Alexander Reiner-Roth 2013 ABSTRACT We begin by discussing properties of orthogonal polynomials on a Borel measur- able subset of C. Then we focus on Jacobi polynomials and give a formula (analogous to that of [5]) for finding Jacobi polynomials on the unit circle. Finally, we consider some examples of Jacobi polynomials and demonstrate different methods of discov- ering them. ii ACKNOWLEDGMENTS I would like to thank my advisor, Dr. Rodica Costin, for all her help on this thesis; for finding a really interesting and doable project for me, for spending so much time explaining the basics of orthogonal polynomials to me, and for perfecting this paper. I also thank my parents for making sure I never starved. iii VITA 2011 . B.A. Mathematics, Vassar College 2011-Present . Graduate Teaching Associate, Department of Mathematics, The Ohio State Univer- sity FIELDS OF STUDY Major Field: Mathematics iv TABLE OF CONTENTS Abstract . ii Acknowledgments . iii Vita......................................... iv List of Tables . vii CHAPTER PAGE 1 Introduction . .1 1.1 Historical Background . .1 1.2 Orthogonality in Hilbert Spaces . .4 1.3 Orthogonal Polynomials with Respect to Measures . .5 1.4 Approximation by Orthogonal Polynomials . 12 1.5 Classical Orthogonal Polynomials . 15 2 Jacobi Polynomials .
    [Show full text]
  • Moments of Classical Orthogonal Polynomials
    Moments of Classical Orthogonal Polynomials zur Erlangung des akademischen Grades eines Doktors der Naturwissenschaften (Dr.rer.nat) im Fachbereich Mathematik der Universität Kassel By Patrick Njionou Sadjang ????? Ph.D thesis co-supervised by: Prof. Dr. Wolfram Koepf University of Kassel, Germany and Prof. Dr. Mama Foupouagnigni University of Yaounde I, Cameroon October 2013 Tag der mündlichen Prüfung 21. Oktober 2013 Erstgutachter Prof. Dr. Wolfram Koepf Universität Kassel Zweitgutachter Prof. Dr. Mama Foupouagnigni University of Yaounde I Abstract The aim of this work is to find simple formulas for the moments mn for all families of classical orthogonal polynomials listed in the book by Koekoek, Lesky and Swarttouw [30]. The generating functions or exponential generating functions for those moments are given. To my dear parents Acknowledgments Foremost, I would like to express my sincere gratitude to my advisors Prof. Dr. Wolfram Koepf and Prof. Dr. Mama Foupouagnigni for the continuous support of my Ph.D study and research, for their patience, motivation, enthusiasm, and immense knowledge. Their guidance helped me in all the time of research and writing of this thesis. I could not have imagined having better advisors and mentors for my Ph.D study. I am grateful to Prof. Dr. Mama Foupouagnigni for enlightening me the first glance of re- search. My sincere thanks also go to Prof. Dr. Wolfram Koepf for offering me the opportunity to visit the University of Kassel where part of this work has been written. I acknowledge the financial supports of the DAAD via the STIBET fellowship which en- abled me to visit the Institute of Mathematics of the University of Kassel.
    [Show full text]
  • Jacobi Polynomials Via Pictures
    Jacobi Polynomials via Pictures Yao-Rui Notes for Pizza Seminar Abstract Jacobi polynomials are an important class of orthogonal polynomials that includes examples like the Chebyshev and Legendre polynomials. The purpose of this expository note is to flesh out two pictorial appearances of these polynomials in physics and combinatorial number theory. We give a quick overview of Jacobi polynomials, followed by applications in electrostatics and dessins d'enfants. 1 Some Facets of Jacobi Polynomials In this section we will introduce the bare minimum on Jacobi polynomials needed to understand this talk. A good reference on this is [4]. 1.1 Chebyshev Polynomials Let start with an example of Jacobi polynomials. Recall from high school calculus that one can expand cos(nθ) as a polynomial in cos(θ). For example, cos(2θ) = 2 cos2(θ) − 1; cos(3θ) = 4 cos3(θ) − 3 cos(θ); and more generally, using Euler's formula on complex numbers, bn=2c X n cos(nθ) = (cos2(θ) − 1)j cosn−2j(θ): 2j j=0 By replacing cos(θ) with a variable, this gives us the Chebyshev polynomials: bn=2c X n T (x) = (x2 − 1)jxn−2j: n 2j j=0 (There is a completely analogous function by expanding sin(nθ); we will omit this here.) The Chebyshev polynomials have a number of properties, and the first two will be essential later. • The zeroes of Tn are simple and lie in (−1; 1). In this case we can explicitly write them down: (1 + 2k)π cos ; k = 0; : : : ; n − 1: 2n Therefore, the non-endpoint critical points of Tn interlaces with the zeros and lies in (−1; 1).
    [Show full text]
  • A New Property of a Class of Jacobi Polynomials
    PROCEEDINGS OF THE AMERICAN MATHEMATICAL SOCIETY Volume 00, Number 0, Pages 000–000 S 0002-9939(XX)0000-0 A NEW PROPERTY OF A CLASS OF JACOBI POLYNOMIALS GEORGE CSORDAS, MARIOS CHARALAMBIDES, AND FABIAN WALEFFE Abstract. Polynomials whose coefficients are successive derivatives of a class of Jacobi polynomials evaluated at x = 1 are stable. This yields a novel and short proof of the known result that the Bessel polynomials are stable polyno- mials. Stability preserving linear operators are discussed. The paper concludes with three open problems involving the distribution of zeros of polynomials. 1. Introduction The new property referred to in the title was observed and conjectured (see Conjecture 1 below) while developing a numerical solution for the Navier-Stokes equations [23]. It is related to the fundamental problem of constructing discretiza- tion schemes of continuous problems (involving, for example, boundary value prob- lems for various systems of partial differential equations) in such a manner that the associated eigenvalue problems are free of “spurious eigenvalues”; that is, the eigenvalues are all negative. For the purpose of this paper, it is sufficient to consider the problem of constructing polynomial approximations to the eigenvalue problem d2u/dx2 = λu for 1 < x < 1 with u( 1) = 0. It is well-known that the solutions to this problem consist− of negative eigenvalues± λ with trigonometric eigenfunctions u(x). If un(x) is a polynomial approximation of degree n to u(x), then the residual d2 (1) R (x) := λu (x) u (x) n n − dx2 n is also a polynomial of degree n in x and this relationship can be inverted to obtain [n/2] d2k (2) u (x) = µk+1 R (x) n dx2k n kX=0 where µ = 1/λ and [n/2] denotes the greatest integer less than or equal to n/2.
    [Show full text]
  • [Math.CA] 9 Oct 1995
    UPWARD EXTENSION OF THE JACOBI MATRIX FOR ORTHOGONAL POLYNOMIALS Andre´ Ronveaux and Walter Van Assche Facult´es Universitaires Notre Dame de la Paix, Namur Katholieke Universiteit Leuven March 3, 1995 Abstract. Orthogonal polynomials on the real line always satisfy a three-term re- currence relation. The recurrence coefficients determine a tridiagonal semi-infinite matrix (Jacobi matrix) which uniquely characterizes the orthogonal polynomials. We investigate new orthogonal polynomials by adding to the Jacobi matrix r new rows and columns, so that the original Jacobi matrix is shifted downward. The r new rows and columns contain 2r new parameters and the newly obtained orthogonal polynomials thus correspond to an upward extension of the Jacobi matrix. We give an explicit expression of the new orthogonal polynomials in terms of the original orthogonal polynomials, their associated polynomials and the 2r new parameters, and we give a fourth order differential equation for these new polynomials when the original orthogonal polynomials are classical. Furthermore we show how the orthogo- nalizing measure for these new orthogonal polynomials can be obtained and work out the details for a one-parameter family of Jacobi polynomials for which the associated polynomials are again Jacobi polynomials. 1. Introduction The construction of families of orthogonal polynomials on the real line from a given system of orthogonal polynomials (or from a given orthogonalizing weight µ) arXiv:math/9510213v1 [math.CA] 9 Oct 1995 has been the subject of various investigations [6], [4], [14], [11], [3], [15], [7], [9], [16], [25]. Let Pn (n = 0, 1, 2,...) be a sequence of monic orthogonal polynomials on the real line, with orthogonality measure µ, then these polynomials satisfy a three-term recurrence relation 2 (1.1) P (x)=(x b )P (x) a P − (x), n 0, n+1 − n n − n n 1 ≥ R 2 with bn and an > 0 and initial conditions P0 = 1, P−1 = 0.
    [Show full text]
  • How Can Mathematicians and Mathematical Historians Help Each Other?
    ---------Richard Askey--------- How Can Mathematicians and Mathematical Historians Help Each Other? 1. Introduction This paper could have a slightly different title with the word How dropped, but I could argue both sides of that question. The present title presumes the optimistic answer, and while we all hope that this is the cor­ rect answer, the present time may not be the right one for this answer. The history of mathematics is not an easy field, and it takes a rare per­ son to be good at it. Keynes supposedly said it took a rare person to be a great economist: one must be a second-rate historian, mathematician, and philosopher. For him second-rate was very good, but not great. The same is probably true about the history of mathematics, except one may not have to be a philosopher. Some great mathematicians have made im­ portant contributions to the history of mathematics, but very few have spent enough time and thought on the history of mathematics to be able to write a first-rate historical account of part of mathematics. One recent exception is A. Weil, who has added an excellent historical account of number theory before Gauss (Weil 1984) to the historical notes he wrote for the Bourbaki volumes (Bourbaki 1974). His paper from the Helsinki Congress (Weil 1980) should also be read by anyone interested in the history of mathematics. Since my training is in mathematics, and my reading of history has been almost random, I have found it useful to think about what history is and how the history of mathematics differs from cultural or political history.
    [Show full text]
  • Shifted Jacobi Polynomials and Delannoy Numbers 3
    SHIFTED JACOBI POLYNOMIALS AND DELANNOY NUMBERS GABOR´ HETYEI A` la m´emoire de Pierre Leroux Abstract. We express a weighted generalization of the Delannoy numbers in terms of shifted Jacobi polynomials. A specialization of our formulas extends a relation between the central Delannoy numbers and Legendre polynomials, observed over 50 years ago, to all Delannoy numbers and certain Jacobi polynomials. Another specialization provides a weighted lattice path enumeration model for shifted Jacobi polynomials, we use this to present a new combinatorial proof of the orthogonality of Jacobi polynomials with natural number parameters. The proof relates the orthogonality of these polynomials to the orthogonality of (generalized) Laguerre polynomials, as they arise in the theory of rook polynomials. We provide a combinatorial proof for the orthogonality of certain Romanovski-Jacobi polynomials with zero first parameter and negative integer second parameter, considered as an initial segment of the list of similarly transformed Jacobi polynomials with the same parameters. We observe that for an odd second parameter one more polynomial may be added to this finite orthogonal polynomial sequence than what was predicted by a classical result of Askey and Romanovski. The remaining transformed Jacobi polynomials in the sequence are either equal to the already listed Romanovski- Jacobi polynomials or monomial multiples of similarly transformed Jacobi polynomials with a positive second parameter. We provide expressions for an analogous weighted generalization of the Schr¨oder numbers in terms of the Jacobi polynomials, and use this model, together with a result of Mansour and Sun, to express the Narayana polynomials in terms of shifted Jacobi polynomials.
    [Show full text]
  • (X) 1. Introduction Orthogonal Families of Polynomial Are Impo
    Orthogonality for a class of generalised Jacobi polynomial $P^{\alpha,\beta}_{\nu}(x)$ Item Type Article Authors Ford, Neville J.; Moayyed, H.; Rodrigues, M. M. Citation Ford, N. J., Moayyed, H. & Rodrigues, M. M. (2018) Orthogonality for a class of generalised Jacobi polynomial $P^{\alpha, \beta}_{\nu}(x)$. Fractional Differential Calculus, 8(1), 95-110 DOI 10.7153/fdc-2018-08-06 Publisher Ele-Math Journal Fractional Differential Calculus Download date 02/10/2021 17:29:02 Item License http://creativecommons.org/licenses/by-nc-nd/4.0/ Link to Item http://hdl.handle.net/10034/620536 F ractional D ifferential C alculus www.ele-math.com ORTHOGONALITY FOR A CLASS OF a;b GENERALISED JACOBI POLYNOMIAL Pn (x) N. J. FORD, H. MOAYYED AND M. M. RODRIGUES Submitted to Fracttional Differ. Calc. Abstract. This work considers g-Jacobi polynomials, a fractional generalisation of the classical Jacobi polynomials. We discuss the polynomials and compare some of their properties to the classical case. The main result of the paper is to show that one can derive an orthogonality prop- (a;b) erty for a sub-class of g-Jacobi polynomials Pn . The paper concludes with an application in modelling of ophthalmic surfaces. 1. Introduction Orthogonal families of polynomial are important both from theoretical and practi- cal viewpoints. They are widely used when approximating functions from mathematics and other sciences and they allow us to solve and interpret solutions of certain differen- tial equations. (a;b) The Jacobi Polynomials Pn are a classical family of orthogonal polynomials (see [7], [23]) that has been used in many applications due to its ability to approximate general classes of function.
    [Show full text]