首页 | 本学科首页   官方微博 | 高级检索  
相似文献
 共查询到20条相似文献,搜索用时 406 毫秒
1.
A comparison of a new parallel block-implicit method and the parallel pressure correction procedure for the solution of the incompressible Navier–Stokes equations is presented. The block-implicit algorithm is based on a pressure equation. The system of non-linear equation s is solved by Newton's method. For the solution of the linear algebraic systems the Bi-CGSTAB algorithm with incomplete lower–upper (ILU) decomposition of the matrix is applied. Domain decomposition serves as a strategy for the parallelization of the algorithms. Different algorithms for the parallel solution of the linear system of algebraic equations in conjunction with the pressure correction procedure are proposed. Three different flows are predicted with the parallel algorithms. Results and efficiency data of the block-implicit method are compared with the parallel version of the pressure correction algorithm. The block-implicit method is characterized by stable convergence behaviour, high numerical efficiency, insensitivity to relaxation parameters and high spatial accuracy. © 1997 John Wiley & Sons, Ltd.  相似文献   

2.
This paper presents the parallelization aspects of a solution method for the fully coupled 3D compressible Navier-Stokes equations. The algorithmic thrust of the approach, embedded in a finite element code NS3D, is the linearization of the governing equations through Newton methods, followed by a fully coupled solution of velocities and pressure at each non-linear iteration by preconditioned conjugate gradient-like iterative algorithms. For the matrix assembly, as well as for the linear equation solver, efficient coarse-grain parallel schemes have been developed for shared memory machines, as well as for networks of workstations, with a moderate number of processors. The parallel iterative schemes, in particular, circumvent some of the difficulties associated with domain decomposition methods, such as geometry bookkeeping and the sometimes drastic convergence slow-down of partitioned non-linear problems.  相似文献   

3.
In this paper, five different algorithms are presented for the simulation of low Mach flows with large temperature variations, based on second‐order central‐difference or fourth‐order compact spatial discretization and a pressure projection‐type method. A semi‐implicit three‐step Runge–Kutta/Crank–Nicolson or second‐order iterative scheme is used for time integration. The different algorithms solve the coupled set of governing scalar equations in a decoupled segregate manner. In the first algorithm, a temperature equation is solved and density is calculated from the equation of state, while the second algorithm advances the density using the differential form of the equation of state. The third algorithm solves the continuity equation and the fourth algorithm solves both the continuity and enthalpy equation in conservative form. An iterative decoupled algorithm is also proposed, which allows the computation of the fully coupled solution. All five algorithms solve the momentum equation in conservative form and use a constant‐ or variable‐coefficient Poisson equation for the pressure. The efficiency of the fourth‐order compact scheme and the performances of the decoupling algorithms are demonstrated in three flow problems with large temperature variations: non‐Boussinesq natural convection, channel flow instability, flame–vortex interaction. Copyright © 2010 John Wiley & Sons, Ltd.  相似文献   

4.
In many popular solution algorithms for the incompressible Navier–Stoke equations the coupling between the momentum equations is neglected when the linearized momentum equations are solved to update the velocities. This is known to lead to poor convergence in highly swirling flows where coupling between the radial and tangential momentum equations is strong. Here we propose a coupled solution algorithm in which the linearized momentum and continuity equations are solved simultaneously. Comparisons between the new method and the well-known SIMPLEC method are presented.  相似文献   

5.
The numerical discretization of the equations governing fluid flow results in coupled, quasi-linear and non-symmetric systems. Various approaches exist for resolving the non-linearity and couplings. During each non-linear iteration, nominally linear systems are solved for each of the flow variables. Line relaxation techniques are traditionally employed for solving these systems. However, they could be very expensive for realistic applications and present serious synchronization problems in a distributed memory parallel environment. In this paper the discrete linear systems are solved using the generalized conjugate gradient method of Concus and Golub. The performance of this algorithm is compared with the line Gauss–Seidel algorithm for laminar recirculatory flow in uni- and multiprocessor environments. The uniprocessor performances of these algorithms are also compared with that of a popular iterative solver for non-symmetric systems (the GMRES algorithm).  相似文献   

6.
A stable fast marching scheme has been developed for the solution of coupled parabolic partial differential equations such as the Navier–Stokes equations. The scheme was developed with the aid of a stability analysis. The implementation of the method in standard alternating direction implicit algorithms is straightforward. The scheme was tested on the problem of natural convection in a square cavity. The number of iterations required for convergence was significantly reduced compared to conventional methods.  相似文献   

7.
This paper presents results of an ongoing research program directed towards developing fast and efficient finite element solution algorithms for the simulation of large-scale flow problems. Two main steps were taken towards achieving this goal. The first step was to employ segregated solution schemes as opposed to the fully coupled solution approach traditionally used in many finite element solution algorithms. The second step was to replace the direct Gaussian elimination linear equation solvers used in the first step with iterative solvers of the conjugate gradient and conjugate residual type. The three segregated solution algorithms developed in step one are first presented and their integrity and relative performance demonstrated by way of a few examples. Next, the four types of iterative solvers (i.e. two options for solving the symmetric pressure type equations and two options for solving the non-symmetric advection–diffusion type equations resulting from the segregated algorithms) together with the two preconditioning strategies employed in our study are presented. Finally, using examples of practical relevance the paper documents the large gains which result in computational efficiency, over fully coupled solution algorithms, as each of the above two main steps are introduced. It is shown that these gains become increasingly more dramatic as the complexity and size of the problem is increased.  相似文献   

8.
Two methods for coupling the Reynolds‐averaged Navier–Stokes equations with the qω turbulence model equations on structured grid systems have been studied; namely a loosely coupled method and a strongly coupled method. The loosely coupled method first solves the Navier–Stokes equations with the turbulent viscosity fixed. In a subsequent step, the turbulence model equations are solved with all flow quantities fixed. On the other hand, the strongly coupled method solves the Reynolds‐averaged Navier–Stokes equations and the turbulence model equations simultaneously. In this paper, numerical stabilities of both methods in conjunction with the approximated factorization‐alternative direction implicit method are analysed. The effect of the turbulent kinetic energy terms in the governing equations on the convergence characteristics is also studied. The performance of the two methods is compared for several two‐ and three‐dimensional problems. Copyright © 2005 John Wiley & Sons, Ltd.  相似文献   

9.
A new numerical method is developed to efficiently solve the unsteady incompressible Navier–Stokes equations with second-order accuracy in time and space. In contrast to the SIMPLE algorithms, the present formulation directly solves the discrete x- and y-momentum equations in a coupled form. It is found that the present implicit formulation retrieves some cross convection terms overlooked by the conventional iterative methods, which contribute to accuracy and fast convergence. The finite volume method is applied on the fully staggered grid to solve the vector-form momentum equations. The preconditioned conjugate gradient squared method (PCGS) has proved very efficient in solving the associate linearized large, sparse block-matrix system. Comparison with the SIMPLE algorithm has indicated that the present momentum coupling method is fast and robust in solving unsteady as well as steady viscous flow problems. © 1998 John Wiley & Sons, Ltd.  相似文献   

10.
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.  相似文献   

11.
This paper presents a?new parallel algorithm for dynamics simulation of general multibody systems. The developed formulations are iterative and possess divide and conquer structure. The constraints equations are imposed at the acceleration level. Augmented Lagrangian methods with mass-orthogonal projections are used to prevent from constraint violation errors. The proposed approaches treat tree topology mechanisms or multibody systems which contain kinematic closed loops in a?uniform manner and can handle problems with rank deficient Jacobian matrices. Test case results indicate good accuracy performance dependent on the expense put in the iterative correction of constraint equations. Good numerical properties and robustness of the algorithms are observed when handling systems with single and coupled kinematic loops, redundant constraints, which may repeatedly enter singular configurations.  相似文献   

12.
Simulation of nano‐scale channel flows using a coupled Navier–Stokes/Molecular Dynamics (MD) method is presented. The flow cases serve as examples of the application of a multi‐physics computational framework put forward in this work. The framework employs a set of (partially) overlapping sub‐domains in which different levels of physical modelling are used to describe the flow. This way, numerical simulations based on the Navier–Stokes equations can be extended to flows in which the continuum and/or Newtonian flow assumptions break down in regions of the domain, by locally increasing the level of detail in the model. Then, the use of multiple levels of physical modelling can reduce the overall computational cost for a given level of fidelity. The present work describes the structure of a parallel computational framework for such simulations, including details of a Navier–Stokes/MD coupling, the convergence behaviour of coupled simulations as well as the parallel implementation. For the cases considered here, micro‐scale MD problems are constructed to provide viscous stresses for the Navier–Stokes equations. The first problem is the planar Poiseuille flow, for which the viscous fluxes on each cell face in the finite‐volume discretization are evaluated using MD. The second example deals with fully developed three‐dimensional channel flow, with molecular level modelling of the shear stresses in a group of cells in the domain corners. An important aspect in using shear stresses evaluated with MD in Navier–Stokes simulations is the scatter in the data due to the sampling of a finite ensemble over a limited interval. In the coupled simulations, this prevents the convergence of the system in terms of the reduction of the norm of the residual vector of the finite‐volume discretization of the macro‐domain. Solutions to this problem are discussed in the present work, along with an analysis of the effect of number of realizations and sample duration. The averaging of the apparent viscosity for each cell face, i.e. the ratio of the shear stress predicted from MD and the imposed velocity gradient, over a number of macro‐scale time steps is shown to be a simple but effective method to reach a good level of convergence of the coupled system. Finally, the parallel efficiency of the developed method is demonstrated. Copyright © 2009 John Wiley & Sons, Ltd.  相似文献   

13.
Most of the turbulence models in the literature contain simplified assumptions which make them computationally inexpensive but of limited accuracy for the solution of separated turbulent flows. Dramatic improvements in computer processing speed and parallel processing make it possible to use more complete models, such as Reynolds Stress Models, for separated turbulent flow simulations, which is the focus of this work. The Reynolds Stress Model consists of coupling the Reynolds transport equations with the Favre–Reynolds averaged Navier–Stokes equations, which results in a system of 12 coupled non-linear partial differential equations. The solutions are obtained by running the PUMA_RSM computational fluid dynamics code on unstructured meshes. The equations are solved all the way to the wall without using any wall functions. Results for high Reynolds number flow around a 6:1 prolate spheroid and a Bell 214ST fuselage are presented. For the prolate spheroid basic flow features such as cross-flow separation are simulated. Predictions of circumferential locations of cross flow separation points are in good agreement with the experiment. A grid refinement study is performed to improve the computations. The fine mesh solution predicted locations of primary and secondary separation points with errors of roughly 2° and 0°, respectively. Flow simulations around an isolated Bell 214ST helicopter fuselage were also performed. Predicted pressure and drag force correlate well with the wind tunnel data, with a less than 10% deviation from the experiment. Drag predictions also show relative speed of Reynolds Stress Model compared to Large Eddy Simulation to compute time averaged quantities. For numerical solutions parallel processing is applied with the MPI communication standard. The code used in this study is run on Beowulf clusters. The parallel performance of the code PUMA_RSM is analysed and presented.  相似文献   

14.
Solution algorithms for solving the Navier–Stokes equations without storing equation matrices are developed. The algorithms operate on a nodal basis, where the finite element information is stored as the co-ordinates of the nodes and the nodes in each element. Temporary storage is needed, such as the search vectors, correction vectors and right hand side vectors in the conjugate gradient algorithms which are limited to one-dimensional vectors. The nodal solution algorithms consist of splitting the Navier–Stokes equations into equation systems which are solved sequencially. In the pressure split algorithm, the velocities are found from the diffusion–convection equation and the pressure is computed from these velocities. The computed velocities are then corrected with the pressure gradient. In the velocity–pressure split algorithm, a velocity approximation is first found from the diffusion equation. This velocity is corrected by solving the convection equation. The pressure is then found from these velocities. Finally, the velocities are corrected by the pressure gradient. The nodal algorithms are compared by solving the original Navier–Stokes equations. The pressure split and velocity–pressure split equation systems are solved using ILU preconditioned conjugate gradient methods where the equation matrices are stored, and by using diagonal preconditioned conjugate gradient methods without storing the equation matrices. © 1998 John Wiley & Sons, Ltd.  相似文献   

15.
In this paper an adaptive parallel multigrid method and an application example for the 2D incompressible Navier–Stokes equations are described. The strategy of the adaptivity in the sense of local grid refinement in the multigrid context is the multilevel adaptive technique (MLAT) suggested by Brandt. The parallelization of this method on scalable parallel systems is based on the portable communication library CLIC and the message-passing standards: PARMACS, PVM and MPI. The specific problem considered in this work is a two-dimensional hole pressure problem in which a Poiseuille channel flow is disturbed by a cavity on one side of the channel. Near geometric singularities a very fine grid is needed for obtaining an accurate solution of the pressure value. Two important issues of the efficiency of adaptive parallel multigrid algorithms, namely the data redistribution strategy and the refinement criterion, are discussed here. For approximate dynamic load balancing, new data in the adaptive steps are redistributed into distributed memories in different processors of the parallel system by block remapping. Among several refinement criteria tested in this work, the most suitable one for the specific problem is that based on finite-element residuals from the point of view of self-adaptivity and computational efficiency, since it is a kind of error indicator and can stop refinement algorithms in a natural way for a given tolerance. Comparisons between different global grids without and with local refinement have shown the advantages of the self-adaptive technique, as this can save computer memory and speed up the computing time several times without impairing the numerical accuracy. © 1997 By John Wiley & Sons, Ltd. Int. J. Numer. Methods Fluids 24, 875–892, 1997.  相似文献   

16.
THE THEORETICAL COST OF SEQUENTIAL AND PARALLEL ALGORITHMS FOR SOLVING LINEAR SYSTEMS OF EQUATIONSSalmanH.Abbas(ReceivedMay24...  相似文献   

17.
In recent years multigrid algorithms have been applied to increasingly difficult systems of partial differential equations and major improvements in both speed of convergence and robustness have been achieved. Problems involving several interacting fluids are of great interest in many industrial applications, especially in the process and petro-chemical sectors. However, the multifluid version of the Navier–Stokes equations is extremely complex and represents a challenge to advanced numerical algorithms. In this paper, we describe an extension of the full approximation storage (FAS) multigrid algorithm to the multifluid equations. A number of special issues had to be addressed. The first was the development of a customised, non-linear, coupled relaxation scheme for the smoothing step. Automatic differentiation was used to facilitate the coding of a robust, globally convergent quasi-Newton method. It was also necessary to use special inter-grid transfer operators to maintain the realisability of the solution. Algorithmic details are given and solutions for a series of test problems are compared with those from a widely validated, commercial code. The new approach has proved to be robust; it achieves convergence without resorting to specialised initialisation methods. Moreover, even though the rate of convergence is complex, the method has achieved very good reduction factors: typically five orders of magnitude in 50 cycles. © 1998 John Wiley & Sons, Ltd.  相似文献   

18.
An algebraic multigrid (AMG) scheme is presented for the efficient solution of large systems of coupled algebraic equations involving second-order discrete differentials. It is based on elementary (zero-order) intergrid transfer operators but exhibits convergence rates that are independent of the system bandwidth. Inconsistencies in the coarse-grid approximation are minimised using a global scaling approximation which requires no explicit geometrical information. Residual components of the error spectrum that remain poorly represented in the coarse-grid approximations are reduced by exploiting Krylof subspace methods. The scheme represents a robust, simple and cost-effective approach to the problem of slowly converging eigenmodes when low-order prolongation and restriction operators are used in multigrid algorithms. The algorithm investigated here uses a generalised conjugate residual (GCR) accelerator; it might also be described as an AMG preconditioned GCR method. It is applied to two test problems, one based on a solution of a discrete Poisson-type equation for nodal pressures in a pipe network, the other based on coupled solutions to the discrete Navier–Stokes equations for flows and pressures in a driven cavity. © 1998 John Wiley & Sons, Ltd.  相似文献   

19.
曾清红 《计算力学学报》2012,29(2):205-209,216
研究了无网格局部Petrov-Galerkin方法MLPG(Meshless Local Petrov-Galerkin Method)的并行算法与并行实现过程。将MLPG方法推广到弹性动力学问题,研究了MLPG方法中节点搜索、积分点搜索、数值积分及方程组求解等过程的并行算法,并给出了MLPG方法并行计算的具体实现过程。两个数值算例验证了MLPG并行算法的有效性;计算结果表明,MLPG方法的并行计算具有很好的并行性能和可扩展性。  相似文献   

20.
Quartz crystal resonators are typical piezoelectric acoustic wave devices for frequency control applications with mechanical vibration frequency at the radio-frequency (RF) range. Precise analyses of the vibration and deformation are generally required in the resonator design and improvement process. The considerations include the presence of electrodes, mountings, bias fields such as temperature, initial stresses, and acceleration. Naturally, the finite element method is the only effective tool for such a coupled problem with multi-physics nature. The main challenge is the extremely large size of resulted linear equations. For this reason, we have been employing the Mindlin plate equations to reduce the computational difficulty. In addition, we have to utilize the parallel computing techniques on Linux clusters, which are widely available for academic and industrial applications nowadays, to improve the computing efficiency. The general principle of our research is to use open source software components and public domain technology to reduce cost for developers and users on a Linux cluster. We start with a mesh generator specifically for quartz crystal resonators of rectangular and circular types, and the Mindlin plate equations are implemented for the finite element analysis. Computing techniques like parallel processing, sparse matrix handling, and the latest eigenvalue extraction package are integrated into the program. It is clear from our computation that the combination of these algorithms and methods on a cluster can meet the memory requirement and reduce computing time significantly.  相似文献   

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

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