Numerical Methods for the Computation of the Confluent and Gauss Hypergeometric Functions

Total Page:16

File Type:pdf, Size:1020Kb

Numerical Methods for the Computation of the Confluent and Gauss Hypergeometric Functions Numer Algor DOI 10.1007/s11075-016-0173-0 ORIGINAL PAPER Numerical methods for the computation of the confluent and Gauss hypergeometric functions John W. Pearson1 · Sheehan Olver2 · Mason A. Porter3 Received: 27 August 2015 / Accepted: 29 June 2016 © Springer Science+Business Media New York 2016 Abstract The two most commonly used hypergeometric functions are the conflu- ent hypergeometric function and the Gauss hypergeometric function. We review the available techniques for accurate, fast, and reliable computation of these two hyper- geometric functions in different parameter and variable regimes. The methods that we investigate include Taylor and asymptotic series computations, Gauss–Jacobi quadra- ture, numerical solution of differential equations, recurrence relations, and others. We discuss the results of numerical experiments used to determine the best methods, in practice, for each parameter and variable regime considered. We provide “roadmaps” with our recommendation for which methods should be used in each situation. Keywords Computation of special functions · Confluent hypergeometric function · Gauss hypergeometric function This work was supported by the Numerical Algorithms Group (NAG) and the Engineering and Physical Sciences Research Council (EPSRC). John W. Pearson [email protected] Sheehan Olver [email protected] Mason A. Porter [email protected] 1 School of Mathematics, Statistics and Actuarial Science, University of Kent, Cornwallis Building (East), Canterbury, Kent, CT2 7NF, UK 2 School of Mathematics and Statistics, The University of Sydney, NSW 2006, Sydney, Australia 3 Oxford Centre for Industrial and Applied Mathematics, Mathematical Institute, University of Oxford, Andrew Wiles Building, Radcliffe Observatory Quarter, Woodstock Road, Oxford, OX2 6GG, UK Numer Algor Mathematics Subject Classification (2010) Primary: 33C05 · 33C15 · Secondary: 41A58 · 41A60 1 Introduction The aim of this review paper is to summarize methods for computing the two most commonly used hypergeometric functions: the confluent hypergeometric function M(a; b, z) and the Gauss hypergeometric function F(a, b; c; z). (We also consider the associated functions 1F1(a; b; z) and 2F1(a, b; c; z).) We overview methods that have been developed for computing M and F, and we discuss how to choose appropri- ate methods for different parameter and variable regimes. We thereby obtain reliable and fast computation for a large range of the parameters (a and b for M;anda, b,and c for F) and the variable z. Because accurate error bounds are seldomly available, we test a large variety of approaches, which we require to be stable, accurate, fast, and robust within the parameter and variable regions for which they have been selected. This is especially important when working with finite-precision arithmetic. The computation of confluent hypergeometric functions and Gauss hypergeomet- ric functions is important in a wide variety of applications [87]. For instance, these functions arise in areas such as photon scattering from atoms [27], networks [79, 100], Coulomb wave functions [8, 21, 67], binary stars [81], mathematical finance [10], non-Newtonian fluids [109], and more. Except for specific situations, computing hypergeometric functions is difficult in practice. A plethora of methods exist for computing each hypergeometric function; these include Taylor series, asymptotic expansions, continued fractions, recurrence relationships, hyperasymptotic expansions, and more. However, each method is only reliable and efficient for limited parameter and variable regimes. Consequently, one must be prepared to use different members of this suite of possibilities in different regimes of parameter and variable values. We have also developed MATLAB code for computing the functions M and F using a range of methods; our code is publicly available [116]. 2 Background on hypergeometric functions The confluent hypergeometric function is defined by [110, Eq. (13.2.3)] ∞ j (a)j z M(a; b; z) = , (2.1) (b + j) j! j=0 where the Pochhammer symbol (μ)j is (μ)0 = 1 ,(μ)j = μ(μ + 1) ×···×(μ + j − 1), j = 1, 2,... The function M is entire (i.e., it is analytic throughout the complex plane C)inthe parameters a and b and the variable z. Therefore, the sum (2.1) always converges. Numer Algor When b is not a non-positive integer, we define ∞ j (a)j z 1F1(a; b; z) = (b)M(a; b; z) = , (b)j j! j=0 which is also commonly denoted by M(a; b; z) and is itself often called the confluent hypergeometric function. Because 1F1(a; b; z) is not defined if b is equal to a non- positive integer and there are numerical issues in its computation if b is close to a non-positive integer, it is preferable to compute M when possible. The Gauss hypergeometric function is defined within the unit disk |z| < 1by [110, Eq. (15.2.2)] ∞ j (a)j (b)j z F(a, b; c; z) = (2.2) (c + j) j! j=0 and defined outside the unit disk by analytic continuation, with a principal branch cut along [1, ∞).On[1, ∞), it is defined to be continuous from below. That is, F(a, b; c; z) = lim→0 F(a, b; c; z −||i).Whenc is not a non-positive integer, we define ⎛ ⎞ ∞ j ⎝ (a)j (b)j z ⎠ 2F1(a, b; c; z) = (c)F(a, b; c; z) = for |z| < 1 . (2.3) (c)j j! j=0 The function 2F1(a, b; c; z) is commonly denoted by F(a,b; c; z) and is also fre- quently called the Gauss hypergeometric function. Analogous to the case for the confluent hypergeometric function, it is better numerically to compute F than to compute 2F1. The confluent hypergeometric function 1F1(a; b; z) satisfies the ordinary differ- ential equation [90] d2f df z + (b − z) − af = 0 , (2.4) dz2 dz and the Gauss hypergeometric function 2F1(a, b; c; z) satisfies [91] d2f df z(1 − z) +[c − (a + b + 1)z] − abf = 0 . (2.5) dz2 dz The confluent and Gauss hypergeometric functions are examples of special func- tions, whose theory and computation are prominent in the scientific literature [3, 6, 40, 53, 57, 58, 62, 73, 95, 97, 108]. A large number of common mathematical func- tions (including ez, (1−z)−a,andsin−1 z [3, 57]) and many special functions (such as the modified Bessel function, the incomplete gamma and error functions, Chebyshev and Legendre polynomials, and other families of orthogonal polynomials [3, 5, 60, 85]) can be expressed in terms of confluent or Gauss hypergeometric functions. In Figs. 1 and 2, we show plots of hypergeometric functions. These provide exam- ples of the possible shapes of such functions in the real and complex planes, though of course there are a wide range of possible representations of them. As we indicated above, the computation of hypergeometric functions arises in a wide variety of applications. This underscores the importance of determining which Numer Algor 100 4 3 50 2 (a;b;z) (a,b;c;z) 1 1 F 0 F 1 1 2 0 −50 −5 0 5 −1 −0.5 0 0.5 1 z z Fig. 1 (Color online) (Left) Plots of 1F1(a; b; z), generated using MATLAB [111], for real z ∈[−5, 5] with parameter values (a, b) = (0.1, 0.2) in dark blue (dotted), (a, b) = (−3.8, 1.5) in red (dashed), and (a, b) = (−3, −2.5) in green (solid). (Right) Plots of 2F1 for real z ∈[−1, 1] with parameter val- ues (a,b,c) = (0.1, 0.2, 0.4) in black (dotted), (a,b,c) = (−3.6, −0.7, −2.5) in purple (dashed), and (a,b,c)= (−5, 1.5, 6.2) in sky blue (solid) computational techniques are accurate and efficient for different parameter and vari- able regimes. It is also important to supply information on how to test the reliability of a routine, provide test cases that a routine might have difficulty computing (see Appendix A), and indicate how to evaluate other special functions required for the computation of hypergeometric functions (see Appendix C). As illustrated in Ref. [80], the inbuilt routines to compute hypergeometric functions in commercial soft- ware packages such as MATLAB R2015a [111] and Mathematica 8 [112] are not without limitations, so one should not rely on them in many parameter and vari- able regimes. We have implemented our routines for MATLAB R2015a, which uses double-precision arithmetic, and we have made it freely available online [116]. Of course, it is easier to obtain accurate results when computing these functions in higher-precision arithmetic, as is done when the inbuilt hypergeometric function commands in MATLAB and MATHEMATICA are called. Our code can be modified to run in higher precision. 100 60 40 50 (a;b;z)| (a,b;c;z)| 1 20 1 F F 1 | 2 0 | 0 5 5 5 5 0 0 0 0 Im(z) −5 −5 Re(z) Im(z) −5 −5 Re(z) 2 Fig. 2 (Color online) (Left)Plotof|1F1(a; b; z)| for(Re(z), Im(z)) ∈[−5, 5] with parameter val- 2 ues (a, b) = (−3 − 2i, 2.5).(Right)Plotof|2F1| for Re(z), Im(z) ∈[−5, 5] with parameter values (a,b,c)= (1 + 2i, −1.5, 0.5 − i) Numer Algor 3 Computation of the confluent hypergeometric function M In this section, we discuss the methods that perform the best in practice for accu- rately and efficiently evaluating the confluent hypergeometric function. The range of methods that we discuss includes series computation methods (Sections 3.2, 3.3, and 3.4), quadrature methods (Section 3.5), recurrence relations (Section 3.6), and other methods (Section 3.7). In Section 3.8, we summarize the computational strate- gies and provide recommendations for the most effective approaches for a variety of parameter regimes.
Recommended publications
  • The Gauss-Airy Functions and Their Properties
    Annals of the University of Craiova, Mathematics and Computer Science Series Volume 43(2), 2016, Pages 119{127 ISSN: 1223-6934 The Gauss-Airy functions and their properties Alireza Ansari Abstract. In this paper, in connection with the generating function of three-variable Hermite polynomials, we introduce the Gauss-Airy function Z 1 3 1 −yt2 zt GAi(x; y; z) = e cos(xt + )dt; y ≥ 0; x; z 2 R: π 0 3 Some properties of this function such as behaviors of zeros, orthogonal relations, corresponding inequalities and their integral transforms are investigated. Key words and phrases. Gauss-Airy function, Airy function, Inequality, Orthogonality, Integral transforms. 1. Introduction We consider the three-variable Hermite polynomials [ n ] [ n−3j ] X3 X2 zj yk H (x; y; z) = n! xn−3j−2k; (1) 3 n j! k!(n − 2k)! j=0 k=0 2 3 as the coefficient set of the generating function ext+yt +zt 1 n 2 3 X t ext+yt +zt = H (x; y; z) : (2) 3 n n! n=0 For the first time, these polynomials [8] and their generalization [9] was introduced by Dattoli et al. and later Torre [10] used them to describe the behaviors of the Hermite- Gaussian wavefunctions in optics. These are wavefunctions appeared as Gaussian apodized Airy polynomials [3,7] in elegant and standard forms. Also, similar families to the generating function (2) have been stated in literature, see [11, 12]. Now in this paper, it is our motivation to introduce the Gauss-Airy function derived from operational relation 2 3 y d +z d n 3Hn(x; y; z) = e dx2 dx3 x : (3) For this purpose, in view of the operational calculus of the Mellin transform [4{6], we apply the following integral representation 1 2 3 Z eys +zs = esξGAi(ξ; y; z) dξ; (4) −∞ Received February 28, 2015.
    [Show full text]
  • Cylindrical Waves Guided Waves
    Cylindrical Waves Guided Waves Cylindrical Waves Daniel S. Weile Department of Electrical and Computer Engineering University of Delaware ELEG 648—Waves in Cylindrical Coordinates D. S. Weile Cylindrical Waves 2 Guided Waves Cylindrical Waveguides Radial Waveguides Cavities Cylindrical Waves Guided Waves Outline 1 Cylindrical Waves Separation of Variables Bessel Functions TEz and TMz Modes D. S. Weile Cylindrical Waves Cylindrical Waves Guided Waves Outline 1 Cylindrical Waves Separation of Variables Bessel Functions TEz and TMz Modes 2 Guided Waves Cylindrical Waveguides Radial Waveguides Cavities D. S. Weile Cylindrical Waves Separation of Variables Cylindrical Waves Bessel Functions Guided Waves TEz and TMz Modes Outline 1 Cylindrical Waves Separation of Variables Bessel Functions TEz and TMz Modes 2 Guided Waves Cylindrical Waveguides Radial Waveguides Cavities D. S. Weile Cylindrical Waves Separation of Variables Cylindrical Waves Bessel Functions Guided Waves TEz and TMz Modes The Scalar Helmholtz Equation Just as in Cartesian coordinates, Maxwell’s equations in cylindrical coordinates will give rise to a scalar Helmholtz Equation. We study it first. r2 + k 2 = 0 In cylindrical coordinates, this becomes 1 @ @ 1 @2 @2 ρ + + + k 2 = 0 ρ @ρ @ρ ρ2 @φ2 @z2 We will solve this by separating variables: = R(ρ)Φ(φ)Z(z) D. S. Weile Cylindrical Waves Separation of Variables Cylindrical Waves Bessel Functions Guided Waves TEz and TMz Modes Separation of Variables Substituting and dividing by , we find 1 d dR 1 d2Φ 1 d2Z ρ + + + k 2 = 0 ρR dρ dρ ρ2Φ dφ2 Z dz2 The third term is independent of φ and ρ, so it must be constant: 1 d2Z = −k 2 Z dz2 z This leaves 1 d dR 1 d2Φ ρ + + k 2 − k 2 = 0 ρR dρ dρ ρ2Φ dφ2 z D.
    [Show full text]
  • Implementation of Airy Function Using Graphics Processing Unit (GPU)
    ITM Web of Conferences 32, 03052 (2020) https://doi.org/10.1051/itmconf/20203203052 ICACC-2020 Implementation of Airy function using Graphics Processing Unit (GPU) Yugesh C. Keluskar1, Megha M. Navada2, Chaitanya S. Jage3 and Navin G. Singhaniya4 Department of Electronics Engineering, Ramrao Adik Institute of Technology, Nerul, Navi Mumbai. Email : [email protected], [email protected], [email protected], [email protected] Abstract—Special mathematical functions are an integral part Airy function is the solution to Airy differential equa- of Fractional Calculus, one of them is the Airy function. But tion,which has the following form [22]: it’s a gruelling task for the processor as well as system that is constructed around the function when it comes to evaluating the d2y special mathematical functions on an ordinary Central Processing = xy (1) Unit (CPU). The Parallel processing capabilities of a Graphics dx2 processing Unit (GPU) hence is used. In this paper GPU is used to get a speedup in time required, with respect to CPU time for It has its applications in classical physics and mainly evaluating the Airy function on its real domain. The objective quantum physics. The Airy function also appears as the so- of this paper is to provide a platform for computing the special lution to many other differential equations related to elasticity, functions which will accelerate the time required for obtaining the heat equation, the Orr-Sommerfield equation, etc in case of result and thus comparing the performance of numerical solution classical physics. While in the case of Quantum physics,the of Airy function using CPU and GPU.
    [Show full text]
  • Appendix a FOURIER TRANSFORM
    Appendix A FOURIER TRANSFORM This appendix gives the definition of the one-, two-, and three-dimensional Fourier transforms as well as their properties. A.l One-Dimensional Fourier Transform If we have a one-dimensional (1-D) function fix), its Fourier transform F(m) is de­ fined as F(m) = [ f(x)exp( -2mmx)dx, (A.l.l) where m is a variable in the Fourier space. Usually it is termed the frequency in the Fou­ rier domain. If xis a variable in the spatial domain, miscalled the spatial frequency. If x represents time, then m is the temporal frequency which denotes, for example, the colour of light in optics or the tone of sound in acoustics. In this book, we call Eq. (A.l.l) the inverse Fourier transform because a minus sign appears in the exponent. Eq. (A.l.l) can be symbolically expressed as F(m) =,r 1{Jtx)}. (A.l.2) where ~-~denotes the inverse Fourier transform in Eq. (A.l.l). Therefore, the direct Fourier transform in this case is given by f(x) = r~ F(m)exp(2mmx)dm, (A.1.3) which can be symbolically rewritten as fix)= ~{F(m)}. (A.l.4) Substituting Eq. (A.l.2) into Eq. (A.l.4) results in 200 Appendix A ftx) = 1"1"-'{.ftx)}. (A.l.5) Therefore we have the following unity relation: ,.,... = l. (A.l.6) It means that performing a direct Fourier transform and an inverse Fourier transform of a function.ftx) successively leads to no change. Using the identity exp(ix) = cosx + isinx and Eq.
    [Show full text]
  • Simple and Robust Method for Determination of Laser Fluence
    Open Research Europe Open Research Europe 2021, 1:7 Last updated: 30 JUN 2021 METHOD ARTICLE Simple and robust method for determination of laser fluence thresholds for material modifications: an extension of Liu’s approach to imperfect beams [version 1; peer review: 1 approved, 2 approved with reservations] Mario Garcia-Lechuga 1,2, David Grojo 1 1Aix Marseille Université, CNRS, LP3, UMR7341, Marseille, 13288, France 2Departamento de Física Aplicada, Universidad Autónoma de Madrid, Madrid, 28049, Spain v1 First published: 24 Mar 2021, 1:7 Open Peer Review https://doi.org/10.12688/openreseurope.13073.1 Latest published: 25 Jun 2021, 1:7 https://doi.org/10.12688/openreseurope.13073.2 Reviewer Status Invited Reviewers Abstract The so-called D-squared or Liu’s method is an extensively applied 1 2 3 approach to determine the irradiation fluence thresholds for laser- induced damage or modification of materials. However, one of the version 2 assumptions behind the method is the use of an ideal Gaussian profile (revision) report that can lead in practice to significant errors depending on beam 25 Jun 2021 imperfections. In this work, we rigorously calculate the bias corrections required when applying the same method to Airy-disk like version 1 profiles. Those profiles are readily produced from any beam by 24 Mar 2021 report report report insertion of an aperture in the optical path. Thus, the correction method gives a robust solution for exact threshold determination without any added technical complications as for instance advanced 1. Laurent Lamaignere , CEA-CESTA, Le control or metrology of the beam. Illustrated by two case-studies, the Barp, France approach holds potential to solve the strong discrepancies existing between the laser-induced damage thresholds reported in the 2.
    [Show full text]
  • The Laplace Transform of the Modified Bessel Function K( T± M X) Where
    THE LAPLACE TRANSFORM OF THE MODIFIED BESSEL FUNCTION K(t±»>x) WHERE m-1, 2, 3, ..., n by F. M. RAGAB (Received in revised form 13th August 1963) 1. Introduction In the present paper we determine the Laplace transforms of the modified ±m Bessel function of the second kind Kn(t x), where m is any positive integer. The Laplace transforms are given in (2) and (4) below, p being the transform parameter and having positive real part. The formulae to be established are as follows (l)-(4): f Jo 2m-1 2\-~ -i-,lx 2m 2m 2m J k + v - 2 2m (2m)2mx2 v+1 v + 2 v + 2m (1) 2m 2m 2m where R(k±nm)>0 and x is taken for simplicity to be real and positive" When m = 1, x may be taken to be complex with real part greater than 1. The asterisk in the generalised hypergeometric function denotes that the . 2m . ., v+1 v + 2 v + 2m . factor =— m th e parametert s , , ..., is omitted; m is a positive 2m 2m 2m 2m integer. m m 1 e~"'Kn(t x)dt = 2 ~ V f V J ±l - 2m-l 2 2m 2m 2m 2m J 2m v+1 n v+1. 4p ' 2 2m 2 1m"' (2m)2mx2 2r2m+l v+1 v+2 v + 2m (2) _ 2m 2m ~lm~ E.M.S.—Y Downloaded from https://www.cambridge.org/core. 02 Oct 2021 at 05:34:47, subject to the Cambridge Core terms of use. 326 F. M. RAGAB where m is a positive integer, R(± mn +1)>0 and R(p) > 0; x is taken to be rea and positive and the asterisk has the same meaning as before.
    [Show full text]
  • Non-Classical Integrals of Bessel Functions
    J. Austral. Math. Soc. (Series E) 22 (1981), 368-378 NON-CLASSICAL INTEGRALS OF BESSEL FUNCTIONS S. N. STUART (Received 14 August 1979) (Revised 20 June 1980) Abstract Certain definite integrals involving spherical Bessel functions are treated by relating them to Fourier integrals of the point multipoles of potential theory. The main result (apparently new) concerns where /,, l2 and N are non-negative integers, and r, and r2 are real; it is interpreted as a generalized function derived by differential operations from the delta function 2 fi(r, — r^. An ancillary theorem is presented which expresses the gradient V "y/m(V) of a spherical harmonic function g(r)YLM(U) in a form that separates angular and radial variables. A simple means of translating such a function is also derived. 1. Introduction Some of the best-known differential equations of mathematical physics lead to Fourier integrals that involve Bessel functions when, for instance, they are solved under conditions of rotational symmetry about a centre. As long as the integrals are absolutely convergent they are amenable to the classical analysis of Watson's standard treatise, but a calculus of wider serviceability can be expected from the theory of generalized functions. This paper identifies a class of Bessel-function integrals that are Fourier integrals of derivatives of the Dirac delta function in three dimensions. They arise in the practical context of manipulating special functions-notably when changing the origin of the polar coordinates, for example, in order to evaluate so-called two-centre integrals and ©Copyright Australian Mathematical Society 1981 368 Downloaded from https://www.cambridge.org/core.
    [Show full text]
  • Radial Functions and the Fourier Transform
    Radial functions and the Fourier transform Notes for Math 583A, Fall 2008 December 6, 2008 1 Area of a sphere The volume in n dimensions is n n−1 n−1 vol = d x = dx1 ··· dxn = r dr d ω. (1) Here r = |x| is the radius, and ω = x/r it a radial unit vector. Also dn−1ω denotes the angular integral. For instance, when n = 2 it is dθ for 0 ≤ θ ≤ 2π, while for n = 3 it is sin(θ) dθ dφ for 0 ≤ θ ≤ π and 0 ≤ φ ≤ 2π. The radial component of the volume gives the area of the sphere. The radial directional derivative along the unit vector ω = x/r may be denoted 1 ∂ ∂ ∂ ωd = (x1 + ··· + xn ) = . (2) r ∂x1 ∂xn ∂r The corresponding spherical area is ωdcvol = rn−1 dn−1ω. (3) Thus when n = 2 it is (1/r)(x dy−y dx) = r dθ, while for n = 3 it is (1/r)(x dy dz+ y dz dx + x dx dy) = r2 sin(θ) dθ dφ. The divergence theorem for the ball Br of radius r is thus Z Z div v dnx = v · ω rn−1dn−1ω. (4) Br Sr Notice that if one takes v = x, then div x = n, while x · ω = r. This shows that n n times the volume of the ball is r times the surface areaR of the sphere. ∞ z −t dt Recall that the Gamma function is defined by Γ(z) = 0 t e t . It is easy to show that Γ(z + 1) = zΓ(z).
    [Show full text]
  • Unified Bessel, Modified Bessel, Spherical Bessel and Bessel-Clifford Functions
    Unified Bessel, Modified Bessel, Spherical Bessel and Bessel-Clifford Functions Banu Yılmaz YAS¸AR and Mehmet Ali OZARSLAN¨ Eastern Mediterranean University, Department of Mathematics Gazimagusa, TRNC, Mersin 10, Turkey E-mail: [email protected]; [email protected] Abstract In the present paper, unification of Bessel, modified Bessel, spherical Bessel and Bessel- Clifford functions via the generalized Pochhammer symbol [ Srivastava HM, C¸etinkaya A, Kıymaz O. A certain generalized Pochhammer symbol and its applications to hypergeometric functions. Applied Mathematics and Computation, 2014, 226 : 484-491] is defined. Several potentially useful properties of the unified family such as generating function, integral representation, Laplace transform and Mellin transform are obtained. Besides, the unified Bessel, modified Bessel, spherical Bessel and Bessel- Clifford functions are given as a series of Bessel functions. Furthermore, the derivatives, recurrence relations and partial differential equation of the so-called unified family are found. Moreover, the Mellin transform of the products of the unified Bessel functions are obtained. Besides, a three-fold integral representation is given for unified Bessel function. Some of the results which are obtained in this paper are new and some of them coincide with the known results in special cases. Key words Generalized Pochhammer symbol; generalized Bessel function; generalized spherical Bessel function; generalized Bessel-Clifford function 2010 MR Subject Classification 33C10; 33C05; 44A10 1 Introduction Bessel function first arises in the investigation of a physical problem in Daniel Bernoulli's analysis of the small oscillations of a uniform heavy flexible chain [26, 37]. It appears when finding separable solutions to Laplace's equation and the Helmholtz equation in cylindrical or spherical coordinates.
    [Show full text]
  • Special Functions
    Chapter 5 SPECIAL FUNCTIONS Chapter 5 SPECIAL FUNCTIONS table of content Chapter 5 Special Functions 5.1 Heaviside step function - filter function 5.2 Dirac delta function - modeling of impulse processes 5.3 Sine integral function - Gibbs phenomena 5.4 Error function 5.5 Gamma function 5.6 Bessel functions 1. Bessel equation of order ν (BE) 2. Singular points. Frobenius method 3. Indicial equation 4. First solution – Bessel function of the 1st kind 5. Second solution – Bessel function of the 2nd kind. General solution of Bessel equation 6. Bessel functions of half orders – spherical Bessel functions 7. Bessel function of the complex variable – Bessel function of the 3rd kind (Hankel functions) 8. Properties of Bessel functions: - oscillations - identities - differentiation - integration - addition theorem 9. Generating functions 10. Modified Bessel equation (MBE) - modified Bessel functions of the 1st and the 2nd kind 11. Equations solvable in terms of Bessel functions - Airy equation, Airy functions 12. Orthogonality of Bessel functions - self-adjoint form of Bessel equation - orthogonal sets in circular domain - orthogonal sets in annular fomain - Fourier-Bessel series 5.7 Legendre Functions 1. Legendre equation 2. Solution of Legendre equation – Legendre polynomials 3. Recurrence and Rodrigues’ formulae 4. Orthogonality of Legendre polynomials 5. Fourier-Legendre series 6. Integral transform 5.8 Exercises Chapter 5 SPECIAL FUNCTIONS Chapter 5 SPECIAL FUNCTIONS Introduction In this chapter we summarize information about several functions which are widely used for mathematical modeling in engineering. Some of them play a supplemental role, while the others, such as the Bessel and Legendre functions, are of primary importance. These functions appear as solutions of boundary value problems in physics and engineering.
    [Show full text]
  • Bessel Functions and Their Applications
    Bessel Functions and Their Applications Jennifer Niedziela∗ University of Tennessee - Knoxville (Dated: October 29, 2008) Bessel functions are a series of solutions to a second order differential equation that arise in many diverse situations. This paper derives the Bessel functions through use of a series solution to a differential equation, develops the different kinds of Bessel functions, and explores the topic of zeroes. Finally, Bessel functions are found to be the solution to the Schroedinger equation in a situation with cylindrical symmetry. 1 INTRODUCTION 0 0 X 2 n+s−1 (xy ) = an(n + s) x n=0 While special types of what would later be known as 1 0 0 X 2 n+s Bessel functions were studied by Euler, Lagrange, and (xy ) = an(n + s) x the Bernoullis, the Bessel functions were first used by F. n=0 W. Bessel to describe three body motion, with the Bessel functions appearing in the series expansion on planetary When the coefficients of the powers of x are organized, we perturbation [1]. This paper presents the Bessel func- find that the coefficient on xs gives the indicial equation tions as arising from the solution of a differential equa- s2 − ν2 = 0; =) s = ±ν, and we develop the general tion; an equation which appears frequently in applica- formula for the coefficient on the xs+n term: tions and solutions to physical situations [2] [3]. Fre- quently, the key to solving such problems is to recognize an−2 the form of this equation, thus allowing employment of an = − (3) (n + s)2 − ν2 the Bessel functions as solutions.
    [Show full text]
  • On Airy Solutions of the Second Painlevé Equation
    On Airy Solutions of the Second Painleve´ Equation Peter A. Clarkson School of Mathematics, Statistics and Actuarial Science, University of Kent, Canterbury, CT2 7NF, UK [email protected] October 18, 2018 Abstract In this paper we discuss Airy solutions of the second Painleve´ equation (PII) and two related equations, the Painleve´ XXXIV equation (P34) and the Jimbo-Miwa-Okamoto σ form of PII (SII), are discussed. It is shown that solutions which depend only on the Airy function Ai(z) have a completely difference structure to those which involve a linear combination of the Airy functions Ai(z) and Bi(z). For all three equations, the special solutions which depend only on Ai(t) are tronquee´ solutions, i.e. they have no poles in a sector of the complex plane. Further for both P34 and SII, it is shown that amongst these tronquee´ solutions there is a family of solutions which have no poles on the real axis. Dedicated to Mark Ablowitz on his 70th birthday 1 Introduction The six Painleve´ equations (PI–PVI) were first discovered by Painleve,´ Gambier and their colleagues in an investigation of which second order ordinary differential equations of the form d2q dq = F ; q; z ; (1.1) dz2 dz where F is rational in dq=dz and q and analytic in z, have the property that their solutions have no movable branch points. They showed that there were fifty canonical equations of the form (1.1) with this property, now known as the Painleve´ property. Further Painleve,´ Gambier and their colleagues showed that of these fifty equations, forty-four can be reduced to linear equations, solved in terms of elliptic functions, or are reducible to one of six new nonlinear ordinary differential equations that define new transcendental functions, see Ince [1].
    [Show full text]