A Grid-Free, Nonlinear Shallow-Water Model with Moving Boundary

Size: px
Start display at page:

Download "A Grid-Free, Nonlinear Shallow-Water Model with Moving Boundary"

Transcription

1 A Grid-Free, Nonlinear Shallow-Water Model with Moving Boundary X. Zhou Y.C. Hon* Department of Mathematics, City University of Hong Kong, Kowloon Tong, Hong Kong K.F. Cheung Department of Ocean and Resources Engineering, University of Hawaii at Manoa, Honolulu, USA ABSTRACT: A meshless method based on the radial basis function is derived to solve the nonlinear, nondispersive shallow-water equations. The one-dimensional initboundary value problem has a fixed boundary at one end and a free boundary at the other. The formulation employs a Lagrangian-Eulerian scheme to track the movement of the free boundary and transform the problem to a time-independent domain. The radial basis function evaluates the spatial derivatives, while the Wilson-θ method integrates the development of the flow in time. The resulting model is applied to calculate the flow of floodwater resulting from dam collapse and the runup of a wave on a plane beach. Comparisons of the computed results with analytical and finite difference solutions demonstrate the accuracy and capability of this meshless model in engineering applications. AMS: 65N15, 65M30, 35R25 Key words: meshless, radial basis functions, shallow-water equations, moving boundary * Corresponding author The work described in this paper was partially supported by a grant from CityU (Project No ) 1

2 1. Introduction A wide variety of numerical solutions have been proposed for the nonlinear, shallow-water equations with moving boundaries. The finite difference method, owing to its flexibility in programming and ease of application, has been one of the commonly used approaches. Besides other complexities, which are generally amenable to computation, the main challenge lies in capturing the moving waterlines. Researchers have developed several strategies to treat this problem. The first approach is to adjust the boundary from grid to grid, or obtaining a local solution at the waterline by extrapolation (e.g., Titov et al. [1], Liu et al. [2], Zelt et al. [3], and Bellos et al. [4] ). Another approach is to transform the boundary value problem to a time-invariant domain using a Lagrangian-Eulerian scheme (Zhang et al. [5]). This approach, however, gives rise to several new nonlinear terms in the governing equations that render the numerical computation considerably more complicated. The present paper investigate the use of the newly developed radial basis function method to the solution of this moving-boundary problem. The idea is to form a basis function space V = {ϕ( x x j )}, where x x j denotes the radial distance between any point x and the given scattered data point x j. Powell [6] and Wu [7] discussed the application of this method for scattered data interpolation. This function space can also be used for approximating the solutions of partial differential and integral equations (e.g., Kansa [8] and Golberg and Chen [9]). Hon et al. further extended the applications of RBFs method to the numerical solutions of various ordinary and partial differential equations including general initial value problems [11], nonlinear Burgers equation with shock wave [12], shallow water equation for tide and currents simulation under irregular boundary [13], and free boundary problems like American option pricing [14][15]. The computations showed the definite advantages in using this truly mesh-free method for solving various initial and boundary values problems. Furthermore, this representation enjoys the benefit of spatial independence and data structure is flexible. The existence, uniqueness, and convergence proofs in applying the RBFs were given by Micchelli [16], Powell [17], Madych and Nelson [18] for scattered data interpolation and Wu [19], Franke and Schaback [20], and Wendland [21] for solving PDEs respectively. In these papers, two important features of the RBFs method had been observed: (1) it is a truly mesh-free algorithm; and (2) it is spatial dimension independent in the sense that the convergence order is of O(h d+1 ) (one of the estimates for MQ), where h is the density of the 2

3 collocation points and d is the spatial dimension. In other words, as the spatial dimension of the problem increases, the convergence order also increases and hence much fewer scattered collocation points will be needed to maintain the same accuracy. In particular, Golberg and Chen [10] showed that a three-dimensional Poisson equation could be solved with only 60 randomly distributed knots to the same degree of accuracy as a FEM solution with 71,000 linear elements. This paper describes the application of the radial basis function to provide a solution for the nonlinear, nondispersive shallow water equations in the Lagrangian-Eulerian form. The use of the radial basis function in principle saves the computational time for evaluating the approximation of the solution and its derivatives. Furthermore, since the radial basis functions are smooth, it can easily be applied to solve high order differential equations. The one-dimensional model is applied to calculate the flow of floodwater resulting from dam collapse and the runup of a solitary wave on a plane beach. The performance of the model is evaluated against the analytic solutions and finite difference solutions of the problems. 2. Mathematical Model The nonlinear, nondispersive shallow-water model is based on the assumptions of hydrostatic pressure and uniform velocity distribution in the depth direction. The governing equations in the Eulerian form are given by y t + [(h + y)u] ζ = 0, (1) u t + uu ζ + gy ζ = 0, (2) where y=wave amplitude, u=depth-average velocity, h=undisturbed water depth, g=acceleration of gravity, and the time t and the spatial variable ζ in subscript denote partial differentiation. In the case of moving boundary problems, the Lagrangian-Eulerian hybrid method [5] was introduced to exactly capture the moving waterlines by combining the Lagrangian description for the moving waterline with the Eulerian description for the interior flow field. Let X(t) denote the position of the mass at waterline, then dx dt = u(x(t), t) = U 0(t). (3) 3

4 Transforming equation (2) to the Lagrangian form, we get du 0 dt = gy(x(t), t) ζ, (4) where U 0 (t) represents the Lagrangian velocity of the mass at the waterline. Introducing a geometric transformation ζ = (1 + X/L)x + X and t = t (5) the variable domain with the original region, say, [-L, 0], can be converted to a fixed one. In equation (5), X(t) locates the moving waterline and L is the other open end of the computation region. By the above transformation, the time-varying region L ζ X(t) is transformed into a fixed region L x 0. And then the equations (1), (2) and (4) become y t c 1 U 0 y x + c 2 [(h + y)u] x = 0, (6) u t c 1 U 0 u x + c 2 (uu x + gy x ) = 0, (7) du 0 dt = c 2 gy(0, t) x, (8) respectively, where c 1 = c 1 (x, t) = 1 + x/a 1 + X/A, (9) c 2 = c 2 (t) = X/A. (10) 4

5 3. Radial Basis Function Algorithm The idea of the meshless RBFs method is to represent an unknown function f(x), x R d by the following linear combination M f(x, t) λ j (t)φ j (x), (11) j=1 where x j are M distinct points in R d, λ j are unknown coefficients, and φ j (x) = φ( x x j ) are called radial basis functions because the Euclidean norm x x j represents the radial distance of x from x j. Denote the radial distance r = x y, x, y R d. The commonly used RBFs φ(r) are: multiquadrics : (r 2 + c 2 ) β/2, β > 0, β (2N + 1) inverse multiquaqrics : (r 2 + c 2 ) β/2, β < 0, β (2N + 1) Gaussians : exp( c 2 r 2 ) thin plate splines : r β log r, β > 0, β 2N smoothing splines : r β, β > 0, β (2N + 1) where c is called a shape parameter. Based on the RBFs method, we Assume that the unknown solutions y and u in equations (6) and (7) are approximated by the RBFs interpolants as follows: M y(x, t) = λ j (t)φ j (x), (12) j=1 M u(x, t) = γ j (t)φ j (x). (13) j=1 Collocating (12) and (13) at the M points (x i, i = 1, 2,..., M) we obtain the following system of equations for the undetermined coefficients λ j and γ j : Φ 0 0 Φ Λ Γ + (c 2u c 1 U)Φ x c 2 gφ x c 2 (h + y)φ x + c 2 h x Φ Λ = 0, (14) (c 2 u c 1 U)Φ x Γ 0 where Φ = [φ j (x i )], i, j = 1, 2,..., M, (15) [ ] d Φ x = dx φ j(x), x = x i, i, j = 1, 2,..., M, (16) 5

6 Λ = [λ j ] T, and Λ = [ dλ j dt ]T j = 1, 2,..., M, (17) Γ = [γ j ] T, and Γ = [ dγ j dt ]T j = 1, 2,..., M. (18) By representing the system of equations (14) in the matrix form: [P ][Ḃ] + [Q][B] = F, (19) where [B] = Λ, Γ [Ḃ] = Λ, Γ [P ] = Φ 0, [Q] = (c 2u c 1 U)Φ x 0 Φ c 2 gφ x and [F] is a vector, we get, at each time step t = t n, c 2 (h + y)φ x + c 2 h x Φ (c 2 u c 1 U)Φ x, [P ] n [Ḃ]n + [Q] n [B] n = [F ] n, (20) U n 0 = c 2 gy(0, t n ) x, (21) and Ẋ n = U n 0 (22) respectively from equations (19), (8) and (3). By Employing the Wilson-θ method to B n and similarly to U n 0 (3) to and [B] n = [B] n 1 + t [ (1 θ)[ḃ]n 1 + θ[ḃ]n], (23) and Xn, we further discretize respectively the equations (19), (8) and [[P ] n θ t[q] n ] [Ḃ]n = [F ] n [Q] n [ [B] n 1 + (1 θ) t[ḃ]n 1], (24) U n 0 = U0 n 1 + t [ ] n 1 (1 θ) U 0 θc 2 gy(0, t n ) x, (25) X n = X n 1 + t [ (1 θ)ẋn 1 + θu n 0 ], (26) where 0 θ 1. When θ equals to zero or one, the integration scheme given by equation (23) is explicit and may need an extra stability constraint for convergence. In the following computations, we choose θ to be 0.5 so that the time integration scheme is implicit and unconditional stable. Furthermore, the Newton s iterative method for solving the nonlinear equation (24) is adopted for faster convergence. 6

7 4. Numerical Computations Dam-Break Flood-Wave Propagation on Dry Bed In order to verify the efficiency and accuracy of the meshless RBFs method devised in the last section, we first apply the method to calculate the flow of floodwater resulting from dam collapse in a reservoir (refer Figure 1). The depth of the reservoir is assumed to be constant. The bottom of the channel bottom is horizontal and friction is neglected. The analytical solution is given by Stoker [22] as: u(ζ, t) = 2 ( ) ζ 3 t + c 0, ( c 0 t ζ 2c 0 t, t > 0), (27) y(ζ, t) = 1 ( ζ 2 0) 9g t + 2c h, ( c 0 t ζ 2c 0 t, t > 0), (28) where u denotes the velocity of the front flood-wave, y represents the depth of the floodwave, and c 0 = gh. The analytical solutions are valid when the dam collapses and the flood-wave propagates to the right-end of the reservoir. It can be observed from equations (27) and (28) that the propagation velocity of the front flood-wave, the water depth and the velocity of the water-wave at the dam site are having constant values of 2c 0, 4 9 h, and 2 3 c 0 respectively when y + h equals zero. For the purpose of comparison, the finite difference method(fdm) is also applied to obtain numerical approximations to the solutions y and u of equations (6) and (7), in which the Richtmyer two-step Lax-Wendroff scheme is used: u n+1/2 i+1/2 y n+1/2 i+1/2 = 1 2 (yn i + yn i+1 ) + t 2 x c 1U 0 (y n i+1 yn i ) t = 1 2 (un i + un i+1 ) + t 2 x c 1U 0 (u n i+1 un i ) t 2 x c 2 2 x c [ 2 (h + y n i+1 )u n i+1 (h + ] yn i )un i, (29) [ 1 2 (un i+1 )2 + gy n i (un i )2 gy n i ], (30) where c 1 U 0 and c 2 are evaluated at the grid points (i + 1/2, n), and y n+1 i = yi n + t x c 1U 0 (y n+1/2 i+1/2 yn+1/2 i 1/2 ) t [ ] x c 2 (h + y n+1/2 i+1/2 )un+1/2 i+1/2 (h + yn+1/2 i 1/2 )un+1/2 i 1/2, (31) u n+1 i = u n i + t x c 1U 0 (u n+1/2 i+1/2 un+1/2 i 1/2 ) t [ 1 x c 2 2 (un+1/2 i+1/2 )2 + gy n+1/2 i+1/2 1 ] 2 (un+1/2 i 1/2 )2 gy n+1/2 i 1/2, (32) where c 1 U 0 and c 2 are evaluated at the grid points (i, n). The comparison on the numerical RBFs and FDM results and the analytical solution are given in Figure 1. The values of the parameters used in the computations are as follow: 7

8 The original spatial domain: [-10m, 0] Time domain: [0, 12s] The original water depth behind the dam: h=1m The total number of time steps: 600 (in RBFs) and 1200 (in FDM) The total number of points: 101 (in RBFs) and 201 (in FDM) The radial basis function used: r 3 In the numerical computation, the boundary conditions y(0, t) = h, u( 10, t) = 0 are imposed which leads to the following equations used in (14): M λ j (t)φ j (x M ) = h, j=1 and M γ j (t)φ j (x 1 ) = 0. j=1 Figure 1 and Figure 2 give respectively the time profiles of the water-surface and the floodflow, where the analytical solution at time t = 1.7s is marked with star for comparison. It can be observed that the numerical results are in excellent agreement with the analytical solution. Figure 3 demonstrates the propagation of the water-front with the stars indicating the analytical solution before the front of the flood-wave moves to the right-end of the reservoir. The numerical results show that the propagation velocity of the water-front is always equal to the constant 2c 0, which matches with the analytical solution. The numerical results on the water depth are shown in Figure 4, where the stars indicate the exact solution, indicate that the water depth remains constant before the front flood-wave extends to the right-end of the reservoir. In the numerical comparisons, the maximum relative error is less than the magnitude of We remark here that although the numerical results obtained by FDM as illustrated in Figures 1-3 are also in good agreement with the analytical solutions, the FDM method needs more time steps and denser grid density than the proposed meshless RBFs method for the same convergence and accuracy. 8

9 Wave Run-up on Sloping Plane Beach Secondly, we apply the RBFs method to successfully simulate the run-up of a long wave from an open ocean of depth h 0 on an uniform plane beach. The original water depth function is assumed to be: h = { αζ ( h 0 α ζ 0 ), h 0 ( x < h 0 α ), (33) where ζ represents the spatial horizontal coordinate and α denotes the slope of the plane beach. The wave is given as: ū(t) = Asin(ωt), (34) which is originally located L meters from the shoreline of the beach. domain is assumed to be [ L, 0]. The boundary conditions are: The fixed solution y(0, t) = αx(t), u( L, t) = ū(t). The initial conditions are taken to be: u(x, 0) = 0, y(x, 0) = 0. The parameters used in the computations are: h 0 = 1m, α = 0.5, A = 0.06, ω = g, L = 12m Time domain: [0, 10s] The total number of time steps: 500 The total number of the points used: 101 The radial basis function used: (r ) 1 2. The numerical simulation of the wave run-up and run-down at the slope of the beach is shown in Figure 5 and Figure 6. It can be observed from the figures that the RBFs method has successfully simulated the complicated wave runup phenomena, which is still considered to be a tedious numerical task by using the traditional finite difference or finite element methods. 9

10 5. Conclusions The meshless radial basis functions(rbfs) method combined with the Lagrangian-Eulerian hybrid scheme is devised in this paper to solve the nonlinear, nondispersive shallow-water equations with moving boundary. The advantages of the meshless method are demonstrated by applying the method to successfully obtain the numerical approximations of the solutions to the flood-flow in the dam-break problem and the wave run-up and run-down in the run-up problem. The resultant coefficient matrix of the system of equations resulted from the RBFs method is usually full and unsymmetric and hence leads to an ill-conditioning problem. The recently developed domain decomposition method for RBFs approximation by Hon et al. [23] has enabled the applications of the method to solve larger scale problems. This will be our future work in the simulation of a dimension wave run-up problem. 10

11 References [1] J.E. Zhang, T.Y. Wu, and T.Y. Hou, Coastal hydrodynamics of ocean waves on beach, Advances in Applied Mechanics, 37, , (2001). [2] V.V. Tito and C.E. Synolakis, Numerical modeling of tidal wave runup, Journal of Water, Port, Coastal, and Ocean Engineering, 124, , (1998). [3] P.L.-F. Liu, Y.-S. Cho, M.J. Briggs, U. Kanoglu, and C.E. Synolakis, Runup of solitary waves on a circular island, J. Fluid Mech., 302, , (1995). [4] J.A. Zelt and F. Raichlen, Overland flow from solitary waves, Journal of Water, Port, Coastal, and Ocean Engineering, 117, , (1991). [5] C.V. Bellos and J.G. Sakkas, 1-D dam-break flood-wave propagation on dry bed, Journal of Hydraulic Engineering, 113, , (1987). [6] M.J.D. Powell, Radial basis functions for multivariable interpolation: a review, in: Numerical Analysis, D. F. Griffiths and G. A. Watson, eds., Longman Scientific & Technical (Harlow), , [7] Z.M. Wu, Hermite-Bikhoff interpolation of scattered data by radial basis function, Approximation Theory and its Application, 8, 1-10, (1992). [8] E.J. Kansa, Multiquadrics - a scattered data approximation scheme with applications to computational fluid dynamics - II. Solution to parabolic, hyperbolic and elliptic partial differential equations, Computers Math. Applic., 19, , (1990). [9] M.A. Golberg and C.S. Chen, The theory of radial basis functions applied to the BEM for inhomogeneous partial differential equations, Boundary Elements Communications, 5, 57-61, (1994). [10] M.A. Golberg and C.S. Chen, Discrete projection methods for integral equations, Comput. Mech. Publ., Boston, MA, (1997). [11] Y.C. Hon and X.Z. Mao, A multiquadric interpolation method for solving initial value problems, Sci. Comput., 12, 51-55, (1997). [12] Y.C. Hon and X.Z. Mao, An efficient numerical scheme for Burgers equation, Appl. Math. Comput., 95, 37-50, (1998). 11

12 [13] Y.C. Hon, K.F. Cheung, X.Z. Mao, and E.J. Kansa, A multiquadric solution for shallow water equation, ASCE Journal of Hydraulic Engineering, 125, , (1999). [14] Y.C. Hon and X.Z. Mao, A radial basis function method for solving options pricing model, Journal of Financial Engineering, 8, 31-49, (1999). [15] Y.C. Hon and X. Zhou, A comparison on using various radial basis functions for options pricing, Int. J. Appl. Sci. Comput., 7, 29-47, (2000). [16] C.A. Micchelli, Interpolation of scattered data: distance matrices and conditionally positive definite functions, Constructive Approximation, 2, 11-22, (1986). [17] M.J.D. Powell, The theory of radial basis function approximation in 1990, in: Advances in Numerical Analysis Vol. 2, W. Light, ed., Clarendon Press, Oxford, (1992), [18] W.R. Madych and S.A. Nelson, Multivariate interpolation and conditionally positive definite functions, Approx. Theory and its Appl. 4, 77-89, (1988). [19] Z. Wu, Solving PDE with radial basis functions, in: Advances in Computational Mathematics, Lecture Notes on Pure and Applied Mathematics, 202, Z. Chen, Y. Li, C.A. Micchelli, Y. Xu, and M. Dekker, GuangZhou, eds., (1998). [20] C. Franke and R. Schaback, Solving partial differential equations by collocation using radial basis functions, Appl. Math. Comput., 93, 73-82, (1998). [21] H. Wendland, Meshless Galerkin methods using radial basis functions, Math. Comp., 119, , (2001). [22] J.J. Stoker, Water waves, John Wiley & Sons, Inc., (1992). [23] X. Zhou, Y.C. Hon, and J.C. Li, Overlapping domain decomposition method by radial basis functions, Applied Numerical Mathematics, in press. 12

13 Depth of Water(m) t=3.3 t=4.9 t=6.5 t=8.1 t=9.7 t=11.3 t=1.7 t=0.1 Analytical Solutions o FDM Results RBFs Results Horizontal Position(m) * Figure 1. Water-surface profile in the dam break problem 13

14 t=0.1 t=1.7 t=3.3 t=4.9 t=6.5 t=8.1 t=9.7 Velocity of Water(m/s) t=11.3 Analytical Solutions * o FDM Results RBFs Results Horizontal Position(m) Figure 2. Velocity Distribution of the flood-flow field in the dam break problem 14

15 Wave Front Position(m) * Analytical Solutions o FDM Results RBFs Results Time(s) Figure 3. Propagation of the water-front in the dam break problem 15

16 Depth of the Water at the Location of the Dam(m) Time(s) Figure 4. History of water-depth at the dam-site in the dam break problem 16

17 t=4.8s 0.03 t=4.4s 0.02 Wave Elevation(m) t=3.8s t=5.4s t=5.8s Horizontal Position(m) Figure 5. Profile of wave run-up and run-down on the sloping plane beach 17

18 Vertical Amplitude of Run up and Run down(m) Time(s) Figure 6. Vertical Amplitude of the wave in the run-up problem 18

Collocation and optimization initialization

Collocation and optimization initialization Boundary Elements and Other Mesh Reduction Methods XXXVII 55 Collocation and optimization initialization E. J. Kansa 1 & L. Ling 2 1 Convergent Solutions, USA 2 Hong Kong Baptist University, Hong Kong

More information

A Random Variable Shape Parameter Strategy for Radial Basis Function Approximation Methods

A Random Variable Shape Parameter Strategy for Radial Basis Function Approximation Methods A Random Variable Shape Parameter Strategy for Radial Basis Function Approximation Methods Scott A. Sarra, Derek Sturgill Marshall University, Department of Mathematics, One John Marshall Drive, Huntington

More information

Determining optimal value of the shape parameter c in RBF for unequal distances topographical points by Cross-Validation algorithm

Determining optimal value of the shape parameter c in RBF for unequal distances topographical points by Cross-Validation algorithm Journal of Mathematical Modeling Vol. 5, No. 1, 2017, pp. 53-60 JMM Determining optimal value of the shape parameter c in RBF for unequal distances topographical points by Cross-Validation algorithm Mohammadreza

More information

New Basis Functions and Their Applications to PDEs

New Basis Functions and Their Applications to PDEs Copyright c 2007 ICCES ICCES, vol.3, no.4, pp.169-175, 2007 New Basis Functions and Their Applications to PDEs Haiyan Tian 1, Sergiy Reustkiy 2 and C.S. Chen 1 Summary We introduce a new type of basis

More information

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

The Method of Particular Solutions for Solving Certain Partial Differential Equations

The Method of Particular Solutions for Solving Certain Partial Differential Equations The Method of Particular Solutions for Solving Certain Partial Differential Equations C.S. Chen, C.M. Fan, P.H. Wen Abstract A standard approach for solving linear partial differential equations is to

More information

INTERNATIONAL JOURNAL OF CIVIL AND STRUCTURAL ENGINEERING Volume 2, No 3, 2012

INTERNATIONAL JOURNAL OF CIVIL AND STRUCTURAL ENGINEERING Volume 2, No 3, 2012 INTERNATIONAL JOURNAL OF CIVIL AND STRUCTURAL ENGINEERING Volume 2, No 3, 2012 Copyright 2010 All rights reserved Integrated Publishing services Research article ISSN 0976 4399 Efficiency and performances

More information

Meshless physical simulation of semiconductor devices using a wavelet-based nodes generator

Meshless physical simulation of semiconductor devices using a wavelet-based nodes generator Meshless physical simulation of semiconductor devices using a wavelet-based nodes generator Rashid Mirzavand 1, Abdolali Abdipour 1a), Gholamreza Moradi 1, and Masoud Movahhedi 2 1 Microwave/mm-wave &

More information

The Method of Approximate Particular Solutions for Solving Elliptic Problems with Variable Coefficients

The Method of Approximate Particular Solutions for Solving Elliptic Problems with Variable Coefficients The Method of Approximate Particular Solutions for Solving Elliptic Problems with Variable Coefficients C.S. Chen, C.M. Fan, P.H. Wen Abstract A new version of the method of approximate particular solutions

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

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

Application of Finite Volume Method for Structural Analysis

Application of Finite Volume Method for Structural Analysis Application of Finite Volume Method for Structural Analysis Saeed-Reza Sabbagh-Yazdi and Milad Bayatlou Associate Professor, Civil Engineering Department of KNToosi University of Technology, PostGraduate

More information

Tsunami coastal impact The use of VOF-URANS methods with examples

Tsunami coastal impact The use of VOF-URANS methods with examples Tsunami coastal impact The use of VOF-URANS methods with examples Richard MARCER 2 Content Coastal impact : physics to simulate EOLE CFD : a 3D Navier-Stokes code Focus on the VOF free surface method Examples

More information

Corrected/Updated References

Corrected/Updated References K. Kashiyama, H. Ito, M. Behr and T. Tezduyar, "Massively Parallel Finite Element Strategies for Large-Scale Computation of Shallow Water Flows and Contaminant Transport", Extended Abstracts of the Second

More information

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

Chapter 6. Semi-Lagrangian Methods

Chapter 6. Semi-Lagrangian Methods Chapter 6. Semi-Lagrangian Methods References: Durran Chapter 6. Review article by Staniford and Cote (1991) MWR, 119, 2206-2223. 6.1. Introduction Semi-Lagrangian (S-L for short) methods, also called

More information

Approximation of a Fuzzy Function by Using Radial Basis Functions Interpolation

Approximation of a Fuzzy Function by Using Radial Basis Functions Interpolation International Journal of Mathematical Modelling & Computations Vol. 07, No. 03, Summer 2017, 299-307 Approximation of a Fuzzy Function by Using Radial Basis Functions Interpolation R. Firouzdor a and M.

More information

A meshfree weak-strong form method

A meshfree weak-strong form method A meshfree weak-strong form method G. R. & Y. T. GU' 'centre for Advanced Computations in Engineering Science (ACES) Dept. of Mechanical Engineering, National University of Singapore 2~~~ Fellow, Singapore-MIT

More information

Lax-Wendroff and McCormack Schemes for Numerical Simulation of Unsteady Gradually and Rapidly Varied Open Channel Flow

Lax-Wendroff and McCormack Schemes for Numerical Simulation of Unsteady Gradually and Rapidly Varied Open Channel Flow Archives of Hydro-Engineering and Environmental Mechanics Vol. 60 (2013), No. 1 4, pp. 51 62 DOI: 10.2478/heem-2013-0008 IBW PAN, ISSN 1231 3726 Lax-Wendroff and McCormack Schemes for Numerical Simulation

More information

Meshless techniques for convection dominated problems

Meshless techniques for convection dominated problems Comput. Mech. (2006) 38: 171 182 DOI 10.1007/s00466-005-0736-8 ORIGINAL PAPER Y. T. Gu G. R. Liu Meshless techniques for convection dominated problems Received: 10 October 2004 / Accepted: 28 June 2005

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

More information

Level Set Methods and Fast Marching Methods

Level Set Methods and Fast Marching Methods Level Set Methods and Fast Marching Methods I.Lyulina Scientific Computing Group May, 2002 Overview Existing Techniques for Tracking Interfaces Basic Ideas of Level Set Method and Fast Marching Method

More information

Recent Developments in Model-based Derivative-free Optimization

Recent Developments in Model-based Derivative-free Optimization Recent Developments in Model-based Derivative-free Optimization Seppo Pulkkinen April 23, 2010 Introduction Problem definition The problem we are considering is a nonlinear optimization problem with constraints:

More information

C. A. D. Fraga Filho 1,2, D. F. Pezzin 1 & J. T. A. Chacaltana 1. Abstract

C. A. D. Fraga Filho 1,2, D. F. Pezzin 1 & J. T. A. Chacaltana 1. Abstract Advanced Computational Methods and Experiments in Heat Transfer XIII 15 A numerical study of heat diffusion using the Lagrangian particle SPH method and the Eulerian Finite-Volume method: analysis of convergence,

More information

Control Volume Finite Difference On Adaptive Meshes

Control Volume Finite Difference On Adaptive Meshes Control Volume Finite Difference On Adaptive Meshes Sanjay Kumar Khattri, Gunnar E. Fladmark, Helge K. Dahle Department of Mathematics, University Bergen, Norway. sanjay@mi.uib.no Summary. In this work

More information

Acknowledgements. Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn. SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar

Acknowledgements. Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn. SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar Philipp Hahn Acknowledgements Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar 2 Outline Motivation Lumped Mass Model Model properties Simulation

More information

Long time integrations of a convective PDE on the sphere by RBF collocation

Long time integrations of a convective PDE on the sphere by RBF collocation Long time integrations of a convective PDE on the sphere by RBF collocation Bengt Fornberg and Natasha Flyer University of Colorado NCAR Department of Applied Mathematics Institute for Mathematics Applied

More information

PARAMETRIC SHAPE AND TOPOLOGY OPTIMIZATION WITH RADIAL BASIS FUNCTIONS

PARAMETRIC SHAPE AND TOPOLOGY OPTIMIZATION WITH RADIAL BASIS FUNCTIONS PARAMETRIC SHAPE AND TOPOLOGY OPTIMIZATION WITH RADIAL BASIS FUNCTIONS Michael Yu Wang 1 and Shengyin Wang 1 Department of Automation and Computer-Aided Engineering The Chinese University of Hong Kong

More information

Third Order WENO Scheme on Three Dimensional Tetrahedral Meshes

Third Order WENO Scheme on Three Dimensional Tetrahedral Meshes COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol. 5, No. 2-4, pp. 86-848 Commun. Comput. Phys. February 29 Third Order WENO Scheme on Three Dimensional Tetrahedral Meshes Yong-Tao Zhang 1, and Chi-Wang Shu

More information

Introduction to Computer Graphics. Modeling (3) April 27, 2017 Kenshi Takayama

Introduction to Computer Graphics. Modeling (3) April 27, 2017 Kenshi Takayama Introduction to Computer Graphics Modeling (3) April 27, 2017 Kenshi Takayama Solid modeling 2 Solid models Thin shapes represented by single polygons Unorientable Clear definition of inside & outside

More information

Realtime Water Simulation on GPU. Nuttapong Chentanez NVIDIA Research

Realtime Water Simulation on GPU. Nuttapong Chentanez NVIDIA Research 1 Realtime Water Simulation on GPU Nuttapong Chentanez NVIDIA Research 2 3 Overview Approaches to realtime water simulation Hybrid shallow water solver + particles Hybrid 3D tall cell water solver + particles

More information

Prof. B.S. Thandaveswara. The computation of a flood wave resulting from a dam break basically involves two

Prof. B.S. Thandaveswara. The computation of a flood wave resulting from a dam break basically involves two 41.4 Routing The computation of a flood wave resulting from a dam break basically involves two problems, which may be considered jointly or seperately: 1. Determination of the outflow hydrograph from the

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

Solve Non-Linear Parabolic Partial Differential Equation by Spline Collocation Method

Solve Non-Linear Parabolic Partial Differential Equation by Spline Collocation Method Solve Non-Linear Parabolic Partial Differential Equation by Spline Collocation Method P.B. Choksi 1 and A.K. Pathak 2 1 Research Scholar, Rai University,Ahemdabad. Email:pinalchoksey@gmail.com 2 H.O.D.

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with:

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with: The Lecture deals with: Some more Suggestions for Improvement of Discretization Schemes Some Non-Trivial Problems with Discretized Equations file:///d /chitra/nptel_phase2/mechanical/cfd/lecture13/13_1.htm[6/20/2012

More information

MODELLING THE FLOW AROUND AN ISLAND AND A HEADLAND: APPLICATION OF A TWO MIXING LENGTH MODEL WITH TELEMAC3D. Nicolas Chini 1 and Peter K.

MODELLING THE FLOW AROUND AN ISLAND AND A HEADLAND: APPLICATION OF A TWO MIXING LENGTH MODEL WITH TELEMAC3D. Nicolas Chini 1 and Peter K. MODELLING THE FLOW AROUND AN ISLAND AND A HEADLAND: APPLICATION OF A TWO MIXING LENGTH MODEL WITH TELEMAC3D Nicolas Chini 1 and Peter K. Stansby 2 Numerical modelling of the circulation around islands

More information

Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2

Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2 Finite Element Convergence for Time-Dependent PDEs with a Point Source in COMSOL 4.2 David W. Trott and Matthias K. Gobbert Department of Mathematics and Statistics, University of Maryland, Baltimore County,

More information

Adaptive Node Selection in Periodic Radial Basis Function Interpolations

Adaptive Node Selection in Periodic Radial Basis Function Interpolations Adaptive Node Selection in Periodic Radial Basis Function Interpolations Muhammad Shams Dept. of Mathematics UMass Dartmouth Dartmouth MA 02747 Email: mshams@umassd.edu December 19, 2011 Abstract In RBFs,

More information

A stable moving-particle semi-implicit method for free surface flows

A stable moving-particle semi-implicit method for free surface flows Fluid Dynamics Research 38 (2006) 241 256 A stable moving-particle semi-implicit method for free surface flows B. Ataie-Ashtiani, Leila Farhadi Department of Civil Engineering, Sharif University of Technology,

More information

An iterative adaptive multiquadric radial basis function method for the detection of local jump discontinuities

An iterative adaptive multiquadric radial basis function method for the detection of local jump discontinuities * Manuscript An iterative adaptive multiquadric radial basis function method for the detection of local jump discontinuities Vincent R. Durante a, Jae-Hun Jung b a Department of Mathematics, University

More information

Solution for Euler Equations Lagrangian and Eulerian Descriptions

Solution for Euler Equations Lagrangian and Eulerian Descriptions Solution for Euler Equations Lagrangian and Eulerian Descriptions Valdir Monteiro dos Santos Godoi valdir.msgodoi@gmail.com Abstract We find an exact solution for the system of Euler equations, following

More information

NUMERICAL SIMULATION OF THE SHALLOW WATER EQUATIONS USING A TIME-CENTERED SPLIT-IMPLICIT METHOD

NUMERICAL SIMULATION OF THE SHALLOW WATER EQUATIONS USING A TIME-CENTERED SPLIT-IMPLICIT METHOD 18th Engineering Mechanics Division Conference (EMD007) NUMERICAL SIMULATION OF THE SHALLOW WATER EQUATIONS USING A TIME-CENTERED SPLIT-IMPLICIT METHOD Abstract S. Fu University of Texas at Austin, Austin,

More information

3D Nearest-Nodes Finite Element Method for Solid Continuum Analysis

3D Nearest-Nodes Finite Element Method for Solid Continuum Analysis Adv. Theor. Appl. Mech., Vol. 1, 2008, no. 3, 131-139 3D Nearest-Nodes Finite Element Method for Solid Continuum Analysis Yunhua Luo Department of Mechanical & Manufacturing Engineering, University of

More information

Modeling Khowr-e Musa Multi-Branch Estuary Currents due to the Persian Gulf Tides Using NASIR Depth Average Flow Solver

Modeling Khowr-e Musa Multi-Branch Estuary Currents due to the Persian Gulf Tides Using NASIR Depth Average Flow Solver Journal of the Persian Gulf (Marine Science)/Vol.1/No.1/September 2010/6/45-50 Modeling Khowr-e Musa Multi-Branch Estuary Currents due to the Persian Gulf Tides Using NASIR Depth Average Flow Solver Sabbagh-Yazdi,

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

RBF Interpolation with CSRBF of Large Data Sets

RBF Interpolation with CSRBF of Large Data Sets RBF Interpolation with CSRBF of Large Data Sets Vaclav Skala University of West Bohemia, Plzen, Czech Republic. www.vaclavskala.eu Abstract This contribution presents a new analysis of properties of the

More information

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Stefan Vater 1 Kaveh Rahnema 2 Jörn Behrens 1 Michael Bader 2 1 Universität Hamburg 2014 PDES Workshop 2 TU München Partial

More information

CHAPTER 1. Introduction

CHAPTER 1. Introduction ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization

More information

Solving a Two Dimensional Unsteady-State. Flow Problem by Meshless Method

Solving a Two Dimensional Unsteady-State. Flow Problem by Meshless Method Applied Mathematical Sciences, Vol. 7, 203, no. 49, 242-2428 HIKARI Ltd, www.m-hikari.com Solving a Two Dimensional Unsteady-State Flow Problem by Meshless Method A. Koomsubsiri * and D. Sukawat Department

More information

Computation of Incompressible Navier-Stokes Equations by Local RBF-based Differential Quadrature Method

Computation of Incompressible Navier-Stokes Equations by Local RBF-based Differential Quadrature Method Copyright c 25 Tech Science Press CMES, vol7, no2, pp95-25, 25 Computation of Incompressible Navier-Stokes Equations by Local RBF-based Differential Quadrature Method C Shu,2,HDing 2, KS Yeo 2 Abstract:

More information

Numerical Simulation of Tsunami Propagation and Runup: Case study on the South China Sea

Numerical Simulation of Tsunami Propagation and Runup: Case study on the South China Sea Numerical Simulation of Tsunami Propagation and Runup: Case study on the South China Sea By Phung D. Hieu Center for Marine and Ocean-Atmosphere Interaction Research, Vietnam Email: phungdanghieu@vkttv.edu.vn;

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

arxiv: v1 [math.na] 20 Sep 2016

arxiv: v1 [math.na] 20 Sep 2016 arxiv:1609.06236v1 [math.na] 20 Sep 2016 A Local Mesh Modification Strategy for Interface Problems with Application to Shape and Topology Optimization P. Gangl 1,2 and U. Langer 3 1 Doctoral Program Comp.

More information

Isogeometric Analysis of Fluid-Structure Interaction

Isogeometric Analysis of Fluid-Structure Interaction Isogeometric Analysis of Fluid-Structure Interaction Y. Bazilevs, V.M. Calo, T.J.R. Hughes Institute for Computational Engineering and Sciences, The University of Texas at Austin, USA e-mail: {bazily,victor,hughes}@ices.utexas.edu

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

3D Simulation of Dam-break effect on a Solid Wall using Smoothed Particle Hydrodynamic

3D Simulation of Dam-break effect on a Solid Wall using Smoothed Particle Hydrodynamic ISCS 2013 Selected Papers Dam-break effect on a Solid Wall 1 3D Simulation of Dam-break effect on a Solid Wall using Smoothed Particle Hydrodynamic Suprijadi a,b, F. Faizal b, C.F. Naa a and A.Trisnawan

More information

Asymptotic Error Analysis

Asymptotic Error Analysis Asymptotic Error Analysis Brian Wetton Mathematics Department, UBC www.math.ubc.ca/ wetton PIMS YRC, June 3, 2014 Outline Overview Some History Romberg Integration Cubic Splines - Periodic Case More History:

More information

Spline Solution Of Some Linear Boundary Value Problems

Spline Solution Of Some Linear Boundary Value Problems Applied Mathematics E-Notes, 8(2008, 171-178 c ISSN 1607-2510 Available free at mirror sites of http://www.math.nthu.edu.tw/ amen/ Spline Solution Of Some Linear Boundary Value Problems Abdellah Lamnii,

More information

An explicit feature control approach in structural topology optimization

An explicit feature control approach in structural topology optimization th World Congress on Structural and Multidisciplinary Optimisation 07 th -2 th, June 205, Sydney Australia An explicit feature control approach in structural topology optimization Weisheng Zhang, Xu Guo

More information

Example 13 - Shock Tube

Example 13 - Shock Tube Example 13 - Shock Tube Summary This famous experiment is interesting for observing the shock-wave propagation. Moreover, this case uses the representation of perfect gas and compares the different formulations:

More information

Water seepage through a dam: A finite element approach

Water seepage through a dam: A finite element approach Water seepage through a dam: A finite element approach Ashley B. Pitcher Student Number 250098269 AM466b Final Project (Undergraduate) University of Western Ontario April 15, 2005 Abstract We consider

More information

Generation and propagation of solitary wave over a steep sloping beach

Generation and propagation of solitary wave over a steep sloping beach Generation and propagation of solitary wave over a steep sloping beach Zouhaier Hafsia (1), Mehdi Ben Haj (2), Hedi Lamloumi (3), Khlifa Maalel (4) and Ridha Zgolli (5) (1-5) ENIT. Laboratoire d Hydraulique

More information

Determination of Free Surface in Steady-State Seepage through a Dam with Toe Drain by the Boundary Element Method

Determination of Free Surface in Steady-State Seepage through a Dam with Toe Drain by the Boundary Element Method Determination of Free Surface in Steady-State Seepage through a Dam with Toe Drain by the Boundary Element Method Somchart Chantasiriwan Faculty of Engineering, Thammasat University, Rangsit Campus, Pathum

More information

An explicit and conservative remapping strategy for semi-lagrangian advection

An explicit and conservative remapping strategy for semi-lagrangian advection An explicit and conservative remapping strategy for semi-lagrangian advection Sebastian Reich Universität Potsdam, Potsdam, Germany January 17, 2007 Abstract A conservative semi-lagrangian advection scheme

More information

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Decheng Wan 1 and Stefan Turek 2 Institute of Applied Mathematics LS III, University of Dortmund,

More information

Wave Uplift on Platforms or Docks in Variable Depth Jiin-Jen Lee and C.P. Lai"

Wave Uplift on Platforms or Docks in Variable Depth Jiin-Jen Lee and C.P. Lai CHAPTER 149 ABSTRACT Wave Uplift on Platforms or Docks in Variable Depth Jiin-Jen Lee and C.P. Lai" Wave uplift forces on two dimensional platforms or docks in a variable depth medium has been studied

More information

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Tamal Pramanick 1,a) 1 Department of Mathematics, Indian Institute of Technology Guwahati, Guwahati

More information

Comparison of Central and Upwind Flux Averaging in Overlapping Finite Volume Methods for Simulation of Super-Critical Flow with Shock Waves

Comparison of Central and Upwind Flux Averaging in Overlapping Finite Volume Methods for Simulation of Super-Critical Flow with Shock Waves Proceedings of the 9th WSEAS International Conference on Applied Mathematics, Istanbul, Turkey, May 7, 6 (pp55665) Comparison of and Flux Averaging in Overlapping Finite Volume Methods for Simulation of

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

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

Geometric Acoustics in High-Speed Boundary Layers

Geometric Acoustics in High-Speed Boundary Layers Accepted for presentation at the 9th International Symposium on Shock Waves. Madison, WI. July -9,. Paper #8 Geometric Acoustics in High-Speed Boundary Layers N. J. Parziale, J. E. Shepherd, and H. G.

More information

Efficiency of adaptive mesh algorithms

Efficiency of adaptive mesh algorithms Efficiency of adaptive mesh algorithms 23.11.2012 Jörn Behrens KlimaCampus, Universität Hamburg http://www.katrina.noaa.gov/satellite/images/katrina-08-28-2005-1545z.jpg Model for adaptive efficiency 10

More information

AS 5850 Finite Element Analysis

AS 5850 Finite Element Analysis AS 5850 Finite Element Analysis INTRODUCTION Prof. IIT Madras Goal of engineering computations Perform analysis and design of physical systems and processes subjected to imposed conditions (or loads) and

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

Fluid structure interaction analysis: vortex shedding induced vibrations

Fluid structure interaction analysis: vortex shedding induced vibrations Fluid structure interaction analysis: vortex shedding induced vibrations N. Di Domenico, M. E. * University of Rome «Tor Vergata», Department of Enterprise Engineering «Mario Lucertini» A. Wade, T. Berg,

More information

Module 1 Lecture Notes 2. Optimization Problem and Model Formulation

Module 1 Lecture Notes 2. Optimization Problem and Model Formulation Optimization Methods: Introduction and Basic concepts 1 Module 1 Lecture Notes 2 Optimization Problem and Model Formulation Introduction In the previous lecture we studied the evolution of optimization

More information

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS JIAN LIANG AND HONGKAI ZHAO Abstract. In this paper we present a general framework for solving partial differential equations on manifolds represented

More information

Comparing different interpolation methods on two-dimensional test functions

Comparing different interpolation methods on two-dimensional test functions Comparing different interpolation methods on two-dimensional test functions Thomas Mühlenstädt, Sonja Kuhnt May 28, 2009 Keywords: Interpolation, computer experiment, Kriging, Kernel interpolation, Thin

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

An introduction to mesh generation Part IV : elliptic meshing

An introduction to mesh generation Part IV : elliptic meshing Elliptic An introduction to mesh generation Part IV : elliptic meshing Department of Civil Engineering, Université catholique de Louvain, Belgium Elliptic Curvilinear Meshes Basic concept A curvilinear

More information

course outline basic principles of numerical analysis, intro FEM

course outline basic principles of numerical analysis, intro FEM idealization, equilibrium, solutions, interpretation of results types of numerical engineering problems continuous vs discrete systems direct stiffness approach differential & variational formulation introduction

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

Mathematics for chemical engineers

Mathematics for chemical engineers Mathematics for chemical engineers Drahoslava Janovská Department of mathematics Winter semester 2013-2014 Numerical solution of ordinary differential equations Initial value problem Outline 1 Introduction

More information

Partition of unity algorithm for two-dimensional interpolation using compactly supported radial basis functions

Partition of unity algorithm for two-dimensional interpolation using compactly supported radial basis functions Communications in Applied and Industrial Mathematics, ISSN 2038-0909, e-431 DOI: 10.1685/journal.caim.431 Partition of unity algorithm for two-dimensional interpolation using compactly supported radial

More information

P257 Transform-domain Sparsity Regularization in Reconstruction of Channelized Facies

P257 Transform-domain Sparsity Regularization in Reconstruction of Channelized Facies P257 Transform-domain Sparsity Regularization in Reconstruction of Channelized Facies. azemi* (University of Alberta) & H.R. Siahkoohi (University of Tehran) SUMMARY Petrophysical reservoir properties,

More information

A Moving Mesh Method for Time dependent Problems Based on Schwarz Waveform Relaxation

A Moving Mesh Method for Time dependent Problems Based on Schwarz Waveform Relaxation A Moving Mesh Method for Time dependent Problems Based on Schwarz Waveform Relaation Ronald D. Haynes, Weizhang Huang 2, and Robert D. Russell 3 Acadia University, Wolfville, N.S., Canada. ronald.haynes@acadiau.ca

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

The DRM-MD integral equation method for the numerical solution of convection-diffusion

The DRM-MD integral equation method for the numerical solution of convection-diffusion The DRM-MD integral equation method for the numerical solution of convection-diffusion equation V. Popov & H. Power Wessex Institute of Technology, Ashurst Lodge, Ashurst, Abstract This work presents a

More information

A Wavelet-Based Method for Simulation of Seismic Wave Propagation

A Wavelet-Based Method for Simulation of Seismic Wave Propagation AGU Fall Meeting, A Wavelet-Based Method for Simulation of Seismic Wave Propagation Tae-Kyung Hong & B.L.N. Kennett Research School of Earth Sciences The Australian National University Abstract Seismic

More information

99 International Journal of Engineering, Science and Mathematics

99 International Journal of Engineering, Science and Mathematics Journal Homepage: Applications of cubic splines in the numerical solution of polynomials Najmuddin Ahmad 1 and Khan Farah Deeba 2 Department of Mathematics Integral University Lucknow Abstract: In this

More information

Homework 4A Due November 7th IN CLASS

Homework 4A Due November 7th IN CLASS CS207, Fall 2014 Systems Development for Computational Science Cris Cecka, Ray Jones Homework 4A Due November 7th IN CLASS Previously, we ve developed a quite robust Graph class to let us use Node and

More information

Second International Workshop on Scientific Computing and Applications. Kananaskis, Canada, May 28 - June 1, 2000

Second International Workshop on Scientific Computing and Applications. Kananaskis, Canada, May 28 - June 1, 2000 Second International Workshop on Scientific Computing and Applications. Kananaskis, Canada, May 28 - June 1, 2000 Program May 28 (Sunday) 19:00-21:00 Registration and reception Session Chairman: Y. Wong

More information

A Comparative Study of LOWESS and RBF Approximations for Visualization

A Comparative Study of LOWESS and RBF Approximations for Visualization A Comparative Study of LOWESS and RBF Approximations for Visualization Michal Smolik, Vaclav Skala and Ondrej Nedved Faculty of Applied Sciences, University of West Bohemia, Univerzitni 8, CZ 364 Plzen,

More information

A meshfree radial point interpolation method (RPIM) for three-dimensional solids

A meshfree radial point interpolation method (RPIM) for three-dimensional solids Comput Mech (5) 6: DOI.7/s66-5-657-6 ORIGINAL PAPER G. R. Liu G. Y. Zhang Y. T. Gu Y. Y. Wang A meshfree radial point interpolation method (RPIM) for three-dimensional solids Received: October / Accepted:

More information

CS 450 Numerical Analysis. Chapter 7: Interpolation

CS 450 Numerical Analysis. Chapter 7: Interpolation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

A Moving Mesh Method for Time Dependent Problems based on Schwarz Waveform Relaxation

A Moving Mesh Method for Time Dependent Problems based on Schwarz Waveform Relaxation A Moving Mesh Method for Time Dependent Problems based on Schwarz Waveform Relaation Ronald D. Haynes, Weizhang Huang 2, and Robert D. Russell 3 Acadia University, Wolfville, N.S., Canada ronald.haynes@acadiau.ca

More information

An explicit and conservative remapping strategy for semi-lagrangian advection

An explicit and conservative remapping strategy for semi-lagrangian advection ATMOSPHERIC SCIENCE LETTERS Atmos. Sci. Let. 8: 58 63 (2007) Published online 22 May 2007 in Wiley InterScience (www.interscience.wiley.com).151 An explicit and conservative remapping strategy for semi-lagrangian

More information

ACCURACY OF NUMERICAL SOLUTION OF HEAT DIFFUSION EQUATION

ACCURACY OF NUMERICAL SOLUTION OF HEAT DIFFUSION EQUATION Scientific Research of the Institute of Mathematics and Computer Science ACCURACY OF NUMERICAL SOLUTION OF HEAT DIFFUSION EQUATION Ewa Węgrzyn-Skrzypczak, Tomasz Skrzypczak Institute of Mathematics, Czestochowa

More information

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD TASK QUARTERLY 12 No 3, 273 287 FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD ZBIGNIEW KOSMA Institute of Applied Mechanics, Technical University

More information

Characteristic Aspects of SPH Solutions

Characteristic Aspects of SPH Solutions Characteristic Aspects of SPH Solutions for Free Surface Problems: Source and Possible Treatment of High Frequency Numerical Oscillations of Local Loads. A. Colagrossi*, D. Le Touzé & G.Colicchio* *INSEAN

More information