Numerical Libraries Solving Large-Scale Problems Developed At

Total Page:16

File Type:pdf, Size:1020Kb

Numerical Libraries Solving Large-Scale Problems Developed At Perspectives in Science (2016) 7, 140—150 Available online at www.sciencedirect.com ScienceDirect j ournal homepage: www.elsevier.com/pisc Numerical libraries solving large-scale problems developed at IT4Innovations Research Programme Supercomputing for Industryଝ a,b,∗ a,b a Michal Merta , Jan Zapletal , Tomas Brzobohaty , a a a Alexandros Markopoulos , Lubomir Riha , Martin Cermak , a,b a,b a,b Vaclav Hapla , David Horak , Lukas Pospisil , a,b Alena Vasatova a IT4Innovations National Supercomputing Center, 17. listopadu 15/2172, 708 00 Ostrava, Czech Republic b Department of Applied Mathematics VSB — Technical University of Ostrava, 17. listopadu 15/2172, 708 33 Ostrava, Czech Republic Received 26 October 2015; accepted 11 November 2015 Available online 15 December 2015 KEYWORDS Summary The team of Research Programme Supercomputing for Industry at IT4Innovations FETI; National Supercomputing Center is focused on development of highly scalable algorithms for TFETI; solution of linear and non-linear problems arising from different engineering applications. BEM; As a main parallelisation technique, domain decomposition methods (DDM) of FETI type are Domain used. These methods are combined with finite element (FEM) or boundary element (BEM) dis- decomposition; cretisation methods and quadratic programming (QP) algorithms. All these algorithms were Quadratic implemented into our in-house software packages BEM4I, ESPRESO and PERMON, which demon- programming; strate high scalability up to tens of thousands of cores. HPC © 2015 Published by Elsevier GmbH. This is an open access article under the CC BY-NC-ND license (http://creativecommons.org/licenses/by-nc-nd/4.0/). Introduction ଝ High performance of contemporary computers results from This article is part of a special issue entitled ‘‘Proceedings of an increasing number of compute nodes in clusters and num- the 1st Czech-China Scientific Conference 2015’’. ∗ ber of processor cores per node. While the current most Corresponding author at: IT4Innovations National Supercompu- ting Center, 17. listopadu 15/2172, 708 33 Ostrava, Czech Republic. powerful petascale or multi-petascale computers contain E-mail address: [email protected] (M. Merta). hundreds of thousands of CPU cores, the future exascale http://dx.doi.org/10.1016/j.pisc.2015.11.023 2213-0209/© 2015 Published by Elsevier GmbH. This is an open access article under the CC BY-NC-ND license (http://creativecommons.org/licenses/by-nc-nd/4.0/). Numerical libraries solving large-scale problems 141 systems will comprise millions of them. For efficient use of original FETI-1 method assumes that the boundary subdo- such systems, algorithms with high parallel scalability have mains inherit Dirichlet conditions from the original problem to be developed. where the conditions are embedded into the linear system Discretisation of most engineering problems describable arising from FEM. This means physically that subdomains by partial differential equations (PDE) leads to large sparse whose interfaces intersect the Dirichlet boundary are fixed linear systems of equations. However, problems that can be while others are kept floating; in the linear algebra speech, expressed as elliptic variational inequalities, such as those the corresponding subdomain stiffness matrices are non- describing the equilibrium of elastic bodies in mutual con- singular and singular, respectively. tact, lead to quadratic programming (QP) problems. The basic idea of the Total-FETI (TFETI) method (Dostál ˇ Finite element tearing and interconnecting (FETI) and et al., 2006, 2010; Cermák et al., 2015) is to keep all boundary element tearing and interconnecting (BETI) the subdomains floating and enforce the Dirichlet bound- (Langer and Steinbach, 2003; Of and Steinbach, 2009) meth- ary conditions by means of a constraint matrix and Lagrange ods form a successful subclass of domain decomposition multipliers, similarly to the gluing conditions along sub- methods (DDM). They belong to non-overlapping methods domain interfaces. This simplifies implementation of the and combine sparse iterative and direct solvers. FETI was stiffness matrix generalised inverse. The key point is that s s firstly introduced by Farhat and Roux (Farhat and Roux, kernels R of subdomain stiffness matrices K are known a 1991, 1992). The key ingredient of the FETI method is the priori, have the same dimension and can be formed with- decomposition of the spatial domain into non-overlapping out any computation from the mesh data, so that R matrix subdomains that are ‘‘glued together’’ by Lagrange multipli- (Im R = Ker K) possess also nice block-diagonal layout. Fur- ers. Elimination of the primal variables reduces the original thermore, each local stiffness matrix can be regularised linear problem to a smaller, relatively well conditioned, cheaply, and the inverse of the resulting nonsingular matrix equality constrained QP. If the FETI procedure is applied to a is at the same time a generalised inverse of the original contact problem (Dostál et al. 1998, 2000, 2005, 2010, 2012; singular one (Dostál et al., 2011; Brzobohat´y et al., 2011). Dostál and Horák, 2004), the resulting QP has additional FETI methods use the Lagrange multipliers to enforce bound constraints. FETI methods allow highly accurate com- both equality and inequality constraints (gluing and nonpen- putations scaling up to tens of thousands of processors. etration conditions) in the original primal problem Our team was successful in adapting FETI approach for contact problems and designed new variants. One of them 1 uT T min Ku − u f s.t. BE u = o and BIu ≤ cI. is Total-FETI (TFETI) developed by Dostal et al. (Dostál et al., 2 ˇ 2006, 2010; Kruis et al., 2002; Cermák et al., 2015) which uses Lagrange multipliers to enforce Dirichlet boundary con- The primal problem is then transformed using duality into ditions. This enables a simpler building of the stiffness significantly smaller and better conditioned dual problem matrix kernel, as all subdomains are floating and associ- with equality constraint and nonnegativity bound ated subdomain stiffness matrices have the same kernel, obtained without any computation. Hybrid-TFETI (HTFETI) 1 T F T min − d s.t. G = e, I ≤ o reduces coarse problem (CP) size by aggregating the subdo- 2 mains into clusters, i.e. TFETI is applied twice. Resulting QP problems can be then solved by means of with efficient MPRGP and SMALBE algorithms designed again by + T T T + T Dostal et al. (Dostál et al., 2003; Dostál and Schöberl, 2005; F = BK B , G = R B , d = BK f, e = R f. Dostál, 2009) with known rate of convergence given by spec- tral properties of the solved system. After homogenisation using particular solution − We develop several software packages dealing with FETI: T T 1 T ˜ = G (GG ) e, while = ˆ + ˜, ˆ ∈ Ker G, ˜ ∈ Im G PERMON based on PETSc and ESPRESO based on Intel MKL and enforcing homogenised equality constraint by means and Cilk. The BEM4I library implements BEM discretisation, − T T 1 − Q = G GG G and together with the other two packages the BETI method. of projector P = I Q on Ker G, where ( ) is T The paper is organised as follows. After introduction, we projector to Im G , SMALSE algorithm can be applied to the describe the main principles of FETI and BETI methods. Then problem the particular libraries and their modules are introduced with the achieved highlights from various areas. 1 T T min ˆ PFPˆ − ˆ P(d − F˜) s.t Gˆ = o, ˆI ≥ −˜I. 2 Numerical methods For this dual problem the classical estimate of the spec- tral condition number is valid, i.e. Ä(PFP|Im P) ≤ C(H/h), FETI methods with H denoting the decomposition and h the discretisation parameter. Natural effort using the massively parallel com- FETI-1 (Farhat and Roux, 1991, 1992; Farhat et al., 1994; puters is to maximise the number of subdomains (decrease Kruis, 2006) is a non-overlapping DDM (Gosselet and Rey, H) so that sizes of subdomain stiffness matrices are reduced 2006) which is based on decomposing the original spatial which accelerates not only their factorisation and subse- domain into non-overlapping subdomains. They are ‘‘glued quent generalised inverse application but also improves together’’ by Lagrange multipliers which have to satisfy cer- conditioning and reduces the number of iterations. Negative tain equality constraints which will be discussed later. The effect of that is increase of dual and null space dimensions, 142 M. Merta et al. 1 which decelerate the coarse problem (CP) solution, i.e. solu- D0 1 ∗ 1 u = u − K u ∈ ∂ T ( )(x) (x) ( )(x)for x (1) tion of the system GG x = y, so that the bottleneck of the 2 TFETI method is the application of the projector dominating ∗ with V, K, K , and D denoting the single-layer, double-layer, the solution time. adjoint double-layer, and hypersigular boundary integral operators, respectively. The Galerkin discretisation of the Hybrid FETI method single-layer operator equation (1) leads to the system of linear equations Although there are several efficient coarse problem paral- lelisation strategies (Hapla and Horák, 2012; Kozubek et al., 1 = + u 2012, 2013), still there are size limitations of the coarse Vt M K 2 problem. So several hybrid (multilevel) methods were pro- posed (Lee, 2009; Klawonn and Rheinbach, 2010). The key idea is to aggregate small number of neighbouring sub- with the boundary element matrices domains into clusters (see Fig. 1), which naturally results into the smaller coarse problem. In our HTFETI, the aggre- V[k, ] := v(x, y) dsy dsx K[k, j] gation of subdomains into the clusters is enforced again k by Lagrange multipliers. Thus TFETI method is used on ∂v = : (x, y)ϕj(y) dsy dsx both cluster and subdomain levels. This approach simpli- ∂ k ∂ ny fies implementation of hybrid FETI methods and enables to extend parallelisation of the original problem up to tens of and the sparse identity matrix M. thousands of cores due to lower memory requirements.
Recommended publications
  • Coupling Finite and Boundary Element Methods for Static and Dynamic
    Comput. Methods Appl. Mech. Engrg. 198 (2008) 449–458 Contents lists available at ScienceDirect Comput. Methods Appl. Mech. Engrg. journal homepage: www.elsevier.com/locate/cma Coupling finite and boundary element methods for static and dynamic elastic problems with non-conforming interfaces Thomas Rüberg a, Martin Schanz b,* a Graz University of Technology, Institute for Structural Analysis, Graz, Austria b Graz University of Technology, Institute of Applied Mechanics, Technikerstr. 4, 8010 Graz, Austria article info abstract Article history: A coupling algorithm is presented, which allows for the flexible use of finite and boundary element meth- Received 1 February 2008 ods as local discretization methods. On the subdomain level, Dirichlet-to-Neumann maps are realized by Received in revised form 4 August 2008 means of each discretization method. Such maps are common for the treatment of static problems and Accepted 26 August 2008 are here transferred to dynamic problems. This is realized based on the similarity of the structure of Available online 5 September 2008 the systems of equations obtained after discretization in space and time. The global set of equations is then established by incorporating the interface conditions in a weighted sense by means of Lagrange Keywords: multipliers. Therefore, the interface continuity condition is relaxed and the interface meshes can be FEM–BEM coupling non-conforming. The field of application are problems from elastostatics and elastodynamics. Linear elastodynamics Ó Non-conforming interfaces 2008 Elsevier B.V. All rights reserved. FETI/BETI 1. Introduction main, this approach is often carried out only once for every time step which gives a staggering scheme.
    [Show full text]
  • On Multigrid Methods for Solving Electromagnetic Scattering Problems
    On Multigrid Methods for Solving Electromagnetic Scattering Problems Dissertation zur Erlangung des akademischen Grades eines Doktor der Ingenieurwissenschaften (Dr.-Ing.) der Technischen Fakultat¨ der Christian-Albrechts-Universitat¨ zu Kiel vorgelegt von Simona Gheorghe 2005 1. Gutachter: Prof. Dr.-Ing. L. Klinkenbusch 2. Gutachter: Prof. Dr. U. van Rienen Datum der mundliche¨ Prufung:¨ 20. Jan. 2006 Contents 1 Introductory remarks 3 1.1 General introduction . 3 1.2 Maxwell’s equations . 6 1.3 Boundary conditions . 7 1.3.1 Sommerfeld’s radiation condition . 9 1.4 Scattering problem (Model Problem I) . 10 1.5 Discontinuity in a parallel-plate waveguide (Model Problem II) . 11 1.6 Absorbing-boundary conditions . 12 1.6.1 Global radiation conditions . 13 1.6.2 Local radiation conditions . 18 1.7 Summary . 19 2 Coupling of FEM-BEM 21 2.1 Introduction . 21 2.2 Finite element formulation . 21 2.2.1 Discretization . 26 2.3 Boundary-element formulation . 28 3 4 CONTENTS 2.4 Coupling . 32 3 Iterative solvers for sparse matrices 35 3.1 Introduction . 35 3.2 Classical iterative methods . 36 3.3 Krylov subspace methods . 37 3.3.1 General projection methods . 37 3.3.2 Krylov subspace methods . 39 3.4 Preconditioning . 40 3.4.1 Matrix-based preconditioners . 41 3.4.2 Operator-based preconditioners . 42 3.5 Multigrid . 43 3.5.1 Full Multigrid . 47 4 Numerical results 49 4.1 Coupling between FEM and local/global boundary conditions . 49 4.1.1 Model problem I . 50 4.1.2 Model problem II . 63 4.2 Multigrid . 64 4.2.1 Theoretical considerations regarding the classical multi- grid behavior in the case of an indefinite problem .
    [Show full text]
  • Coupling of the Finite Volume Element Method and the Boundary Element Method – an a Priori Convergence Result
    COUPLING OF THE FINITE VOLUME ELEMENT METHOD AND THE BOUNDARY ELEMENT METHOD – AN A PRIORI CONVERGENCE RESULT CHRISTOPH ERATH∗ Abstract. The coupling of the finite volume element method and the boundary element method is an interesting approach to simulate a coupled system of a diffusion convection reaction process in an interior domain and a diffusion process in the corresponding unbounded exterior domain. This discrete system maintains naturally local conservation and a possible weighted upwind scheme guarantees the stability of the discrete system also for convection dominated problems. We show existence and uniqueness of the continuous system with appropriate transmission conditions on the coupling boundary, provide a convergence and an a priori analysis in an energy (semi-) norm, and an existence and an uniqueness result for the discrete system. All results are also valid for the upwind version. Numerical experiments show that our coupling is an efficient method for the numerical treatment of transmission problems, which can be also convection dominated. Key words. finite volume element method, boundary element method, coupling, existence and uniqueness, convergence, a priori estimate 1. Introduction. The transport of a concentration in a fluid or the heat propa- gation in an interior domain often follows a diffusion convection reaction process. The influence of such a system to the corresponding unbounded exterior domain can be described by a homogeneous diffusion process. Such a coupled system is usually solved by a numerical scheme and therefore, a method which ensures local conservation and stability with respect to the convection term is preferable. In the literature one can find various discretization schemes to solve similar prob- lems.
    [Show full text]
  • Uncertainties in the Solutions to Boundary Element
    UNCERTAINTIES IN THE SOLUTIONS TO BOUNDARY ELEMENT METHOD: AN INTERVAL APPROACH by BARTLOMIEJ FRANCISZEK ZALEWSKI Submitted in partial fulfillment of the requirements For the degree of Doctor of Philosophy Dissertation Adviser: Dr. Robert L. Mullen Department of Civil Engineering CASE WESTERN RESERVE UNIVERSITY August, 2008 CASE WESTERN RESERVE UNIVERSITY SCHOOL OF GRADUATE STUDIES We hereby approve the thesis/dissertation of ______________Bartlomiej Franciszek Zalewski______________ candidate for the Doctor of Philosophy degree *. (signed)_________________Robert L. Mullen________________ (chair of the committee) ______________Arthur A. Huckelbridge_______________ ______________Xiangwu (David) Zeng_______________ _________________Daniela Calvetti__________________ _________________Shad M. Sargand_________________ (date) _______4-30-2008________ *We also certify that written approval has been obtained for any proprietary material contained therein. With love I dedicate my Ph.D. dissertation to my parents. TABLE OF CONTENTS LIST OF TABLES ………………………………………………………………………. 5 LIST OF FIGURES ……………………………………………………………………… 6 ACKNOWLEDGEMENTS ………………………………………………………..…… 10 LIST OF SYMBOLS ……………………………………………………….……………11 ABSTRACT …………………………………………………………………………...... 13 CHAPTER I. INTRODUCTION ……………………………………………………………… 15 1.1 Background ………………………………………………...………… 15 1.2 Overview ……………………………………………..…………….… 20 1.3 Historical Background ………………………………………….……. 21 1.3.1 Historical Background of Boundary Element Method ……. 21 1.3.2 Historical Background of Interval
    [Show full text]
  • The Boundary Element Method in Acoustics
    The Boundary Element Method in Acoustics by Stephen Kirkup 1998/2007 . The Boundary Element Method in Acoustics by S. M. Kirkup First edition published in 1998 by Integrated Sound Software and is published in 2007 in electronic format (corrections and minor amendments on the 1998 print). Information on this and related publications and software (including the second edi- tion of this work, when complete) can be obtained from the web site http://www.boundary-element-method.com The author’s publications can generally be found through the web page http://www.kirkup.info/papers The nine subroutines and the corresponding nine example test programs are available in Fortran 77 on CD ABEMFULL. The original core routines can be downloaded from the web site. The learning package of subroutines ABEM2D is can be downloaded from the web site. See the web site for a full price list and alternative methods of obtaining the software. ISBN 0 953 4031 06 The work is subject to copyright. All rights are reserved, whether the whole or part of the material is concerned, specifically the rights of translation, reprinting, reuse of illustrations, recitation, broadcasting, reproduction on microfilm or in any other way, and storage in data banks. Duplication of this publication or parts thereof is subject to the permission of the author. c Stephen Kirkup 1998-2007. Preface to 2007 Print Having run out of hard copies of the book a number of years ago, the author is pleased to publish an on-line version of the book in PDF format. A number of minor corrections have been made to the original, following feedback from a number of readers.
    [Show full text]
  • A Boundary-Spheropolygon Element Method for Modelling Sub-Particle Stress and Particle Breakage
    A Boundary-Spheropolygon Element Method for Modelling Sub-particle Stress and Particle Breakage YUPENG JIANG1, HANS J. HERRMANN2, FERNANDO ALONSO-MARROQUIN*1, 1. School of Civil Engineering, The University of Sydney, Australia 2. Computational Physics for Engineering Materials, ETH Zurich, Switzerland Abstract: We present a boundary-spheropolygon element method that combines the boundary element method (BEM) and the spheropolygon-based discrete element method (SDEM). The interaction between particles is simulated via the SDEM, and the sub-particle stress is calculated by BEM. The framework of BSEM is presented. Then, the accuracy and efficiency of the method are analysed by comparison with both analytical solutions and a well-established finite element method. The results demonstrate that BSEM can efficiently provide instant sub-particle stress for particles with an optimized compromise between computational time and accuracy, thus overcoming most of the disadvantages of existing numerical methods. Keywords: Boundary-Spheropolygon element method; Particle stress state; Particle breakage; Numerical simulation 1. Introduction Particle breakage is ubiquitous for granular materials. Breakage is caused by many reasons, such as strong compressive loading, large shear displacement, extreme temperature, dehydration or chemical effects. Based on laboratory studies, it is concluded that breakage causes changes in particle size distribution [1-4] and particle shape [5,6], which in turn change the state variables, such as density and compressibility, that govern the mechanical behaviour of the bulk granular material. These studies have provided a framework for studying particle breakage. However, due to the limitations in experimental observations, laboratory studies are not able to offer more detailed information about the breakage process.
    [Show full text]
  • Optimal Additive Schwarz Preconditioning for Adaptive 2D IGA
    OPTIMAL ADDITIVE SCHWARZ PRECONDITIONING FOR ADAPTIVE 2D IGA BOUNDARY ELEMENT METHODS THOMAS FUHRER,¨ GREGOR GANTNER, DIRK PRAETORIUS, AND STEFAN SCHIMANKO Abstract. We define and analyze (local) multilevel diagonal preconditioners for isogeo- metric boundary elements on locally refined meshes in two dimensions. Hypersingular and weakly-singular integral equations are considered. We prove that the condition number of the preconditioned systems of linear equations is independent of the mesh-size and the re- finement level. Therefore, the computational complexity, when using appropriate iterative solvers, is optimal. Our analysis is carried out for closed and open boundaries and numerical examples confirm our theoretical results. 1. Introduction In the last decade, the isogeometric analysis (IGA) had a strong impact on the field of scientific computing and numerical analysis. We refer, e.g., to the pioneering work [HCB05] and to [CHB09, BdVBSV14] for an introduction to the field. The basic idea is to utilize the same ansatz functions for approximations as are used for the description of the geometry by some computer aided design (CAD) program. Here, we consider the case, where the geometry is represented by rational splines. For certain problems, where the fundamental solution is known, the boundary element method (BEM) is attractive since CAD programs usually only provide a parametrization of the boundary ∂Ω and not of the volume Ω itself. Isogeometric BEM (IGABEM) has first been considered for 2D BEM in [PGK+09] and for 3D BEM in [SSE+13]. We refer to [SBTR12, PTC13, SBLT13, NZW+17] for numerical experiments, to [HR10, TM12, MZBF15, DHP16, DHK+18, DKSW18] for fast IGABEM based on wavelets, fast multipole, -matrices resp.
    [Show full text]
  • Numerical Analysis of Heat Conduction and Potential Flow Problems Over a Sphere and a 3- Dimensional Prolate Spheroidal Body
    ISTANBUL TECHNICAL UNIVERSITY INSTITUTE OF SCIENCE AND TECHNOLOGY NUMERICAL ANALYSIS OF HEAT CONDUCTION AND POTENTIAL FLOW PROBLEMS OVER A SPHERE AND A 3- DIMENSIONAL PROLATE SPHEROIDAL BODY M.Sc. Thesis by Onur ÖLMEZ, B.Sc. Department: Ocean Engineering Programme: Ocean Engineering Supervisor : Assist. Prof. Şafak Nur Ertürk JUNE 2008 ISTANBUL TECHNICAL UNIVERSITY INSTITUTE OF SCIENCE AND TECHNOLOGY NUMERICAL ANALYSIS OF HEAT CONDUCTION AND POTENTIAL FLOW PROBLEMS OVER A SPHERE AND A 3- DIMENSIONAL PROLATE SPHEROIDAL BODY M.Sc. Thesis by Onur ÖLMEZ, B.Sc. (508051107) Date of submission : 21 April 2008 Date of defence examination: 10 June 2008 Supervisor (Chairman): Assist. Prof. Şafak Nur ERTÜRK (I.T.U) Members of the Examining Committee: Prof. Dr. Ömer GÖREN (I.T.U) Prof. Dr. Serdar BEJ İ (I.T.U) JUNE 2008 İSTANBUL TEKN İK ÜN İVERS İTES İ FEN B İLİMLER İ ENSTİTÜSÜ KÜRESEL VE 3 BOYUTLU PROLAT KÜRESEL GÖVDE ÇEVRES İNDE ISI TRANSFER İ VE POTANS İYEL AKI Ş PROBLEMLER İNİN NUMER İK ANAL İZİ YÜKSEK L İSANS TEZ İ Müh. Onur ÖLMEZ (508051107) Tezin Enstitüye Verildi ği Tarih : 21 Nisan 2008 Tezin Savunuldu ğu Tarih : 10 Haziran 2008 Tez Danı şmanı : Yrd. Doç. Dr. Şafak Nur ERTÜRK ( İ.T.Ü.) Di ğer Jüri Üyeleri: Prof. Dr. Ömer GÖREN ( İ.T.Ü.) Prof. Dr. Serdar BEJ İ ( İ.T.Ü.) HAZ İRAN 2008 ACKNOWLEDGEMENTS I would like to thank to my advisor Assist. Prof. Şafak Nur ERTÜRK who supported me to complete this study and illuminated me whenever I encountered with problems. I would also wish to thank to my friends for sophisticated discussions.
    [Show full text]
  • A Coupled Level Set–Boundary Integral Method for Moving Boundary Simulations
    Interfaces and Free Boundaries 7 (2005), 1–26 A coupled level set–boundary integral method for moving boundary simulations M. GARZON† Department of Applied Mathematics, University of Oviedo, Oviedo, Spain D. ADALSTEINSSON‡ Department of Mathematics, University of North Carolina, Chapel Hill, NC, USA L. GRAY§ Computer Science and Mathematics Division, Oak Ridge National Laboratory AND J. A. SETHIAN¶ Department of Mathematics, University of California, Berkeley, and Mathematics Department, Lawrence Berkeley National Laboratory, Berkeley, CA, USA [Received 27 September 2004 and in revised form 12 February 2005] A numerical method for moving boundary problems based upon level set and boundary integral formulations is presented. The interface velocity is obtained from the boundary integral solution using a Galerkin technique for post-processing function gradients on the interface. We introduce a new level set technique for propagating free boundary values in time, and couple this to a narrow band level set method. Together, they allow us to both update the function values and the location of the interface. The methods are discussed in the context of the well-studied two-dimensional nonlinear potential flow model of breaking waves over a sloping beach. The numerical results show wave breaking and rollup, and the algorithm is verified by means of convergence studies and comparisons with previous techniques. 1. Introduction and overview In this paper, we develop an algorithm for solving moving boundary problems. Our approach is based on a combined level set method and boundary integral method, allowing us to handle topological changes while maintaining the highly accurate aspects of boundary integral formulations. There are many scientific and engineering areas where this capability is expected to be important, such as free surface flows [12] and electrostatically driven flows [24, 36].
    [Show full text]
  • A Non-Standard Finite Element Method Using Boundary Integral Operators
    JOHANNES KEPLER UNIVERSITAT¨ LINZ JKU Technisch-Naturwissenschaftliche Fakult¨at A Non-standard Finite Element Method using Boundary Integral Operators DISSERTATION zur Erlangung des akademischen Grades Doktor im Doktoratsstudium der Technischen Wissenschaften Eingereicht von: DI Clemens Hofreither Angefertigt am: Doktoratskolleg Computational Mathematics Beurteilung: O.Univ.-Prof. Dipl.-Ing. Dr. Ulrich Langer (Betreuung) Prof. Dr. Sergej Rjasanow Linz, Oktober, 2012 Acknowledgments This thesis was created during my employment at the Doctoral Program “Computational Mathematics” (W1214) at the Johannes Kepler University in Linz. First of all I would like to thank my advisor, Prof. Ulrich Langer, for interesting me in the research topic treated in this thesis, for giving me the chance to work on it within the framework of the Doctoral Program, and for his guidance and advice during my work on the thesis. Even before, during my graduate studies and supervising my diploma thesis, he has taught me a lot and shaped my academic career in a significant way. Furthermore, I am very grateful to Clemens Pechstein for the countless hours he has invested in the past four years into discussions which have deepened my insight into many topics. Without him, many results of this thesis would not have been possible. I want to thank all the other past and present students at the Doctoral Program for creating a very pleasant environment in which to discuss and work, as well as for the friendships which have developed during my time at the Program, making this time not only a productive, but also a highly enjoyable one. Furthermore, the director of the Doctoral Program, Prof.
    [Show full text]
  • Application of the Boundary Element Method to Parabolic Type Equations
    1 APPLICATION OF THE BOUNDARY ELEMENT METHOD TO PARABOLIC TYPE EQUATIONS A THESIS SUBMITTED TO THE GRADUATE SCHOOL OF NATURAL AND APPLIED SCIENCES OF MIDDLE EAST TECHNICAL UNIVERSITY BY NURAY BOZKAYA IN PARTIAL FULFILLMENT OF THE REQUIREMENTS FOR THE DEGREE OF DOCTOR OF PHILOSOPHY IN MATHEMATICS JUNE 2010 Approval of the thesis: APPLICATION OF THE BOUNDARY ELEMENT METHOD TO PARABOLIC TYPE EQUATIONS submitted by NURAY BOZKAYA in partial fulfillment of the requirements for the degree of Doctor of Philosophy in Mathematics Department, Middle East Technical Uni- versity by, Prof. Dr. Canan Ozgen¨ Dean, Graduate School of Natural and Applied Sciences Prof. Dr. Zafer Nurlu Head of Department, Mathematics Prof. Dr. Munevver¨ Tezer-Sezgin Supervisor, Department of Mathematics, METU Examining Committee Members: Prof. Dr. Tanıl Ergenc¸ Mathematics Department, Atılım University Prof. Dr. Munevver¨ Tezer-Sezgin Mathematics Department, METU Assoc. Prof. Dr. Ismail˙ Aydın Civil Engineering, METU Assoc. Prof. Dr. Songul¨ Kaya Merdan Mathematics Department, METU Prof. Dr. Nevzat Guneri¨ Genc¸er Electrical and Electronics Engineering, METU Date: I hereby declare that all information in this document has been obtained and presented in accordance with academic rules and ethical conduct. I also declare that, as required by these rules and conduct, I have fully cited and referenced all material and results that are not original to this work. Name, Last Name: NURAY BOZKAYA Signature : iii ABSTRACT APPLICATION OF THE BOUNDARY ELEMENT METHOD TO PARABOLIC TYPE EQUATIONS Bozkaya, Nuray Ph.D., Department of Mathematics Supervisor : Prof. Dr. Munevver¨ Tezer-Sezgin June 2010, 165 pages In this thesis, the two-dimensional initial and boundary value problems governed by unsteady partial differential equations are solved by making use of boundary element techniques.
    [Show full text]
  • The Boundary Element Method
    2nd Reading April 23, 2013 16:39 WSPC/0219-8762 196-IJCM 1350037 International Journal of Computational Methods Vol. 10, No. 6 (2013) 1350037 (91 pages) c World Scientific Publishing Company DOI: 10.1142/S0219876213500370 THE BOUNDARY ELEMENT METHOD SUBRATA MUKHERJEE∗ Sibley School of Mechanical and Aerospace Engineering Kimball Hall, Cornell University Ithaca, NY 14853, USA [email protected] YIJUN LIU Department of Mechanical Engineering University of Cincinnati Cincinnati, OH 45221, USA Received 15 September 2010 Accepted 25 September 2011 Published 9 April 2013 The boundary element method (BEM), along with the finite element and finite difference methods, is commonly used to carry out numerical simulations in a wide variety of subjects in science and engineering. The BEM, rooted in classical mathematics of integral equations, started becoming a useful computational tool around 50 years ago. Many researchers have worked on computational aspects of this method during this time. This paper presents an overview of the BEM and related methods. It has three sec- tions. The first, relatively short section, presents the governing equations for classical applications of the BEM in potential theory, linear elasticity and acoustics. The second describes specialized applications in bodies with thin features including micro-electro- mechanical systems (MEMS). The final section addresses current research. It has three subsections that present the boundary contour, boundary node and fast multipole meth- ods (BCM, BNM and FMM), respectively. Several numerical examples are included in the second and third sections of this paper. Keywords: Boundary integral equation; boundary element method; boundary contour method; boundary node method; fast multipole method; potential theory; elasticity; acoustics.
    [Show full text]