Products: Abaqus/CFD Abaqus/CAE
An incompressible fluid dynamics analysis:
is one where the velocity field is divergence-free and the pressure does not contain a thermodynamic component;
is one where the energy contained in acoustic waves is small relative to the energy transported by advection;
can be either laminar or turbulent, steady or time-dependent;
can be used to study either internal or external flows;
can include energy transport and buoyancy forces;
can be used with a deforming mesh for ALE calculations; and
can be performed with conjugate heat transfer or fluid-structure interaction.
Incompressible flow is one of the most frequently encountered flow regimes encompassing a diverse set of problems that include: atmospheric dispersal, food processing, aerodynamic design of automobiles, biomedical flows, electronics cooling, and manufacturing processes such as chemical vapor deposition, mold filling, and casting.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Flow type: Incompressible |
The momentum equations in integral form for an arbitrary control volume can be written as
is an arbitrary control volume with surface area ,
is the outward normal to ,
is the fluid density,
is the pressure,
is the velocity vector,
is the velocity of the moving mesh,
is the body force, and
is the viscous shear stress.
Incompressibility requires a solenoidal velocity field expressed by
The solution of the incompressible Navier-Stokes equations poses a number of algorithmic issues due to the divergence-free velocity condition and the concomitant spatial and temporal resolution required to achieve solutions in complex geometries for engineering applications. The Abaqus/CFD incompressible solver uses a hybrid discretization built on the integral conservation statements for an arbitrary deforming domain. For time-dependent problems, an advanced second-order projection method is used with a node-centered finite-element discretization for the pressure. This hybrid approach guarantees accurate solutions and eliminates the possibility of spurious pressure modes while retaining the local conservation properties associated with traditional finite volume methods. An edge-based implementation is used for all transport equations permitting a single implementation that spans a broad variety of element topologies ranging from simple tetrahedral and hexahedral elements to arbitrary polyhedral. In Abaqus/CFD tetrahedral, wedge, and hexahedral elements are supported.
The basic concept for projection methods is the legitimate segregation of pressure and velocity fields for efficient solution of the incompressible Navier-Stokes equations. Over the past decade, projection methods have found broad application for problems involving laminar and turbulent fluid dynamics, large density variations, chemical reactions, free surfaces, mold filling, and non-Newtonian behavior.
In practice, the projection is used to remove the part of the velocity field that is not divergence-free (“div-free”). The projection is achieved by splitting the velocity field into div-free and curl-free components using a Helmholtz decomposition. The projection operators are constructed so that they satisfy prescribed boundary conditions and are norm-reducing, resulting in a robust solution algorithm for incompressible flows.
The solution methods in Abaqus/CFD use a linearly complete second-order accurate least-squares gradient estimation. This permits accurate evaluation of dual-edge fluxes for both advective and diffusive processes. All transport equations in Abaqus/CFD make use of the second-order least-squares operators.
The implementation of advection in Abaqus/CFD is edge-based, monotonicity-preserving, and preserves smooth variations to second-order in space. The advection relies on a least-squares gradient estimation with unstructured-grid slope limiters that are topology independent. Sharp gradients are captured within approximately 2–3 elements; i.e., , and the use of slope limiting in conjunction with a local diffusive limiter precludes over-/under-shoots in advected fields. The advection is treated explicitly (see the stability discussion in “Time incrementation” below).
The energy transport equation is optionally activated in Abaqus/CFD for non-isothermal flows. For small density variations, the Boussinesq approximation provides the coupling between momentum and energy equations. In turbulent flows, the energy transport includes a turbulent heat flux based on the turbulent eddy viscosity and turbulent Prandtl number. Abaqus/CFD provides a temperature-based energy equation.
The energy equation, in temperature form, can be obtained from the first law of thermodynamics and is given by
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Use the following option to specify a temperature-based energy equation: |
Step module: Create Step: General: Flow; Basic: Energy equation: Temperature Use the following option to specify the turbulent Prandtl number for a temperature-based energy equation: Step module: Create Step: General: Flow; Turbulence: Turbulent Prandtl number: enter value |
Turbulence modeling is a pacing technology for computational fluid dynamics. There is no single universal turbulence model that can adequately handle all possible flow conditions and geometrical configurations. This is complicated by the plethora of turbulence models and modeling approaches that are currently available; e.g., Reynolds Averaged Navier-Stokes (RANS), Unsteady Reynolds Averaged Navier-Stokes (URANS), Large-Eddy Simulation (LES), Implicit Large-Eddy Simulation (ILES), and hybrid RANS/LES (HRLES). Ultimately, you must ensure that the approximations made in a given turbulence model are consistent with the physical problem being modeled.
The following turbulent flow models are available: ILES, Spalart-Allmaras (SA), and RNG k–. These models span a relatively broad set of flow problems that include time-dependent flows, fluid-structure interaction (FSI), and conjugate heat transfer (CHT).
Large-eddy simulation relies on a segregation of length and time scales in turbulent flows and a modeling approach that permits the direct simulation of grid-resolved flow structures and the modeling of unresolved subgrid features. Implicit LES is a methodology for modeling high Reynolds number flows that combines computational efficiency and ease of implementation with predictive calculations and flexible application. In Abaqus/CFD ILES relies on the discrete monotonicity-preserving form of the advective operator to implicitly define the subgrid-scale model. This model is inherently time-dependent requiring time-accurate solutions to the incompressible Navier-Stokes equations where the time scale is approximately that of an eddy-turnover time for resolve-scale flow features. In addition, this model must be run in full three dimensions, which typically imposes larger grid densities and stringent grid resolution criteria relative to more traditional steady-state RANS simulations. However, this approach is extremely flexible and can be applied to a broad range of flows and FSI problems. There are no user settings for this turbulence model.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Use the following option to use the Implicit Large-Eddy Simulation turbulence model (default): |
Step module: Create Step: General: Flow; Turbulence: None |
The Spalart-Allmaras (SA) model is a one-equation turbulence model that uses an eddy-viscosity variable with a nonlinear transport equation. The model was developed based on empiricism, dimensional analysis, and a requirement for Galilean invariance. The model has found broad use and has been calibrated for two-dimensional mixing layers, wakes, and flat-plate boundary layers. The model produces reasonably accurate predictions of turbulent flows in the presence of adverse pressure gradients and may be used for flows where separation occurs. This model is spatially local and requires only moderate resolution in boundary layers. Although initially designed for external and free-shear flows, the Spalart-Allmaras model can also be used for internal flows.
The basic form of the one-equation Spalart-Allmaras model consists of one transport equation for the turbulent eddy viscosity, . The model requires the normal distance from the wall used in the damping functions needed to control the turbulent viscosity in the near-wall region. Abaqus/CFD automatically computes the normal distance function, permitting simple specification of the model boundary conditions. The turbulent viscosity transport equation for the Spalart-Allmaras model is given by
The Spalart-Allmaras model can provide very accurate boundary layer results if the near-wall region is resolved (near-wall resolution such that the nondimensional wall distance is approximately 3). However, the implementation of boundary conditions for the Spalart-Allmaras model in Abaqus/CFD permits the use of coarser meshes as well.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Turbulence: Spalart-Allmaras |
The RNG k– model is a two-equation turbulence model that evolves an equation for the turbulent kinetic energy, k, and the energy dissipation rate,
. The model equations are developed from fundamental physical principles and dimensional analysis. In general, the coefficients of the model are usually calibrated using canonical flows and experimental data. However, the RNG version of the model computes the coefficients using Renormalization Group theory (Yakhot et al., 1992). The model equations are
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Turbulence: k-epsilon renormalization group (RNG) |
It is well known that the k– model has limitations, especially on wall-bounded simulations where high values of eddy viscosity in the near-wall region are usually reproduced. Consequently, near-wall modeling is usually provided to improve the accuracy of the predictions. For the current implementation the “law of the wall” approach is used to provide near-wall modeling to the k–
model. This approach relies on known results (law of the wall) to obtain the wall shear stress.
The law of the wall is a universal velocity profile that wall-bounded flows (in the absence of pressure gradients) develop when the proper viscous scales are used to normalize the velocity and length scales. This law can be stated as
In equilibrium conditions (i.e., in the absence of pressure gradients, ), the law of the wall can be written in the following alternative form:
Many industrial CFD/FSI/CHT problems involve moving boundaries or deforming geometries. This class of problem includes prescribed boundary motion that induces fluid flow or where the boundary motion is relatively independent of the fluid flow. Abaqus/CFD uses an arbitrary Lagrangian Eulerian (ALE) formulation and automated mesh deformation method that preserves element size in boundary layers. The ALE and deforming-mesh algorithms are activated automatically for problems that involve a moving boundary prescribed by the user or identified as a moving boundary in an FSI co-simulation.
To properly control the mesh motion during a simulation, it is the user’s responsibility to prescribe appropriate displacement boundary conditions on the computational mesh.
The solution methods for the momentum and auxiliary transport equations in Abaqus/CFD rely on scalable parallel preconditioned Krylov solvers. The pressure, pressure-increment, and distance function equations are solved with user-selectable Krylov solvers and a robust algebraic multigrid preconditioner. A set of preselected default convergence criteria and iteration limits are prescribed for all linear equation solvers. The default solver settings should provide computationally efficient and robust solutions across a spectrum of CFD problems. However, full access to diagnostic information, convergence criteria, and optional solvers is provided. In practice, the pressure-increment equation may be the most sensitive linear system and could require user intervention based on knowledge of the specific flow problem.
Iterative solvers compute an approximate solution to a given set of equations; therefore, convergence criteria are required to determine if the solution is acceptable. While default settings should be adequate for most problems, you can modify the convergence criteria. In addition to the option of setting convergence criteria, convergence history output is available that may be useful for some advanced users to tune the solvers for performance or robustness. For the algebraic multigrid preconditioner, diagnostic information such as the number of grids, grid sparsity, and largest eigenvalue and condition number estimates are available upon request. The diagnostic information for the algebraic multigrid preconditioner is printed every time the preconditioner is computed.
The linear convergence limit (also commonly referred to as the convergence tolerance), the frequency of convergence checking, and the maximum number of iterations can be set. The iterative solver will stop when the relative residual norm of the system of equations and the relative correction of the solution norm fall below the convergence limit.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Solvers: Momentum Equation, Pressure Equation, or Transport Equation; enter values for Iteration limit, Convergence checking frequency, and Linear convergence limit |
You can monitor the convergence of the iterative solver by accessing convergence output. When you activate the convergence output, the current relative residual norm and the relative solution correction norm are output each time the convergence is checked.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Solvers: Momentum Equation, Pressure Equation, or Transport Equation; toggle on Include convergence output |
Diagnostic output is useful only for the algebraic multigrid preconditioner. For other preconditioners, only a solver initialization message is printed for diagnostic output. For the algebraic multigrid preconditioner, the number of grids, grid sparsity, and largest eigenvalue and condition number estimates are output each time the preconditioner is computed.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Solvers: Momentum Equation, Pressure Equation, or Transport Equation; toggle on Include diagnostic output |
For the pressure equation solver, you can change the Krylov solver and preconditioner. Three Krylov solvers are available: conjugate gradient, bi-conjugate gradient stabilized, and flexible generalized minimal residual; and two preconditioners are available: symmetric successive over-relaxation (SSOR) and algebraic multigrid (AMG). Of the two preconditioners available, AMG provides many additional options that are intended for advanced usage and in cases where convergence difficulties are encountered.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Use the following option to specify a nondefault solver: |
Step module: Create Step: General: Flow; Solvers: Pressure Equation: Solver options: Specify Use one of the following options to specify the preconditioner type: Preconditioner Type: Algebraic multi-grid or Symmetric successive over-relaxation |
For the AMG preconditioner, you can choose from three preset levels or you can specify the Krylov solver and smoother settings directly. The presets are provided for convenience. Preset level one is primarily intended for use with meshes with good element aspect ratios and in some cases may provide a performance benefit over the default preset level two. Preset level three is intended for problems that encounter convergence difficulties, which typically have elements with high aspect ratios or skewed elements.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Solvers: Pressure Equation: Solver options: Specify, Preconditioner Type: Algebraic multi-grid |
Use one of the following options to choose a preset complexity level: Complexity Level: Preset: 1, 2, or 3 Use the following option to specify the Krylov solver and smoother settings directly: Complexity Level: User defined |
Three Krylov solver options are provided. The default conjugate gradient solver is the fastest; however, in some cases where convergence difficulties are observed, the bi-conjugate gradient stabilized or flexible generalized minimal residual solvers are recommended. These two solvers are more robust but computationally more expensive than the conjugate gradient solver.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Solvers: Pressure Equation: Solver options: Specify, Preconditioner Type: Algebraic multi-grid |
Use one of the following options to specify the Krylov solver: Solver Type: Conjugate gradient, Bi-conjugate gradient, stabilized, or Flexible generalized minimal residual |
You can choose between incomplete factorization and polynomial residual smoothers that are used within the AMG preconditioner. While incomplete factorization is computationally more expensive than polynomial smoothing, in many cases this cost is amortized by fast convergence and robustness. Polynomial smoothing is recommended for problems with a very good mesh quality (i.e., no skewed or large aspect ratio elements). The number of pre- and post-smoothing sweeps can also be specified. It is recommended that you apply the same number of pre- and post-sweeps. For the polynomial smoother, a minimum of two pre- and post-sweeps are recommended.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Solvers: Pressure Equation: Solver options: Specify, Preconditioner Type: Algebraic multi-grid |
Use one of the following options to choose the residual smoother: Residual Smoother: Incomplete factorization or Polynomial Use the following options to specify the number of pre-sweeps and post-sweeps: Smoothing sweeps: Pre-sweeps: select number, Post-sweeps: select number |
Abaqus/CFD relies on a second-order semi-implicit projection method for time-dependent problems. By default, all viscous/diffusive terms are treated with a second-order accurate trapezoid rule while the advective terms are currently treated explicitly. In addition, the use of a Galerkin or backward-Euler integrator may be selected for the viscous/diffusive terms. When attempting to reach a steady state, the use of backward-Euler time-marching with a relaxed tolerance on the divergence is recommended.
By default, Abaqus/CFD uses automatic time incrementation that guarantees the solution stability. You may select fixed time-step incrementation, but stability may not be guaranteed. The explicit advection treatment requires that the Courant-Freidrichs-Levy (CFL) stability condition be respected, which requires that . With automatic incrementation, you can select an initial time increment, but the initial time step may be recomputed.
Input File Usage: | You can generate the input file using Abaqus/CAE. |
Abaqus/CAE Usage: | Step module: Create Step: General: Flow; Incrementation |
Use the following options to specify the integrator for viscous/diffusive terms: Viscous or Load/Boundary condition: Trapezoid (1/2), Galerkin (2/3), or Backward-Euler (1) Use one of the following options to specify the time integration type: Type: Automatic (Fixed CFL) or Fixed |
Abaqus/CFD provides a number of output variables that are useful for monitoring the health of a calculation and are good indicators for situations where the flow has reached a steady-state condition. These variables are typically written to the status (.sta) file. The RMS divergence output variable is useful for determining if a calculation is proceeding normally. Abnormally large values of the RMS divergence output variable typically indicate that the problem is incorrectly specified or that the calculation has become unstable. The global kinetic energy (KE) provides a good indicator for when the flow has reached a steady state. Alternatively, the global kinetic energy can indicate a steady-periodic flow situation.
Initial conditions for the density, velocity, temperature, turbulent eddy viscosity, turbulent kinetic energy, and dissipation rate can be specified (see “Initial conditions in Abaqus/CFD,” Section 30.2.2). If the density is omitted, the specified material density is used for incompressible flow simulations.
For a well-posed incompressible flow problem, the initial velocity must satisfy the boundary conditions and also the imposed divergence-free condition; i.e., the solvability conditions. Abaqus/CFD automatically uses the user-defined boundary conditions and tests the specified velocity initial conditions to be sure the solvability conditions are satisfied. If they are not, the initial velocity is projected onto a divergence-free subspace, yielding initial conditions that define a well-posed incompressible Navier-Stokes problem. Therefore, in some circumstances, user-specified velocity initial conditions may be overridden with velocity conditions that satisfy solvability.
Boundary conditions for velocity, temperature, pressure, and eddy viscosity can be defined (see “Boundary conditions in Abaqus/CFD,” Section 30.3.2). During the analysis prescribed boundary conditions can be varied using an amplitude definition (see “Amplitude curves,” Section 30.1.2). All amplitude definitions except smooth step and solution-dependent amplitudes are available. By default, all boundary conditions are applied instantaneously.
Displacement and velocity boundary conditions at FSI interfaces are prescribed automatically by the definition of a co-simulation region; therefore, you should not prescribe these conditions at an FSI interface. Similarly, you should not define the temperature at a CHT interface; the temperature is automatically prescribed by the definition of a co-simulation region. For more information, see “Preparing an Abaqus/CFD analysis for co-simulation,” Section 14.1.3.
The specification of no-slip/no-penetration boundary conditions at walls requires the specification of the turbulent eddy viscosity and normal-distance function, which is handled automatically by Abaqus/CFD.
In incompressible flows, the pressure is only known within an arbitrary additive constant value or the hydrostatic pressure. In many practical situations, the pressure at an outflow boundary may be prescribed, which, in effect, sets the hydrostatic pressure level. In cases where there is no pressure prescribed, it is necessary to set the hydrostatic pressure level at a minimum of one node in the mesh.
The fluid reference pressure can be used to specify the hydrostatic pressure level. When there are no prescribed pressure boundary conditions, the fluid reference pressure establishes the hydrostatic pressure level and makes the pressure-increment equation non-singular. If pressure boundary conditions are prescribed in addition to the reference pressure level, the reference pressure simply adjusts the output pressures according to the specified pressure level. For more information, see “Specifying a fluid reference pressure” in “Concentrated loads,” Section 30.4.2.
The loading types for Abaqus/CFD include applied heat flux, volumetric heat-generation sources, general body forces, and gravity loading. Gravity loading is most typically used in conjunction with an energy equation, and a Boussinesq-type body force for flows involving natural convection. During the analysis prescribed loads can be varied using an amplitude definition (see “Amplitude curves,” Section 30.1.2). All amplitude definitions except smooth step and solution-dependent amplitudes are available.
Material definitions in Abaqus/CFD follow the Abaqus conventions but also present several material properties specific to fluid dynamics. In Abaqus/CFD the typical material properties include viscosity, constant-pressure specific heat, density, and coefficient of thermal expansion. The thermal expansion is used with the Boussinesq approximation for bouyancy-driven flows.
In contrast to Abaqus/Standard and Abaqus/Explicit, which use the constant-volume specific heat, the constant-pressure specific heat is required when the energy equation is used for thermal-flow problems. For problems involving an ideal gas, the user may optionally specify constant-volume specific heat and the ideal gas constant.
Abaqus/CFD supports three element types: the 8-node hexahedral element, FC3D8; the 6-node triangular prism element, FC3D6; and the 4-node tetrahedral element, FC3D4 (see “Fluid (continuum) elements,” Section 25.2.1). These elements cannot be mixed in a single connected fluid domain. However, a single flow model can contain multiple domains, each with a different element type.
The output available from Abaqus/CFD for an incompressible fluid dynamic analysis includes both nodal field data and element time-history data. The preselected field and history data include velocity (V), temperature (TEMP), and pressure (PRESSURE). In addition, preselected field data include displacement (U).
In addition to the preselected output, you can request several derived and auxiliary variables. All of the output variable identifiers are outlined in “Abaqus/CFD output variable identifiers,” Section 4.2.3.