Solving integral equations on non-smooth domains

Size: px
Start display at page:

Download "Solving integral equations on non-smooth domains"

Transcription

1 Solving integral equations on non-smooth domains Johan Helsing Lund University Talk at the IMA Hot Topics workshop, August 2-5, 2010 σ yy A B C σ yy

2 Acknowledgement The work presented in this talk has been supported by, inspired by, or carried out in cooperation with, among others: Michael Benedicks Björn Dahlberg Jonas Englund Leslie Greengard Bertil Gustafsson Robert V. Kohn Graeme Milton Nikoloz Muskhelishvili Rikard Ojala Gunnar Peters the Swedish Research Council the Knut and Alice Wallenberg Foundation

3 Just for fun: Stagnation in the GMRES Fredholm second kind integral equation with compact operator (I + K)x = b.

4 Just for fun: Stagnation in the GMRES Fredholm second kind integral equation with compact operator (I + K)x = b. After discretization (I + K)x = b.

5 Just for fun: Stagnation in the GMRES Fredholm second kind integral equation with compact operator After discretization (I + K)x = b. (I + K)x = b. Solve using GMRES with modified Gram-Schmidt. Feed Arnoldi process with {b,(i + K)q 1,(I + K)q 2,(I + K)q 3,...} to form orthonormal bases for Krylov subspaces. Textbook practice.

6 The result is: 10 0 GMRES for (I+K)x=b, Modified GS 10 5 Internal estimator True residual Orthogonality Relative residual Number of iterations

7 The result is: 10 0 GMRES for (I+K)x=b, Modified GS 10 5 Internal estimator True residual Orthogonality Relative residual Number of iterations Well known behavior. Is it a problem?

8 The result is: 10 0 GMRES for (I+K)x=b, Modified GS 10 5 Internal estimator True residual Orthogonality Relative residual Number of iterations Well known behavior. Is it a problem? If so, many fixes: Replace Gram-Schmidt with Householder, reverse order...

9 Empirical result: Simplest and best fix is to feed Arnoldi with rather than {b,kq 1,Kq 2,Kq 3,...} {b,(i + K)q 1,(I + K)q 2,(I + K)q 3,...}. Same Krylov subspaces. Less loss of precision. Even saves a few FLOPs!

10 The result is: 10 0 GMRES for (I+K)x=b, Modified GS, 2nd kind fix 10 5 Internal estimator True residual Orthogonality Relative residual Number of iterations

11 Comparison: 10 0 GMRES for (I+K)x=b, Modified GS Internal estimator True residual Orthogonality 10 0 GMRES for (I+K)x=b, Modified GS, 2nd kind fix Internal estimator True residual Orthogonality Relative residual Relative residual Number of iterations Number of iterations Advantage with 2nd kind fix Slightly better accuracy Slightly less work Need not worry about stopping criterion threshold Section 8 in JCP 227(5) pp (2008)

12 Interesting problems in planar elasticity Which material has the more interesting stress field? or

13 Interesting problems in planar elasticity Which material has the more interesting stress field? C ty B pr D a E y x 2h β F w or G A ty pr Figure: Smooth: JMPS (1998). Non-smooth: IJNME (2002)

14 Interesting problems in planar elasticity Which material has the more interesting stress field? C ty B pr D a E y x 2h β F w or G A ty pr Figure: Smooth: JMPS (1998). Non-smooth: IJNME (2002) If G-A is clamped and with a crack emanating from E, it is even more interesting: Corners. Mixed conditions. Triple-junctions.

15 Fredholm second kind integral equation with compact operator (I + K)x = b. on a smooth boundary open arcs or closed contours Convergence of stress field 80 GMRES iterations for full convergence (Estimated) relative error Number of iterations Number N of discretization points Number N of discretization points Figure: Convergence with mesh refinement for the elastic field in specimens with smooth interfaces and cracks. Better and better.

16 Essentially the same equation on a non-smooth boundary (I + K)x = b. The operator K is not compact. A fundamental difference Convergence of stress field 80 GMRES iterations for full convergence (Estimated) relative error Number of iterations Number N of discretization points Number N of discretization points Figure: Convergence with mesh refinement for the elastic field in specimens with non-smooth interfaces. First better then worse.

17 It this fundamental difference a problem? 10 0 Convergence of stress field 10 0 Convergence of stress field 80 GMRES iterations for full convergence 80 GMRES iterations for full convergence (Estimated) relative error (Estimated) relative error Number of iterations Number of iterations Number N of discretization points Number N of discretization points Number N of discretization points Number N of discretization points Yes, it is. Aggravated behavior in more complicated settings. Destroys the simulation of damage evolution.

18 Corners-B-gone A numerical method for corners, triple-junctions, quadruple-junctions, mixed problems... (I + K)x = b. (1)

19 Corners-B-gone A numerical method for corners, triple-junctions, quadruple-junctions, mixed problems... (I + K)x = b. (1) Assumptions: K is compact away from a finite number of boundary points γ j. b is piecewise smooth.

20 Corners-B-gone A numerical method for corners, triple-junctions, quadruple-junctions, mixed problems... (I + K)x = b. (1) Assumptions: K is compact away from a finite number of boundary points γ j. b is piecewise smooth. Let K(τ,z) denote the kernel of K. Split K(τ,z) into two functions K(τ,z) = K (τ,z) + K (τ,z), (2) where K (τ,z) is zero except for when τ and z simultaneously lie close to the same γ j. Then K (τ,z) is zero.

21 Corners-B-gone A numerical method for corners, triple-junctions, quadruple-junctions, mixed problems... (I + K)x = b. (1) Assumptions: K is compact away from a finite number of boundary points γ j. b is piecewise smooth. Let K(τ,z) denote the kernel of K. Split K(τ,z) into two functions K(τ,z) = K (τ,z) + K (τ,z), (2) where K (τ,z) is zero except for when τ and z simultaneously lie close to the same γ j. Then K (τ,z) is zero. The kernel split corresponds to an operator split K = K + K. K is a compact operator. After discretization on fine grid (I fin + K fin + K fin )x fin = b fin, (3)

22 GMRES stagnation control Interesting problems in planar elasticity Corners-B-gone Numerical Examples Figure: A coarse mesh with eight quadrature panels on a closed contour. A fine mesh of 14 panels is created by refinement near the corner nz = nz = Figure: Kfin = K fin + K fin nz =

23 Variable substitution (change of basis) x fin = (I fin + K fin ) 1 x fin (4) gives ( I fin + K fin (I fin + K fin ) 1) x fin = b fin. (5)

24 Variable substitution (change of basis) x fin = (I fin + K fin ) 1 x fin (4) gives ( I fin + K fin (I fin + K fin ) 1) x fin = b fin. (5) Here K fin (I fin + K fin ) 1 is a compact operator from a practical viewpoint x fin is piecewise smooth Neither b fin, nor x fin, nor K fin need a fine grid for resolution.

25 Introduce a prolongation operator P from the coarse grid to the fine grid and a restriction operator Q in the other direction QP = I (6)

26 Introduce a prolongation operator P from the coarse grid to the fine grid and a restriction operator Q in the other direction Then QP = I (6) b fin = Pb coa (7) x fin = P x coa (8) K fin = PK coap T W (9) Compare economy-size SVD. Here P W = W fin PW 1 coa and W contains quadrature weights on the diagonal.

27 Introduce a prolongation operator P from the coarse grid to the fine grid and a restriction operator Q in the other direction Then QP = I (6) b fin = Pb coa (7) x fin = P x coa (8) K fin = PK coap T W (9) Compare economy-size SVD. Here P W = W fin PWcoa 1 and W contains quadrature weights on the diagonal. Taken together ( ) I coa + K coap T W (I fin + K fin ) 1 P x coa = b coa. (10)

28 Introducing eq. (10) reads R = P T W (I fin + K fin ) 1 P, (11) (I coa + K coar) x coa = b coa. (12) We only need the fine grid for constructing the small (block) matrix R.

29 Introducing eq. (10) reads R = P T W (I fin + K fin ) 1 P, (11) (I coa + K coar) x coa = b coa. (12) We only need the fine grid for constructing the small (block) matrix R. The blocks of R can be constructed via an extremely fast recursion, i = 1,..., n, where step i inverts and compresses contributions to R involving the outermost quadrature panels on level i of a locally n-ply refined mesh.

30 Introducing eq. (10) reads R = P T W (I fin + K fin ) 1 P, (11) (I coa + K coar) x coa = b coa. (12) We only need the fine grid for constructing the small (block) matrix R. The blocks of R can be constructed via an extremely fast recursion, i = 1,..., n, where step i inverts and compresses contributions to R involving the outermost quadrature panels on level i of a locally n-ply refined mesh. From a practical viewpoint the corner difficulties are gone: JCP 227(20) pp (2008), IJSS 46(25/26) pp (2009), JCP 228(23) pp (2009).

31 The fast recursion R i = P T Wbc ( F{R 1 (i 1) } + I b + K b) 1 Pbc, i = 1,...,n. (13) part of coarse mesh i = 1 i = 2 refined n = 4 i = 3 Figure: Recursion on the refined mesh surrounding a corner.

32 Electrostatics: quadruple-junctions A unit cell with 10,000 squares whose conductivities vary between σ=0.001 and σ=1000. With discretization points, construction of R takes 20 minutes and iterative solution of (12) takes 14 minutes. The estimated relative error in σ eff is O(10 11 ).

33 Elastostatics: triple-junctions A perturbed honeycomb structure with 2475 grains. The coloring is based on the Young s modulus. The operator K is actually singular. Construction of R takes 40% of the total solution time. The estimated relative error in computed quantities is O(10 12 ).

34 Elastostatics: mixed boundary conditions Elasticity: Relative error of pointwise stress (max norm) Im{z} Re{z} 14 Traction and displacement prescribed at different boundary parts. The 10-logarithm of the relative error for σ xx + σ yy at 484,670 points in the computational domain is shown. The maximum pointwise error is The computing time is 24 seconds.

35 Singular integral equations on piecewise smooth curves σ yy A B C σ yy Stress intensity factors are computed for a 176-ply branched crack in an elastic plane. The estimated relative error is O(10 12 ). The computing times is less than 10 minutes.

On the polarizability and capacitance of the cube

On the polarizability and capacitance of the cube On the polarizability and capacitance of the cube Johan Helsing Lund University Double Seminar at CSC, May 10, 2012 Acknowledgement The work presented has in part been carried out in cooperation with or

More information

Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems

Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems z Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems Johan Helsing Lund University Talk at Integral equation methods: fast algorithms and applications, Banff,

More information

The effective conductivity of random checkerboards

The effective conductivity of random checkerboards The effective conductivity of random checkerboards Johan Helsing 1 Numerical Analysis, Centre for Mathematical Sciences, Lund University, Box 118, SE-221 00 LUND, Sweden Abstract An algorithm is presented

More information

Stress intensity factors for a crack in front of an inclusion

Stress intensity factors for a crack in front of an inclusion Stress intensity factors for a crack in front of an inclusion Johan Helsing Department of Solid Mechanics and NADA, Royal Institute of Technology, SE-100 44 Stockholm, Sweden Email: helsing@nada.kth.se,

More information

A robust and accurate solver of Laplace s equation with general boundary conditions on general domains in the plane. 1.

A robust and accurate solver of Laplace s equation with general boundary conditions on general domains in the plane. 1. A robust and accurate solver of Laplace s equation with general boundary conditions on general domains in the plane Rikard Ojala Numerical Analysis, Centre for Mathematical Sciences, Lund University, Box

More information

Fast and accurate numerical solution to an elastostatic problem involving ten thousand randomly oriented cracks

Fast and accurate numerical solution to an elastostatic problem involving ten thousand randomly oriented cracks Fast and accurate numerical solution to an elastostatic problem involving ten thousand randomly oriented cracks Johan Helsing (helsing@nada.kth.se) Department of Solid Mechanics and NADA, Royal Institute

More information

The effective conductivity of arrays of squares: large random unit cells and extreme contrast ratios

The effective conductivity of arrays of squares: large random unit cells and extreme contrast ratios The effective conductivity of arrays of squares: large random unit cells and extreme contrast ratios Johan Helsing 1 Numerical Analysis, Centre for Mathematical Sciences, Lund University, Box 118, SE-221

More information

4.8 Arnoldi Iteration, Krylov Subspaces and GMRES

4.8 Arnoldi Iteration, Krylov Subspaces and GMRES 48 Arnoldi Iteration, Krylov Subspaces and GMRES We start with the problem of using a similarity transformation to convert an n n matrix A to upper Hessenberg form H, ie, A = QHQ, (30) with an appropriate

More information

- by solving for an unknown density that is related to the crack opening displacement (not to its derivative) we can retrieve the crack opening displa

- by solving for an unknown density that is related to the crack opening displacement (not to its derivative) we can retrieve the crack opening displa On the numerical evaluation of stress intensity factors for an interface crack of a general shape Johan Helsing Department of Solid Mechanics, Royal Institute of Technology, SE-100 44 Stockholm, Sweden

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

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

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

Conservation of mass. Continuum Mechanics. Conservation of Momentum. Cauchy s Fundamental Postulate. # f body

Conservation of mass. Continuum Mechanics. Conservation of Momentum. Cauchy s Fundamental Postulate. # f body Continuum Mechanics We ll stick with the Lagrangian viewpoint for now Let s look at a deformable object World space: points x in the object as we see it Object space (or rest pose): points p in some reference

More information

LINEAR ALGEBRA 1, 2012-I PARTIAL EXAM 3 SOLUTIONS TO PRACTICE PROBLEMS

LINEAR ALGEBRA 1, 2012-I PARTIAL EXAM 3 SOLUTIONS TO PRACTICE PROBLEMS LINEAR ALGEBRA, -I PARTIAL EXAM SOLUTIONS TO PRACTICE PROBLEMS Problem (a) For each of the two matrices below, (i) determine whether it is diagonalizable, (ii) determine whether it is orthogonally diagonalizable,

More information

Krylov Subspace Methods that Are Based on the Minimization of the Residual

Krylov Subspace Methods that Are Based on the Minimization of the Residual Chapter 5 Krylov Subspace Methods that Are Based on the Minimization of the Residual Remark 51 Goal he goal of these methods consists in determining x k x 0 +K k r 0,A such that the corresponding Euclidean

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

Simple iteration procedure

Simple iteration procedure Simple iteration procedure Solve Known approximate solution Preconditionning: Jacobi Gauss-Seidel Lower triangle residue use of pre-conditionner correction residue use of pre-conditionner Convergence Spectral

More information

SIMULATION OF PLANE STRAIN FIBER COMPOSITE PLATES IN BENDING THROUGH A BEM/ACA/HM FORMULATION

SIMULATION OF PLANE STRAIN FIBER COMPOSITE PLATES IN BENDING THROUGH A BEM/ACA/HM FORMULATION 8 th GRACM International Congress on Computational Mechanics Volos, 12 July 15 July 2015 SIMULATION OF PLANE STRAIN FIBER COMPOSITE PLATES IN BENDING THROUGH A BEM/ACA/HM FORMULATION Theodore V. Gortsas

More information

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Elena Virnik, TU BERLIN Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov

More information

Chapter 7. Iterative methods for large sparse linear systems. 7.1 Sparse matrix algebra. Large sparse matrices

Chapter 7. Iterative methods for large sparse linear systems. 7.1 Sparse matrix algebra. Large sparse matrices Chapter 7 Iterative methods for large sparse linear systems In this chapter we revisit the problem of solving linear systems of equations, but now in the context of large sparse systems. The price to pay

More information

which arises when we compute the orthogonal projection of a vector y in a subspace with an orthogonal basis. Hence assume that P y = A ij = x j, x i

which arises when we compute the orthogonal projection of a vector y in a subspace with an orthogonal basis. Hence assume that P y = A ij = x j, x i MODULE 6 Topics: Gram-Schmidt orthogonalization process We begin by observing that if the vectors {x j } N are mutually orthogonal in an inner product space V then they are necessarily linearly independent.

More information

Chapter 3 Transformations

Chapter 3 Transformations Chapter 3 Transformations An Introduction to Optimization Spring, 2014 Wei-Ta Chu 1 Linear Transformations A function is called a linear transformation if 1. for every and 2. for every If we fix the bases

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

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

Solving integral equations on piecewise smooth boundaries using the RCIP method: a tutorial

Solving integral equations on piecewise smooth boundaries using the RCIP method: a tutorial Solving integral equations on piecewise smooth boundaries using the RCIP method: a tutorial Helsing, Johan Published in: Abstract and Applied Analysis DOI: 10.1155/2013/938167 Published: 2013-01-01 Link

More information

FEM and sparse linear system solving

FEM and sparse linear system solving FEM & sparse linear system solving, Lecture 9, Nov 19, 2017 1/36 Lecture 9, Nov 17, 2017: Krylov space methods http://people.inf.ethz.ch/arbenz/fem17 Peter Arbenz Computer Science Department, ETH Zürich

More information

Course Notes: Week 1

Course Notes: Week 1 Course Notes: Week 1 Math 270C: Applied Numerical Linear Algebra 1 Lecture 1: Introduction (3/28/11) We will focus on iterative methods for solving linear systems of equations (and some discussion of eigenvalues

More information

Solving Sparse Linear Systems: Iterative methods

Solving Sparse Linear Systems: Iterative methods Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccs Lecture Notes for Unit VII Sparse Matrix Computations Part 2: Iterative Methods Dianne P. O Leary c 2008,2010

More information

Solving Sparse Linear Systems: Iterative methods

Solving Sparse Linear Systems: Iterative methods Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccswebpage Lecture Notes for Unit VII Sparse Matrix Computations Part 2: Iterative Methods Dianne P. O Leary

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

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A.

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A. AMSC/CMSC 661 Scientific Computing II Spring 2005 Solution of Sparse Linear Systems Part 2: Iterative methods Dianne P. O Leary c 2005 Solving Sparse Linear Systems: Iterative methods The plan: Iterative

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

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

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

compute the eective conductivity for unit cells at two hundred dierent area fractions and with a relative error of At percolation the unit cel

compute the eective conductivity for unit cells at two hundred dierent area fractions and with a relative error of At percolation the unit cel A high-order accurate algorithm for electrostatics of overlapping disks Johan Helsing Department of Solid Mechanics, Royal Institute of Technology, SE-100 44 Stockholm, Sweden (August 13, 1997, revised

More information

Integral equations for crack systems in a slightly heterogeneous elastic medium

Integral equations for crack systems in a slightly heterogeneous elastic medium Boundary Elements and Other Mesh Reduction Methods XXXII 65 Integral equations for crack systems in a slightly heterogeneous elastic medium A. N. Galybin & S. M. Aizikovich Wessex Institute of Technology,

More information

CLASS NOTES Computational Methods for Engineering Applications I Spring 2015

CLASS NOTES Computational Methods for Engineering Applications I Spring 2015 CLASS NOTES Computational Methods for Engineering Applications I Spring 2015 Petros Koumoutsakos Gerardo Tauriello (Last update: July 27, 2015) IMPORTANT DISCLAIMERS 1. REFERENCES: Much of the material

More information

Discrete Projection Methods for Integral Equations

Discrete Projection Methods for Integral Equations SUB Gttttingen 7 208 427 244 98 A 5141 Discrete Projection Methods for Integral Equations M.A. Golberg & C.S. Chen TM Computational Mechanics Publications Southampton UK and Boston USA Contents Sources

More information

Numerical Methods in Matrix Computations

Numerical Methods in Matrix Computations Ake Bjorck Numerical Methods in Matrix Computations Springer Contents 1 Direct Methods for Linear Systems 1 1.1 Elements of Matrix Theory 1 1.1.1 Matrix Algebra 2 1.1.2 Vector Spaces 6 1.1.3 Submatrices

More information

Linear Algebra Massoud Malek

Linear Algebra Massoud Malek CSUEB Linear Algebra Massoud Malek Inner Product and Normed Space In all that follows, the n n identity matrix is denoted by I n, the n n zero matrix by Z n, and the zero vector by θ n An inner product

More information

Common pitfalls while using FEM

Common pitfalls while using FEM Common pitfalls while using FEM J. Pamin Instytut Technologii Informatycznych w Inżynierii Lądowej Wydział Inżynierii Lądowej, Politechnika Krakowska e-mail: JPamin@L5.pk.edu.pl With thanks to: R. de Borst

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

More information

Reduction of Finite Element Models of Complex Mechanical Components

Reduction of Finite Element Models of Complex Mechanical Components Reduction of Finite Element Models of Complex Mechanical Components Håkan Jakobsson Research Assistant hakan.jakobsson@math.umu.se Mats G. Larson Professor Applied Mathematics mats.larson@math.umu.se Department

More information

Adapted linear approximation for singular integral equations

Adapted linear approximation for singular integral equations Malaya J. Mat. 2(4)(2014) 497 501 Adapted linear approximation for singular integral equations Mostefa NADIR a, and Belkacem LAKEHALI b a,b Department of Mathematics, Faculty of Mathematics and Informatics,

More information

Summary of Iterative Methods for Non-symmetric Linear Equations That Are Related to the Conjugate Gradient (CG) Method

Summary of Iterative Methods for Non-symmetric Linear Equations That Are Related to the Conjugate Gradient (CG) Method Summary of Iterative Methods for Non-symmetric Linear Equations That Are Related to the Conjugate Gradient (CG) Method Leslie Foster 11-5-2012 We will discuss the FOM (full orthogonalization method), CG,

More information

U.S. South America Workshop. Mechanics and Advanced Materials Research and Education. Rio de Janeiro, Brazil. August 2 6, Steven L.

U.S. South America Workshop. Mechanics and Advanced Materials Research and Education. Rio de Janeiro, Brazil. August 2 6, Steven L. Computational Modeling of Composite and Functionally Graded Materials U.S. South America Workshop Mechanics and Advanced Materials Research and Education Rio de Janeiro, Brazil August 2 6, 2002 Steven

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

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

University of Sheffield The development of finite elements for 3D structural analysis in fire

University of Sheffield The development of finite elements for 3D structural analysis in fire The development of finite elements for 3D structural analysis in fire Chaoming Yu, I. W. Burgess, Z. Huang, R. J. Plank Department of Civil and Structural Engineering StiFF 05/09/2006 3D composite structures

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 panel clustering method to the three-dimensional elastostatic problem K. Hayami* and S. A. Sauter** ^Department of Mathematical Engineering and Information Physics, School ofengineering,

More information

Linear Algebra, part 3 QR and SVD

Linear Algebra, part 3 QR and SVD Linear Algebra, part 3 QR and SVD Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2012 Going back to least squares (Section 1.4 from Strang, now also see section 5.2). We

More information

On the adaptive finite element analysis of the Kohn-Sham equations

On the adaptive finite element analysis of the Kohn-Sham equations On the adaptive finite element analysis of the Kohn-Sham equations Denis Davydov, Toby Young, Paul Steinmann Denis Davydov, LTM, Erlangen, Germany August 2015 Denis Davydov, LTM, Erlangen, Germany College

More information

Lecture Notes 5: Multiresolution Analysis

Lecture Notes 5: Multiresolution Analysis Optimization-based data analysis Fall 2017 Lecture Notes 5: Multiresolution Analysis 1 Frames A frame is a generalization of an orthonormal basis. The inner products between the vectors in a frame and

More information

Efficient numerical solution of the Biot poroelasticity system in multilayered domains

Efficient numerical solution of the Biot poroelasticity system in multilayered domains Efficient numerical solution of the Biot poroelasticity system Anna Naumovich Oleg Iliev Francisco Gaspar Fraunhofer Institute for Industrial Mathematics Kaiserslautern, Germany, Spain Workshop on Model

More information

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2 Index advection equation, 29 in three dimensions, 446 advection-diffusion equation, 31 aluminum, 200 angle between two vectors, 58 area integral, 439 automatic step control, 119 back substitution, 604

More information

A orthonormal basis for Radial Basis Function approximation

A orthonormal basis for Radial Basis Function approximation A orthonormal basis for Radial Basis Function approximation 9th ISAAC Congress Krakow, August 5-9, 2013 Gabriele Santin, joint work with S. De Marchi Department of Mathematics. Doctoral School in Mathematical

More information

The Lanczos and conjugate gradient algorithms

The Lanczos and conjugate gradient algorithms The Lanczos and conjugate gradient algorithms Gérard MEURANT October, 2008 1 The Lanczos algorithm 2 The Lanczos algorithm in finite precision 3 The nonsymmetric Lanczos algorithm 4 The Golub Kahan bidiagonalization

More information

ANALYSIS AND NUMERICAL METHODS FOR SOME CRACK PROBLEMS

ANALYSIS AND NUMERICAL METHODS FOR SOME CRACK PROBLEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING, SERIES B Volume 2, Number 2-3, Pages 155 166 c 2011 Institute for Scientific Computing and Information ANALYSIS AND NUMERICAL METHODS FOR SOME

More information

5 Compact linear operators

5 Compact linear operators 5 Compact linear operators One of the most important results of Linear Algebra is that for every selfadjoint linear map A on a finite-dimensional space, there exists a basis consisting of eigenvectors.

More information

6.4 Krylov Subspaces and Conjugate Gradients

6.4 Krylov Subspaces and Conjugate Gradients 6.4 Krylov Subspaces and Conjugate Gradients Our original equation is Ax = b. The preconditioned equation is P Ax = P b. When we write P, we never intend that an inverse will be explicitly computed. P

More information

Krylov Space Methods. Nonstationary sounds good. Radu Trîmbiţaş ( Babeş-Bolyai University) Krylov Space Methods 1 / 17

Krylov Space Methods. Nonstationary sounds good. Radu Trîmbiţaş ( Babeş-Bolyai University) Krylov Space Methods 1 / 17 Krylov Space Methods Nonstationary sounds good Radu Trîmbiţaş Babeş-Bolyai University Radu Trîmbiţaş ( Babeş-Bolyai University) Krylov Space Methods 1 / 17 Introduction These methods are used both to solve

More information

Review problems for MA 54, Fall 2004.

Review problems for MA 54, Fall 2004. Review problems for MA 54, Fall 2004. Below are the review problems for the final. They are mostly homework problems, or very similar. If you are comfortable doing these problems, you should be fine on

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

More information

Assignment #9: Orthogonal Projections, Gram-Schmidt, and Least Squares. Name:

Assignment #9: Orthogonal Projections, Gram-Schmidt, and Least Squares. Name: Assignment 9: Orthogonal Projections, Gram-Schmidt, and Least Squares Due date: Friday, April 0, 08 (:pm) Name: Section Number Assignment 9: Orthogonal Projections, Gram-Schmidt, and Least Squares Due

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

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

Inexactness and flexibility in linear Krylov solvers

Inexactness and flexibility in linear Krylov solvers Inexactness and flexibility in linear Krylov solvers Luc Giraud ENSEEIHT (N7) - IRIT, Toulouse Matrix Analysis and Applications CIRM Luminy - October 15-19, 2007 in honor of Gérard Meurant for his 60 th

More information

Krylov Subspaces. Lab 1. The Arnoldi Iteration

Krylov Subspaces. Lab 1. The Arnoldi Iteration Lab 1 Krylov Subspaces Lab Objective: Discuss simple Krylov Subspace Methods for finding eigenvalues and show some interesting applications. One of the biggest difficulties in computational linear algebra

More information

Introduction to Multigrid Methods

Introduction to Multigrid Methods Introduction to Multigrid Methods Chapter 9: Multigrid Methodology and Applications Gustaf Söderlind Numerical Analysis, Lund University Textbooks: A Multigrid Tutorial, by William L Briggs. SIAM 1988

More information

Upon successful completion of MATH 220, the student will be able to:

Upon successful completion of MATH 220, the student will be able to: MATH 220 Matrices Upon successful completion of MATH 220, the student will be able to: 1. Identify a system of linear equations (or linear system) and describe its solution set 2. Write down the coefficient

More information

Wavelets in Scattering Calculations

Wavelets in Scattering Calculations Wavelets in Scattering Calculations W. P., Brian M. Kessler, Gerald L. Payne polyzou@uiowa.edu The University of Iowa Wavelets in Scattering Calculations p.1/43 What are Wavelets? Orthonormal basis functions.

More information

A stable variant of Simpler GMRES and GCR

A stable variant of Simpler GMRES and GCR A stable variant of Simpler GMRES and GCR Miroslav Rozložník joint work with Pavel Jiránek and Martin H. Gutknecht Institute of Computer Science, Czech Academy of Sciences, Prague, Czech Republic miro@cs.cas.cz,

More information

Math 671: Tensor Train decomposition methods II

Math 671: Tensor Train decomposition methods II Math 671: Tensor Train decomposition methods II Eduardo Corona 1 1 University of Michigan at Ann Arbor December 13, 2016 Table of Contents 1 What we ve talked about so far: 2 The Tensor Train decomposition

More information

Lab 1: Iterative Methods for Solving Linear Systems

Lab 1: Iterative Methods for Solving Linear Systems Lab 1: Iterative Methods for Solving Linear Systems January 22, 2017 Introduction Many real world applications require the solution to very large and sparse linear systems where direct methods such as

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 9 Minimizing Residual CG

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

Heaviside projection based aggregation in stress constrained topology optimization

Heaviside projection based aggregation in stress constrained topology optimization Heaviside projection based aggregation in stress constrained topology optimization Cunfu Wang Xiaoping Qian Department of Mechanical Engineering, University of Wisconsin-Madison, 1513 University Avenue,

More information

Linear Algebra. Session 12

Linear Algebra. Session 12 Linear Algebra. Session 12 Dr. Marco A Roque Sol 08/01/2017 Example 12.1 Find the constant function that is the least squares fit to the following data x 0 1 2 3 f(x) 1 0 1 2 Solution c = 1 c = 0 f (x)

More information

Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators

Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators Preconditioned Locally Minimal Residual Method for Computing Interior Eigenpairs of Symmetric Operators Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University

More information

Conjugate Gradients: Idea

Conjugate Gradients: Idea Overview Steepest Descent often takes steps in the same direction as earlier steps Wouldn t it be better every time we take a step to get it exactly right the first time? Again, in general we choose a

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2017/18 Part 3: Iterative Methods PD

More information

Weighted Regularization of Maxwell Equations Computations in Curvilinear Polygons

Weighted Regularization of Maxwell Equations Computations in Curvilinear Polygons Weighted Regularization of Maxwell Equations Computations in Curvilinear Polygons Martin Costabel, Monique Dauge, Daniel Martin and Gregory Vial IRMAR, Université de Rennes, Campus de Beaulieu, Rennes,

More information

ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS

ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS ITERATIVE METHODS FOR SPARSE LINEAR SYSTEMS YOUSEF SAAD University of Minnesota PWS PUBLISHING COMPANY I(T)P An International Thomson Publishing Company BOSTON ALBANY BONN CINCINNATI DETROIT LONDON MADRID

More information

1 Extrapolation: A Hint of Things to Come

1 Extrapolation: A Hint of Things to Come Notes for 2017-03-24 1 Extrapolation: A Hint of Things to Come Stationary iterations are simple. Methods like Jacobi or Gauss-Seidel are easy to program, and it s (relatively) easy to analyze their convergence.

More information

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

Algorithms that use the Arnoldi Basis

Algorithms that use the Arnoldi Basis AMSC 600 /CMSC 760 Advanced Linear Numerical Analysis Fall 2007 Arnoldi Methods Dianne P. O Leary c 2006, 2007 Algorithms that use the Arnoldi Basis Reference: Chapter 6 of Saad The Arnoldi Basis How to

More information

CLASS NOTES Models, Algorithms and Data: Introduction to computing 2018

CLASS NOTES Models, Algorithms and Data: Introduction to computing 2018 CLASS NOTES Models, Algorithms and Data: Introduction to computing 2018 Petros Koumoutsakos, Jens Honore Walther (Last update: June 11, 2018) IMPORTANT DISCLAIMERS 1. REFERENCES: Much of the material (ideas,

More information

Applied Linear Algebra

Applied Linear Algebra Applied Linear Algebra Peter J. Olver School of Mathematics University of Minnesota Minneapolis, MN 55455 olver@math.umn.edu http://www.math.umn.edu/ olver Chehrzad Shakiban Department of Mathematics University

More information

After lecture 16 you should be able to

After lecture 16 you should be able to Lecture 16: Design of paper and board packaging Advanced concepts: FEM, Fracture Mechanics After lecture 16 you should be able to describe the finite element method and its use for paper- based industry

More information

Lecture 9: Krylov Subspace Methods. 2 Derivation of the Conjugate Gradient Algorithm

Lecture 9: Krylov Subspace Methods. 2 Derivation of the Conjugate Gradient Algorithm CS 622 Data-Sparse Matrix Computations September 19, 217 Lecture 9: Krylov Subspace Methods Lecturer: Anil Damle Scribes: David Eriksson, Marc Aurele Gilles, Ariah Klages-Mundt, Sophia Novitzky 1 Introduction

More information

Augmented GMRES-type methods

Augmented GMRES-type methods Augmented GMRES-type methods James Baglama 1 and Lothar Reichel 2, 1 Department of Mathematics, University of Rhode Island, Kingston, RI 02881. E-mail: jbaglama@math.uri.edu. Home page: http://hypatia.math.uri.edu/

More information

Some improvements of Xfem for cracked domains

Some improvements of Xfem for cracked domains Some improvements of Xfem for cracked domains E. Chahine 1, P. Laborde 2, J. Pommier 1, Y. Renard 3 and M. Salaün 4 (1) INSA Toulouse, laboratoire MIP, CNRS UMR 5640, Complexe scientifique de Rangueil,

More information

Autodesk Helius PFA. Guidelines for Determining Finite Element Cohesive Material Parameters

Autodesk Helius PFA. Guidelines for Determining Finite Element Cohesive Material Parameters Autodesk Helius PFA Guidelines for Determining Finite Element Cohesive Material Parameters Contents Introduction...1 Determining Cohesive Parameters for Finite Element Analysis...2 What Test Specimens

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

Modeling of Thermoelastic Damping in MEMS Resonators

Modeling of Thermoelastic Damping in MEMS Resonators Modeling of Thermoelastic Damping in MEMS Resonators T. Koyama a, D. Bindel b, S. Govindjee a a Dept. of Civil Engineering b Computer Science Division 1 University of California, Berkeley MEMS Resonators

More information

Index. for generalized eigenvalue problem, butterfly form, 211

Index. for generalized eigenvalue problem, butterfly form, 211 Index ad hoc shifts, 165 aggressive early deflation, 205 207 algebraic multiplicity, 35 algebraic Riccati equation, 100 Arnoldi process, 372 block, 418 Hamiltonian skew symmetric, 420 implicitly restarted,

More information

Practice Exam. 2x 1 + 4x 2 + 2x 3 = 4 x 1 + 2x 2 + 3x 3 = 1 2x 1 + 3x 2 + 4x 3 = 5

Practice Exam. 2x 1 + 4x 2 + 2x 3 = 4 x 1 + 2x 2 + 3x 3 = 1 2x 1 + 3x 2 + 4x 3 = 5 Practice Exam. Solve the linear system using an augmented matrix. State whether the solution is unique, there are no solutions or whether there are infinitely many solutions. If the solution is unique,

More information

homogeneous 71 hyperplane 10 hyperplane 34 hyperplane 69 identity map 171 identity map 186 identity map 206 identity matrix 110 identity matrix 45

homogeneous 71 hyperplane 10 hyperplane 34 hyperplane 69 identity map 171 identity map 186 identity map 206 identity matrix 110 identity matrix 45 address 12 adjoint matrix 118 alternating 112 alternating 203 angle 159 angle 33 angle 60 area 120 associative 180 augmented matrix 11 axes 5 Axiom of Choice 153 basis 178 basis 210 basis 74 basis test

More information

Sparse Tensor Galerkin Discretizations for First Order Transport Problems

Sparse Tensor Galerkin Discretizations for First Order Transport Problems Sparse Tensor Galerkin Discretizations for First Order Transport Problems Ch. Schwab R. Hiptmair, E. Fonn, K. Grella, G. Widmer ETH Zürich, Seminar for Applied Mathematics IMA WS Novel Discretization Methods

More information

Linear algebra for MATH2601: Theory

Linear algebra for MATH2601: Theory Linear algebra for MATH2601: Theory László Erdős August 12, 2000 Contents 1 Introduction 4 1.1 List of crucial problems............................... 5 1.2 Importance of linear algebra............................

More information