首页 | 本学科首页   官方微博 | 高级检索  
相似文献
 共查询到20条相似文献,搜索用时 23 毫秒
1.
Computations of wall distances still play a key role in modern turbulence modeling. Motivated by the expense involved in the computation, an approach solving partial differential equations is considered. An Euler-like transport equation is proposed based on the Eikonal equation. Thus, the efficient algorithms and code components developed for solving transport equations such as Euler and Navier-Stokes equations can be reused. This article provides a detailed implementation of the transport equation in the Cartesian coordinates based on the code of computational fluid dynamics for missiles (MICFD) of Beihang University. The transport equation is robust and rapidly convergent by the implicit lower-upper symmetric Gauss-Seidel (LUSGS) time advancement and upwind spatial discretization. Geometric derivatives must also be upwind determined to ensure accuracy. Special treatments on initial and boundary conditions are discussed. This distance solving approach is successfully applied on several complex geometries with 1-1 blocking or overset grids.  相似文献   

2.
提出一种Fourier-Legendre谱元方法用于求解极坐标系下的Navier-Stokes方程,其中极点所在单元的径向采用Gauss-Radau积分点,避免了r=0处的1/r坐标奇异性。时间离散采用时间分裂法,引入数值同位素模型跟踪同位素的输运过程验证数值模拟的精度,分别利用谱元法和有限差分法的迎风差分格式求解匀速和加速坩埚旋转流动中的同位素方程。计算结果表明,有限差分法中的一阶迎风差分格式存在严重的数值假扩散,二阶迎风差分格式的数值结果较精确,增加节点可以有效地缓解数值扩散。然而,谱元法具有以较少节点得到高精度解的优势。  相似文献   

3.
A numerical scheme for the simulation of blood flow and transport processes in large arteries is presented. Blood flow is described by the unsteady 3D incompressible Navier–Stokes equations for Newtonian fluids; solute transport is modelled by the advection–diffusion equation. The resistance of the arterial wall to transmural transport is described by a shear-dependent wall permeability model. The finite element formulation of the Navier–Stokes equations is based on an operator-splitting method and implicit time discretization. The streamline upwind/Petrov–Galerkin (SUPG) method is applied for stabilization of the advective terms in the transport equation and in the flow equations. A numerical simulation is carried out for pulsatile mass transport in a 3D arterial bend to demonstrate the influence of arterial flow patterns on wall permeability characteristics and transmural mass transfer. The main result is a substantial wall flux reduction at the inner side of the curved region. © 1997 John Wiley & Sons, Ltd.  相似文献   

4.
This paper presents the optimization of unsteady Navier–Stokes flows using the variational level set method. The solid–liquid interface is expressed by the level set function implicitly, and the fluid velocity is constrained to be zero in the solid domain. An optimization problem, which is constrained by the Navier–Stokes equations and a fluid volume constraint, is analyzed by the Lagrangian multiplier based adjoint approach. The corresponding continuous adjoint equations and the shape sensitivity are derived. The level set function is evolved by solving the Hamilton–Jacobian equation with the upwind finite difference method. The optimization method can be used to design channels for flows with or without body forces. The numerical examples demonstrate the feasibility and robustness of this optimization method for unsteady Navier–Stokes flows.Copyright © 2012 John Wiley & Sons, Ltd.  相似文献   

5.
A high‐resolution upwind compact method based on flux splitting is developed for solving the compressive Euler equations. The convective flux terms are discretized by using the modified advection upstream splitting method (AUSM). The developed scheme is used to compute the one‐dimensional Burgers equation and four different example problems of supersonic compressible flows, respectively. The results show that the high‐resolution upwind compact scheme based on modified AUSM+ flux splitting can capture shock wave and other discontinuities, obtain higher resolution and restrain numerical oscillation. Copyright © 2007 John Wiley & Sons, Ltd.  相似文献   

6.
A new numerical model has been developed to evaluate the removal efficiency of primary sedimentation clarifiers operating at neutral density condition. The velocity and concentration fields as well as the development in time and space of the settled particle bed thickness are simulated. The main difficulties in simulation of velocity and concentration fields are related to (1) numerical instabilities produced by the prevalence of convective terms in the unknown variable high-gradient regions and (2) turbulence effects on the suspension of solid particles from the settled bed. The need to overcome the numerical instabilities without the upwind difference approximation, which introduces high numerical viscosity, suggests the use of non-uniform grids of calculation. The velocity field is obtained by solving the motion equations in the vorticity and streamfunction formulation by means of a new numerical method based upon a dynamically self-adjusting calculation grid. These grids allow for a finer mesh following the evolution of the unknown quantities. A k–? model is used to simulate turbulence phenomena. The sedimentation field is found by solving the diffusion and transport equation of the solid particle concentration. Boundary conditions on the bottom line are imposed relating the amount of turbulence flux and sedimentation flux to the actual concentration and the reference concentration. Such an approach makes it possible to represent the solid particle suspension from the bottom, taking into account its dependence on (1) the characteristics and the evolution in time of the settled bed, (2) the velocity component parallel to the bottom line and (3) the turbulence structure.  相似文献   

7.
A high-resolution finite volume hydrodynamic solver is presented for open-channel flows based on the 2D shallow water equations. This Godunov-type upwind scheme uses an efficient Harten–Lax–van Leer (HLL) approximate Riemann solver capable of capturing bore waves and simulating supercritical flows. Second-order accuracy is achieved by means of MUSCL reconstruction in conjunction with a Hancock two-stage scheme for the time integration. By using a finite volume approach, the computational grid can be irregular which allows for easy boundary fitting. The method can be applied directly to model 1D flows in an open channel with a rectangular cross-section without the need to modify the scheme. Such a modification is normally required for solving the 1D St Venant equations to take account of the variation of channel width. The numerical scheme and results of three test problems are presented in this paper. © 1998 John Wiley & Sons, Ltd.  相似文献   

8.
This work presents a parallel numerical strategy to transport Lagrangian particles in a fluid using a dynamic load balance strategy. Both fluid and particle solvers are parallel, with two levels of parallelism. The first level is based on a substructuring technique and uses message passing interface (MPI) as the communication library; the second level consists of OpenMP pragmas for loop parallelisation at the node level. When dealing with transient flows, there exist two main alternatives to address the coupling of these solvers. On the one hand, a single-code approach consists in solving the particle equations once the fluid solution has been obtained at the end of a time step, using the same instance of the same code. On the other hand, a multi-code approach enables one to overlap the transport of the particles with the next time-step solution of the fluid equations, and thus obtain asynchronism. In this case, different codes or two instances of the same code can be used. Both approaches will be presented. In addition, a dynamic load balancing library is used on the top of OpenMP pragmas in order to continuously exploit all the resources available at the node level, thus increasing the load balance and the efficiency of the parallelisation and uses the MPI.  相似文献   

9.
A streamline upwind formulation is presented for the treatment of the advection terms in the general transport equation. The formulation is monotone and conservative and is based on the discontinuous nature of the advection mechanism. The results of there benchmark test cases for the full range of flow Peclet numbers are presented. The new formulation is shown to accurately model the advection phenomenon with significantly smaller numerical diffusion than the existing methods. The results are also free of all spatial oscillations. Considerable savings in computer storage and execution time have been achieved by employing the three-noded triangular element for which exact integrations exist. The formulation is straightforward and can be readily incorporated into any finite element code using the conventional Galerkin approach.  相似文献   

10.
We present a simple and efficient finite element method to solve the Navier-Stokes equations in primitive variables V, p. It uses (a) an explicit advection step, by upwind differencing. Improvement with regard to the classical upwind differencing scheme of the first order is realized by accurate calculation of the characteristic curve across several elements, and higher order interpolation; (b) an implicit diffusion step, avoiding any theoretical limitation on the time increment, and (c) determination of the pressure field by solving the Poisson equation. Two laminar flow calculations are presented and compared to available numerical and experimental results.  相似文献   

11.
A new computational method is presented for reducing numerical diffusion in environmental fluid problems. This method, which is referred to as the Semi-Implicit Skew Upwind Method (SISUM), is a robust solution procedure for the conditional convergence of the discretized transport equations. The method retains the advantage of the low numerical diffusion of the conventional skew upwind schemes but does not suffer from over- or under-shooting often found in these methods due to the improved interpolation schemes. The effectiveness of SISUM is demonstrated in several examples. The comparison of the results of a hybrid scheme and SISUM with field observations of convection-dominated pollutant transport in strongly curvilinear river flow shows that SISUM successfully eliminates the high numerical diffusion produced by the hybrid scheme. The robustness of the method was tested by solving the hydrodynamics of a circular clarifier model with a large density gravity source term in the vertical-momentum equation.  相似文献   

12.
A new numerical procedure for solving the two‐dimensional, steady, incompressible, viscous flow equations on a staggered Cartesian grid is presented in this paper. The proposed methodology is finite difference based, but essentially takes advantage of the best features of two well‐established numerical formulations, the finite difference and finite volume methods. Some weaknesses of the finite difference approach are removed by exploiting the strengths of the finite volume method. In particular, the issue of velocity–pressure coupling is dealt with in the proposed finite difference formulation by developing a pressure correction equation using the SIMPLE approach commonly used in finite volume formulations. However, since this is purely a finite difference formulation, numerical approximation of fluxes is not required. Results presented in this paper are based on first‐ and second‐order upwind schemes for the convective terms. This new formulation is validated against experimental and other numerical data for well‐known benchmark problems, namely developing laminar flow in a straight duct, flow over a backward‐facing step, and lid‐driven cavity flow. Copyright © 2010 John Wiley & Sons, Ltd.  相似文献   

13.
A numerical model for the simulation of flow and transport of organic compounds undergoing bacterial oxygen- and nitrate-based respiration is presented. General assumptions regarding microbial population, bacteria metabolism and effects of oxygen, nitrogen and nutrient concentration on organic substrate rate of consumption are briefly described. The numerical solution techniques for solving both the flow and the transport are presented. The saturated flow equation is discretized using a high-order mixed finite element scheme, which provides a highly accurate estimation of the velocity field. The transport equation for a sorbing porous medium is approximated using a finite volume scheme enclosing an upwind TVD shock-capturing technique for capturing concentration-unsteady steep fronts. The performance and capabilities of the present approach in a bio-remediation context are assessed by considering a set of test problems. The reliability of the numerical results concerning solution accuracy and the computational efficiency in terms of cost and memory requirements are also estimated. © 1998 John Wiley & Sons, Ltd.  相似文献   

14.
This paper is concerned with the development of the finite element method in simulating scalar transport, governed by the convection–reaction (CR) equation. A feature of the proposed finite element model is its ability to provide nodally exact solutions in the one‐dimensional case. Details of the derivation of the upwind scheme on quadratic elements are given. Extension of the one‐dimensional nodally exact scheme to the two‐dimensional model equation involves the use of a streamline upwind operator. As the modified equations show in the four types of element, physically relevant discretization error terms are added to the flow direction and help stabilize the discrete system. The proposed method is referred to as the streamline upwind Petrov–Galerkin finite element model. This model has been validated against test problems that are amenable to analytical solutions. In addition to a fundamental study of the scheme, numerical results that demonstrate the validity of the method are presented. Copyright © 2001 John Wiley & Sons, Ltd.  相似文献   

15.
Separated flow past a circular cylinder is computed from two finite-difference Navier–Stokes models. Stream functions are calculated using a successive-over-relaxation (SOR) procedure. Alternating-direction-implicil (ADI) and ‘upwind’ directional difference explicit (DDE) numerical schemes for solving the vorticity-transport equation are compared. The ‘upwind’ differencing technique produces artificial viscosity which damps the wake and suppresses vortex shedding. It is shown to be unreliable and so the ADI approach is recommended.  相似文献   

16.
This paper examines the modeling of two-dimensional homogeneous stratified turbulent shear flows using the Reynolds-stress and Reynolds-heat-flux equations. Several closure models have been investigated; the emphasis is placed on assessing the effect of modeling the dissipation rate tensor in the Reynolds-stress equation. Three different approaches are considered; one is an isotropic approach while the other two are anisotropic approaches. The isotropic approach is based on Kolmogorov's hypothesis and a dissipation rate equation modified to account for vortex stretching. One of the anisotropic approaches is based on an algebraic representation of the dissipation rate tensor, while another relies on solving a modeled transport equation for this tensor. In addition, within the former anisotropic approach, two different algebraic representations are examined; one is a function of the Reynolds-stress anisotropy tensor, and the other is a function of the mean velocity gradients. The performance of these closure models is evaluated against experimental and direct numerical simulation data of pure shear flows, pure buoyant flows and buoyant shear flows. Calculations have been carried out over a range of Richardson numbers (Ri) and two different Prandtl numbers (Pr); thus the effect of Pr on the development of counter-gradient heat flux in a stratified shear flow can be assessed. At low Ri, the isotropic model performs well in the predictions of stratified shear flows; however, its performance deteriorates as Ri increases. At high Ri, the transport equation model for the dissipation rate tensor gives the best result. Furthermore, the results also lend credence to the algebraic dissipation rate model based on the Reynolds stress anisotropy tensor. Finally, it is found that Pr has an effect on the development of counter-gradient heat flux. The calculations show that, under the action of shear, counter-gradient heat flux does not occur even at Ri = 1 in an air flow. This revised version was published online in July 2006 with corrections to the Cover Date.  相似文献   

17.
Standard Galerkin finite element methods (GFEM) lack stability in solving advection-dominated solute transport in porous media. They usually require prohibitively fine grids and extremely small time steps to solve for advection-dominated problems. The algebraic subgrid-scale stabilized (ASGS) finite element method has been proved to overcome such problems for single-species reactive transport. Its potential for dealing with multicomponent reactive transport has not yet been explored. Here we present a numerical formulation of ASGS for steady and transient multicomponent reactive transport. Subgrid-scale transport equations are solved first by using an ASGS approximation and their solutions are substituted back into the grid-scale equations. A sequential iteration approach (SIA) is used to solve for coupled transport and chemical equations. Coupling of ASGS and SIA, ASGS+SIA, has been implemented in a reactive transport code, CORE2D V4, and verified for conservative solute transport. ASGS+SIA has been tested for a wide range of 1-D transient multicomponent reactive transport problems involving different types of chemical reactions such as: (1) Kinetically controlled aqueous species degradation, (2) Kinetic mineral dissolution, (3) Serial-parallel decay networks, and (4) Cation exchange and pyrite oxidation at local equilibrium. ASGS+SIA always provides accurate solutions and therefore offers an efficient option to solve for advection-dominated multicomponent reactive transport problems.  相似文献   

18.
Third‐order and fifth‐order upwind compact finite difference schemes based on flux‐difference splitting are proposed for solving the incompressible Navier–Stokes equations in conjunction with the artificial compressibility (AC) method. Since the governing equations in the AC method are hyperbolic, flux‐difference splitting (FDS) originally developed for the compressible Euler equations can be used. In the present upwind compact schemes, the split derivatives for the convective terms at grid points are linked to the differences of split fluxes between neighboring grid points, and these differences are computed by using FDS. The viscous terms are approximated with a sixth‐order central compact scheme. Comparisons with 2D benchmark solutions demonstrate that the present compact schemes are simple, efficient, and high‐order accurate. Copyright © 2008 John Wiley & Sons, Ltd.  相似文献   

19.
In this paper we present a finite difference method for solving two-dimensional viscoelastic unsteady free surface flows governed by the single equation version of the eXtended Pom-Pom (XPP) model. The momentum equations are solved by a projection method which uncouples the velocity and pressure fields. We are interested in low Reynolds number flows and, to enhance the stability of the numerical method, an implicit technique for computing the pressure condition on the free surface is employed. This strategy is invoked to solve the governing equations within a Marker-and-Cell type approach while simultaneously calculating the correct normal stress condition on the free surface. The numerical code is validated by performing mesh refinement on a two-dimensional channel flow. Numerical results include an investigation of the influence of the parameters of the XPP equation on the extrudate swelling ratio and the simulation of the Barus effect for XPP fluids.  相似文献   

20.
In order to obtain stable and accurate numerical solutions for the convection-dominated steady transport equations, we propose a criterion for constructing numerical schemes for the convection term that the roots of the characteristic equation of the resulting difference equation have poles. By imposing this criterion on the difference coefficients of the convection term, we construct two numerical schemes for the convection-dominated equations. One is based on polynomial differencing and the other on locally exact differencing. The former scheme coincides with the QUICK scheme when the mesh Reynolds number (Rm) is $\mathop \[{\textstyle{{\rm 8} \over {\rm 3}}}\] $, which is the critical value for its stability, while it approaches the second-order upwind scheme as Rm goes to infinity. Hence the former scheme interpolates a stable scheme between the QUICK scheme at Rm = $\mathop \[{\textstyle{{\rm 8} \over {\rm 3}}}\] $ and the second-order upwind scheme at Rm = ∞. Numerical solutions with the present new schemes for the one-dimensional, linear, steady convection-diffusion equations showed good results.  相似文献   

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

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