Logo. A Massively-Parallel Multicore Acceleration of a Point Contact Solid Mechanics Simulation DRAFT

Size: px
Start display at page:

Download "Logo. A Massively-Parallel Multicore Acceleration of a Point Contact Solid Mechanics Simulation DRAFT"

Transcription

1 Paper 1 Logo Civil-Comp Press, 2017 Proceedings of the Fifth International Conference on Parallel, Distributed, Grid and Cloud Computing for Engineering, P. Iványi, B.H.V Topping and G. Várady (Editors) Civil-Comp Press, Stirlingshire, Scotland A Massively-Parallel Multicore Acceleration of a Point Contact Solid Mechanics Simulation M. Kolman, G. Kosec Parallel and Distributed Systems Laboratory, Jožef Stefan Institute, Ljubljana, Slovenia Abstract This paper deals with the numerical determination of the stress and displacement distribution in a solid body subjected to the applied external force. The tackled solid mechanics problem is governed by the Navier-Cauchy equation that describes the deformation within the solid body through the displacement vector field. To obtain the solution, a coupled system of non-linear Partial Differential Equations (PDE) of second order has to be solved. In this paper, the problem is approached by a strong form Moving Least Squares (MLS) based numerical discretization also referred to as a Meshless Local Strong Form Method (MLSM). A generic C++ implementation of a MLSM is used for demonstration of parallel solution of a Point Contact problem on Intel Xeon Phi multicore accelerator. All tests are executed on either the host machine with two Intel Xeon E v3 6 core processors or offloaded to its 60 core Intel Xeon Phi SE10/7120 series. The shared memory parallelization is implemented through an OpenMP API. Keywords: MLSM, meshless, OpenMP, Intel Xeon Phi coprocessor, parallel implementation 1 Introduction In the majority of numerical simulations the solid mechanics problems are tackled with Finite Elements Methods (FEM) [1]. However, as an alternative to the mesh based FEM, a new class of numerical methods, referred to as Meshless methods, has emerged to alleviate the meshing complexity, which is in many cases, especially in 3D, still the most cumbersome part of the solution procedure. Both of the weak and strong form variants of the Meshless methods have been already applied on the solid mechanics problems [2, 3]. 1

2 In this paper we consider a Strong Form Meshless method that is based on the MLS approximation [4]. The most important features of the employed numerical method are the locality and generality. The locality is manifested by the fact that the evaluation of partial differential operators, which is the main part of the solution process, relies only on a small number of surrounding computational nodes. This is important from the computation point of view, since it reduces the inter-processor communication, which is often the bottleneck of parallel algorithms [5]. The generality, on the other hand, arises from the fact that all the building blocks of the method depend only on the distance between the computational nodes. This is a very useful feature, especially when dealing with problems in multidimensional spaces, complex geometries, and moving boundaries. The generality of the method also allows for an elegant computer implementation. All these facts make the MLSM an attractive alternative to the classical approaches like Finite Differences Method that suffers from geometrical limitations, and more general weak form Finite Elements Method that require meshing. 2 Point contact problem The Navier-Cauchy equations describe the dynamics of a solid through the displacement vector field u, expressed concisely in vector form as ρ 2 u t = (λ + µ) ( u) + 2 µ 2 u D u (1) t where µ and λ stand for Lamé constants, ρ is the density, and D is damping coefficient. The point contact problem on the lower half-plane, i.e. a point-load applied to a surface of the body, is characterised with the traction boundary conditions σ xy (x, 0) = 0, σ yy (x, y) = P δ(x, y) (2) where σ xy and σ xx are shear and normal stress tensor components, and δ(x, y) is the Dirac delta function. These boundary conditions state that there is a singular normal force P applied at (x, y) = (0, 0) and that there are no shear stresses on the surface of the elastic half- plane. The problem s solution can be expressed in a closed form and is therefore ideal for testing purposes. The solution is presented as σ xx = 2P π x 2 y (x 2 + y 2 ) 2, σ yy = 2P π y 3 (x 2 + y 2 ) 2, σ xy = 2P π xy 2 (x 2 + y 2 ) 2, (3) for a point (x, y) in the half-plane. For our purposes a solution in terms of displacement vector u = (u x, u y ) is more convenient. It can be obtained by integrating Eq. (3), which yields u x = P ( 4πµ u y = P 4πµ (κ 1)θ 2xy ), (4) r ((κ 2 ) + 1) log r + 2x2, (5) r 2 2

3 where r = x 2 + y 2, tan θ = x. and κ = 3 4ν, with ν standing for the Poisson y ratio. 3 Meshless Local Strong Form numerical approach To numerically solve a problem at hand, we discretize a domain into a finite set of nodes, at which the partial differential operators, occurring in Eq. (1), are evaluated. The core concept of the spatial discretization used here, namely a MLSM, is a local Moving Least Squares (MLS) approximation of a considered field over the overlapping local support domains. In each node we create an approximation function over a small local sub-set of neighbouring n nodes acting as a trial function û(p) = m α i b i (p) = b(p) T α, (6) i=1 with m, α, b, p (x, y) standing for the number of basis functions, approximation coefficients, basis functions and the position vector, respectively. The problem can be written in matrix form as α = ( W 0.5 B ) + W 0.5 u, (7) where (W 0.5 B) + stand for a Moore Penrose pseudo inverse. By explicitly expressing the coefficients α into the trial function one gets û (p) = b(p) T( W 0.5 (p) B ) + W 0.5 (p) u = χ (p) u, (8) where χ stand for the shape functions. Now, we can apply any partial differential operator L, as is our goal, on the trial function L û (p) = Lχ (p) u. (9) The presented formulation is convenient for implementation since most of the complex operations, i.e. finding support nodes and building shape functions, are performed only when nodal topology changes. During computation the pre- computed shape functions are convoluted with the vector of field values in the support to evaluate the desired operator. With the explicit temporal discretization the solution of Eq. (1) is formulated as u 3 = t2 ρ ( (λ + µ) ( u 2 ) + µ 2 u 2 D u ) 2 u 1, (10) t where u 1, u 2 and u 3 stand for displacement vector at two previous time steps and the one currently computed, respectively. The operators L =,, 2 are computed with Equations (8) and (9) [4]. 3

4 4 Implementation A MLSM solution for the point contact problem is implemented in C++ and compiled either with GNU C++ compiler g or Intel s C++ compiler ICPC version (which has GCC version compatibility) both with compiler flags -O3 -std=c++14 -fopenmp. The code is developed within an open source project and is freely available at [6]. It implements different domain classes, a Nearest Neighbour (knn) search based on the kd-tree algorithm, a general Moving Least Squares (MLS) engine and its extension to a full MLSM engine. 4.1 Building the shape functions In a first major step all the necessary shape functions needed to calculate the required differential operator Lû(p) are prepared. This set-up procedure comprises positioning of the nodes, finding support nodes, defining the MLS approximation, and finally creating the operators class. The implementation concept is schematically presented in Figure 1, and written in a C++ with MLSM library [6] as 1 RectangleDomain <Vec2d > domain ( domain_lo, domain_hi ) ; 2 domain. f i l l U n i f o r m I n t e r i o r W i t h S t e p ( d_space ) ; domain. f i l l U n i f o r m B o u n d a r y W i t h S t e p ( d_space ) ; 4 domain. f i n d S u p p o r t ( n ) ; s u p p o r t = domain. p o s i t i o n s [ domain. s u p p o r t [ 0 ] ] ; 6 EngineMLS<Vec2d, Gaussians, Gaussians > mls ( { sigmab, m}, s u p p o r t, sigmaw ) ) ; 8 auto mlsm = make_mlsm ( domain, mls ) ; The domain is an object containing all information about the nodes, including support domain of all nodes. It is formed by parameters domain_lo, domain_hi and d_space, which define its boundaries and node density. The variable mlsm is an instance of the MLSM class that is capable of calculating certain differential operators (e.g. Laplacian, grad, div, etc.) of fields defined on the domain. The variables sigmab and sigmaw are the standard deviations of basis functions and weight function, respectively, both Gaussians in present case, defined as g(p) = 1 ) exp ( p 2, (11) 2πσ 2σ The m defines the number of basis functions and n the number of support nodes. In this paper the same number of basis functions and support nodes is assumed. The n = m = 9 assumption effectively reduces the approximation to the collocation, which is a popular set-up in a meshless community [7, 8], especially when regular nodal distributions are used. However, in cases when irregular distributions are needed the overdetermined MLS is preferred [4]. 4

5 4.2 Time simulation Figure 1: A MLSM implementation diagram. Before the time stepping the boundary conditions and initial state are set. The boundaries are assumed to be of a Dirichlet type with values obtained from the closed form solution, while the initial state of the displacement is set to zero throughout whole the domain, implemented as 1 Range < vec_t > u_1 ( domain. s i z e ( ), 0 ), 2 u_2 ( domain. s i z e ( ), 0 ), u_3 ( domain. s i z e ( ), 0 ) ; 4 u_3 [ boundary ] = u _ a n a l y t i c a l ( boundary ) ; Note, that the boundary is a vector of indices of boundary nodes. With prepared operators, known two consequential previous time steps and the boundary conditions, the Eq. (10) can be numerically solved as 1 #pragma omp p a r a l l e l f o r p r i v a t e ( j ) s c h e d u l e ( s t a t i c ) 2 f o r ( j = 0 ; j < N; ++ j ) { u_3 [ i ] = d t * d t / rho * ( 4 mu * mlsm. l a p ( u_2, i ) + E / (2 2 * nu ) * mlsm. g r a d d i v ( u_2, i ) 6 D * ( u_2 [ i ] u_1 [ i ] ) / d t ) + 2 * u_2 [ i ] u_1 [ i ] ; 8 } The N states the number of nodes in the domain and dt is the size of the time step. Variables mu, rho, E and nu are physical constants of the material corresponding to the first Lamé constant µ, density ρ, Young modulus E and Poisson coefficient ν, respectively. The variable mlsm is an operator object holding shape functions and procedures for computing the partial differential operators. Since the loop iterations are independent the whole process can be easily parallelized with OpenMP API by using a compiler option #pragma omp. Once the u 3 is computed for all nodes in the domain, the step forward can be 5

6 performed simply by u 1 = u 2 and u 2 = u 3. This iterative process takes place until the steady state is achieved. 5 Results 5.1 Solution of a point contact problem The point contact problem is solved on a domain (x, y) Ω = [ 1, 1] [ 1, 0.01]. The standard deviation of basis functions is 70 times the domain characteristic distance, i.e. the average distance to the closest neighbour. The physical constants are set to ρ = 7874 [kg/m 3 ], ν = 0.25, E = [Pa], D = 10 9 and the applied force is P = 1000 [Pa]. All calculations are done with dt = 10 7 [s]. In Figure 2 a MLSM solution û(p) computed with N = regularly distributed nodes is presented and compared against the known analytical solution u(p), with relative displacement error computed as E = û(p) u(p) / ( u(p) ) (12) and visualized through the color map. The displacement field has been, for the sake of visibility, multiplied with a factor of Figure 2: Relative displacement error E displayed on displaced nodes, with magnified displacement by a factor of Next comparison is focused on the displacement over two horizontal crosssections, at y = and y = 0.5. The numerical and analytical solutions are presented in Figure 3 and it is evident that MLSM agrees well with a known solution. 6

7 uy(x,y = 0.015),ux(x,y = 0.015) u y MLSM u y analytical -5 u x MLSM u x analytical x uy(x,y = 0.5),ux(x,y = 0.5) x (a) Horizontal displacement cross section at the (b) Horizontal displacement cross section in top of the domain. the middle of the domain u y MLSM u y analytical u x MLSM u x analytical Figure 3: Two horizontal crosssections of the analytical and numerical solution for the point contact problem. 5.2 Execution performance We tested the execution on a 60-core computing machine Intel Xeon Phi Coprocessor SE10/7120 series and its server host with two Intel Xeon CPU E v3 processors. The two machines are compared in Table 1. Name Cores Clock [GHz] L2 Cache [MB] Memory [GB] Intel Xeon Phi (0.5/core) 16 Intel Xeon CPU (2.5/core) 64 Table 1: Specification comparison between Intel Xeon Phi and Intel Xeon CPU. In this preliminary study we are interested in the scalability of the execution performance. In Figures 4 and 5 a speed-up, defined as S = T (1) T (N t ), (13) with T (N t ) standing for execution time on N t threads, for different domain sizes and number of utilized threads is presented. The domain size is ranged from N = 741 up to N = nodes. For both computers all available threads, including hyperthreading, are utilized. On the host machine in total 12 physical cores support up to 24 threads and on the coprocessor 120 threads can be used on its 60 physical cores. 7

8 S N=741 N=2178 N= N=79401 N= N= N= N= N t (a) Execution speedup on the Intel Xeon (b) Execution speedup on Intel host. Coprocessor. S N=741 N=2178 N=19701 N=79401 N= N= N= N= N t Xeon Phi Figure 4: Shared memory parallelization speedup with respect to the number of threads for different problem sizes. Increasing the number of threads on the host is beneficial only up to the limit of physical cores, while on the coprocessor using additional 2 threads also improves results. It can be also seen that coprocessor requires much bigger problems to show its full potential in terms of scalability. The maximal efficiency (S/N t ) of 0.6 is achieved on host already on a relatively small systems (N = 10 5 ), while the same efficiency is achieved on the coprocessor only with systems consisting of N = nodes. 6 Conclusions In this paper we demonstrated the application of the MLSM discretization technique on the solution of a coupled system of second order partial differential equations. Namely we solved a Navier-Cauchy equation that describes displacements in a solid body subjected to an external force. The code has been written in C++ and executed on two different computing architectures, i.e. the Intel Xeon server class CPU and Intel Xeon Phi coprocessor. On both architectures a relatively good scalability has been achieved, with a maximal parallel efficiency of 0.67 for 12 cores on a host machine and 60 cores on a coprocessor. Although, the parallel efficiency on the coprocessor is good, the overall performance is not satisfactory. It is our main focus in future work to improve the performance of the MLSM on the coprocessor by means of improving the utilization of the vectorization in the lowest level operations, namely the convolution of the shape 8

9 S N t = 1 N t = 2 3 N t = 4 N t = 8 2 N t = 12 N t = 16 N t = N N (a) Execution speedup on the Intel Xeon (b) Execution speedup on Intel host. Coprocessor. S N t = 1 N t = 2 N t = 5 N t = 10 N t = 30 N t = 60 N t = 120 Xeon Phi Figure 5: Shared memory parallelization speedup with respect to the problem size for different number of utilized threads. functions and the field values in the support nodes. Acknowledgement The authors acknowledge the financial support from the Slovenian Research Agency (research core funding No. P2-0095) References [1] O.C. Zienkiewicz, R.L. Taylor, The Finite Element Method: Solid Mechanics, Butterworth-Heinemann, [2] Y. Chen, J.D. Lee, A. Eskandarian, Meshless methods in solid mechanics, Springer, New York, NY, [3] B. Mavrič, B. Šarler, Local radial basis function collocation method for linear thermoelasticity in two dimensions, International Journal of Numerical Methods for Heat and Fluid Flow, 25: , [4] G. Kosec, A local numerical solution of a fluid-flow problem on an irregular domain, Advances in Engineering Software, in press,

10 [5] R. Trobec, M. Šterk, B. Robič, Computational complexity and parallelization of the meshless local Petrov-Galerkin method, Computers and Structures, 87(1-2): 81 90, [6] G. Kosec, M. Kolman, J. Slak, Utilities for solving PDEs with meshless methods, 2016, URL [7] M. Zerroukat, H. Power, C.S. Chen, A numerical method for heat transfer problems using collocation and radial basis functions, International Journal of Numerical Methods in Engineering, 42: , [8] S. Chantasiriwan, Performance of multiquadric collocation method in solving lid-driven cavity flow problem with low reynolds number, CMES: Computer Modeling in Engineering and Sciences, 15: ,

Computation Time Assessment of a Galerkin Finite Volume Method (GFVM) for Solving Time Solid Mechanics Problems under Dynamic Loads

Computation Time Assessment of a Galerkin Finite Volume Method (GFVM) for Solving Time Solid Mechanics Problems under Dynamic Loads Proceedings of the International Conference on Civil, Structural and Transportation Engineering Ottawa, Ontario, Canada, May 4 5, 215 Paper o. 31 Computation Time Assessment of a Galerkin Finite Volume

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Finite Element Method in Geotechnical Engineering

Finite Element Method in Geotechnical Engineering Finite Element Method in Geotechnical Engineering Short Course on + Dynamics Boulder, Colorado January 5-8, 2004 Stein Sture Professor of Civil Engineering University of Colorado at Boulder Contents Steps

More information

DISPENSA FEM in MSC. Nastran

DISPENSA FEM in MSC. Nastran DISPENSA FEM in MSC. Nastran preprocessing: mesh generation material definitions definition of loads and boundary conditions solving: solving the (linear) set of equations components postprocessing: visualisation

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem

Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem Katharina Kormann 1 Klaus Reuter 2 Markus Rampp 2 Eric Sonnendrücker 1 1 Max Planck Institut für Plasmaphysik 2 Max Planck Computing

More information

A truly meshless Galerkin method based on a moving least squares quadrature

A truly meshless Galerkin method based on a moving least squares quadrature A truly meshless Galerkin method based on a moving least squares quadrature Marc Duflot, Hung Nguyen-Dang Abstract A new body integration technique is presented and applied to the evaluation of the stiffness

More information

Solving Elastic Problems with Local Boundary Integral Equations (LBIE) and Radial Basis Functions (RBF) Cells

Solving Elastic Problems with Local Boundary Integral Equations (LBIE) and Radial Basis Functions (RBF) Cells Copyright 2010 Tech Science Press CMES, vol.57, no.2, pp.109-135, 2010 Solving Elastic Problems with Local Boundary Integral Equations (LBIE) and Radial Basis Functions (RBF) Cells E. J. Sellountos 1,

More information

A Meshless Radial Basis Function Method for Fluid Flow with Heat Transfer

A Meshless Radial Basis Function Method for Fluid Flow with Heat Transfer Copyright c 2008 ICCES ICCES, vol.6, no.1, pp.13-18 A Meshless Radial Basis Function Method for Fluid Flow with Heat Transfer K agamani Devi 1,D.W.Pepper 2 Summary Over the past few years, efforts have

More information

Multipole-Based Preconditioners for Sparse Linear Systems.

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

More information

DEFORMATION AND FRACTURE ANALYSIS OF ELASTIC SOLIDS BASED ON A PARTICLE METHOD

DEFORMATION AND FRACTURE ANALYSIS OF ELASTIC SOLIDS BASED ON A PARTICLE METHOD Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm DEFORMATION AND FRACTURE ANALYSIS OF ELASTIC SOLIDS BASED ON A PARTICLE METHOD R. A. Amaro

More information

ME FINITE ELEMENT ANALYSIS FORMULAS

ME FINITE ELEMENT ANALYSIS FORMULAS ME 2353 - FINITE ELEMENT ANALYSIS FORMULAS UNIT I FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PROBLEMS 01. Global Equation for Force Vector, {F} = [K] {u} {F} = Global Force Vector [K] = Global Stiffness

More information

Point interpolation method based on local residual formulation using radial basis functions

Point interpolation method based on local residual formulation using radial basis functions Structural Engineering and Mechanics, Vol. 14, No. 6 (2002) 713-732 713 Point interpolation method based on local residual formulation using radial basis functions G.R. Liu, L. Yan, J.G. Wang and Y.T.

More information

Computational Numerical Integration for Spherical Quadratures. Verified by the Boltzmann Equation

Computational Numerical Integration for Spherical Quadratures. Verified by the Boltzmann Equation Computational Numerical Integration for Spherical Quadratures Verified by the Boltzmann Equation Huston Rogers. 1 Glenn Brook, Mentor 2 Greg Peterson, Mentor 2 1 The University of Alabama 2 Joint Institute

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Large-scale Electronic Structure Simulations with MVAPICH2 on Intel Knights Landing Manycore Processors

Large-scale Electronic Structure Simulations with MVAPICH2 on Intel Knights Landing Manycore Processors Large-scale Electronic Structure Simulations with MVAPICH2 on Intel Knights Landing Manycore Processors Hoon Ryu, Ph.D. (E: elec1020@kisti.re.kr) Principal Researcher / Korea Institute of Science and Technology

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

Solving Pure Torsion Problem and Modelling Radionuclide Migration Using Radial Basis Functions

Solving Pure Torsion Problem and Modelling Radionuclide Migration Using Radial Basis Functions International Workshop on MeshFree Methods 3 1 Solving Pure Torsion Problem and Modelling Radionuclide Migration Using Radial Basis Functions Leopold Vrankar (1), Goran Turk () and Franc Runovc (3) Abstract:

More information

Application of pseudo-symmetric technique in dynamic analysis of concrete gravity dams

Application of pseudo-symmetric technique in dynamic analysis of concrete gravity dams Application of pseudo-symmetric technique in dynamic analysis of concrete gravity dams V. Lotfi Department of Civil and Environmental Engineering, Amirkabir University, Iran Abstract A new approach is

More information

A Comparison of Service Life Prediction of Concrete Structures using the Element-Free Galerkin, Finite Element and Finite Difference Methods

A Comparison of Service Life Prediction of Concrete Structures using the Element-Free Galerkin, Finite Element and Finite Difference Methods Paper 64 Civil-Comp Press, 4. Proceedings of the Seventh International Conference on Computational Structures Technology, B.H.V. Topping and C.A. Mota Soares (Editors, Civil-Comp Press, Stirling, Scotland.

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

Mechanics PhD Preliminary Spring 2017

Mechanics PhD Preliminary Spring 2017 Mechanics PhD Preliminary Spring 2017 1. (10 points) Consider a body Ω that is assembled by gluing together two separate bodies along a flat interface. The normal vector to the interface is given by n

More information

Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs

Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs 1 School of Information Engineering, China University of Geosciences (Beijing) Beijing, 100083, China E-mail: Yaolk1119@icloud.com Ailan

More information

EXTENDED ABSTRACT. Dynamic analysis of elastic solids by the finite element method. Vítor Hugo Amaral Carreiro

EXTENDED ABSTRACT. Dynamic analysis of elastic solids by the finite element method. Vítor Hugo Amaral Carreiro EXTENDED ABSTRACT Dynamic analysis of elastic solids by the finite element method Vítor Hugo Amaral Carreiro Supervisor: Professor Fernando Manuel Fernandes Simões June 2009 Summary The finite element

More information

Numerical analysis of heat conduction problems on 3D general-shaped domains by means of a RBF Collocation Meshless Method

Numerical analysis of heat conduction problems on 3D general-shaped domains by means of a RBF Collocation Meshless Method Journal of Physics: Conference Series PAPER OPEN ACCESS Numerical analysis of heat conduction problems on 3D general-shaped domains by means of a RBF Collocation Meshless Method To cite this article: R

More information

HYCOM and Navy ESPC Future High Performance Computing Needs. Alan J. Wallcraft. COAPS Short Seminar November 6, 2017

HYCOM and Navy ESPC Future High Performance Computing Needs. Alan J. Wallcraft. COAPS Short Seminar November 6, 2017 HYCOM and Navy ESPC Future High Performance Computing Needs Alan J. Wallcraft COAPS Short Seminar November 6, 2017 Forecasting Architectural Trends 3 NAVY OPERATIONAL GLOBAL OCEAN PREDICTION Trend is higher

More information

ERLANGEN REGIONAL COMPUTING CENTER

ERLANGEN REGIONAL COMPUTING CENTER ERLANGEN REGIONAL COMPUTING CENTER Making Sense of Performance Numbers Georg Hager Erlangen Regional Computing Center (RRZE) Friedrich-Alexander-Universität Erlangen-Nürnberg OpenMPCon 2018 Barcelona,

More information

Dual Reciprocity Boundary Element Method for Magma Ocean Simulations

Dual Reciprocity Boundary Element Method for Magma Ocean Simulations Dual Reciprocity Boundary Element Method for Magma Ocean Simulations Tyler W. Drombosky drombosk@math.umd.edu Saswata Hier-Majumder saswata@umd.edu 28 April 2010 Physical Motivation Earth s early history

More information

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

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

More information

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Computational Design Forward design: direct manipulation of design parameters Level of abstraction Exploration

More information

Basic Equations of Elasticity

Basic Equations of Elasticity A Basic Equations of Elasticity A.1 STRESS The state of stress at any point in a loaded bo is defined completely in terms of the nine components of stress: σ xx,σ yy,σ zz,σ xy,σ yx,σ yz,σ zy,σ zx,andσ

More information

Elmer :Heat transfert with phase change solid-solid in transient problem Application to silicon properties. SIF file : phasechange solid-solid

Elmer :Heat transfert with phase change solid-solid in transient problem Application to silicon properties. SIF file : phasechange solid-solid Elmer :Heat transfert with phase change solid-solid in transient problem Application to silicon properties 3 6 1. Tb=1750 [K] 2 & 5. q=-10000 [W/m²] 0,1 1 Ω1 4 Ω2 7 3 & 6. α=15 [W/(m²K)] Text=300 [K] 4.

More information

Hydroelastic vibration of a rectangular perforated plate with a simply supported boundary condition

Hydroelastic vibration of a rectangular perforated plate with a simply supported boundary condition Fluid Structure Interaction and Moving Boundary Problems IV 63 Hydroelastic vibration of a rectangular perforated plate with a simply supported boundary condition K.-H. Jeong, G.-M. Lee, T.-W. Kim & J.-I.

More information

A Finite-Element based Navier-Stokes Solver for LES

A Finite-Element based Navier-Stokes Solver for LES A Finite-Element based Navier-Stokes Solver for LES W. Wienken a, J. Stiller b and U. Fladrich c. a Technische Universität Dresden, Institute of Fluid Mechanics (ISM) b Technische Universität Dresden,

More information

Numerical Solutions of 2-D Linear Elastostatic Problems by Network Method

Numerical Solutions of 2-D Linear Elastostatic Problems by Network Method Copyright 2011 Tech Science Press CMES, vol.76, no.1, pp.1-18, 2011 Numerical Solutions of 2-D Linear Elastostatic Problems by Network Method J.L. Morales 1, J.A. Moreno 2 and F. Alhama 3 Abstract: Following

More information

arxiv: v1 [hep-lat] 7 Oct 2010

arxiv: v1 [hep-lat] 7 Oct 2010 arxiv:.486v [hep-lat] 7 Oct 2 Nuno Cardoso CFTP, Instituto Superior Técnico E-mail: nunocardoso@cftp.ist.utl.pt Pedro Bicudo CFTP, Instituto Superior Técnico E-mail: bicudo@ist.utl.pt We discuss the CUDA

More information

Comparison of local weak and strong form meshless methods for 2-D diffusion equation

Comparison of local weak and strong form meshless methods for 2-D diffusion equation Comparison of local weak and strong form meshless methods for 2-D diffusion equation R. Trobec, G. Kosec 2, M. Šterk, B. Šarler2 Department of Communication Systems, Jožef Stefan Institute, Jamova 39,

More information

Content. Department of Mathematics University of Oslo

Content. Department of Mathematics University of Oslo Chapter: 1 MEK4560 The Finite Element Method in Solid Mechanics II (January 25, 2008) (E-post:torgeiru@math.uio.no) Page 1 of 14 Content 1 Introduction to MEK4560 3 1.1 Minimum Potential energy..............................

More information

Bake, shake or break - and other applications for the FEM. 5: Do real-life experimentation using your FEM code

Bake, shake or break - and other applications for the FEM. 5: Do real-life experimentation using your FEM code Bake, shake or break - and other applications for the FEM Programming project in TMA4220 - part 2 by Kjetil André Johannessen TMA4220 - Numerical solution of partial differential equations using the finite

More information

A two-dimensional FE truss program

A two-dimensional FE truss program A two-dimensional FE truss program 4M020: Design Tools Eindhoven University of Technology Introduction The Matlab program fem2d allows to model and analyze two-dimensional truss structures, where trusses

More information

Performance of Multiquadric Collocation Method in Solving Lid-driven Cavity Flow Problem with Low Reynolds Number

Performance of Multiquadric Collocation Method in Solving Lid-driven Cavity Flow Problem with Low Reynolds Number Copyright c 2006 Tech Science Press CMES, vol.15, no.3, pp.137-146, 2006 Performance of Multiquadric Collocation Method in Solving Lid-driven Cavity Flow Problem with Low Reynolds umber S. Chantasiriwan

More information

Department of Structural, Faculty of Civil Engineering, Architecture and Urban Design, State University of Campinas, Brazil

Department of Structural, Faculty of Civil Engineering, Architecture and Urban Design, State University of Campinas, Brazil Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm A SIMPLIFIED FORMULATION FOR STRESS AND TRACTION BOUNDARY IN- TEGRAL EQUATIONS USING THE

More information

Dynamic Responses of Composite Marine Propeller in Spatially Wake

Dynamic Responses of Composite Marine Propeller in Spatially Wake Dynamic Responses of Composite Marine Propeller in Spatially Wake Dynamic Responses of Composite Marine Propeller in Spatially Wake Y. Hong a, X.D. He a,*, R.G. Wang a, Y.B. Li a, J.Z. Zhang a, H.M. Zhang

More information

FREE VIBRATION OF AXIALLY LOADED FUNCTIONALLY GRADED SANDWICH BEAMS USING REFINED SHEAR DEFORMATION THEORY

FREE VIBRATION OF AXIALLY LOADED FUNCTIONALLY GRADED SANDWICH BEAMS USING REFINED SHEAR DEFORMATION THEORY FREE VIBRATION OF AXIALLY LOADED FUNCTIONALLY GRADED SANDWICH BEAMS USING REFINED SHEAR DEFORMATION THEORY Thuc P. Vo 1, Adelaja Israel Osofero 1, Marco Corradi 1, Fawad Inam 1 1 Faculty of Engineering

More information

Parallel PIPS-SBB Multi-level parallelism for 2-stage SMIPS. Lluís-Miquel Munguia, Geoffrey M. Oxberry, Deepak Rajan, Yuji Shinano

Parallel PIPS-SBB Multi-level parallelism for 2-stage SMIPS. Lluís-Miquel Munguia, Geoffrey M. Oxberry, Deepak Rajan, Yuji Shinano Parallel PIPS-SBB Multi-level parallelism for 2-stage SMIPS Lluís-Miquel Munguia, Geoffrey M. Oxberry, Deepak Rajan, Yuji Shinano ... Our contribution PIPS-PSBB*: Multi-level parallelism for Stochastic

More information

Parallel Transposition of Sparse Data Structures

Parallel Transposition of Sparse Data Structures Parallel Transposition of Sparse Data Structures Hao Wang, Weifeng Liu, Kaixi Hou, Wu-chun Feng Department of Computer Science, Virginia Tech Niels Bohr Institute, University of Copenhagen Scientific Computing

More information

Introduction to Benchmark Test for Multi-scale Computational Materials Software

Introduction to Benchmark Test for Multi-scale Computational Materials Software Introduction to Benchmark Test for Multi-scale Computational Materials Software Shun Xu*, Jian Zhang, Zhong Jin xushun@sccas.cn Computer Network Information Center Chinese Academy of Sciences (IPCC member)

More information

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters H. Köstler 2nd International Symposium Computer Simulations on GPU Freudenstadt, 29.05.2013 1 Contents Motivation walberla software concepts

More information

A Cartesian-Grid Discretisation Scheme Based on Local Integrated RBFNs for Two-Dimensional Elliptic Problems

A Cartesian-Grid Discretisation Scheme Based on Local Integrated RBFNs for Two-Dimensional Elliptic Problems Copyright 2009 Tech Science Press CMES, vol.51, no.3, pp.213-238, 2009 A Cartesian-Grid Discretisation Scheme Based on Local Integrated RBFNs for Two-Dimensional Elliptic Problems N. Mai-Duy 1 and T. Tran-Cong

More information

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Khramtsov D.P., Nekrasov D.A., Pokusaev B.G. Department of Thermodynamics, Thermal Engineering and Energy Saving Technologies,

More information

A Massively Parallel Eigenvalue Solver for Small Matrices on Multicore and Manycore Architectures

A Massively Parallel Eigenvalue Solver for Small Matrices on Multicore and Manycore Architectures A Massively Parallel Eigenvalue Solver for Small Matrices on Multicore and Manycore Architectures Manfred Liebmann Technische Universität München Chair of Optimal Control Center for Mathematical Sciences,

More information

Performance of the fusion code GYRO on three four generations of Crays. Mark Fahey University of Tennessee, Knoxville

Performance of the fusion code GYRO on three four generations of Crays. Mark Fahey University of Tennessee, Knoxville Performance of the fusion code GYRO on three four generations of Crays Mark Fahey mfahey@utk.edu University of Tennessee, Knoxville Contents Introduction GYRO Overview Benchmark Problem Test Platforms

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

Finite Element Analysis of Dynamic Properties of Thermally Optimal Two-phase Composite Structure

Finite Element Analysis of Dynamic Properties of Thermally Optimal Two-phase Composite Structure Vibrations in Physical Systems Vol.26 (2014) Finite Element Analysis of Dynamic Properties of Thermally Optimal Two-phase Composite Structure Abstract Maria NIENARTOWICZ Institute of Applied Mechanics,

More information

Chapter 4 Analysis of a cantilever

Chapter 4 Analysis of a cantilever Chapter 4 Analysis of a cantilever Before a complex structure is studied performing a seismic analysis, the behaviour of simpler ones should be fully understood. To achieve this knowledge we will start

More information

A Finite Element Model for Numerical Analysis of Sintering

A Finite Element Model for Numerical Analysis of Sintering A Finite Element Model for Numerical Analysis of Sintering DANIELA CÂRSTEA High-School Group of Railways, Craiova ION CÂRSTEA Department of Computer Engineering and Communication University of Craiova

More information

Numerically Solving Partial Differential Equations

Numerically Solving Partial Differential Equations Numerically Solving Partial Differential Equations Michael Lavell Department of Applied Mathematics and Statistics Abstract The physics describing the fundamental principles of fluid dynamics can be written

More information

International Journal of Advanced Engineering Technology E-ISSN

International Journal of Advanced Engineering Technology E-ISSN Research Article INTEGRATED FORCE METHOD FOR FIBER REINFORCED COMPOSITE PLATE BENDING PROBLEMS Doiphode G. S., Patodi S. C.* Address for Correspondence Assistant Professor, Applied Mechanics Department,

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Optimal thickness of a cylindrical shell under dynamical loading

Optimal thickness of a cylindrical shell under dynamical loading Optimal thickness of a cylindrical shell under dynamical loading Paul Ziemann Institute of Mathematics and Computer Science, E.-M.-A. University Greifswald, Germany e-mail paul.ziemann@uni-greifswald.de

More information

Fundamentals of Linear Elasticity

Fundamentals of Linear Elasticity Fundamentals of Linear Elasticity Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research of the Polish Academy

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

An Assessment of the LS-DYNA Hourglass Formulations via the 3D Patch Test

An Assessment of the LS-DYNA Hourglass Formulations via the 3D Patch Test 5 th European LS-DYNA Users Conference Code Developments An Assessment of the LS-DYNA Hourglass Formulations via the 3D Patch Test Authors Leonard E. Schwer, Schwer, Engineering & Consulting Services Samuel

More information

University of Illinois at Urbana-Champaign College of Engineering

University of Illinois at Urbana-Champaign College of Engineering University of Illinois at Urbana-Champaign College of Engineering CEE 570 Finite Element Methods (in Solid and Structural Mechanics) Spring Semester 2014 Quiz #2 April 14, 2014 Name: SOLUTION ID#: PS1.:

More information

Explicit solid dynamics in OpenFOAM

Explicit solid dynamics in OpenFOAM Explicit solid dynamics in OpenFOAM Jibran Haider a, Chun Hean Lee a, Antonio J. Gil a, Javier Bonet b and Antonio Huerta c m.j.haider@swansea.ac.uk a Zienkiewicz Centre for Computational Engineering,

More information

Performance Analysis of Lattice QCD Application with APGAS Programming Model

Performance Analysis of Lattice QCD Application with APGAS Programming Model Performance Analysis of Lattice QCD Application with APGAS Programming Model Koichi Shirahata 1, Jun Doi 2, Mikio Takeuchi 2 1: Tokyo Institute of Technology 2: IBM Research - Tokyo Programming Models

More information

Comparison of Galerkin and collocation Trefftz formulations for plane elasticity

Comparison of Galerkin and collocation Trefftz formulations for plane elasticity Comparison of Galerkin and collocation Trefftz formulations for plane elasticity V.M.A. Leitão December 8, 2000 Abstract The purpose of this work is to compare and assess, more in terms of computational

More information

Accelerating incompressible fluid flow simulations on hybrid CPU/GPU systems

Accelerating incompressible fluid flow simulations on hybrid CPU/GPU systems Accelerating incompressible fluid flow simulations on hybrid CPU/GPU systems Yushan Wang 1, Marc Baboulin 1,2, Karl Rupp 3,4, Yann Fraigneau 1,5, Olivier Le Maître 1,5 1 Université Paris-Sud, France 2

More information

The effect of restraints type on the generated stresses in gantry crane beam

The effect of restraints type on the generated stresses in gantry crane beam The effect of restraints type on the generated stresses in gantry crane beam Leszek Sowa 1,*, Wiesława Piekarska 1, Tomasz Skrzypczak 1, Paweł Kwiatoń 1 1 Czestochowa University of Technology, Institute

More information

Computing least squares condition numbers on hybrid multicore/gpu systems

Computing least squares condition numbers on hybrid multicore/gpu systems Computing least squares condition numbers on hybrid multicore/gpu systems M. Baboulin and J. Dongarra and R. Lacroix Abstract This paper presents an efficient computation for least squares conditioning

More information

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

More information

Linearized theory of elasticity

Linearized theory of elasticity Linearized theory of elasticity Arie Verhoeven averhoev@win.tue.nl CASA Seminar, May 24, 2006 Seminar: Continuum mechanics 1 Stress and stress principles Bart Nowak March 8 2 Strain and deformation Mark

More information

Flow Field and Oscillation Frequency of a Rotating Liquid Droplet

Flow Field and Oscillation Frequency of a Rotating Liquid Droplet Flow Field and Oscillation Frequency of a Rotating Liquid Droplet TADASHI WATANABE Center for Computational Science and e-systems Japan Atomic Energy Agency (JAEA) Tokai-mura, Naka-gun, Ibaraki-ken, 319-1195

More information

Partial Differential Equations

Partial Differential Equations Next: Using Matlab Up: Numerical Analysis for Chemical Previous: Ordinary Differential Equations Subsections Finite Difference: Elliptic Equations The Laplace Equations Solution Techniques Boundary Conditions

More information

Analytical Mechanics: Elastic Deformation

Analytical Mechanics: Elastic Deformation Analytical Mechanics: Elastic Deformation Shinichi Hirai Dept. Robotics, Ritsumeikan Univ. Shinichi Hirai (Dept. Robotics, Ritsumeikan Univ.) Analytical Mechanics: Elastic Deformation 1 / 60 Agenda Agenda

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Petascale Quantum Simulations of Nano Systems and Biomolecules

Petascale Quantum Simulations of Nano Systems and Biomolecules Petascale Quantum Simulations of Nano Systems and Biomolecules Emil Briggs North Carolina State University 1. Outline of real-space Multigrid (RMG) 2. Scalability and hybrid/threaded models 3. GPU acceleration

More information

Efficient Method of Solution of Large Scale Engineering Probelms with Interval Parameters

Efficient Method of Solution of Large Scale Engineering Probelms with Interval Parameters Efficient Method of Solution of Large Scale Engineering Probelms with Interval Parameters ANDRZEJ POWNUK Department of Civil Engineering, Silesian University of Technology,Gliwice, Poland, pownuk@zeus.polsl.gliwice.pl,

More information

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

SOLUTION OF A LOW PRANDTL NUMBER NATURAL CONVECTION BENCHMARK BY A LOCAL MESHLESS METHOD

SOLUTION OF A LOW PRANDTL NUMBER NATURAL CONVECTION BENCHMARK BY A LOCAL MESHLESS METHOD SOLUTION OF A LOW PRANDTL NUMBER NATURAL CONVECTION BENCHMARK BY A LOCAL MESHLESS METHOD Gregor Kosec * and Božidar Šarler * Jožef Stefan Institute Laboratory for Parallel and Distributed Computing Jamova

More information

TRANSVERSE VIBRATION OF A GEAR WHEEL

TRANSVERSE VIBRATION OF A GEAR WHEEL ISSN 14-364 TRANSVERSE VIBRATION OF A GEAR WHEEL Stanislaw Noga, Rzeszow University of Technology, ul. W. Pola, 35 959 Rzeszow, Poland. Abstract: In the paper, transversal vibration of the annular plate

More information

NUMERICAL MLPG ANALYSIS OF PIEZOELECTRIC SENSOR IN STRUCTURES

NUMERICAL MLPG ANALYSIS OF PIEZOELECTRIC SENSOR IN STRUCTURES DOI: 10.2478/sjce-2014-0009 NUMERICAL MLPG ANALYSIS OF PIEZOELECTRIC SENSOR IN STRUCTURES Peter STAŇÁK 1*, Ján SLÁDEK 1, Vladimír SLÁDEK 1, Slavomír KRAHULEC 1 Abstract The paper deals with a numerical

More information

Macroscopic theory Rock as 'elastic continuum'

Macroscopic theory Rock as 'elastic continuum' Elasticity and Seismic Waves Macroscopic theory Rock as 'elastic continuum' Elastic body is deformed in response to stress Two types of deformation: Change in volume and shape Equations of motion Wave

More information

arxiv: v1 [physics.comp-ph] 27 Nov 2018

arxiv: v1 [physics.comp-ph] 27 Nov 2018 Monolithic coupling of implicit material point method with finite element method Eugenio Aulisa Giacomo Capodaglio arxiv:1811.11150v1 [physics.comp-ph] 27 Nov 2018 Abstract A monolithic coupling between

More information

Transactions on Modelling and Simulation vol 12, 1996 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 12, 1996 WIT Press,   ISSN X Plate-soil elastodynamic coupling using analysis S.F.A. Baretto, H.B. Coda, W.S. Venturini Sao Carlos School of Engineering, University ofsao Paulo, Sao Carlos - SP, Brazil BEM Abstract The aim of this

More information

FINITE ELEMENTS ANALYSIS OF THERMAL STEADY STATE, USING ANSYS

FINITE ELEMENTS ANALYSIS OF THERMAL STEADY STATE, USING ANSYS FINITE ELEMENTS ANALYSIS OF THERMAL STEADY STATE, USING ANSYS Gavril GREBENIŞAN 1, Ioan Eugen RADU 2 Ioan ANTON 3 1 University of Oradea, grebe@uoradea.ro 2 University of Oradea, iradu@uoradea.ro 3 GMAB

More information

º Õߪí À À Ë ËÕπ â«ß Õ µ «â«µ Àπàß ÿ æ Ë Ëß øíß å π µ «Õ ªìπøíß å π π ß»

º Õߪí À À Ë ËÕπ â«ß Õ µ «â«µ Àπàß ÿ æ Ë Ëß øíß å π µ «Õ ªìπøíß å π π ß» ««æ π. ªï Ë 31 Ë 4 µÿ - π«2551 643 º Õߪí À À Ë ËÕπ â«ß Õ µ «â«µ Àπàß ÿ æ Ë Ëß øíß å π µ «Õ ªìπøíß å π π ß» µ π» «1 À µ å»ÿπ å ß µ ÕßÀ «ß ª ÿ π 12121 ËÕ 1 惻 π 2550 µõ ËÕ 20 ÿπ π 2551 àõ «µ Àπàß ÿ æ Ë

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Massively scalable computing method to tackle large eigenvalue problems for nanoelectronics modeling

Massively scalable computing method to tackle large eigenvalue problems for nanoelectronics modeling 2019 Intel extreme Performance Users Group (IXPUG) meeting Massively scalable computing method to tackle large eigenvalue problems for nanoelectronics modeling Hoon Ryu, Ph.D. (E: elec1020@kisti.re.kr)

More information

Fluid-Structure Interaction Problems using SU2 and External Finite-Element Solvers

Fluid-Structure Interaction Problems using SU2 and External Finite-Element Solvers Fluid-Structure Interaction Problems using SU2 and External Finite-Element Solvers R. Sanchez 1, D. Thomas 2, R. Palacios 1, V. Terrapon 2 1 Department of Aeronautics, Imperial College London 2 Department

More information

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16.

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16. CAVITY INSPECTION NDT&E Methods: UT VJ Technologies NDT&E Methods: UT 6. NDT&E: Introduction to Methods 6.1. Ultrasonic Testing: Basics of Elasto-Dynamics 6.2. Principles of Measurement 6.3. The Pulse-Echo

More information

Investigation of Utilizing a Secant Stiffness Matrix for 2D Nonlinear Shape Optimization and Sensitivity Analysis

Investigation of Utilizing a Secant Stiffness Matrix for 2D Nonlinear Shape Optimization and Sensitivity Analysis Print ISSN: 2322-2093; Online ISSN: 2423-6691 DOI: 10.7508/ceij.2016.02.011 Technical Note Investigation of Utilizing a Secant Stiffness Matrix for 2D Nonlinear Shape Optimization and Sensitivity Analysis

More information

Scalable Hybrid Programming and Performance for SuperLU Sparse Direct Solver

Scalable Hybrid Programming and Performance for SuperLU Sparse Direct Solver Scalable Hybrid Programming and Performance for SuperLU Sparse Direct Solver Sherry Li Lawrence Berkeley National Laboratory Piyush Sao Rich Vuduc Georgia Institute of Technology CUG 14, May 4-8, 14, Lugano,

More information

ROTATING RING. Volume of small element = Rdθbt if weight density of ring = ρ weight of small element = ρrbtdθ. Figure 1 Rotating ring

ROTATING RING. Volume of small element = Rdθbt if weight density of ring = ρ weight of small element = ρrbtdθ. Figure 1 Rotating ring ROTATIONAL STRESSES INTRODUCTION High centrifugal forces are developed in machine components rotating at a high angular speed of the order of 100 to 500 revolutions per second (rps). High centrifugal force

More information

The Finite Element Method for Solid and Structural Mechanics

The Finite Element Method for Solid and Structural Mechanics The Finite Element Method for Solid and Structural Mechanics Sixth edition O.C. Zienkiewicz, CBE, FRS UNESCO Professor of Numerical Methods in Engineering International Centre for Numerical Methods in

More information

AN ALTERNATIVE TECHNIQUE FOR TANGENTIAL STRESS CALCULATION IN DISCONTINUOUS BOUNDARY ELEMENTS

AN ALTERNATIVE TECHNIQUE FOR TANGENTIAL STRESS CALCULATION IN DISCONTINUOUS BOUNDARY ELEMENTS th Pan-American Congress of Applied Mechanics January 04-08, 00, Foz do Iguaçu, PR, Brazil AN ALTERNATIVE TECHNIQUE FOR TANGENTIAL STRESS CALCULATION IN DISCONTINUOUS BOUNDARY ELEMENTS Otávio Augusto Alves

More information

R. Glenn Brook, Bilel Hadri*, Vincent C. Betro, Ryan C. Hulguin, and Ryan Braby Cray Users Group 2012 Stuttgart, Germany April 29 May 3, 2012

R. Glenn Brook, Bilel Hadri*, Vincent C. Betro, Ryan C. Hulguin, and Ryan Braby Cray Users Group 2012 Stuttgart, Germany April 29 May 3, 2012 R. Glenn Brook, Bilel Hadri*, Vincent C. Betro, Ryan C. Hulguin, and Ryan Braby Cray Users Group 2012 Stuttgart, Germany April 29 May 3, 2012 * presenting author Contents Overview on AACE Overview on MIC

More information

Towards a Numerical Benchmark for 3D Low Mach Number Mixed Flows in a Rectangular Channel Heated from Below

Towards a Numerical Benchmark for 3D Low Mach Number Mixed Flows in a Rectangular Channel Heated from Below Copyright 2008 Tech Science Press FDMP, vol.4, no.4, pp.263-269, 2008 Towards a Numerical Benchmark for 3D Low Mach Number Mixed Flows in a Rectangular Channel Heated from Below G. Accary 1, S. Meradji

More information