首页 | 本学科首页   官方微博 | 高级检索  
相似文献
 共查询到20条相似文献,搜索用时 31 毫秒
1.
This paper is concerned with the numerical resolution of the incompressible Navier–Stokes equations in the velocity–vorticity form on non-orthogonal structured grids. The discretization is performed in such a way, that the discrete operators mimic the properties of the continuous ones. This allows the discrete equivalence between the primitive and velocity–vorticity formulations to be proved. This last formulation can thus be seen as a particular technique for solving the primitive equations. The difficulty associated with non-simply connected computational domains and with the implementation of the boundary conditions are discussed. One of the main drawback of the velocity–vorticity formulation, relative to the additional computational work required for solving the additional unknowns, is alleviated. Two- and three-dimensional numerical test cases validate the proposed method. © 1998 John Wiley & Sons, Ltd.  相似文献   

2.
We present a numerical scheme to solve the incompressible Navier–Stokes equations with open boundary condition. After replacing the incompressibility constraint by the pressure Poisson equation, the key is how to give an appropriate boundary condition for the pressure Poisson equation. We propose a new boundary condition for the pressure on the open boundary. Some numerical experiments are presented to verify the accuracy and stability of scheme. Copyright © 2013 John Wiley & Sons, Ltd.  相似文献   

3.
The velocity–vorticity formulation is selected to develop a time‐accurate CFD finite element algorithm for the incompressible Navier–Stokes equations in three dimensions.The finite element implementation uses equal order trilinear finite elements on a non‐staggered hexahedral mesh. A second order vorticity kinematic boundary condition is derived for the no slip wall boundary condition which also enforces the incompressibility constraint. A biconjugate gradient stabilized (BiCGSTAB) sparse iterative solver is utilized to solve the fully coupled system of equations as a Newton algorithm. The solver yields an efficient parallel solution algorithm on distributed‐memory machines, such as the IBM SP2. Three dimensional laminar flow solutions for a square channel, a lid‐driven cavity, and a thermal cavity are established and compared with available benchmark solutions. Copyright © 2002 John Wiley & Sons, Ltd.  相似文献   

4.
This paper describes the Eulerian–Lagrangian boundary element model for the solution of incompressible viscous flow problems using velocity–vorticity variables. A Eulerian–Lagrangian boundary element method (ELBEM) is proposed by the combination of the Eulerian–Lagrangian method and the boundary element method (BEM). ELBEM overcomes the limitation of the traditional BEM, which is incapable of dealing with the arbitrary velocity field in advection‐dominated flow problems. The present ELBEM model involves the solution of the vorticity transport equation for vorticity whose solenoidal vorticity components are obtained iteratively by solving velocity Poisson equations involving the velocity and vorticity components. The velocity Poisson equations are solved using a boundary integral scheme and the vorticity transport equation is solved using the ELBEM. Here the results of two‐dimensional Navier–Stokes problems with low–medium Reynolds numbers in a typical cavity flow are presented and compared with a series solution and other numerical models. The ELBEM model has been found to be feasible and satisfactory. Copyright © 2000 John Wiley & Sons, Ltd.  相似文献   

5.
Two Cartesian grid stretching functions are investigated for solving the unsteady incompressible Navier–Stokes equations using the pressure–velocity formulation. The first function is developed for the Fourier method and is a generalization of earlier work. This function concentrates more points at the centre of the computational box while allowing the box to remain finite. The second stretching function is for the second‐order central finite difference scheme, which uses a staggered grid in the computational domain. This function is derived to allow a direct discretization of the Laplacian operator in the pressure equation while preserving the consistent behaviour exhibited by the uniform grid scheme. Both functions are analysed for their effects on the matrix of the discretized pressure equation. It is shown that while the second function does not spoil the matrix diagonal dominance, the first one can. Limits to stretching of the first method are derived for the cases of mappings in one and two directions. A limit is also derived for the second function in order to prevent a strong distortion of a sine wave. The performances of the two types of stretching are examined in simulations of periodic co‐flowing jets and a time developing boundary layer. Copyright © 2000 John Wiley & Sons, Ltd.  相似文献   

6.
The numerical method of lines (NUMOL) is a numerical technique used to solve efficiently partial differential equations. In this paper, the NUMOL is applied to the solution of the two‐dimensional unsteady Navier–Stokes equations for incompressible laminar flows in Cartesian coordinates. The Navier–Stokes equations are first discretized (in space) on a staggered grid as in the Marker and Cell scheme. The discretized Navier–Stokes equations form an index 2 system of differential algebraic equations, which are afterwards reduced to a system of ordinary differential equations (ODEs), using the discretized form of the continuity equation. The pressure field is computed solving a discrete pressure Poisson equation. Finally, the resulting ODEs are solved using the backward differentiation formulas. The proposed method is illustrated with Dirichlet boundary conditions through applications to the driven cavity flow and to the backward facing step flow. Copyright © 2015 John Wiley & Sons, Ltd.  相似文献   

7.
A new finite volume method for the incompressible Navier–Stokes equations, expressed in arbitrary Lagrangian–Eulerian (ALE) form, is presented. The method uses a staggered storage arrangement for the pressure and velocity variables and adopts an edge‐based data structure and assembly procedure which is valid for arbitrary n‐sided polygonal meshes. Edge formulas are presented for assembling the ALE form of the momentum and pressure equations. An implicit multi‐stage time integrator is constructed that is geometrically conservative to the precision of the arithmetic used in the computation. The method is shown to be second‐order‐accurate in time and space for general time‐dependent polygonal meshes. The method is first evaluated using several well‐known unsteady incompressible Navier–Stokes problems before being applied to a periodically forced aeroelastic problem and a transient free surface problem. Published in 2003 by John Wiley & Sons, Ltd.  相似文献   

8.
An efficient numerical method to solve the unsteady incompressible Navier–Stokes equations is developed. A fully implicit time advancement is employed to avoid the Courant–Friedrichs–Lewy restriction, where the Crank–Nicolson discretization is used for both the diffusion and convection terms. Based on a block LU decomposition, velocity–pressure decoupling is achieved in conjunction with the approximate factorization. The main emphasis is placed on the additional decoupling of the intermediate velocity components with only nth time step velocity. The temporal second‐order accuracy is preserved with the approximate factorization without any modification of boundary conditions. Since the decoupled momentum equations are solved without iteration, the computational time is reduced significantly. The present decoupling method is validated by solving several test cases, in particular, the turbulent minimal channel flow unit. Copyright © 2002 John Wiley & Sons, Ltd.  相似文献   

9.
The Chimera method was developed three decades ago as a meshing simplification tool. Different components are meshed independently and then glued together using a domain decomposition technique to couple the equations solved on each component. This coupling is achieved via transmission conditions (in the finite element context) or by imposing the continuity of fluxes (in the finite volume context). Historically, the method has then been used extensively to treat moving objects, as the independent meshes are free to move with respect to the others. At each time step, the main task consists in recomputing the interpolation of the transmission conditions or fluxes. This paper presents a Chimera method applied to the Navier–Stokes equations. After an introduction on the Chimera method, we describe in two different sections the two independent steps of the method: the hole cutting to create the interfaces of the subdomains and the coupling of the subdomains. Then, we present the Navier–Stokes solver considered in this work. Implementation aspects are then detailed in order to apply efficiently the method to this specific parallel Navier–Stokes solver. We conclude with some examples to demonstrate the reliability and application of the proposed method. Copyright © 2014 John Wiley & Sons, Ltd.  相似文献   

10.
A class of lower–upper/approximate factorization (LUAF) implicit weighted essentially non‐oscillatory (ENO; WENO) schemes for solving the two‐dimensional incompressible Navier–Stokes equations in a generalized co‐ordinate system is presented. The algorithm is based on the artificial compressibility formulation, and symmetric Gauss–Seidel relaxation is used for computing steady state solutions while symmetric successive overrelaxation is used for treating time‐dependent flows. WENO spatial operators are employed for inviscid fluxes and central differencing for viscous fluxes. Internal and external viscous flow test problems are presented to verify the numerical schemes. The use of a WENO spatial operator not only enhances the accuracy of solutions but also improves the convergence rate for the steady state computation as compared with using the ENO counterpart. It is found that the present solutions compare well with exact solutions, experimental data and other numerical results. Copyright © 1999 John Wiley & Sons, Ltd.  相似文献   

11.
This paper presents a numerical algorithm using the pseudostress–velocity formulation to solve incompressible Newtonian flows. The pseudostress–velocity formulation is a variation of the stress–velocity formulation, which does not require symmetric tensor spaces in the finite element discretization. Hence its discretization is greatly simplified. The discrete system is further decoupled into an H ( div ) problem for the pseudostress and a post‐process resolving the velocity. This can be done conveniently by using the penalty method for steady‐state flows or by using the time discretization for nonsteady‐state flows. We apply this formulation to the 2D lid‐driven cavity problem and study its grid convergence rate. Also, computational results of the time‐dependent‐driven cavity problem and the flow past rectangular problem are reported. Copyright © 2009 John Wiley & Sons, Ltd.  相似文献   

12.
This paper describes the finite difference numerical procedure for solving velocity–vorticity form of the Navier–Stokes equations in three dimensions. The velocity Poisson equations are made parabolic using the false‐transient technique and are solved along with the vorticity transport equations. The parabolic velocity Poisson equations are advanced in time using the alternating direction implicit (ADI) procedure and are solved along with the continuity equation for velocities, thus ensuring a divergence‐free velocity field. The vorticity transport equations in conservative form are solved using the second‐order accurate Adams–Bashforth central difference scheme in order to assure divergence‐free vorticity field in three dimensions. The velocity and vorticity Cartesian components are discretized using a central difference scheme on a staggered grid for accuracy reasons. The application of the ADI procedure for the parabolic velocity Poisson equations along with the continuity equation results in diagonally dominant tri‐diagonal matrix equations. Thus the explicit method for the vorticity equations and the tri‐diagonal matrix algorithm for the Poisson equations combine to give a simplified numerical scheme for solving three‐dimensional problems, which otherwise requires enormous computational effort. For three‐dimensional‐driven cavity flow predictions, the present method is found to be efficient and accurate for the Reynolds number range 100?Re?2000. Copyright © 2004 John Wiley & Sons, Ltd.  相似文献   

13.
In the present work, an indirect boundary integral method for the numerical solution of Navier–Stokes equations formulated in velocity–vorticity dependent variables is proposed. This wholly integral approach, based on Helmholtz's decomposition, deals directly with the vorticity field and gives emphasis to the establishment of appropriate boundary conditions for the vorticity transport equation. The coupling between the vorticity and the vortical velocity fields is expressed by an iterative procedure. The present analysis shows the usefulness of an integral formulation not only in providing a potentially more efficient computational tool, but also in giving a better understanding to the physics of the phenomenon. Copyright © 2000 John Wiley & Sons, Ltd.  相似文献   

14.
A complete boundary integral formulation for compressible Navier–Stokes equations with time discretization by operator splitting is developed using the fundamental solutions of the Helmholtz operator equation with different order. The numerical results for wall pressure and wall skin friction of two‐dimensional compressible laminar viscous flow around airfoils are in good agreement with field numerical methods. Copyright © 2004 John Wiley & Sons, Ltd.  相似文献   

15.
We discuss in this paper some implementation aspects of a finite element formulation for the incompressible Navier–Stokes equations which allows the use of equal order velocity–pressure interpolations. The method consists in introducing the projection of the pressure gradient and adding the difference between the pressure Laplacian and the divergence of this new field to the incompressibility equation, both multiplied by suitable algorithmic parameters. The main purpose of this paper is to discuss how to deal with the new variable in the implementation of the algorithm. Obviously, it could be treated as one extra unknown, either explicitly or as a condensed variable. However, we take for granted that the only way for the algorithm to be efficient is to uncouple it from the velocity–pressure calculation in one way or another. Here we discuss some iterative schemes to perform this uncoupling of the pressure gradient projection (PGP) from the calculation of the velocity and the pressure, both for the stationary and the transient Navier–Stokes equations. In the first case, the strategies analyzed refer to the interaction of the linearization loop and the iterative segregation of the PGP, whereas in the second the main dilemma concerns the explicit or implicit treatment of the PGP. Copyright © 2001 John Wiley & Sons, Ltd.  相似文献   

16.
This paper describes a domain decomposition method for the incompressible Navier–Stokes equations in general co‐ordinates. Domain decomposition techniques are needed for solving flow problems in complicated geometries while retaining structured grids on each of the subdomains. This is the so‐called block‐structured approach. It enables the use of fast vectorized iterative methods on the subdomains. The Navier–Stokes equations are discretized on a staggered grid using finite volumes. The pressure‐correction technique is used to solve the momentum equations together with incompressibility conditions. Schwarz domain decomposition is used to solve the momentum and pressure equations on the composite domain. Convergence of domain decomposition is accelerated by a GMRES Krylov subspace method. Computations are presented for a variety of flows. Copyright © 2000 John Wiley & Sons, Ltd.  相似文献   

17.
A new finite difference method for the discretization of the incompressible Navier–Stokes equations is presented. The scheme is constructed on a staggered‐mesh grid system. The convection terms are discretized with a fifth‐order‐accurate upwind compact difference approximation, the viscous terms are discretized with a sixth‐order symmetrical compact difference approximation, the continuity equation and the pressure gradient in the momentum equations are discretized with a fourth‐order difference approximation on a cell‐centered mesh. Time advancement uses a three‐stage Runge–Kutta method. The Poisson equation for computing the pressure is solved with preconditioning. Accuracy analysis shows that the new method has high resolving efficiency. Validation of the method by computation of Taylor's vortex array is presented. Copyright © 1999 John Wiley & Sons, Ltd.  相似文献   

18.
The present study aims to accelerate the convergence to incompressible Navier–Stokes solution. For the sake of computational efficiency, Newton linearization of equations is invoked on non‐staggered grids to shorten the sequence to the final solution of the non‐linear differential system of equations. For the sake of accuracy, the resulting convection–diffusion–reaction finite‐difference equation is solved line‐by‐line using the proposed nodally exact one‐dimensional scheme. The matrix size is reduced and, at the same time, the CPU time is considerably saved due to the decrease of stencil points. The effectiveness of the implemented Newton linearization is demonstrated through computational exercises. Copyright © 2004 John Wiley & Sons, Ltd.  相似文献   

19.
A complete boundary integral formulation for incompressible Navier–Stokes equations with time discretization by operator splitting is developed using the fundamental solutions of the Helmholtz operator equation with different order. The numerical results for the lift and the drag hysteresis associated with a NACA0012 aerofoil oscillating in pitch show good agreement with available experimental data. © 1998 John Wiley & Sons, Ltd.  相似文献   

20.
This paper presents a numerical method for solving the two‐dimensional unsteady incompressible Navier–Stokes equations in a vorticity–velocity formulation. The method is applicable for simulating the nonlinear wave interaction in a two‐dimensional boundary layer flow. It is based on combined compact difference schemes of up to 12th order for discretization of the spatial derivatives on equidistant grids and a fourth‐order five‐ to six‐alternating‐stage Runge–Kutta method for temporal integration. The spatial and temporal schemes are optimized together for the first derivative in a downstream direction to achieve a better spectral resolution. In this method, the dispersion and dissipation errors have been minimized to simulate physical waves accurately. At the same time, the schemes can efficiently suppress numerical grid‐mesh oscillations. The results of test calculations on coarse grids are in good agreement with the linear stability theory and comparable with other works. The accuracy and the efficiency of the current code indicate its potential to be extended to three‐dimensional cases in which full boundary layer transition happens. Copyright © 2011 John Wiley & Sons, Ltd.  相似文献   

设为首页 | 免责声明 | 关于勤云 | 加入收藏

Copyright©北京勤云科技发展有限公司  京ICP备09084417号