Efficient resolution of linear systems involving in wave radiation and diffraction around multiple bodies

Size: px
Start display at page:

Download "Efficient resolution of linear systems involving in wave radiation and diffraction around multiple bodies"

Transcription

1 Proceedings of the Seventh International Workshop on Ship Hydrodynamics, September 16-19, 211, Shanghai, China Efficient resolution of linear systems involving in wave radiation and diffraction around multiple bodies Y. Su 1, W.Y. Duan 1 & X.B. Chen 2,3 1 Shipbuilding Engineering College, HEU, 151 Harbin (China) 2 Research Department, BV, 9257 Neuilly-Sur-Seine (France) 3 Professorship, HEU, 151 Harbin (China) Abstract: Boundary element methods to evaluate the wave radiation and diffraction around bodies involve a large linear system which is complex, full, non diagonal-dominant and of large size. In order to solve it efficiently, the algorithm based on the generalized minimal residual algorithm (GMRES) and incomplete LU precondition (ILU) has been developed. A parameter µ is defined to quantify the incompleteness of LU decomposition. The optimizations of this ILU-GMRES algorithm by varying the value of µ is then studied by numerical tests of bodies with different geometry. It is shown that a significant reduction of CPU time can be obtained even for complex offshore structures. Key words: Incomplete LU factorization, GMRES, Boundary element method, Offshore structure, Optimization 1 Introduction Efficient resolution of the linear system Ax = b involving in the problem of wave radiation and diffraction around bodies by using the classical boundary element method, is critically important since the system matrix is complex, full, non diagonal-dominant and of large size. Indeed, the resolution of linear systems costs the major part of CPU expense in routine applications of seakeeping computations. The usual direct methods like Gauss Elimination or LU decomposition are not practical, especially, in the analysis of interactions between multiple bodies. The generalized minimal residual algorithm (GMRES), as an iterative (indirect) method, has been used to solve this type of problems combining with some preconditioners to reduce the number of iterations. For different numerical models, it is important for us to select a proper preconditioner for the iterative method, and the optimal selection between the direct method and the iterative method. The GMRES approach was first proposed by Saad and Schultz (1986), which is used for nonsymmetric and not necessarily positive definite matrices. Then the solver was tested in the fluid dynamics context for three dimensional models of viscous flows or boundary element analysis of structural problems by Kane et al. (1991) and Habashi et al. (1992). Kane et al. concluded that the GMRES solver is faster than direct solvers for a given large matrix. And it is more consistent than other iterative solvers due to convergence characteristics as shown in Habashi et al. (1992). By an out-of-core treatment, the classical RAM requirement in the solution of boundary element analysis of large offshore structures has been reduced to O(n) instead of O(n 2 ) in Y. Zhao and J.M.R. Graham (1996). The modified version of the incomplete LU factorization (ILU) was used as a preconditioner for GMRES in hydrodynamic analysis of the interaction between the global structural response of a very large floating structure and the associated diffraction wave field in an unbounded exterior domain by Noritoshi Makihata et al. (25). As for the boundary element solution of offshore structures, the constant element method based on frequency-domain free surface Green function has been widely used to solve the wave radiation and diffraction problem of offshore structures. There have been some hydrodynamic software based on this method, like HydroStar developed by Bureau Veritas (France). It also consumes a large amount of CPU time and memory requirement for large and complicated offshore structures if the direct method is used. In order to solve the problem, the GMRES approach combining with a preconditioner was tested. In this paper, firstly, the effectiveness of the GMRES program with the preconditioner ILU is tested

2 for the solution of linear systems involving in boundary element method of wave diffraction-radiation around floating bodies. Secondly, in order to improve the efficiency, the value of the parameter µ in the preconditioner varies according to different shapes of floating bodies. Thirdly, as for different linear systems, a judgment formula has been presented to select more time-saving method between the iterative method and direct method. 2 ILU-GMRES algorithm The GMRES approach was proposed for solving nonsymmetric linear systems in Saad and Schultz (1986). First we construct an orthonormal basis by using Arnoldi process. Then the norm of the residual vector over a Krylov subspace is minimized at every step. If the coefficient matrix A C n n is nonsingular, b C n, and x C n is an initial guess. After k steps of Arnoldi iteration we have the factorization following Golub and Van Loan (1996): AQ k = Q k+1 Hk (1) in which the columns of Q k+1 = [Q k q k+1 ] are the orthonormal Arnoldi vectors and H k is a (k +1) k matrix which has the form : [ ] H H k = k (2),,,h k+1,k in which H k is an upper Hessenberg matrix H k = Q H k AQ k of order k where Q H k is the conjugated transpose of Q k. In the kth step of GMRES, the norm b Ax k 2 is minimized subject to the constraint that x k has the form x k = x + Q k y k for some y k C k. If q 1 = r /ρ in which ρ = r 2, then it follows that: b A(x +Q k y k ) 2 = r AQ k y k 2 = r Q k+1 Hk y k 2 = ρ e 1 H k y k 2 (3) in which e 1 is the first column of (k+1) (k+1) identity matrix. Thus, y k is the solution to a (k+1)- by-k least squares problem and that can be efficiently solved using Givens rotations. The solution of the linear system is given by x k = x +Q k y k. In order to acquire precise numerical solution, backward error analysis is used for stop criterion. As in Dai (23), the stop criterion adopted in the program is: ǫ(x k ) = b Ax k 2 / b 2 (4) by the ratios of the residue vectors with respect to right hand side. If ǫ is less than a parameter (1 5 ), the program will stop. At high wave frequencies, the number of iterations will increase sharply due to ill-conditioned coefficient matrices. Preconditioning is one of the key to making GMRES effective. The incomplete LU factorization is one of the most effective preconditioner according to Quarteroni et al. (2). After multiplying the ILU on both sides of Ax = b, the coefficient matrix tends to the identity and the right hand sides will tend to the solution. As for the ILU program, the process of decomposition is the same as the classical LU factorization but only part of the elements can be decomposed. We set a parameter µ to control the elements which should be decomposed. a(i,j)/a(i,i) > µ for j = i+1,i+2,,n (5) For the ith row, the elements which satisfy the above equation will be decomposed. The value of the parameter µ varies due to different linear systems, which will be presented in the following section. The algorithm of ILU is sketched below : for k = 1 : n-1 A(k+1 : n, k) = A(k+1 : n, k) / A(k, k) for i = k+1 : n if ( formula(5) ) then for j = k+1 : n A(i, j) = A(i, j) - A(i, k) * A(k, j) end endif end end A case of cylinder with a radius of R = 12.5m and draft D = 3R was tested. As for comparison, the direct solver based on the subroutine ZGESV from the LAPACK library. ZGESV computes the solution

3 Table 1: Comparisons of solutions by using LU and ILU-GMRES methods RhS M j (LU) E j (LU - ILU-GMRES) D D D+.2551D D D D D D D D D D D 6 to a complex system of linear equations Ax = b using LU factorization with partial pivoting, where A is an N N matrix and x and b are N M matrices with M the number of second members. Firstly, the ILU-GMRES solver was validated by the cylinder with 318 panels on the surface of the body. The nondimansionalfrequencyofanincidentwaveisω 2R/g =.6rad/s. Thefirstsixcolumnsofright-hand sides in the linear systems represent radiation components and the last column represents diffraction. In Table 1, RhS means the right-hand sides of the linear system. M j means the average of absolute value of all the elements in each column of the solution obtained by the direct method. M j = N x(i,j) /N for j = 1,2,,7 (6) i=1 Compared to the results by the direct method, we apply the following equation to compute the relative error. N E j = x (i,j) x(i,j) /N for j = 1,2,,7 (7) i=1 In Table 1, the first column represents the column number of the right hand side matrix. The second column represents the average of the solution of linear system solved by the direct method. Compared to the solution of the direct solver using LU decomposition, the third column presents the relative error between the direct method (LU) and the preconditioned iterative method (ILU-GMRES). We can find the solutions of linear system solved by ILU-GMRES are very good. That means the program GMRES with preconditioner ILU can provide precise solution for the linear system arising from the boundary element analysis of wave radiation and diffraction around offshore structures. Based on the former numerical model cylinder, we tested a set of wave frequencies. The CPU time of different methods has been depicted against nondimensional wave frequencies on Figure 1. It is shows that the GMRES method is faster than LU factorization for this numerical model. But it will cost more and more time at higher frequencies due to the increase of iterations. Using the ILU preconditioner, the CPU-TIME at high frequencies is reduced significantly as the number of iterations is decreased due to the preconditioner CPU_TIME(s) 15 1 direct method GMRES ILU_GMRES Figure 1: Mesh of the cylinder (left) and CPU time for different methods (right)

4 The second example concerns the case of multiple bodies. Two LNGs of different size (L=275m for the larger one) and with different draft are in the position of side-by-side as shown on the left part of Figure 2. The mesh composed of 3134 panels ( ) for both hulls is used in the computation. Both the direct method (LU decomposition) and the iterative method (ILU-GMRES) have been used to solve the linear system. The comparison of CPU time by using both methods is depicted on the right part of Figure 2. It is shown that ILU-GMRES can save at least half of CPU time with the same accuracy direct method ILU_GMRES CPU_TIME(s) Figure 2: Mesh of two LNGs (left) and comparison of CPU time (right) 3 Optimizations The method based on extending integral equations to the interior waterplane has been widely used to remove the irregular frequencies. Panels are then distributed on the interior free surface of a ship or an offshore structure. The surface of interior waterplane for a ship is much larger than that for a semisubmersible, TLP or a spar. Four models of different geometry like cylinder, TLP, 2LNGs and container ship will be tested. The cylinder has its radius and height equal to 12.5m and 37.5m, respectively. The TLP presented in Eatock Taylor and Jeffrey (1985) was used. We also test the classical ITTC S-175 container ship. The surfaces of above 4 structure are represented by the meshes composed of 3532, 3432, 3134 and 3422 panels for the cylinder, ITTC TLP, 2LNGs and containership S175, respectively. A series of wave frequencies has been used with their non-dimensional values varying up to 12. To note that the non-dimensional frequency is defined as ω L/g with wave frequency ω associated with the characteristic length L taking as 1R, 13m, 275m and 175m for the cylinder, TLP, 2LNGs and S175, respectively TLP S175 2LNG Cylinder The number of iteration The number of iteration Figure 3: Numbers of iterations for different frequencies (left) and for different values of µ (right) On the left part of Figure 3, the CPU time is presented for different structures associated with a large range of wave frequencies. The CPU cost for 2LNGs and S175 are much more than cylindrical structures. As we know, the parameter µ represents how complete is the LU decomposition. If we reduce the value of the parameter, the number of iteration can be decreased. We use the case of 2LNGs for our experiments.

5 According to the right part of Figure 3, we can see the number of iterations can be reduced through declining the value of µ. But the CPU-TIME does not always decline along with the number of iteration due to the incomplete LU decomposition. It will cost more CPU-TIME when we choose small value of µ. According to numerical experiments, we set the value of µ equals to.5 for ships. As for the four models, the numbers of iterations are different mainly due to the different interior free surface. Through computing the ratio of area between the interior surface and wetted surface, we find that the ratios of cylinder, TLP, 2LNGs, S-175 are.14,.5,.65 and.58 respectively. According to the shapes of ships and platforms, the value of parameter µ is set to.2 when the ratio of area is less than.35. And the parameter µ should be set to.5 when the ratio of area is larger than.35. According to the above-mentioned results, it seems that the iterative method is always better than direct methods for the given linear system. But for some linear systems which have many right hand sides, it is important for us to select the more time saving solver. A flop is a floating point operation, i.e., a floating point addition or a floating point multiplication. As for a general linear system Ax = b, the dimension of A, x and b are N N, N M and N M, respectively. The flops of the direct method using classical LU factorization can be counted as follows: 2N 3 /3+2MN 2 (8) As for the ILU-GMRES, we divide it into two parts, including the incomplete LU decomposition and the process of iterations. For the first part, we set the parameter coef for calculation. The value of coef is about 1 2. The flops of the first part can be counted as coef 2N 3 /3. For the second part, applying M it for the number of iteration we can obtain: M [2N 2 +M it 4N 2 +M it (M it +1) 2N] (9) According to the numerical experiments, the M it is usually much less than N and larger than 1. The total flops of ILU-GMRES can be counted as follows. Let (8) equals to (1), we can obtain: coef 2N 3 /3+4N 2 M M it (1) M/N = (1 coef)/(6m it 3) (11) According to our numerical experiments, the value of coef is much less than 1 so that c = (6M it 3))M/N 1 (12) The above equation means the direct method and ILU-GMRES will cost the same CPU time. For larger N and less iterations M it, the criterion c < 1 and the ILU-GMRES method is preferable. On the other side, if more second members (larger M) and smaller N, the criterion c > 1 which means the direct method is more economic. According to the value of c, we will select ILU-GMRES for c < 1 and the direct method for c > 1. In order to validate the above criterion, we use the case of cylinder as a test. We select N = 3372, M = 66, and wave frequency is 2.3. After computing, we know M it = 9. Based on (12), we get c = 1.2 which means the iterative method consumes the same CPU time as with direct method. Actually, through our numerical experiment, the CPU time of direct method with LU factorization is 255 seconds and that of ILU-GMRES is 258 seconds. The number of iteration can not be known before the process of iteration. It is necessary for us to build a database about the number of iterations in different frequencies and shape of offshore structures. In the field of naval architecture and ocean engineering, the number of the directions of incident wave is usually less than 24 if we select an incident wave every 15 degree. That means the number of right hand sides is up to 3. According to our numerical experiments, the number of iteration is usually less than 15. Through the criterion, we can conclude that ILU-GMRES is always faster than direct method when the number of panels is larger than 26. On the other side, the number of the wave headings is usually larger than 7 and iteration is usually larger than 7 too. We conclude that direct methods are always faster than ILU-GMRES when the number of the panels is less than Conclusions For the given numerical model, ILU-GMRES is significantly faster than direct methods when solving the linear systems arising from boundary element analysis of offshore structures. By the preconditioner

6 with incomplete LU factorization, the number of iterations at high wave frequencies has been reduced effectively. The value of the parameter µ should be different according to different shape of offshore structures. When the ratio of area between interior free surface and wetted surface is less than.35, like semisubmersibles, TLP and spar, the value of µ should be equal to.2. When the value of ratio is larger than.35, the value of µ should be equal to.5. According to different linear systems, we should choose a better solver between ILU-GMRES method and direct method. When the number of the panels is larger than 26, we select ILU-GMRES. When the number of the panels is less than 27, we select direct methods. Between them, the criterion formula (12) can be useful to estimate which method is faster. Acknowledgments The research is financially supported by the National Natural Science Foundation of China (Grant No ), Excellent Youth Foundation of Heilongjiang Province of China and the 111 project (B719). References [1] Saad Y. and Schultz M.H. (1986) GMRES: A generalized minimal residual algorithm for solving non-symmetric linear systems. SIAM J. Sci. Stat. Comput. 7, [2] Kane J.H., Keyes D.E. and Prasad K.G (1991) Iteration solution techniques in boundary element analysis. Int. J. Numerical Methods Engng. 31, [3] Habashi W.G., Peeters M.F., Robichand M.P. and Nguyen V.N. (1992) A fully-coupled finite element algorithm using direct and iterative solvers for the incompressible Navier-Stokes equations. Incompressible computational fluid dynamics: trends and advances. Cambridge Univ. Press. ed. Gunzburger, M.D. and Nicolaides, R.A [4] Zhao Y. and Graham J.M.R. (1996) An iterative method for boundary solution of large offshore structures using the GMRES solver. Ocean Engng 23, [5] Makihata N., Utsunomiya T. and Watanabe E. (25) Effectiveness of GMRES-DR and OSP- ILUC for wave diffraction analysis of a very large floating structure (VLFS). Engng analysis with boundary elements 3, [6] Chen X.B. (24) Hydrodynamics in offshore and naval applications. Research Department, Bureau Veritas [7] Dai Y.S. and Duan W.Y. (28) Potential flow theory of ship motions in waves. National Defense Industry Press. [8] HydroStar for Experts - user manual (28) Research Department, Bureau Veritas. [9] Golub G.H. and Van Loan C.F. (1996) Matrix computations John Hopkins University Press. [1] Quarteroni A., Sacco R. and Saleri F. (2) Numerical mathematics, Springer [11] Eatock-taylor R. and Jeffery E.R. (1985) Variability of hydrodynamic load predictions for a tension leg platform. Ocean Engng. 13, [12] Dai Y.Z. (23) Rapid 3-dimensional hydroelastic analysis of large offshore structures. PhD thesis. College of Shipbuilding Engineering, Harbin Engineering University. [13] LAPACK routine DBDSQR with url as

A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS

A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS Contemporary Mathematics Volume 157, 1994 A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS T.E. Tezduyar, M. Behr, S.K. Aliabadi, S. Mittal and S.E. Ray ABSTRACT.

More information

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND Student Submission for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany: SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND TESSA UROIĆ Faculty of Mechanical Engineering and Naval Architecture, Ivana

More information

THE DEVELOPMENT OF THE POTENTIAL AND ACADMIC PROGRAMMES OF WROCLAW UNIVERISTY OF TECH- NOLOGY ITERATIVE LINEAR SOLVERS

THE DEVELOPMENT OF THE POTENTIAL AND ACADMIC PROGRAMMES OF WROCLAW UNIVERISTY OF TECH- NOLOGY ITERATIVE LINEAR SOLVERS ITERATIVE LIEAR SOLVERS. Objectives The goals of the laboratory workshop are as follows: to learn basic properties of iterative methods for solving linear least squares problems, to study the properties

More information

Transactions on Modelling and Simulation vol 10, 1995 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 10, 1995 WIT Press,  ISSN X Hydrodynamic coefficients and motions due to a floating cylinder in waves D.D. Bhatta, M. Rahman Department of Applied Mathematics, Technical University of Nova Scotia, Halifax, Nova Scotia, Canada B3J

More information

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation Amir Nejat * and Carl Ollivier-Gooch Department of Mechanical Engineering, The University of British Columbia, BC V6T 1Z4, Canada

More information

Solution of 2D Euler Equations and Application to Airfoil Design

Solution of 2D Euler Equations and Application to Airfoil Design WDS'6 Proceedings of Contributed Papers, Part I, 47 52, 26. ISBN 8-86732-84-3 MATFYZPRESS Solution of 2D Euler Equations and Application to Airfoil Design J. Šimák Charles University, Faculty of Mathematics

More information

Implementation of the skyline algorithm in finite-element computations of Saint-Venant equations

Implementation of the skyline algorithm in finite-element computations of Saint-Venant equations P a g e 61 Journal of Applied Research in Water and Wastewater (14) 61-65 Original paper Implementation of the skyline algorithm in finite-element computations of Saint-Venant equations Reza Karimi 1,

More information

Nonsymmetric Problems. Abstract. The eect of a threshold variant TPABLO of the permutation

Nonsymmetric Problems. Abstract. The eect of a threshold variant TPABLO of the permutation Threshold Ordering for Preconditioning Nonsymmetric Problems Michele Benzi 1, Hwajeong Choi 2, Daniel B. Szyld 2? 1 CERFACS, 42 Ave. G. Coriolis, 31057 Toulouse Cedex, France (benzi@cerfacs.fr) 2 Department

More information

Comparison of parallel preconditioners for a Newton-Krylov flow solver

Comparison of parallel preconditioners for a Newton-Krylov flow solver Comparison of parallel preconditioners for a Newton-Krylov flow solver Jason E. Hicken, Michal Osusky, and David W. Zingg 1Introduction Analysis of the results from the AIAA Drag Prediction workshops (Mavriplis

More information

Comparison of open-source code Nemoh with Wamit for cargo ship motions in shallow water

Comparison of open-source code Nemoh with Wamit for cargo ship motions in shallow water Comparison of open-source code Nemoh with Wamit for cargo ship motions in shallow water G.Parisella 1 and T.P.Gourlay 2 Centre for Marine Science and Technology, Curtin University Research report 2016-23,

More information

Xinyu Dou Acoustics Technology Center, Motorola, Inc., Schaumburg, Illinois 60196

Xinyu Dou Acoustics Technology Center, Motorola, Inc., Schaumburg, Illinois 60196 A unified boundary element method for the analysis of sound and shell-like structure interactions. II. Efficient solution techniques Shaohai Chen and Yijun Liu a) Department of Mechanical Engineering,

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

Report of Linear Solver Implementation on GPU

Report of Linear Solver Implementation on GPU Report of Linear Solver Implementation on GPU XIANG LI Abstract As the development of technology and the linear equation solver is used in many aspects such as smart grid, aviation and chemical engineering,

More information

Implicit schemes for wave models

Implicit schemes for wave models Implicit schemes for wave models Mathieu Dutour Sikirić Rudjer Bo sković Institute, Croatia and Universität Rostock April 17, 2013 I. Wave models Stochastic wave modelling Oceanic models are using grids

More information

Sparse Linear Systems

Sparse Linear Systems 1 Sparse Linear Systems Rob H. Bisseling Mathematical Institute, Utrecht University Course Introduction Scientific Computing February 22, 2018 2 Outline Iterative solution methods 3 A perfect bipartite

More information

GTC 2013: DEVELOPMENTS IN GPU-ACCELERATED SPARSE LINEAR ALGEBRA ALGORITHMS. Kyle Spagnoli. Research EM Photonics 3/20/2013

GTC 2013: DEVELOPMENTS IN GPU-ACCELERATED SPARSE LINEAR ALGEBRA ALGORITHMS. Kyle Spagnoli. Research EM Photonics 3/20/2013 GTC 2013: DEVELOPMENTS IN GPU-ACCELERATED SPARSE LINEAR ALGEBRA ALGORITHMS Kyle Spagnoli Research Engineer @ EM Photonics 3/20/2013 INTRODUCTION» Sparse systems» Iterative solvers» High level benchmarks»

More information

Index. C m (Ω), 141 L 2 (Ω) space, 143 p-th order, 17

Index. C m (Ω), 141 L 2 (Ω) space, 143 p-th order, 17 Bibliography [1] J. Adams, P. Swarztrauber, and R. Sweet. Fishpack: Efficient Fortran subprograms for the solution of separable elliptic partial differential equations. http://www.netlib.org/fishpack/.

More information

1 2 (3 + x 3) x 2 = 1 3 (3 + x 1 2x 3 ) 1. 3 ( 1 x 2) (3 + x(0) 3 ) = 1 2 (3 + 0) = 3. 2 (3 + x(0) 1 2x (0) ( ) = 1 ( 1 x(0) 2 ) = 1 3 ) = 1 3

1 2 (3 + x 3) x 2 = 1 3 (3 + x 1 2x 3 ) 1. 3 ( 1 x 2) (3 + x(0) 3 ) = 1 2 (3 + 0) = 3. 2 (3 + x(0) 1 2x (0) ( ) = 1 ( 1 x(0) 2 ) = 1 3 ) = 1 3 6 Iterative Solvers Lab Objective: Many real-world problems of the form Ax = b have tens of thousands of parameters Solving such systems with Gaussian elimination or matrix factorizations could require

More information

Transactions on Modelling and Simulation vol 20, 1998 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 20, 1998 WIT Press,   ISSN X Parallel indirect multipole BEM analysis of Stokes flow in a multiply connected domain M.S. Ingber*, A.A. Mammoli* & J.S. Warsa* "Department of Mechanical Engineering, University of New Mexico, Albuquerque,

More information

nag sparse nsym sol (f11dec)

nag sparse nsym sol (f11dec) f11 Sparse Linear Algebra f11dec nag sparse nsym sol (f11dec) 1. Purpose nag sparse nsym sol (f11dec) solves a real sparse nonsymmetric system of linear equations, represented in coordinate storage format,

More information

GRAPH CENTERS USED FOR STABILIZATION OF MATRIX FACTORIZATIONS

GRAPH CENTERS USED FOR STABILIZATION OF MATRIX FACTORIZATIONS Discussiones Mathematicae Graph Theory 30 (2010 ) 349 359 GRAPH CENTERS USED FOR STABILIZATION OF MATRIX FACTORIZATIONS Pavla Kabelíková Department of Applied Mathematics FEI, VSB Technical University

More information

NAG Fortran Library Routine Document F11DSF.1

NAG Fortran Library Routine Document F11DSF.1 NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

Numerical Estimation and Validation of Shallow Draft Effect on Roll Damping

Numerical Estimation and Validation of Shallow Draft Effect on Roll Damping The 14 th International Ship Stability Workshop (ISSW), 29 th September- 1 st October 2014, Kuala Lumpur, Malaysia Numerical Estimation and Validation of Shallow Draft Effect on Roll Damping Toru Katayama

More information

What is Multigrid? They have been extended to solve a wide variety of other problems, linear and nonlinear.

What is Multigrid? They have been extended to solve a wide variety of other problems, linear and nonlinear. AMSC 600/CMSC 760 Fall 2007 Solution of Sparse Linear Systems Multigrid, Part 1 Dianne P. O Leary c 2006, 2007 What is Multigrid? Originally, multigrid algorithms were proposed as an iterative method to

More information

Iterative Algorithms I: Elementary Iterative Methods and the Conjugate Gradient Algorithms

Iterative Algorithms I: Elementary Iterative Methods and the Conjugate Gradient Algorithms Iterative Algorithms I: Elementary Iterative Methods and the Conjugate Gradient Algorithms By:- Nitin Kamra Indian Institute of Technology, Delhi Advisor:- Prof. Ulrich Reude 1. Introduction to Linear

More information

Efficient Use of Iterative Solvers in Nested Topology Optimization

Efficient Use of Iterative Solvers in Nested Topology Optimization Efficient Use of Iterative Solvers in Nested Topology Optimization Oded Amir, Mathias Stolpe and Ole Sigmund Technical University of Denmark Department of Mathematics Department of Mechanical Engineering

More information

Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil

Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil Case C3.1: Turbulent Flow over a Multi-Element MDA Airfoil Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts Institute of Technology I. Code Description ProjectX

More information

Recent developments in the solution of indefinite systems Location: De Zwarte Doos (TU/e campus)

Recent developments in the solution of indefinite systems Location: De Zwarte Doos (TU/e campus) 1-day workshop, TU Eindhoven, April 17, 2012 Recent developments in the solution of indefinite systems Location: De Zwarte Doos (TU/e campus) :10.25-10.30: Opening and word of welcome 10.30-11.15: Michele

More information

A hybrid GMRES and TV-norm based method for image restoration

A hybrid GMRES and TV-norm based method for image restoration A hybrid GMRES and TV-norm based method for image restoration D. Calvetti a, B. Lewis b and L. Reichel c a Department of Mathematics, Case Western Reserve University, Cleveland, OH 44106 b Rocketcalc,

More information

Performance Evaluation of a New Parallel Preconditioner

Performance Evaluation of a New Parallel Preconditioner Performance Evaluation of a New Parallel Preconditioner Keith D. Gremban Gary L. Miller Marco Zagha School of Computer Science Carnegie Mellon University 5 Forbes Avenue Pittsburgh PA 15213 Abstract The

More information

Journal of Engineering Research and Studies E-ISSN

Journal of Engineering Research and Studies E-ISSN Journal of Engineering Research and Studies E-ISS 0976-79 Research Article SPECTRAL SOLUTIO OF STEADY STATE CODUCTIO I ARBITRARY QUADRILATERAL DOMAIS Alavani Chitra R 1*, Joshi Pallavi A 1, S Pavitran

More information

S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS

S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS John R Appleyard Jeremy D Appleyard Polyhedron Software with acknowledgements to Mark A Wakefield Garf Bowen Schlumberger Outline of Talk Reservoir

More information

Parallel Threshold-based ILU Factorization

Parallel Threshold-based ILU Factorization A short version of this paper appears in Supercomputing 997 Parallel Threshold-based ILU Factorization George Karypis and Vipin Kumar University of Minnesota, Department of Computer Science / Army HPC

More information

Chapter 1 A New Parallel Algorithm for Computing the Singular Value Decomposition

Chapter 1 A New Parallel Algorithm for Computing the Singular Value Decomposition Chapter 1 A New Parallel Algorithm for Computing the Singular Value Decomposition Nicholas J. Higham Pythagoras Papadimitriou Abstract A new method is described for computing the singular value decomposition

More information

NAG Library Function Document nag_sparse_nsym_sol (f11dec)

NAG Library Function Document nag_sparse_nsym_sol (f11dec) f11 Large Scale Linear Systems NAG Library Function Document nag_sparse_nsym_sol () 1 Purpose nag_sparse_nsym_sol () solves a real sparse nonsymmetric system of linear equations, represented in coordinate

More information

HYPERDRIVE IMPLEMENTATION AND ANALYSIS OF A PARALLEL, CONJUGATE GRADIENT LINEAR SOLVER PROF. BRYANT PROF. KAYVON 15618: PARALLEL COMPUTER ARCHITECTURE

HYPERDRIVE IMPLEMENTATION AND ANALYSIS OF A PARALLEL, CONJUGATE GRADIENT LINEAR SOLVER PROF. BRYANT PROF. KAYVON 15618: PARALLEL COMPUTER ARCHITECTURE HYPERDRIVE IMPLEMENTATION AND ANALYSIS OF A PARALLEL, CONJUGATE GRADIENT LINEAR SOLVER AVISHA DHISLE PRERIT RODNEY ADHISLE PRODNEY 15618: PARALLEL COMPUTER ARCHITECTURE PROF. BRYANT PROF. KAYVON LET S

More information

AN IMPROVED ITERATIVE METHOD FOR SOLVING GENERAL SYSTEM OF EQUATIONS VIA GENETIC ALGORITHMS

AN IMPROVED ITERATIVE METHOD FOR SOLVING GENERAL SYSTEM OF EQUATIONS VIA GENETIC ALGORITHMS AN IMPROVED ITERATIVE METHOD FOR SOLVING GENERAL SYSTEM OF EQUATIONS VIA GENETIC ALGORITHMS Seyed Abolfazl Shahzadehfazeli 1, Zainab Haji Abootorabi,3 1 Parallel Processing Laboratory, Yazd University,

More information

Performance Evaluation of Multiple and Mixed Precision Iterative Refinement Method and its Application to High-Order Implicit Runge-Kutta Method

Performance Evaluation of Multiple and Mixed Precision Iterative Refinement Method and its Application to High-Order Implicit Runge-Kutta Method Performance Evaluation of Multiple and Mixed Precision Iterative Refinement Method and its Application to High-Order Implicit Runge-Kutta Method Tomonori Kouya Shizuoa Institute of Science and Technology,

More information

3D Helmholtz Krylov Solver Preconditioned by a Shifted Laplace Multigrid Method on Multi-GPUs

3D Helmholtz Krylov Solver Preconditioned by a Shifted Laplace Multigrid Method on Multi-GPUs 3D Helmholtz Krylov Solver Preconditioned by a Shifted Laplace Multigrid Method on Multi-GPUs H. Knibbe, C. W. Oosterlee, C. Vuik Abstract We are focusing on an iterative solver for the three-dimensional

More information

Parallel Numerical Algorithms

Parallel Numerical Algorithms Parallel Numerical Algorithms Chapter 4 Sparse Linear Systems Section 4.3 Iterative Methods Michael T. Heath and Edgar Solomonik Department of Computer Science University of Illinois at Urbana-Champaign

More information

Lecture 11: Randomized Least-squares Approximation in Practice. 11 Randomized Least-squares Approximation in Practice

Lecture 11: Randomized Least-squares Approximation in Practice. 11 Randomized Least-squares Approximation in Practice Stat60/CS94: Randomized Algorithms for Matrices and Data Lecture 11-10/09/013 Lecture 11: Randomized Least-squares Approximation in Practice Lecturer: Michael Mahoney Scribe: Michael Mahoney Warning: these

More information

(Sparse) Linear Solvers

(Sparse) Linear Solvers (Sparse) Linear Solvers Ax = B Why? Many geometry processing applications boil down to: solve one or more linear systems Parameterization Editing Reconstruction Fairing Morphing 2 Don t you just invert

More information

Performance of Implicit Solver Strategies on GPUs

Performance of Implicit Solver Strategies on GPUs 9. LS-DYNA Forum, Bamberg 2010 IT / Performance Performance of Implicit Solver Strategies on GPUs Prof. Dr. Uli Göhner DYNAmore GmbH Stuttgart, Germany Abstract: The increasing power of GPUs can be used

More information

2D numerical simulation of ocean waves

2D numerical simulation of ocean waves 2D numerical simulation of ocean waves Qingjie. Du,*, Y.C. Dennis. Leung Department of Mechanical Engineering, The University of Hong Kong, Hong Kong, China * Corresponding author. Tel: +852 51743593,

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

Numerical Linear Algebra

Numerical Linear Algebra Numerical Linear Algebra Probably the simplest kind of problem. Occurs in many contexts, often as part of larger problem. Symbolic manipulation packages can do linear algebra "analytically" (e.g. Mathematica,

More information

Finite Element Methods for the Poisson Equation and its Applications

Finite Element Methods for the Poisson Equation and its Applications Finite Element Methods for the Poisson Equation and its Applications Charles Crook July 30, 2013 Abstract The finite element method is a fast computational method that also has a solid mathematical theory

More information

A parallel direct/iterative solver based on a Schur complement approach

A parallel direct/iterative solver based on a Schur complement approach A parallel direct/iterative solver based on a Schur complement approach Gene around the world at CERFACS Jérémie Gaidamour LaBRI and INRIA Bordeaux - Sud-Ouest (ScAlApplix project) February 29th, 2008

More information

Chapter 1 A New Parallel Algorithm for Computing the Singular Value Decomposition

Chapter 1 A New Parallel Algorithm for Computing the Singular Value Decomposition Chapter 1 A New Parallel Algorithm for Computing the Singular Value Decomposition Nicholas J. Higham Pythagoras Papadimitriou Abstract A new method is described for computing the singular value decomposition

More information

A Parallel Implementation of the BDDC Method for Linear Elasticity

A Parallel Implementation of the BDDC Method for Linear Elasticity A Parallel Implementation of the BDDC Method for Linear Elasticity Jakub Šístek joint work with P. Burda, M. Čertíková, J. Mandel, J. Novotný, B. Sousedík Institute of Mathematics of the AS CR, Prague

More information

Parallel Hybrid Monte Carlo Algorithms for Matrix Computations

Parallel Hybrid Monte Carlo Algorithms for Matrix Computations Parallel Hybrid Monte Carlo Algorithms for Matrix Computations V. Alexandrov 1, E. Atanassov 2, I. Dimov 2, S.Branford 1, A. Thandavan 1 and C. Weihrauch 1 1 Department of Computer Science, University

More information

Simulation of Freak Wave Impact Using the Higher Order Spectrum

Simulation of Freak Wave Impact Using the Higher Order Spectrum Simulation of Freak Wave Impact Using the Higher Order Spectrum The Naval Hydro Pack Hrvoje Jasak and Vuko Vukčević Faculty of Mechanical Engineering and Naval Architecture, Uni Zagreb, Croatia Wikki Ltd.

More information

Wigley Hull. SeaFEM - Validation Case 2

Wigley Hull. SeaFEM - Validation Case 2 SeaFEM - Validation Case 2 Wigley Hull Compass Ingeniería y Sistemas, SA T. +34 93 218 19 89 F. +34 93 396 97 46 E. info@compassis.com c/ Tuset, 8 7-2 Barcelona 08006 C.I.F.: A 62485180 1 Validation Case

More information

Hierarchical Divergence-Free Bases and Their Application to Particulate Flows

Hierarchical Divergence-Free Bases and Their Application to Particulate Flows V. Sarin 1 Department of Computer Science, Texas A&M University, College Station, TX 77843 e-mail: sarin@cs.tamu.edu A. H. Sameh Department of Computer Science, Purdue University, West Lafayette, IN 47907

More information

Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil

Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil Case C2.2: Turbulent, Transonic Flow over an RAE 2822 Airfoil Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts Institute of Technology I. Code Description ProjectX

More information

Iterative methods for use with the Fast Multipole Method

Iterative methods for use with the Fast Multipole Method Iterative methods for use with the Fast Multipole Method Ramani Duraiswami Perceptual Interfaces and Reality Lab. Computer Science & UMIACS University of Maryland, College Park, MD Joint work with Nail

More information

Parallel Implementations of Gaussian Elimination

Parallel Implementations of Gaussian Elimination s of Western Michigan University vasilije.perovic@wmich.edu January 27, 2012 CS 6260: in Parallel Linear systems of equations General form of a linear system of equations is given by a 11 x 1 + + a 1n

More information

Techniques for Optimizing FEM/MoM Codes

Techniques for Optimizing FEM/MoM Codes Techniques for Optimizing FEM/MoM Codes Y. Ji, T. H. Hubing, and H. Wang Electromagnetic Compatibility Laboratory Department of Electrical & Computer Engineering University of Missouri-Rolla Rolla, MO

More information

1 Exercise: 1-D heat conduction with finite elements

1 Exercise: 1-D heat conduction with finite elements 1 Exercise: 1-D heat conduction with finite elements Reading This finite element example is based on Hughes (2000, sec. 1.1-1.15. 1.1 Implementation of the 1-D heat equation example In the previous two

More information

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution P. BURDA a,, J. NOVOTNÝ b,, J. ŠÍSTE a, a Department of Mathematics Czech University of Technology

More information

Simulation of Offshore Wave Impacts with a Volume of Fluid Method. Tim Bunnik Tim Bunnik MARIN

Simulation of Offshore Wave Impacts with a Volume of Fluid Method. Tim Bunnik Tim Bunnik MARIN Simulation of Offshore Wave Impacts with a Volume of Fluid Method Tim Bunnik Tim Bunnik MARIN Outline Part I: Numerical method -Overview Part II: Applications - Dambreak - Wave run-up - Sloshing loads

More information

Optimal design of floating platform and substructure for a spar type wind turbine system

Optimal design of floating platform and substructure for a spar type wind turbine system The 2012 World Congress on Advances in Civil, Environmental, and Materials Research (ACEM 12) Seoul, Korea, August 26-30, 2012 Optimal design of floating platform and substructure for a spar type wind

More information

CE 601: Numerical Methods Lecture 5. Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati.

CE 601: Numerical Methods Lecture 5. Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati. CE 601: Numerical Methods Lecture 5 Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati. Elimination Methods For a system [A]{x} = {b} where [A]

More information

Iterative Sparse Triangular Solves for Preconditioning

Iterative Sparse Triangular Solves for Preconditioning Euro-Par 2015, Vienna Aug 24-28, 2015 Iterative Sparse Triangular Solves for Preconditioning Hartwig Anzt, Edmond Chow and Jack Dongarra Incomplete Factorization Preconditioning Incomplete LU factorizations

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 20: Sparse Linear Systems; Direct Methods vs. Iterative Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 26

More information

Parallel solution for finite element linear systems of. equations on workstation cluster *

Parallel solution for finite element linear systems of. equations on workstation cluster * Aug. 2009, Volume 6, No.8 (Serial No.57) Journal of Communication and Computer, ISSN 1548-7709, USA Parallel solution for finite element linear systems of equations on workstation cluster * FU Chao-jiang

More information

PARDISO Version Reference Sheet Fortran

PARDISO Version Reference Sheet Fortran PARDISO Version 5.0.0 1 Reference Sheet Fortran CALL PARDISO(PT, MAXFCT, MNUM, MTYPE, PHASE, N, A, IA, JA, 1 PERM, NRHS, IPARM, MSGLVL, B, X, ERROR, DPARM) 1 Please note that this version differs significantly

More information

NUMERICAL STUDY OF TWO DIFFERENT TYPES OF SEMI-SUBMERSIBLE PLATFORMS WITH MOORING SYSTEMS IN THE SEA

NUMERICAL STUDY OF TWO DIFFERENT TYPES OF SEMI-SUBMERSIBLE PLATFORMS WITH MOORING SYSTEMS IN THE SEA NUMERICAL STUDY OF TWO DIFFERENT TYPES OF SEMI-SUBMERSIBLE PLATFORMS WITH MOORING SYSTEMS IN THE SEA Yao Peng, Decheng Wan* State Key Laboratory of Ocean Engineering, School of Naval Architecture, Ocean

More information

(Sparse) Linear Solvers

(Sparse) Linear Solvers (Sparse) Linear Solvers Ax = B Why? Many geometry processing applications boil down to: solve one or more linear systems Parameterization Editing Reconstruction Fairing Morphing 1 Don t you just invert

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

Overview and Recent Developments of Dynamic Mesh Capabilities

Overview and Recent Developments of Dynamic Mesh Capabilities Overview and Recent Developments of Dynamic Mesh Capabilities Henrik Rusche and Hrvoje Jasak h.rusche@wikki-gmbh.de and h.jasak@wikki.co.uk Wikki Gmbh, Germany Wikki Ltd, United Kingdom 6th OpenFOAM Workshop,

More information

HPISD Eighth Grade Math

HPISD Eighth Grade Math HPISD Eighth Grade Math The student uses mathematical processes to: acquire and demonstrate mathematical understanding Apply mathematics to problems arising in everyday life, society, and the workplace.

More information

A 3D VOF model in cylindrical coordinates

A 3D VOF model in cylindrical coordinates A 3D VOF model in cylindrical coordinates Marmar Mehrabadi and Markus Bussmann Department of Mechanical and Industrial Engineering, University of Toronto Recently, volume of fluid (VOF) methods have improved

More information

GPU-based Parallel Reservoir Simulators

GPU-based Parallel Reservoir Simulators GPU-based Parallel Reservoir Simulators Zhangxin Chen 1, Hui Liu 1, Song Yu 1, Ben Hsieh 1 and Lei Shao 1 Key words: GPU computing, reservoir simulation, linear solver, parallel 1 Introduction Nowadays

More information

Factorization with Missing and Noisy Data

Factorization with Missing and Noisy Data Factorization with Missing and Noisy Data Carme Julià, Angel Sappa, Felipe Lumbreras, Joan Serrat, and Antonio López Computer Vision Center and Computer Science Department, Universitat Autònoma de Barcelona,

More information

Frequency Scaling and Energy Efficiency regarding the Gauss-Jordan Elimination Scheme on OpenPower 8

Frequency Scaling and Energy Efficiency regarding the Gauss-Jordan Elimination Scheme on OpenPower 8 Frequency Scaling and Energy Efficiency regarding the Gauss-Jordan Elimination Scheme on OpenPower 8 Martin Köhler Jens Saak 2 The Gauss-Jordan Elimination scheme is an alternative to the LU decomposition

More information

FINITE ELEMENT SOLUTION OF NAVIER-STOKES EQUATIONS USING KRYLOV SUBSPACE METHODS

FINITE ELEMENT SOLUTION OF NAVIER-STOKES EQUATIONS USING KRYLOV SUBSPACE METHODS HEFAT2014 10 th International Conference on Heat Transfer, Fluid Mechanics and Thermodynamics 14 16 July 2014 Orlando, Florida FINITE ELEMENT SOLUTION OF NAVIER-STOKES EQUATIONS USING KRYLOV SUBSPACE METHODS

More information

A PRIMAL-DUAL EXTERIOR POINT ALGORITHM FOR LINEAR PROGRAMMING PROBLEMS

A PRIMAL-DUAL EXTERIOR POINT ALGORITHM FOR LINEAR PROGRAMMING PROBLEMS Yugoslav Journal of Operations Research Vol 19 (2009), Number 1, 123-132 DOI:10.2298/YUJOR0901123S A PRIMAL-DUAL EXTERIOR POINT ALGORITHM FOR LINEAR PROGRAMMING PROBLEMS Nikolaos SAMARAS Angelo SIFELARAS

More information

ALTERNATIVE METHODS FOR THE NUMERICAL ANALYSIS OF RESPONSE OF SEMISUBMERSIBLE PLATFORMS IN WAVES

ALTERNATIVE METHODS FOR THE NUMERICAL ANALYSIS OF RESPONSE OF SEMISUBMERSIBLE PLATFORMS IN WAVES INSTITUT FRANCAIS DU PETROLE Direction de Recherche "Exploitation en Mer" 76.20 CB/jn 30 exemplaires N de ref. : 34 639 Etude B4463017 Novembre 1986 ALTERNATIVE METHODS FOR THE NUMERICAL ANALYSIS OF RESPONSE

More information

Floating Cylinder. SeaFEM - Validation Case 4

Floating Cylinder. SeaFEM - Validation Case 4 SeaFEM - Validation Case 4 Floating Cylinder Compass Ingeniería y Sistemas, SA T. +34 93 218 19 89 F. +34 93 396 97 46 E. info@compassis.com c/ Tuset, 8 7-2 Barcelona 08006 C.I.F.: A 62485180 1 Validation

More information

Parallel resolution of sparse linear systems by mixing direct and iterative methods

Parallel resolution of sparse linear systems by mixing direct and iterative methods Parallel resolution of sparse linear systems by mixing direct and iterative methods Phyleas Meeting, Bordeaux J. Gaidamour, P. Hénon, J. Roman, Y. Saad LaBRI and INRIA Bordeaux - Sud-Ouest (ScAlApplix

More information

The effect of irregular interfaces on the BDDC method for the Navier-Stokes equations

The effect of irregular interfaces on the BDDC method for the Navier-Stokes equations 153 The effect of irregular interfaces on the BDDC method for the Navier-Stokes equations Martin Hanek 1, Jakub Šístek 2,3 and Pavel Burda 1 1 Introduction The Balancing Domain Decomposition based on Constraints

More information

Least-Squares Fitting of Data with B-Spline Curves

Least-Squares Fitting of Data with B-Spline Curves Least-Squares Fitting of Data with B-Spline Curves David Eberly, Geometric Tools, Redmond WA 98052 https://www.geometrictools.com/ This work is licensed under the Creative Commons Attribution 4.0 International

More information

Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation

Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation Nikolai Sakharnykh - NVIDIA San Jose Convention Center, San Jose, CA September 21, 2010 Introduction Tridiagonal solvers very popular

More information

Contents. I Basics 1. Copyright by SIAM. Unauthorized reproduction of this article is prohibited.

Contents. I Basics 1. Copyright by SIAM. Unauthorized reproduction of this article is prohibited. page v Preface xiii I Basics 1 1 Optimization Models 3 1.1 Introduction... 3 1.2 Optimization: An Informal Introduction... 4 1.3 Linear Equations... 7 1.4 Linear Optimization... 10 Exercises... 12 1.5

More information

THE application of advanced computer architecture and

THE application of advanced computer architecture and 544 IEEE TRANSACTIONS ON ANTENNAS AND PROPAGATION, VOL. 45, NO. 3, MARCH 1997 Scalable Solutions to Integral-Equation and Finite-Element Simulations Tom Cwik, Senior Member, IEEE, Daniel S. Katz, Member,

More information

Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows

Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows Case C1.3: Flow Over the NACA 0012 Airfoil: Subsonic Inviscid, Transonic Inviscid, and Subsonic Laminar Flows Masayuki Yano and David L. Darmofal Aerospace Computational Design Laboratory, Massachusetts

More information

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001)

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001) An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (000/001) Summary The objectives of this project were as follows: 1) Investigate iterative

More information

RAPID COMPUTATION OF THE DISCRETE FOURIER TRANSFORM*

RAPID COMPUTATION OF THE DISCRETE FOURIER TRANSFORM* SIAM J. ScI. COMPUT. Vol. 17, No. 4, pp. 913-919, July 1996 1996 Society for Industrial and Applied Mathematics O08 RAPID COMPUTATION OF THE DISCRETE FOURIER TRANSFORM* CHRIS ANDERSON AND MARIE DILLON

More information

Solving Sparse Linear Systems. Forward and backward substitution for solving lower or upper triangular systems

Solving Sparse Linear Systems. Forward and backward substitution for solving lower or upper triangular systems AMSC 6 /CMSC 76 Advanced Linear Numerical Analysis Fall 7 Direct Solution of Sparse Linear Systems and Eigenproblems Dianne P. O Leary c 7 Solving Sparse Linear Systems Assumed background: Gauss elimination

More information

PARALLEL METHODS FOR SOLVING PARTIAL DIFFERENTIAL EQUATIONS. Ioana Chiorean

PARALLEL METHODS FOR SOLVING PARTIAL DIFFERENTIAL EQUATIONS. Ioana Chiorean 5 Kragujevac J. Math. 25 (2003) 5 18. PARALLEL METHODS FOR SOLVING PARTIAL DIFFERENTIAL EQUATIONS Ioana Chiorean Babeş-Bolyai University, Department of Mathematics, Cluj-Napoca, Romania (Received May 28,

More information

Approaches to Parallel Implementation of the BDDC Method

Approaches to Parallel Implementation of the BDDC Method Approaches to Parallel Implementation of the BDDC Method Jakub Šístek Includes joint work with P. Burda, M. Čertíková, J. Mandel, J. Novotný, B. Sousedík. Institute of Mathematics of the AS CR, Prague

More information

Experimental Validation of the Computation Method for Strongly Nonlinear Wave-Body Interactions

Experimental Validation of the Computation Method for Strongly Nonlinear Wave-Body Interactions Experimental Validation of the Computation Method for Strongly Nonlinear Wave-Body Interactions by Changhong HU and Masashi KASHIWAGI Research Institute for Applied Mechanics, Kyushu University Kasuga

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

A Fast Hierarchical Algorithm for Three-Dimensional Capacitance Extraction

A Fast Hierarchical Algorithm for Three-Dimensional Capacitance Extraction 330 IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 21, NO. 3, MARCH 2002 A Fast Hierarchical Algorithm for Three-Dimensional Capacitance Extraction Weiping Shi, Member,

More information

CFD Analysis of a Novel Hull Design for an Offshore Wind Farm Service Vessel

CFD Analysis of a Novel Hull Design for an Offshore Wind Farm Service Vessel CFD Analysis of a Novel Hull Design for an Offshore Wind Farm Service Vessel M. Shanley 1, J. Murphy 1, and P. Molloy 2 1 Hydraulics and Maritime, Civil and Environmental Engineering University College

More information

CFD FOR OFFSHORE APPLICATIONS USING REFRESCO. Arjen Koop - Senior Project Manager Offshore MARIN

CFD FOR OFFSHORE APPLICATIONS USING REFRESCO. Arjen Koop - Senior Project Manager Offshore MARIN CFD FOR OFFSHORE APPLICATIONS USING REFRESCO Arjen Koop - Senior Project Manager Offshore MARIN COMPUTATIONAL FLUID DYNAMICS (CFD) Advantages: Quantitative predictions Detailed insight in physical processes

More information

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

Large-scale Structural Analysis Using General Sparse Matrix Technique

Large-scale Structural Analysis Using General Sparse Matrix Technique Large-scale Structural Analysis Using General Sparse Matrix Technique Yuan-Sen Yang 1), Shang-Hsien Hsieh 1), Kuang-Wu Chou 1), and I-Chau Tsai 1) 1) Department of Civil Engineering, National Taiwan University,

More information