19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 HIGH FREQUENCY ACOUSTIC SIMULATIONS VIA FMM ACCELERATED BEM

Size: px
Start display at page:

Download "19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 HIGH FREQUENCY ACOUSTIC SIMULATIONS VIA FMM ACCELERATED BEM"

Transcription

1 19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 HIGH FREQUENCY ACOUSTIC SIMULATIONS VIA FMM ACCELERATED BEM PACS: Fn Gumerov, Nail A.; Duraiswami, Ramani; Fantalgo LLC, 7496 Merrymaker Way, Elkridge, MD 21075; ABSTRACT High frequency simulations of acoustics are among the most expensive problems to simulate. In practice 6 to 10 points per wavelength are required. Since the wavenumber k is inversely proportional to wavelength, if a numerical method is a surface based method (such as the BEM), then problem size scales as O(k 2 D 2 ),whered is the size of the domain. Dense matrices appear and typical iterative solution can be achieved for O(k 4 D 4 ) memory and O(k 4 D 4 ) per iteration cost. We employ an algorithm based on the fast multipole method (FMM) using coaxial and diagonal translation operators based on the frequency of simulation to reduce the memory requirements and per iteration cost to O(k 2 D 2 log kd) for larger kd (kd ~250). The number of iterations needed depend upon the condition of the matrix, and preconditioning chosen. Preconditioned Krylov methods such as the flexible generalized minimum residual method (FGMRES), with preconditioning based upon a lower accuracy FMM, usually ensure a convergent iteration. Example calculations are presented. 1 INTRODUCTION For many problems boundary element methods have long been considered as very promising. They can handle complex shapes, lead to problems in boundary variables alone, and lead to simpler meshes as the boundary alone must be discretized rather than the entire domain. Despite these advantages, one issue that has impeded their widespread adoption of these methods is that they lead to dense nonsymmetric complex valued linear systems, for which efficient iterative solvers may not be available. For N unknowns this requires O N 2 storage. The computation of the individual matrix elements is expensive requiring quadrature of singular or hypersingular functions. To reduce the singularity order and achieve symmetric matrices, many investigators employ Galerkin techniques, which lead to further O N 2 integral computations. Direct solution of the linear systems has an O(N 3 ) cost. Use of iterative methods can reduce the cost to O(N iter N 2 ) operations, where N iter is the number of iterations required, but this is still quite large. An iteration strategy that minimizes N iter is also needed. These expenses have meant that the BEM was not used for very large problems. For the Helmholtz equation the cost of computations grows with frequency. In a BEM calculation, the number of variables also grow with frequency. Any calculation must resolve the smallest wavelengths of interest, and in practice 6-10 points per wavelength are required. Since the wavenumber k is inversely proportional to wavelength, if a numerical method is a surface based method (such as the BEM), then problem N size scales as O k 2 D 2,whereD is the size of the domain. Thus the cost of a direct solver will be O(k 6 D 6 ), while an iterative BEM solver will cost O(N iter k 4 D 4 ) operations. The development of the fast multipole method (FMM) [2] and use of Krylov iterative methods presents a promising approach to improving the scalability of BEM. FMM allows the matrix vector product in an iterative method to be performed to a given precision ² in O(N log N) operations, and does not require the computation or storage of all N 2 matrix elements, reducing storage costs to O(N log N) as well. Incorporating the FMM in a quickly convergent iterative scheme allows rapid solved with O(N iter N log N) cost. Later this method was intensively studied and extended to solution of many other problems. While the literature and previous work is extensive, reasons of space do not permit us to discussion them. We refer the reader to the comprehensive review [6]. While this appears to be promising for the solution of BEM problems, for the Helmholtz equation the situations is not as nice as it may initially appear, as there are hidden factors which also grow 1

2 with the frequency increasing the cost of the solution. The FMM exploits factorized local and farfield (multipole) expansions of the Green s function obtained via the addition theorem. The basic idea of the FMM is to truncate the infinite series up to p 2 terms in 3D, and use translation operators for reexpansion of the solution about an arbitrary spatial point. The truncation number p depends on the frequency of the problem being simulated, and this is the cause of the trouble. In fact as the frequency (wavenumber k) and the domain size D increase, the truncation number must grow as O (kd) for kd > 40. In the original FMM the translation cost for a O p 2 representation was O p 4 which makes the FMM-BEM cost at high frequencies as O(N iter k 6 D 6 log kd) which is even larger than the direct solver! Improved translation methods with costs of O p 3, O p 2 log p and even O p 2 diagonal methods [7] are available. As is discussed in details in [5] by changing p in the FMM procedure with the level of the discretization we can achieve using the O(p 3 ) and O(p 2 ) translation methods O(N log N) matrix vector products. Contributions of the present paper: The FMM for both the Helmholtz equations at moderate frequencies can be handled well by O p 3 translation techniques based on a decomposition of the translation to rotation and coaxial translations (see [3]), and the switch to the O(p 2 ) diagonal forms at higher frequencies can be handled automatically. We must emphasize that several other authors (e.g., [9]) have developed FMM/BEM algorithms. Here our intention is to present some aspects of our implementations. In particular our approach is characterized by the use of the Burton Miller formulation, collocation techniques, preconditioned Krylov iterative methods, and an overall choice of techniques that have a consistent accuracy in all aspects of the algorithm. The results of solutions of the test problems and issues related to errors and performance of the methods employed are discussed. 2 PROBLEM FORMULATION We consider solutions of the Helmholtz equation with real wavenumber k 2 φ + k 2 φ =0, (1) inside or outside finite three dimensional domain V bounded by closed surface S, subject to mixed boundary conditions α (x) φ (x)+β(x) q (x) =γ (x), q(x) = φ (x), α + β 6= 0, x S. (2) n Here and below all normal derivatives are taken assuming that the normal to the surface is directed outward V. For external problems we also assume that the field satisfies the Sommerfeld radiation condition µ φ lim r r r ikφ =0, r = x. (3) This means that for scattering problems φ is treated as the scattered potential. Boundary integral equations: The boundary element method presumes that the problem will be formulated in terms of boundary integral equations, which solution together with the boundary conditions provides the values of φ (x) and q (x) on the boundary. Knowledge of these quantities enables determination of φ (y) for any domain point y. This can be done, e.g. using Greens identity, which is ±φ (y) =L [q] M [φ], y / S ± 1 φ (y) =L [q] M [φ], y S. (4) 2 Here the upper sign in the left hand side should be taken for the internal domain while the lower the lower sign is for the external domain (this convention is used everywhere below), and L and M denote the following boundary operators: Z L [q] = S Z q (x) G (x, y) ds(x), M [φ] = S φ (x) G (x, y) ds(x), (5) n (x) 19th INTERNATIONAL CONGRESS ON ACOUSTICS - ICA2007MADRID 2

3 where G is the free-space Green s function for the Helmholtz equation. G (x, y) = eikr, r = x y. (6) 4πr Burton Miller formulation: The well-known deficiency of this formulation is related to possible degeneration of operators L and M 2 1 at certain frequencies depending on S, which correspond to resonances of the internal problem for sound-soft and sound-hard boundaries. Despite the solution of the external problem is unique for these frequencies formulation (4) is deficient in these cases, since it provides non-unique solution. Moreover, despite the spurious values of resonance frequencies, for frequencies in the vicinity of the resonances the system becomes poorly conditioned. On the other hand, when solving the internal problems (e.g. room acoustics), the non-uniqueness of the solution for the internal problem, seems, have physical meaning, as there, in fact, can be resonances. In any case, boundary integral equation (4) can be modified to avoid the problem of degeneracy of boundary operators when solving correctly posed problem (1)-(3). In the present paper we use direct formulation based on the integral equation combining Green s and Maue s identities, which is the same trick as proposed by Burton and Miller (1971) for sound-hard boundaries. The latter identity is ± 1 2 q (y) =L0 [q] M 0 [φ]; L 0 [q] = Z q (x) G (x, y) ds, M 0 [φ] = Z G (x, y) φ (x) n (y) S n (y) S n (x) ds. (7) Multiplying Eq. (7) by some complex constant λ and summing with Eq. (4), we obtain ± 1 2 [φ (y)+λq(y)] = (L + λl0 )[q] (M + λm 0 )[φ]. (8) Burton & Miller (1971) proved that it is sufficient to have Im (λ) 6= 0to guarantee the uniqueness of the solution for external problem with sound-hard boundaries. Below we demonstrate a case where use of this formulation in our FMM BEM code resulted in proper computation of a spuriously resonant case of a sound hard sphere insonified by a plane wave. 3 BEM SPEED UP WITH FMM BEM and FMM data structures: Detailed description of the FMM for the Laplace and Helmholtz equations can be found elsewhere [2, 5]. The data structure of the FMM is based on the octree space subdivision up to some level l max. Selection of l max is dictated by an optimization problem for FMM costs, which balances the costs of the translation and direct summation operations. Deviations from optimal l max are not desirable, as they heavily influence the FMM performance [5]. On the other hand the split between near and far is dictated by the accuracy of the BEM and therefore Abs error 1.E+00 1.E-01 1.E-02 1.E-03 1.E-04 Preconditioned Unpreconditioned Iteration # Computational Cost Converged (10-4 ) Preconditioned Converged (10-4 ) Unpreconditioned Iteration # Figure 1: IfGMRES solve with a low-accurace FMM-BEM preconditioner. Left: No. of unpreconditioned GMRES loops vs. number of outer loops in the fgmres. Right: Since fgmres iterations are more expensive, the total computational cost is shown. Our preconditioning strategy is very effective. 19th INTERNATIONAL CONGRESS ON ACOUSTICS - ICA2007MADRID 3

4 the size of the neighborhood where we perform direct computations of integrals may not coincide with the sizes of neighborhoods at different levels of the FMM. Our numerical tests show that (fortunately) the size of the neighborhood at the optimal maximum space subdivision level is larger than the size required for direct integral evaluations. This means that all elements which intersect the neighborhood of an element i at the finest level, and whose contribution to the potential at the element center can be classified into two sets. First are the elements j that arecloserthansomedistancer min from the center of i to the closest corner of j. The contribution of these elements is performed using higher order quadrature or special integral treatment (for singular and hypersingular integrals) as in the conventional BEM. The second set of elements are located further than r min. Their contribution is taken into account using low order quadrature, as they are remote in the sense of BEM, but close in the sense of the FMM. Iterative methods: The basic iterative method we used is the Generalized Minimal Residual Method (GMRES) and its modifications (flexible GMRES, fgmres) [8], which allow the use of various FMM-based preconditioners [4]. In all cases for the Helmholtz equation at low frequencies unpreconditioned GMRES showed good results, while the convergence rate of this method for the Helmholtz equation substantially reduces at higher frequencies. Preconditioning: The best preconditioners we found were those that compute solution of the system Aψ j = c j on the jth step using unpreconditioned GMRES (inner loop), low accuracy FMM, and lower bounds for convergence of iterations. For example, if in the outer loop of the fgmres the prescribed accuracy for the FMM solution was 10 5, and the iterative process was terminated as the residual reaches 10 4, for the inner preconditioning loop we used FMM with prescribed accuracy 0.05 and the iterative process was terminated at residual value 0.5. Computation of normal derivatives in the FMM: Eq. (8) requires four matrix-vector products, and the use of Eq. (6) requires two matrix-vector products (in the case of mixed boundary conditions). These can be performed by the FMM in a single run, as for a single matrix-vector product. Indeed, the first step of the regular FMM is to build multipole expansions about the centers of the source boxes, x. We handle this step using expansions of Greens function over the multipole basis functions Sn m (r): G (y x) Xp 1 nx n=0 m= n C m n S m n (y x ), C m n = C m n (x, x ), (9) where p is the truncation number, and expressions for coefficients Cn m for the Laplace and Helmholtz equations can be found elsewhere [5]. We compute the normal derivative of arbitrary function F (x), which can be expanded inton a series over the basis functions with coefficients {Cn m } using sparsematrix differential operators Dnn o: mm0 0 Xp 1 n x F (x) nx n=0m= n Bn m Sn m (y x ), {Bn m }= nd mm0 nn 0 (n) on Cn m0 0 Expressions for Dnn mm0 0 for the Helmholtz equation can be found in [5]. 4 RESULTS o p 1 X, Bn m = nx Xp 1 Xn 0 D mm 0 nn 0 n=0m= nn 0 =0m 0 = n 0 The tests of the BEM for the Helmholtz equation were performed by solution of acoustic scattering problems off objects of different shape. The objects were sound-hard leading to an external Neumann problem for the scattered field. As a test we selected scattering of the plane incident wave from a single sphere, which has an analytical solution in the form of the infinite series (due to Lord Rayleigh, can be found elsewhere, e.g. [5]). These series can be appropriately truncated and the error of the solution can be accurately estimated. We performed tests using the same four methods as reported (10) Cm0 n. 0 19th INTERNATIONAL CONGRESS ON ACOUSTICS - ICA2007MADRID 4

5 Total CPU time (s) 1.E+04 1.E+03 1.E+02 1.E+01 kd=34.64 y=cx 3 y=bx 2 GMRES+FMM y=ax BEM Neumann Problem for Sphere (3D Helmholtz) GMRES+Low Mem Direct O(N 2 ) Memory GMRES+High Mem Direct Threshold LU-decomposition 1.E+00 1.E+03 1.E+04 1.E+05 1.E+06 Number of Vertices, N Single Matrix-Vector Multiplication CPU Time (s) 1.E+03 1.E+02 1.E+01 1.E+00 1.E-01 Number of GMRES Iterations Low Mem Direct y=bx 2 Multiplication of Stored Matrix y=ax FMM 3D Helmholtz, kd= E-02 1.E+03 1.E+04 1.E+05 1.E+06 Number of Vertices, N Figure 3: Left: CPU time for computation of scattering off a sphere in a domain of size kd =34.64 as a function of the degrees of freedom. Right: Dependence of the matrix vector multiplication time on N. Crosses show number of iterations. for the Laplace equation, plus we compared solutions obtained using boundary integral equations resulting from the layer potential and Green s identity. Also some tests using the fgmres with different preconditioners were performed. Fig. 2 shows scattering off a sphere. The numerical solution reproduces fine oscillating structure of the acoustic field near the point θ = 180 which happens at large ka, wherea is the sphere radius. Even the use of high frequency mesh with 480,000 elements for ka =30provided kδ =0.4, where δ is the size of the largest boundary element (about 16 elements per wavelength). Computations of this were performed with 6 levels of the octree with maximum truncation number p =22at level 2, and convergence to error ² =10 5 took 115 unpreconditioned iterations. The CPU time required for solution of the problem with ka =10using different db methods is shown in Fig. 3. As the kd for different N is fixed (kd =34.64) themeth- ods show scaling close to O(N 3 ), O(N 2 ), O(N 2 ), and O(N), respectively. Finally we applied the software for solution of some large scattering problems off a animal head, and from composite media for which the developed BEM/FMM works Plane wave scattering from a sphere, ka=30 (kd=103.9) Incident Wave well. Parameters such as BEM/FMM, vertices, elements sound pressure or head related transfer functions (HRTF) are computed. Fig. 4 provides one such case. (A dence angle is 0 for the front point and 180 o for the rear point. Figure 2: Scattering of a plane wave from a sound-hard sphere. The inci- color movie visualizing scattering can be viewed online on the web sites of the authors.) 19th INTERNATIONAL CONGRESS ON ACOUSTICS - ICA2007MADRID 5

6 Figure 4: An example of computation of sound scattering from bunny model using the BEM/FMM. The sound pressure for different frequencies at some moment of time is shown on the bottom pictures. Figure 5: A large case of dense object scattering run with our code. On the left is shown a case of plane-wave scattering from sound hard ellipsoids (kd = 29), while on the right is a case of plane wave scattering with a Robin boundary condition (kd = 144.5). There are vertices and elements in the mesh over 512 ellipsoids. References [1] Chen, L.H and Zhou, J. (1992) Boundary Element Methods. Academic Press. [2] Greengard, L. (1988). The Rapid Evaluation of Potential Fields in Particle Sytems. (MIT Press, MA). [3] Gumerov, N.A., Duraiswami, R. (2003). Recursions for the computation of multipole translation and rotation coefficients for the 3-D Helmholtz equation, SIAM J. Sci. Stat. Comput. 25(4), , [4] Gumerov, N.A. and Duraiswami, R. (2005). Computation of scattering from clusters of spheres using the fast multipole method, J. Acoust. Soc. Am., 117 (4), Pt. 1, [5] Gumerov, N.A. and Duraiswami, R. (2005) Fast Multipole Methods for the Helmholtz Equation in Three Dimensions. (Elsevier, Oxford, UK). [6] N. Nishimura, Fast multipole accelerated boundary integral equation methods, App Mech. 55: , [7] Rokhlin, V. (1993). Diagonal forms of translation operators for the Helmholtz equation in three dimensions, Appl. and Comp. Harmonic Analysis, 1: [8] Saad, Y.(1993). A flexible inner-outer preconditioned GMRES algorithm, SIAM J. Sci. Comput. 14: [9] Sakuma, T. and Yasuda, Y. (2002). Fast multipole boundary element method for large scale steady state sound field analysis, part i: Setup and validation. Acustica/Acta Acustica, 88: th INTERNATIONAL CONGRESS ON ACOUSTICS - ICA2007MADRID 6

An adaptive fast multipole boundary element method for the Helmholtz equation

An adaptive fast multipole boundary element method for the Helmholtz equation An adaptive fast multipole boundary element method for the Helmholtz equation Vincenzo Mallardo 1, Claudio Alessandri 1, Ferri M.H. Aliabadi 2 1 Department of Architecture, University of Ferrara, Italy

More information

Fast Multipole Methods for Incompressible Flow Simulation

Fast Multipole Methods for Incompressible Flow Simulation Fast Multipole Methods for Incompressible Flow Simulation Nail A. Gumerov & Ramani Duraiswami Institute for Advanced Computer Studies University of Maryland, College Park Support of NSF awards 0086075

More information

Fast Multipole BEM for Structural Acoustics Simulation

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

More information

Fast Multipole Methods for The Laplace Equation. Outline

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

More information

Partial Differential Equations. Examples of PDEs

Partial Differential Equations. Examples of PDEs Partial Differential Equations Almost all the elementary and numerous advanced parts of theoretical physics are formulated in terms of differential equations (DE). Newton s Laws Maxwell equations Schrodinger

More information

Transactions on Modelling and Simulation vol 18, 1997 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 18, 1997 WIT Press,  ISSN X Application of the fast multipole method to the 3-D BEM analysis of electron guns T. Nishida and K. Hayami Department of Mathematical Engineering and Information Physics, School of Engineering, University

More information

A far-field based T-matrix method for three dimensional acoustic scattering

A far-field based T-matrix method for three dimensional acoustic scattering ANZIAM J. 50 (CTAC2008) pp.c121 C136, 2008 C121 A far-field based T-matrix method for three dimensional acoustic scattering M. Ganesh 1 S. C. Hawkins 2 (Received 14 August 2008; revised 4 October 2008)

More information

FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials

FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials Boundary Elements and Other Mesh Reduction Methods XXXVIII 113 FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials Y. M. Xu, H.

More information

Lecture 8: Boundary Integral Equations

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

More information

Efficient calculation for evaluating vast amounts of quadrupole sources in BEM using fast multipole method

Efficient calculation for evaluating vast amounts of quadrupole sources in BEM using fast multipole method PROCEEDINGS of the 22 nd International Congress on Acoustics Boundary Element and Meshless Methods on Acoustics and Vibrations: Paper ICA2016-309 Efficient calculation for evaluating vast amounts of quadrupole

More information

Fast Multipole Methods

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

More information

Semi-analytical computation of acoustic scattering by spheroids and disks

Semi-analytical computation of acoustic scattering by spheroids and disks Semi-analytical computation of acoustic scattering by spheroids and disks Ross Adelman, a),b) Nail A. Gumerov, c) and Ramani Duraiswami b),c) Institute for Advanced Computer Studies, University of Maryland,

More information

A Fast, Parallel Potential Flow Solver

A Fast, Parallel Potential Flow Solver Advisor: Jaime Peraire December 16, 2012 Outline 1 Introduction to Potential FLow 2 The Boundary Element Method 3 The Fast Multipole Method 4 Discretization 5 Implementation 6 Results 7 Conclusions Why

More information

CONVERGENCE BOUNDS FOR PRECONDITIONED GMRES USING ELEMENT-BY-ELEMENT ESTIMATES OF THE FIELD OF VALUES

CONVERGENCE BOUNDS FOR PRECONDITIONED GMRES USING ELEMENT-BY-ELEMENT ESTIMATES OF THE FIELD OF VALUES European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 CONVERGENCE BOUNDS FOR PRECONDITIONED GMRES USING ELEMENT-BY-ELEMENT

More information

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc.

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc. Lecture 11: CMSC 878R/AMSC698R Iterative Methods An introduction Outline Direct Solution of Linear Systems Inverse, LU decomposition, Cholesky, SVD, etc. Iterative methods for linear systems Why? Matrix

More information

Improved near-wall accuracy for solutions of the Helmholtz equation using the boundary element method

Improved near-wall accuracy for solutions of the Helmholtz equation using the boundary element method Center for Turbulence Research Annual Research Briefs 2006 313 Improved near-wall accuracy for solutions of the Helmholtz equation using the boundary element method By Y. Khalighi AND D. J. Bodony 1. Motivation

More information

FastBEM Acoustics. Verification Manual , Advanced CAE Research, LLC (ACR) Cincinnati, Ohio, USA All Rights Reserved

FastBEM Acoustics. Verification Manual , Advanced CAE Research, LLC (ACR) Cincinnati, Ohio, USA All Rights Reserved FastBEM Acoustics Verification Manual 2007-2017, Advanced CAE Research, LLC (ACR) Cincinnati, Ohio, USA All Rights Reserved www.fastbem.com Copyright 2007-2017, Advanced CAE Research, LLC, All Rights Reserved

More information

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

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

More information

Fast multipole boundary element method for the analysis of plates with many holes

Fast multipole boundary element method for the analysis of plates with many holes Arch. Mech., 59, 4 5, pp. 385 401, Warszawa 2007 Fast multipole boundary element method for the analysis of plates with many holes J. PTASZNY, P. FEDELIŃSKI Department of Strength of Materials and Computational

More information

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

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

More information

Multipole-Based Preconditioners for Sparse Linear Systems.

Multipole-Based Preconditioners for Sparse Linear Systems. Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation. Overview Summary of Contributions Generalized Stokes Problem Solenoidal

More information

ABSTRACT. Title of thesis: IMPROVING RADIAL BASIS FUNCTION INTER- POLATION VIA RANDOM SVD PRECONDITION- ERS AND FAST MULTIPOLE METHODS

ABSTRACT. Title of thesis: IMPROVING RADIAL BASIS FUNCTION INTER- POLATION VIA RANDOM SVD PRECONDITION- ERS AND FAST MULTIPOLE METHODS ABSTRACT Title of thesis: IMPROVING RADIAL BASIS FUNCTION INTER- POLATION VIA RANDOM SVD PRECONDITION- ERS AND FAST MULTIPOLE METHODS Kerry Cheng, Master of Science, 2013 Thesis directed by: Professor

More information

On the use of multipole methods for domain integration in the BEM

On the use of multipole methods for domain integration in the BEM On the use of multipole methods for domain integration in the BEM A.A. Mammoii, M.S. Ingber & M.J. Brown Department of Mechanical Engineering, University of New Mexico, USA Abstract Often, a single application

More information

Frequency Domain Integral Equations for Acoustic and Electromagnetic Scattering Problems

Frequency Domain Integral Equations for Acoustic and Electromagnetic Scattering Problems Frequency Domain Integral Equations for Acoustic and Electromagnetic Scattering Problems Christophe Geuzaine, U of Liege Fernando Reitich, U of Minnesota Catalin Turc, UNC Charlotte Outline Integral equations

More information

Fast Methods for Integral Equations. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy

Fast Methods for Integral Equations. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Introduction to Simulation - Lecture 23 Fast Methods for Integral Equations Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Solving Discretized Integral Equations Using

More information

Incomplete LU Preconditioning and Error Compensation Strategies for Sparse Matrices

Incomplete LU Preconditioning and Error Compensation Strategies for Sparse Matrices Incomplete LU Preconditioning and Error Compensation Strategies for Sparse Matrices Eun-Joo Lee Department of Computer Science, East Stroudsburg University of Pennsylvania, 327 Science and Technology Center,

More information

On spherical-wave scattering by a spherical scatterer and related near-field inverse problems

On spherical-wave scattering by a spherical scatterer and related near-field inverse problems IMA Journal of Applied Mathematics (2001) 66, 539 549 On spherical-wave scattering by a spherical scatterer and related near-field inverse problems C. ATHANASIADIS Department of Mathematics, University

More information

Simulation of acoustic and vibroacoustic problems in LS-DYNA using boundary element method ABSTRACT:

Simulation of acoustic and vibroacoustic problems in LS-DYNA using boundary element method ABSTRACT: Simulation of acoustic and vibroacoustic problems in LS-DYNA using boundary element method Yun Hang, Mhamed Souli, Rogelio Perez Livermore Software Technology Corporation USA & University of Lille Laboratoire

More information

Electromagnetic wave propagation. ELEC 041-Modeling and design of electromagnetic systems

Electromagnetic wave propagation. ELEC 041-Modeling and design of electromagnetic systems Electromagnetic wave propagation ELEC 041-Modeling and design of electromagnetic systems EM wave propagation In general, open problems with a computation domain extending (in theory) to infinity not bounded

More information

Course Requirements. Course Mechanics. Projects & Exams. Homework. Week 1. Introduction. Fast Multipole Methods: Fundamentals & Applications

Course Requirements. Course Mechanics. Projects & Exams. Homework. Week 1. Introduction. Fast Multipole Methods: Fundamentals & Applications Week 1. Introduction. Fast Multipole Methods: Fundamentals & Applications Ramani Duraiswami Nail A. Gumerov What are multipole methods and what is this course about. Problems from phsics, mathematics,

More information

Fast iterative BEM for high-frequency scattering

Fast iterative BEM for high-frequency scattering Fast iterative BEM for high-frequency scattering elastodynamic problems In 3D. Marion Darbas LAMFA UMR CNRS 7352, Amiens, France S. Chaillat (POEMS, CNRS-INRIA-ENSTA) and F. Le Louër (LMAC, UTC) Conference

More information

On complex shifted Laplace preconditioners for the vector Helmholtz equation

On complex shifted Laplace preconditioners for the vector Helmholtz equation On complex shifted Laplace preconditioners for the vector Helmholtz equation C. Vuik, Y.A. Erlangga, M.B. van Gijzen, C.W. Oosterlee, D. van der Heul Delft Institute of Applied Mathematics c.vuik@tudelft.nl

More information

c 2007 Society for Industrial and Applied Mathematics

c 2007 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 9, No. 3, pp. 07 6 c 007 Society for Industrial and Applied Mathematics NUMERICAL QUADRATURES FOR SINGULAR AND HYPERSINGULAR INTEGRALS IN BOUNDARY ELEMENT METHODS MICHAEL CARLEY

More information

An eigenvalue method using multiple frequency data for inverse scattering problems

An eigenvalue method using multiple frequency data for inverse scattering problems An eigenvalue method using multiple frequency data for inverse scattering problems Jiguang Sun Abstract Dirichlet and transmission eigenvalues have important applications in qualitative methods in inverse

More information

Nested Krylov methods for shifted linear systems

Nested Krylov methods for shifted linear systems Nested Krylov methods for shifted linear systems M. Baumann, and M. B. van Gizen Email: M.M.Baumann@tudelft.nl Delft Institute of Applied Mathematics Delft University of Technology Delft, The Netherlands

More information

WHEN studying distributed simulations of power systems,

WHEN studying distributed simulations of power systems, 1096 IEEE TRANSACTIONS ON POWER SYSTEMS, VOL 21, NO 3, AUGUST 2006 A Jacobian-Free Newton-GMRES(m) Method with Adaptive Preconditioner and Its Application for Power Flow Calculations Ying Chen and Chen

More information

BEM Methods for Acoustic and Vibroacoustic Problems in LS-DYNA

BEM Methods for Acoustic and Vibroacoustic Problems in LS-DYNA 12 th International LS-DYNA Users Conference Simulation(2) BEM Methods for Acoustic and Vibroacoustic Problems in LS-DYNA Mhamed Souli, Yun Huang, Rongfeng Liu Livermore Software Technology Corporation

More information

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

ON THE INFLUENCE OF THE WAVENUMBER ON COMPRESSION IN A WAVELET BOUNDARY ELEMENT METHOD FOR THE HELMHOLTZ EQUATION

ON THE INFLUENCE OF THE WAVENUMBER ON COMPRESSION IN A WAVELET BOUNDARY ELEMENT METHOD FOR THE HELMHOLTZ EQUATION INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 4, Number 1, Pages 48 62 c 2007 Institute for Scientific Computing and Information ON THE INFLUENCE OF THE WAVENUMBER ON COMPRESSION IN A

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

An explicit time-domain finite-element method for room acoustics simulation

An explicit time-domain finite-element method for room acoustics simulation An explicit time-domain finite-element method for room acoustics simulation Takeshi OKUZONO 1 ; Toru OTSURU 2 ; Kimihiro SAKAGAMI 3 1 Kobe University, JAPAN 2 Oita University, JAPAN 3 Kobe University,

More information

Finite and Boundary Element Methods in Acoustics

Finite and Boundary Element Methods in Acoustics Finite and Boundary Element Methods in Acoustics W. Kreuzer, Z. Chen, H. Waubke Austrian Academy of Sciences, Acoustics Research Institute ARI meets NuHAG Kreuzer, Chen, Waubke (ARI) FEM-BEM-FMM ARI meets

More information

New Developments of Frequency Domain Acoustic Methods in LS-DYNA

New Developments of Frequency Domain Acoustic Methods in LS-DYNA 11 th International LS-DYNA Users Conference Simulation (2) New Developments of Frequency Domain Acoustic Methods in LS-DYNA Yun Huang 1, Mhamed Souli 2, Rongfeng Liu 3 1 Livermore Software Technology

More information

Series Solution of Linear Ordinary Differential Equations

Series Solution of Linear Ordinary Differential Equations Series Solution of Linear Ordinary Differential Equations Department of Mathematics IIT Guwahati Aim: To study methods for determining series expansions for solutions to linear ODE with variable coefficients.

More information

A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY MATCHED LAYER

A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY MATCHED LAYER European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 16-02 The Induced Dimension Reduction method applied to convection-diffusion-reaction problems R. Astudillo and M. B. van Gijzen ISSN 1389-6520 Reports of the Delft

More information

Simulation of Acoustic and Vibro-Acoustic Problems in LS-DYNA using Boundary Element Method

Simulation of Acoustic and Vibro-Acoustic Problems in LS-DYNA using Boundary Element Method 10 th International LS-DYNA Users Conference Simulation Technolog (2) Simulation of Acoustic and Vibro-Acoustic Problems in LS-DYNA using Boundar Element Method Yun Huang Livermore Software Technolog Corporation

More information

Green s Functions, Boundary Integral Equations and Rotational Symmetry

Green s Functions, Boundary Integral Equations and Rotational Symmetry Green s Functions, Boundary Integral Equations and Rotational Symmetry...or, How to Construct a Fast Solver for Stokes Equation Saibal De Advisor: Shravan Veerapaneni University of Michigan, Ann Arbor

More information

FastMMLib: a generic Fast Multipole Method library. Eric DARRIGRAND. IRMAR Université de Rennes 1

FastMMLib: a generic Fast Multipole Method library. Eric DARRIGRAND. IRMAR Université de Rennes 1 FastMMLib: a generic Fast Multipole Method library Eric DARRIGRAND joint work with Yvon LAFRANCHE IRMAR Université de Rennes 1 Outline Introduction to FMM Historically SVD principle A first example of

More information

On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption

On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption Ivan Graham and Euan Spence (Bath, UK) Collaborations with: Paul Childs (Emerson Roxar,

More information

A Fast Regularized Boundary Integral Method for Practical Acoustic Problems

A Fast Regularized Boundary Integral Method for Practical Acoustic Problems Copyright 2013 Tech Science Press CMES, vol.91, no.6, pp.463-484, 2013 A Fast Regularized Boundary Integral Method for Practical Acoustic Problems Z.Y. Qian, Z.D. Han 1, and S.N. Atluri 1,2 Abstract: To

More information

Numerical computation of the Green s function for two-dimensional finite-size photonic crystals of infinite length

Numerical computation of the Green s function for two-dimensional finite-size photonic crystals of infinite length Numerical computation of the Green s function for two-dimensional finite-size photonic crystals of infinite length F.Seydou 1,Omar M.Ramahi 2,Ramani Duraiswami 3 and T.Seppänen 1 1 University of Oulu,

More information

THE solution to electromagnetic wave interaction with material

THE solution to electromagnetic wave interaction with material IEEE TRANSACTIONS ON ANTENNAS AND PROPAGATION, VOL. 52, NO. 9, SEPTEMBER 2004 2277 Sparse Inverse Preconditioning of Multilevel Fast Multipole Algorithm for Hybrid Integral Equations in Electromagnetics

More information

Fast Structured Spectral Methods

Fast Structured Spectral Methods Spectral methods HSS structures Fast algorithms Conclusion Fast Structured Spectral Methods Yingwei Wang Department of Mathematics, Purdue University Joint work with Prof Jie Shen and Prof Jianlin Xia

More information

Solving Time-Harmonic Scattering Problems by the Ultra Weak Variational Formulation

Solving Time-Harmonic Scattering Problems by the Ultra Weak Variational Formulation Introduction Solving Time-Harmonic Scattering Problems by the Ultra Weak Variational Formulation Plane waves as basis functions Peter Monk 1 Tomi Huttunen 2 1 Department of Mathematical Sciences University

More information

USAGE OF NUMERICAL METHODS FOR ELECTROMAGNETIC SHIELDS OPTIMIZATION

USAGE OF NUMERICAL METHODS FOR ELECTROMAGNETIC SHIELDS OPTIMIZATION October 4-6, 2007 - Chiinu, Rep.Moldova USAGE OF NUMERICAL METHODS FOR ELECTROMAGNETIC SHIELDS OPTIMIZATION Ionu- P. NICA, Valeriu Gh. DAVID, /tefan URSACHE Gh. Asachi Technical University Iai, Faculty

More information

Error analysis and fast solvers for high-frequency scattering problems

Error analysis and fast solvers for high-frequency scattering problems Error analysis and fast solvers for high-frequency scattering problems I.G. Graham (University of Bath) Woudschoten October 2014 High freq. problem for the Helmholtz equation Given an object Ω R d, with

More information

arxiv: v2 [math.na] 1 Oct 2016

arxiv: v2 [math.na] 1 Oct 2016 Inexact Krylov iterations and relaxation strategies with fast-multipole boundary element method Tingyu Wang a, Simon K. Layton b,c,1, Lorena A. Barba a a Department of Mechanical and Aerospace Engineering,

More information

Spherical harmonics based aggregation in the multilevel fast multipole algorithm

Spherical harmonics based aggregation in the multilevel fast multipole algorithm Nationaal Lucht- en Ruimtevaartlaboratorium National Aerospace Laboratory NLR NLR-TR-NLR-TR-2015-218 pherical harmonics based aggregation in the multilevel fast multipole algorithm Mc Thesis. Hack No part

More information

Iterative solution of high-order boundary element method for acoustic impedance boundary value problems

Iterative solution of high-order boundary element method for acoustic impedance boundary value problems ARTICLE IN PRE Journal of ound and Vibration 291 (2006) 824 843 JOURNAL OF OUND AND VIBRATION www.elsevier.com/locate/jsvi Iterative solution of high-order boundary element method for acoustic impedance

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Mathematics and Computer Science

Mathematics and Computer Science Technical Report TR-2007-002 Block preconditioning for saddle point systems with indefinite (1,1) block by Michele Benzi, Jia Liu Mathematics and Computer Science EMORY UNIVERSITY International Journal

More information

The solution of the discretized incompressible Navier-Stokes equations with iterative methods

The solution of the discretized incompressible Navier-Stokes equations with iterative methods The solution of the discretized incompressible Navier-Stokes equations with iterative methods Report 93-54 C. Vuik Technische Universiteit Delft Delft University of Technology Faculteit der Technische

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

Computing the Acoustic Field of a Radiating Cavity by the Boundary Element - Rayleigh Integral Method (BERIM)

Computing the Acoustic Field of a Radiating Cavity by the Boundary Element - Rayleigh Integral Method (BERIM) Computing the Acoustic Field of a Radiating Cavity by the Boundary Element - Rayleigh Integral Method (BERIM) Stephen Kirkup and Ambrose Thompson Abstract This paper describes the Fortran subroutine BERIM3

More information

THE IMPEDANCE SCATTERING PROBLEM FOR A POINT-SOURCE FIELD. THE SMALL RESISTIVE SPHERE

THE IMPEDANCE SCATTERING PROBLEM FOR A POINT-SOURCE FIELD. THE SMALL RESISTIVE SPHERE THE IMPEDANCE SCATTERING PROBLEM FOR A POINT-SOURCE FIELD. THE SMALL RESISTIVE SPHERE By GEORGE DASSIOS (Division of Applied Mathematics, Department of Chemical Engineering, University of Patras, Greece)

More information

High Frequency Scattering by Convex Polygons Stephen Langdon

High Frequency Scattering by Convex Polygons Stephen Langdon Bath, October 28th 2005 1 High Frequency Scattering by Convex Polygons Stephen Langdon University of Reading, UK Joint work with: Simon Chandler-Wilde Steve Arden Funded by: Leverhulme Trust University

More information

A fast and well-conditioned spectral method: The US method

A fast and well-conditioned spectral method: The US method A fast and well-conditioned spectral method: The US method Alex Townsend University of Oxford Leslie Fox Prize, 24th of June 23 Partially based on: S. Olver & T., A fast and well-conditioned spectral method,

More information

Spectral analysis of complex shifted-laplace preconditioners for the Helmholtz equation

Spectral analysis of complex shifted-laplace preconditioners for the Helmholtz equation Spectral analysis of complex shifted-laplace preconditioners for the Helmholtz equation C. Vuik, Y.A. Erlangga, M.B. van Gijzen, and C.W. Oosterlee Delft Institute of Applied Mathematics c.vuik@tudelft.nl

More information

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 1 SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 2 OUTLINE Sparse matrix storage format Basic factorization

More information

A Solenoidal Basis Method For Efficient Inductance Extraction Λ

A Solenoidal Basis Method For Efficient Inductance Extraction Λ A Solenoidal Basis Method For Efficient Inductance Extraction Λ Hemant Mahawar Department of Computer Science Texas A&M University College Station, TX 77843 mahawarh@cs.tamu.edu Vivek Sarin Department

More information

BOUNDARY ELEMENT METHOD IN REFRACTIVE MEDIA

BOUNDARY ELEMENT METHOD IN REFRACTIVE MEDIA BOUDARY ELEMET METHOD I REFRACTIVE MEDIA David R. Bergman Exact Solution Scientific Consulting LLC, Morristown J, USA email: davidrbergman@essc-llc.com Boundary Element Method (BEM), an application of

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

M.A. Botchev. September 5, 2014

M.A. Botchev. September 5, 2014 Rome-Moscow school of Matrix Methods and Applied Linear Algebra 2014 A short introduction to Krylov subspaces for linear systems, matrix functions and inexact Newton methods. Plan and exercises. M.A. Botchev

More information

A STUDY OF FAST MULTIPOLE METHOD ON THE ANALYSIS OF 2D BARRIER

A STUDY OF FAST MULTIPOLE METHOD ON THE ANALYSIS OF 2D BARRIER A STUDY OF FAST ULTIPOLE ETHOD ON THE ANALYSIS OF D BARRIER C.-H. Wu * C.-N. Wang ** Department of Engineering Science and Ocean Engineering National Taiwan University Taipei Taiwan 67 R.O.C. T.-D. Wu

More information

Domain decomposition on different levels of the Jacobi-Davidson method

Domain decomposition on different levels of the Jacobi-Davidson method hapter 5 Domain decomposition on different levels of the Jacobi-Davidson method Abstract Most computational work of Jacobi-Davidson [46], an iterative method suitable for computing solutions of large dimensional

More information

A Crash Course on Fast Multipole Method (FMM)

A Crash Course on Fast Multipole Method (FMM) A Crash Course on Fast Multipole Method (FMM) Hanliang Guo Kanso Biodynamical System Lab, 2018 April What is FMM? A fast algorithm to study N body interactions (Gravitational, Coulombic interactions )

More information

Hybrid Cross Approximation for the Electric Field Integral Equation

Hybrid Cross Approximation for the Electric Field Integral Equation Progress In Electromagnetics Research M, Vol. 75, 79 90, 2018 Hybrid Cross Approximation for the Electric Field Integral Equation Priscillia Daquin, Ronan Perrussel, and Jean-René Poirier * Abstract The

More information

Solution of Kirchhoff's Time-Domain Integral Equation in Acoustics

Solution of Kirchhoff's Time-Domain Integral Equation in Acoustics Solution of Kirchhoff's Time-Domain Integral Equation in Acoustics Dr. George Benthien and Dr. Stephen Hobbs March 29, 2005 E-mail: george@gbenthien.net In this paper we will loo at the time-domain equivalent

More information

Journal of Computational Science and Technology

Journal of Computational Science and Technology Science and Technology Explicit Evaluation of Hypersingular Boundary Integral Equation for 3-D Helmholtz Equation Discretized with Constant Triangular Element Toshiro MATSUMOTO, Changjun ZHENG,, Shinya

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

Efficient boundary element analysis of periodic sound scatterers

Efficient boundary element analysis of periodic sound scatterers Boundary Element and Meshless Methods in Acoustics and Vibrations: Paper ICA2016-418 Efficient boundary element analysis of periodic sound scatterers M. Karimi, P. Croaker, N. Kessissoglou 1 School of

More information

High Frequency Scattering by Convex Polygons Stephen Langdon

High Frequency Scattering by Convex Polygons Stephen Langdon High Frequency Scattering by Convex Polygons Stephen Langdon University of Reading, UK Joint work with: Simon Chandler-Wilde, Steve Arden Funded by: Leverhulme Trust University of Maryland, September 2005

More information

9.1 Preconditioned Krylov Subspace Methods

9.1 Preconditioned Krylov Subspace Methods Chapter 9 PRECONDITIONING 9.1 Preconditioned Krylov Subspace Methods 9.2 Preconditioned Conjugate Gradient 9.3 Preconditioned Generalized Minimal Residual 9.4 Relaxation Method Preconditioners 9.5 Incomplete

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 14-1 Nested Krylov methods for shifted linear systems M. Baumann and M. B. van Gizen ISSN 1389-652 Reports of the Delft Institute of Applied Mathematics Delft 214

More information

A dual BIE approach for large-scale modelling of 3-D electrostatic problems with the fast multipole boundary element method

A dual BIE approach for large-scale modelling of 3-D electrostatic problems with the fast multipole boundary element method INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 2007; 71:837 855 Published online 5 February 2007 in Wiley InterScience (www.interscience.wiley.com)..2000 A dual BIE

More information

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Marcella Bonazzoli 2, Victorita Dolean 1,4, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier

More information

Analysis of thin acoustic barriers over an

Analysis of thin acoustic barriers over an Analysis of thin acoustic barriers over an impedance plane using a dual BEM formulation L.A. de Lacerda*\ L.C. Wrobel*, WJ. Mansur^ "Wessex Institute of Technology, Ashurst, Southampton, UK ^COPPE/URRJ,

More information

IDR(s) A family of simple and fast algorithms for solving large nonsymmetric systems of linear equations

IDR(s) A family of simple and fast algorithms for solving large nonsymmetric systems of linear equations IDR(s) A family of simple and fast algorithms for solving large nonsymmetric systems of linear equations Harrachov 2007 Peter Sonneveld en Martin van Gijzen August 24, 2007 1 Delft University of Technology

More information

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Sunyoung Bu University of North Carolina Department of Mathematics CB # 325, Chapel Hill USA agatha@email.unc.edu Jingfang

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

Iterative methods for Linear System

Iterative methods for Linear System Iterative methods for Linear System JASS 2009 Student: Rishi Patil Advisor: Prof. Thomas Huckle Outline Basics: Matrices and their properties Eigenvalues, Condition Number Iterative Methods Direct and

More information

Comparison of the Fast Multipole Method with Hierarchical Matrices for the Helmholtz-BEM

Comparison of the Fast Multipole Method with Hierarchical Matrices for the Helmholtz-BEM Copyright 2010 Tech Science Press CMES, vol.58, no.2, pp.131-158, 2010 Comparison of the Fast Multipole Method with Hierarchical Matrices for the Helmholtz-BEM D. Brunner 1, M. Junge 1, P. Rapp 1, M. Bebendorf

More information

Finite Element Method (FEM)

Finite Element Method (FEM) Finite Element Method (FEM) The finite element method (FEM) is the oldest numerical technique applied to engineering problems. FEM itself is not rigorous, but when combined with integral equation techniques

More information

ON A ROBUST ITERATIVE METHOD FOR HETEROGENEOUS HELMHOLTZ PROBLEMS FOR GEOPHYSICS APPLICATIONS

ON A ROBUST ITERATIVE METHOD FOR HETEROGENEOUS HELMHOLTZ PROBLEMS FOR GEOPHYSICS APPLICATIONS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 2, Supp, Pages 197 28 c 25 Institute for Scientific Computing and Information ON A ROBUST ITERATIVE METHOD FOR HETEROGENEOUS HELMHOLTZ PROBLEMS

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information