Search results for: compressible Navier-Stokes equations
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 1864

Search results for: compressible Navier-Stokes equations

1864 A Runge Kutta Discontinuous Galerkin Method for Lagrangian Compressible Euler Equations in Two-Dimensions

Authors: Xijun Yu, Zhenzhen Li, Zupeng Jia

Abstract:

This paper presents a new cell-centered Lagrangian scheme for two-dimensional compressible flow. The new scheme uses a semi-Lagrangian form of the Euler equations. The system of equations is discretized by Discontinuous Galerkin (DG) method using the Taylor basis in Eulerian space. The vertex velocities and the numerical fluxes through the cell interfaces are computed consistently by a nodal solver. The mesh moves with the fluid flow. The time marching is implemented by a class of the Runge-Kutta (RK) methods. A WENO reconstruction is used as a limiter for the RKDG method. The scheme is conservative for the mass, momentum and total energy. The scheme maintains second-order accuracy and has free parameters. Results of some numerical tests are presented to demonstrate the accuracy and the robustness of the scheme.

Keywords: cell-centered Lagrangian scheme, compressible Euler equations, RKDG method

Procedia PDF Downloads 523
1863 An Axisymmetric Finite Element Method for Compressible Swirling Flow

Authors: Raphael Zanella, Todd A. Oliver, Karl W. Schulz

Abstract:

This work deals with the finite element approximation of axisymmetric compressible flows with swirl velocity. We are interested in problems where the flow, while weakly dependent on the azimuthal coordinate, may have a strong azimuthal velocity component. We describe the approximation of the compressible Navier-Stokes equations with H1-conformal spaces of axisymmetric functions. The weak formulation is implemented in a C++ solver with explicit time marching. The code is first verified with a convergence test on a manufactured solution. The verification is completed by comparing the numerical and analytical solutions in a Poiseuille flow case and a Taylor-Couette flow case. The code is finally applied to the problem of a swirling subsonic air flow in a plasma torch geometry.

Keywords: axisymmetric problem, compressible Navier-Stokes equations, continuous finite elements, swirling flow

Procedia PDF Downloads 154
1862 An Inviscid Compressible Flow Solver Based on Unstructured OpenFOAM Mesh Format

Authors: Utkan Caliskan

Abstract:

Two types of numerical codes based on finite volume method are developed in order to solve compressible Euler equations to simulate the flow through forward facing step channel. Both algorithms have AUSM+- up (Advection Upstream Splitting Method) scheme for flux splitting and two-stage Runge-Kutta scheme for time stepping. In this study, the flux calculations differentiate between the algorithm based on OpenFOAM mesh format which is called 'face-based' algorithm and the basic algorithm which is called 'element-based' algorithm. The face-based algorithm avoids redundant flux computations and also is more flexible with hybrid grids. Moreover, some of OpenFOAM’s preprocessing utilities can be used on the mesh. Parallelization of the face based algorithm for which atomic operations are needed due to the shared memory model, is also presented. For several mesh sizes, 2.13x speed up is obtained with face-based approach over the element-based approach.

Keywords: cell centered finite volume method, compressible Euler equations, OpenFOAM mesh format, OpenMP

Procedia PDF Downloads 292
1861 A Parallel Computation Based on GPU Programming for a 3D Compressible Fluid Flow Simulation

Authors: Sugeng Rianto, P.W. Arinto Yudi, Soemarno Muhammad Nurhuda

Abstract:

A computation of a 3D compressible fluid flow for virtual environment with haptic interaction can be a non-trivial issue. This is especially how to reach good performances and balancing between visualization, tactile feedback interaction, and computations. In this paper, we describe our approach of computation methods based on parallel programming on a GPU. The 3D fluid flow solvers have been developed for smoke dispersion simulation by using combinations of the cubic interpolated propagation (CIP) based fluid flow solvers and the advantages of the parallelism and programmability of the GPU. The fluid flow solver is generated in the GPU-CPU message passing scheme to get rapid development of haptic feedback modes for fluid dynamic data. A rapid solution in fluid flow solvers is developed by applying cubic interpolated propagation (CIP) fluid flow solvers. From this scheme, multiphase fluid flow equations can be solved simultaneously. To get more acceleration in the computation, the Navier-Stoke Equations (NSEs) is packed into channels of texel, where computation models are performed on pixels that can be considered to be a grid of cells. Therefore, despite of the complexity of the obstacle geometry, processing on multiple vertices and pixels can be done simultaneously in parallel. The data are also shared in global memory for CPU to control the haptic in providing kinaesthetic interaction and felling. The results show that GPU based parallel computation approaches provide effective simulation of compressible fluid flow model for real-time interaction in 3D computer graphic for PC platform. This report has shown the feasibility of a new approach of solving the compressible fluid flow equations on the GPU. The experimental tests proved that the compressible fluid flowing on various obstacles with haptic interactions on the few model obstacles can be effectively and efficiently simulated on the reasonable frame rate with a realistic visualization. These results confirm that good performances and balancing between visualization, tactile feedback interaction, and computations can be applied successfully.

Keywords: CIP, compressible fluid, GPU programming, parallel computation, real-time visualisation

Procedia PDF Downloads 407
1860 Compressible Flow Modeling in Pipes and Porous Media during Blowdown Experiment

Authors: Thomas Paris, Vincent Bruyere, Patrick Namy

Abstract:

A numerical model is developed to simulate gas blowdowns through a thin tube and a filter (porous media), separating a high pressure gas filled reservoir to low pressure ones. Based on a previous work, a one-dimensional approach is developed by using the finite element method to solve the transient compressible flow and to predict the pressure and temperature evolution in space and time. Mass, momentum, and energy conservation equations are solved in a fully coupled way in the reservoirs, the pipes and the porous media. Numerical results, such as pressure and temperature evolutions, are firstly compared with experimental data to validate the model for different configurations. Couplings between porous media and pipe flow are then validated by checking mass balance. The influence of the porous media and the nature of the gas is then studied for different initial high pressure values.

Keywords: compressible flow, fluid mechanics, heat transfer, porous media

Procedia PDF Downloads 379
1859 Compressible Lattice Boltzmann Method for Turbulent Jet Flow Simulations

Authors: K. Noah, F.-S. Lien

Abstract:

In Computational Fluid Dynamics (CFD), there are a variety of numerical methods, of which some depend on macroscopic model representatives. These models can be solved by finite-volume, finite-element or finite-difference methods on a microscopic description. However, the lattice Boltzmann method (LBM) is considered to be a mesoscopic particle method, with its scale lying between the macroscopic and microscopic scales. The LBM works well for solving incompressible flow problems, but certain limitations arise from solving compressible flows, particularly at high Mach numbers. An improved lattice Boltzmann model for compressible flow problems is presented in this research study. A higher-order Taylor series expansion of the Maxwell equilibrium distribution function is used to overcome limitations in LBM when solving high-Mach-number flows. Large eddy simulation (LES) is implemented in LBM to simulate turbulent jet flows. The results have been validated with available experimental data for turbulent compressible free jet flow at subsonic speeds.

Keywords: compressible lattice Boltzmann method, multiple relaxation times, large eddy simulation, turbulent jet flows

Procedia PDF Downloads 250
1858 Computational Aerodynamic Shape Optimisation Using a Concept of Control Nodes and Modified Cuckoo Search

Authors: D. S. Naumann, B. J. Evans, O. Hassan

Abstract:

This paper outlines the development of an automated aerodynamic optimisation algorithm using a novel method of parameterising a computational mesh by employing user–defined control nodes. The shape boundary movement is coupled to the movement of the novel concept of the control nodes via a quasi-1D-linear deformation. Additionally, a second order smoothing step has been integrated to act on the boundary during the mesh movement based on the change in its second derivative. This allows for both linear and non-linear shape transformations dependent on the preference of the user. The domain mesh movement is then coupled to the shape boundary movement via a Delaunay graph mapping. A Modified Cuckoo Search (MCS) algorithm is used for optimisation within the prescribed design space defined by the allowed range of control node displacement. A finite volume compressible NavierStokes solver is used for aerodynamic modelling to predict aerodynamic design fitness. The resulting coupled algorithm is applied to a range of test cases in two dimensions including the design of a subsonic, transonic and supersonic intake and the optimisation approach is compared with more conventional optimisation strategies. Ultimately, the algorithm is tested on a three dimensional wing optimisation case.

Keywords: mesh movement, aerodynamic shape optimization, cuckoo search, shape parameterisation

Procedia PDF Downloads 312
1857 Direct Compression Formulation of Poorly Compressible Drugs to Minimize the Tablet Defects

Authors: Abhishek Pandey

Abstract:

Capping and lamination are the most common tablet defects with poorly compressible drugs the common example of that Ibuprofen and Acetaminophen. Generally both these drugs are compressed by wet granulation method which is very time consuming process Ibuprofen and Acetaminophen is widely used as prescription & non-prescription medicine. Ibuprofen mainly used in the treatment of mild to moderate pain related to headache, migraine, postoperative condition and in the management of spondylitis, osteoarthritis Acetaminophen used as an analgesic and antipyretic drug. Ibuprofen having high tendency of sticking to punches of tablet punching machine while Acetaminophen is not ordinarily compressible to tablet formulation because Acetaminophen crystals are very hard and brittle in nature and fracture very easily when compressed producing capping and laminating tablet defects therefore wet granulation method is used to make them compressible. The aim of study was to prepare Ibuprofen and Acetaminophen tablets by direct compression technique and their evaluation. In this Investigation tablets were prepared by using directly compressible grade excipients. Dibasic calcium phosphate, lactose anhydrous (DCL21), microcrystalline cellulose (Avicel PH 101). In order to obtain best or optimize formulation nine different formulations were generated among them batch F5, F6, F7 shows good results and within the acceptable limit. Formulation (F7) selected as optimize product on the basis of evaluation parameters.

Keywords: capping, lamination, tablet defects, direct compression

Procedia PDF Downloads 404
1856 Energy Separation Mechanism in Uni-Flow Vortex Tube Using Compressible Vortex Flow

Authors: Hiroshi Katanoda, Mohd Hazwan bin Yusof

Abstract:

A theoretical investigation from the viewpoint of gas-dynamics and thermodynamics was carried out, in order to clarify the energy separation mechanism in a viscous compressible vortex, as a primary flow element in a uni-flow vortex tube. The mathematical solutions of tangential velocity, density and temperature in a viscous compressible vortical flow were used in this study. It is clear that a total temperature in the vortex core falls well below that distant from the vortex core in the radial direction, causing a region with higher total temperature, compared to the distant region, peripheral to the vortex core.

Keywords: energy separation mechanism, theoretical analysis, vortex tube, vortical flow

Procedia PDF Downloads 367
1855 Numerical Analysis of Gas-Particle Mixtures through Pipelines

Authors: G. Judakova, M. Bause

Abstract:

The ability to model and simulate numerically natural gas flow in pipelines has become of high importance for the design of pipeline systems. The understanding of the formation of hydrate particles and their dynamical behavior is of particular interest, since these processes govern the operation properties of the systems and are responsible for system failures by clogging of the pipelines under certain conditions. Mathematically, natural gas flow can be described by multiphase flow models. Using the two-fluid modeling approach, the gas phase is modeled by the compressible Euler equations and the particle phase is modeled by the pressureless Euler equations. The numerical simulation of compressible multiphase flows is an important research topic. It is well known that for nonlinear fluxes, even for smooth initial data, discontinuities in the solution are likely to occur in finite time. They are called shock waves or contact discontinuities. For hyperbolic and singularly perturbed parabolic equations the standard application of the Galerkin finite element method (FEM) leads to spurious oscillations (e.g. Gibb's phenomenon). In our approach, we use stabilized FEM, the streamline upwind Petrov-Galerkin (SUPG) method, where artificial diffusion acting only in the direction of the streamlines and using a special treatment of the boundary conditions in inviscid convective terms, is added. Numerical experiments show that the numerical solution obtained and stabilized by SUPG captures discontinuities or steep gradients of the exact solution in layers. However, within this layer the approximate solution may still exhibit overshoots or undershoots. To suitably reduce these artifacts we add a discontinuity capturing or shock capturing term. The performance properties of our numerical scheme are illustrated for two-phase flow problem.

Keywords: two-phase flow, gas-particle mixture, inviscid two-fluid model, euler equation, finite element method, streamline upwind petrov-galerkin, shock capturing

Procedia PDF Downloads 290
1854 Prediction of Finned Projectile Aerodynamics Using a Lattice-Boltzmann Method CFD Solution

Authors: Zaki Abiza, Miguel Chavez, David M. Holman, Ruddy Brionnaud

Abstract:

In this paper, the prediction of the aerodynamic behavior of the flow around a Finned Projectile will be validated using a Computational Fluid Dynamics (CFD) solution, XFlow, based on the Lattice-Boltzmann Method (LBM). XFlow is an innovative CFD software developed by Next Limit Dynamics. It is based on a state-of-the-art Lattice-Boltzmann Method which uses a proprietary particle-based kinetic solver and a LES turbulent model coupled with the generalized law of the wall (WMLES). The Lattice-Boltzmann method discretizes the continuous Boltzmann equation, a transport equation for the particle probability distribution function. From the Boltzmann transport equation, and by means of the Chapman-Enskog expansion, the compressible Navier-Stokes equations can be recovered. However to simulate compressible flows, this method has a Mach number limitation because of the lattice discretization. Thanks to this flexible particle-based approach the traditional meshing process is avoided, the discretization stage is strongly accelerated reducing engineering costs, and computations on complex geometries are affordable in a straightforward way. The projectile that will be used in this work is the Army-Navy Basic Finned Missile (ANF) with a caliber of 0.03 m. The analysis will consist in varying the Mach number from M=0.5 comparing the axial force coefficient, normal force slope coefficient and the pitch moment slope coefficient of the Finned Projectile obtained by XFlow with the experimental data. The slope coefficients will be obtained using finite difference techniques in the linear range of the polar curve. The aim of such an analysis is to find out the limiting Mach number value starting from which the effects of high fluid compressibility (related to transonic flow regime) lead the XFlow simulations to differ from the experimental results. This will allow identifying the critical Mach number which limits the validity of the isothermal formulation of XFlow and beyond which a fully compressible solver implementing a coupled momentum-energy equations would be required.

Keywords: CFD, computational fluid dynamics, drag, finned projectile, lattice-boltzmann method, LBM, lift, mach, pitch

Procedia PDF Downloads 393
1853 Classification of Equations of Motion

Authors: Amritpal Singh Nafria, Rohit Sharma, Md. Shami Ansari

Abstract:

Up to now only five different equations of motion can be derived from velocity time graph without needing to know the normal and frictional forces acting at the point of contact. In this paper we obtained all possible requisite conditions to be considering an equation as an equation of motion. After that we classified equations of motion by considering two equations as fundamental kinematical equations of motion and other three as additional kinematical equations of motion. After deriving these five equations of motion, we examine the easiest way of solving a wide variety of useful numerical problems. At the end of the paper, we discussed the importance and educational benefits of classification of equations of motion.

Keywords: velocity-time graph, fundamental equations, additional equations, requisite conditions, importance and educational benefits

Procedia PDF Downloads 766
1852 Weak Solutions Of Stochastic Fractional Differential Equations

Authors: Lev Idels, Arcady Ponosov

Abstract:

Stochastic fractional differential equations have recently attracted considerable attention, as they have been used to model real-world processes, which are subject to natural memory effects and measurement uncertainties. Compared to conventional hereditary differential equations, one of the advantages of fractional differential equations is related to more realistic geometric properties of their trajectories that do not intersect in the phase space. In this report, a Peano-like existence theorem for nonlinear stochastic fractional differential equations is proven under very general hypotheses. Several specific classes of equations are checked to satisfy these hypotheses, including delay equations driven by the fractional Brownian motion, stochastic fractional neutral equations and many others.

Keywords: delay equations, operator methods, stochastic noise, weak solutions

Procedia PDF Downloads 180
1851 Integrable Heisenberg Ferromagnet Equations with Self-Consistent Potentials

Authors: Gulgassyl Nugmanova, Zhanat Zhunussova, Kuralay Yesmakhanova, Galya Mamyrbekova, Ratbay Myrzakulov

Abstract:

In this paper, we consider some integrable Heisenberg Ferromagnet Equations with self-consistent potentials. We study their Lax representations. In particular we derive their equivalent counterparts in the form of nonlinear Schr\"odinger type equations. We present the integrable reductions of the Heisenberg Ferromagnet Equations with self-consistent potentials. These integrable Heisenberg Ferromagnet Equations with self-consistent potentials describe nonlinear waves in ferromagnets with some additional physical fields.

Keywords: Heisenberg Ferromagnet equations, soliton equations, equivalence, Lax representation

Procedia PDF Downloads 434
1850 Data-Driven Analysis of Velocity Gradient Dynamics Using Neural Network

Authors: Nishant Parashar, Sawan S. Sinha, Balaji Srinivasan

Abstract:

We perform an investigation of the unclosed terms in the evolution equation of the velocity gradient tensor (VGT) in compressible decaying turbulent flow. Velocity gradients in a compressible turbulent flow field influence several important nonlinear turbulent processes like cascading and intermittency. In an attempt to understand the dynamics of the velocity gradients various researchers have tried to model the unclosed terms in the evolution equation of the VGT. The existing models proposed for these unclosed terms have limited applicability. This is mainly attributable to the complex structure of the higher order gradient terms appearing in the evolution equation of VGT. We investigate these higher order gradients using the data from direct numerical simulation (DNS) of compressible decaying isotropic turbulent flow. The gas kinetic method aided with weighted essentially non-oscillatory scheme (WENO) based flow- reconstruction is employed to generate DNS data. By applying neural-network to the DNS data, we map the structure of the unclosed higher order gradient terms in the evolution of the equation of the VGT with VGT itself. We validate our findings by performing alignment based study of the unclosed higher order gradient terms obtained using the neural network with the strain rate eigenvectors.

Keywords: compressible turbulence, neural network, velocity gradient tensor, direct numerical simulation

Procedia PDF Downloads 141
1849 Efficient Monolithic FEM for Compressible Flow and Conjugate Heat Transfer

Authors: Santhosh A. K.

Abstract:

This work presents an efficient monolithic finite element strategy for solving thermo-fluid-structure interaction problems involving compressible fluids and linear-elastic structure. This formulation uses displacement variables for structure and velocity variables for the fluid, with no additional variables required to ensure traction, velocity, temperature, and heat flux continuity at the fluid-structure interface. Rate of convergence in each time step is quadratic, which is achieved in this formulation by deriving an exact tangent stiffness matrix. The robustness and good performance of the method is ascertained by applying the proposed strategy on a wide spectrum of problems taken from the literature pertaining to steady, transient, two dimensional, axisymmetric, and three dimensional fluid flow and conjugate heat transfer. It is shown that the current formulation gives excellent results on all the case studies conducted, which includes problems involving compressibility effects as well as problems where fluid can be treated as incompressible.

Keywords: linear thermoelasticity, compressible flow, conjugate heat transfer, monolithic FEM

Procedia PDF Downloads 173
1848 2D RF ICP Torch Modelling with Fluid Plasma

Authors: Mokhtar Labiod, Nabil Ikhlef, Keltoum Bouherine, Olivier Leroy

Abstract:

A numerical model for the radio-frequency (RF) Argon discharge chamber is developed to simulate the low pressure low temperature inductively coupled plasma. This model will be of fundamental importance in the design of the plasma magnetic control system. Electric and magnetic fields inside the discharge chamber are evaluated by solving a magnetic vector potential equation. To start with, the equations of the ideal magnetohydrodynamics theory will be presented describing the basic behaviour of magnetically confined plasma and equations are discretized with finite element method in cylindrical coordinates. The discharge chamber is assumed to be axially symmetric and the plasma is treated as a compressible gas. Plasma generation due to ionization is added to the continuity equation. Magnetic vector potential equation is solved for the electromagnetic fields. A strong dependence of the plasma properties on the discharge conditions and the gas temperature is obtained.

Keywords: direct-coupled model, magnetohydrodynamic, modelling, plasma torch simulation

Procedia PDF Downloads 412
1847 Formulation Development, Process Optimization and Comparative study of Poorly Compressible Drugs Ibuprofen, Acetaminophen Using Direct Compression and Top Spray Granulation Technique

Authors: Abhishek Pandey

Abstract:

Ibuprofen and Acetaminophen is widely used as prescription & non-prescription medicine. Ibuprofen mainly used in the treatment of mild to moderate pain related to headache, migraine, postoperative condition and in the management of spondylitis, osteoarthritis and rheumatoid arthritis. Acetaminophen is used as an analgesic and antipyretic drug. Ibuprofen having high tendency of sticking to punches of tablet punching machine while Acetaminophen is not ordinarily compressible to tablet formulation because Acetaminophen crystals are very hard and brittle in nature and fracture very easily when compressed producing capping and laminating tablet defects therefore wet granulation method is used to make them compressible. The aim of study was to prepare Ibuprofen and Acetaminophen tablets by direct compression and top spray granulation technique. In this Investigation tablets were prepared by using directly compressible grade excipients. Dibasic calcium phosphate, lactose anhydrous (DCL21), microcrystalline cellulose (Avicel PH 101). In order to obtain best or optimized formulation, nine different formulations were generated among them batch F7, F8, F9 shows good results and within the acceptable limit. Formulation (F7) selected as optimize product on the basis of dissolution study. Furtherly, directly compressible granules of both drugs were prepared by using top spray granulation technique in fluidized bed processor equipment and compressed .In order to obtain best product process optimization was carried out by performing four trials in which various parameters like inlet air temperature, spray rate, peristaltic pump rpm, % LOD, properties of granules, blending time and hardness were optimized. Batch T3 coined as optimized batch on the basis physical & chemical evaluation. Finally formulations prepared by both techniques were compared.

Keywords: direct compression, top spray granulation, process optimization, blending time

Procedia PDF Downloads 338
1846 A Computational Analysis of Gas Jet Flow Effects on Liquid Aspiration in the Collison Nebulizer

Authors: James Q. Feng

Abstract:

Pneumatic nebulizers (as variations based on the Collison nebulizer) have been widely used for producing fine aerosol droplets from a liquid material. As qualitatively described by many authors, the basic working principle of those nebulizers involves utilization of the negative pressure associated with an expanding gas jet to syphon liquid into the jet stream, then to blow and shear into liquid sheets, filaments, and eventually droplets. But detailed quantitative analysis based on fluid mechanics theory has been lacking in the literature. The purpose of present work is to investigate the nature of negative pressure distribution associated with compressible gas jet flow in the Collison nebulizer by a computational fluid dynamics (CFD) analysis, using an OpenFOAM® compressible flow solver. The value of the negative pressure associated with a gas jet flow is examined by varying geometric parameters of the jet expansion channel adjacent to the jet orifice outlet. Such an analysis can provide valuable insights into fundamental mechanisms in liquid aspiration process, helpful for effective design of the pneumatic atomizer in the Aerosol Jet® direct-write system for micro-feature, high-aspect-ratio material deposition in additive manufacturing.

Keywords: collison nebulizer, compressible gas jet flow, liquid aspiration, pneumatic atomization

Procedia PDF Downloads 153
1845 The Observable Method for the Regularization of Shock-Interface Interactions

Authors: Teng Li, Kamran Mohseni

Abstract:

This paper presents an inviscid regularization technique that is capable of regularizing the shocks and sharp interfaces simultaneously in the shock-interface interaction simulations. The direct numerical simulation of flows involving shocks has been investigated for many years and a lot of numerical methods were developed to capture the shocks. However, most of these methods rely on the numerical dissipation to regularize the shocks. Moreover, in high Reynolds number flows, the nonlinear terms in hyperbolic Partial Differential Equations (PDE) dominates, constantly generating small scale features. This makes direct numerical simulation of shocks even harder. The same difficulty happens in two-phase flow with sharp interfaces where the nonlinear terms in the governing equations keep sharpening the interfaces to discontinuities. The main idea of the proposed technique is to average out the small scales that is below the resolution (observable scale) of the computational grid by filtering the convective velocity in the nonlinear terms in the governing PDE. This technique is named “observable method” and it results in a set of hyperbolic equations called observable equations, namely, observable Navier-Stokes or Euler equations. The observable method has been applied to the flow simulations involving shocks, turbulence, and two-phase flows, and the results are promising. In the current paper, the observable method is examined on the performance of regularizing shocks and interfaces at the same time in shock-interface interaction problems. Bubble-shock interactions and Richtmyer-Meshkov instability are particularly chosen to be studied. Observable Euler equations will be numerically solved with pseudo-spectral discretization in space and third order Total Variation Diminishing (TVD) Runge Kutta method in time. Results are presented and compared with existing publications. The interface acceleration and deformation and shock reflection are particularly examined.

Keywords: compressible flow simulation, inviscid regularization, Richtmyer-Meshkov instability, shock-bubble interactions.

Procedia PDF Downloads 328
1844 Further Results on Modified Variational Iteration Method for the Analytical Solution of Nonlinear Advection Equations

Authors: A. W. Gbolagade, M. O. Olayiwola, K. O. Kareem

Abstract:

In this paper, further to our result on recent paper on the solution of nonlinear advection equations, we present further results on the nonlinear nonhomogeneous advection equations using a modified variational iteration method.

Keywords: lagrange multiplier, non-homogeneous equations, advection equations, mathematics

Procedia PDF Downloads 274
1843 A Unified Fitting Method for the Set of Unified Constitutive Equations for Modelling Microstructure Evolution in Hot Deformation

Authors: Chi Zhang, Jun Jiang

Abstract:

Constitutive equations are very important in finite element (FE) modeling, and the accuracy of the material constants in the equations have significant effects on the accuracy of the FE models. A wide range of constitutive equations are available; however, fitting the material constants in the constitutive equations could be complex and time-consuming due to the strong non-linearity and relationship between the constants. This work will focus on the development of a set of unified MATLAB programs for fitting the material constants in the constitutive equations efficiently. Users will only need to supply experimental data in the required format and run the program without modifying functions or precisely guessing the initial values, or finding the parameters in previous works and will be able to fit the material constants efficiently.

Keywords: constitutive equations, FE modelling, MATLAB program, non-linear curve fitting

Procedia PDF Downloads 74
1842 Non–Geometric Sensitivities Using the Adjoint Method

Authors: Marcelo Hayashi, João Lima, Bruno Chieregatti, Ernani Volpe

Abstract:

The adjoint method has been used as a successful tool to obtain sensitivity gradients in aerodynamic design and optimisation for many years. This work presents an alternative approach to the continuous adjoint formulation that enables one to compute gradients of a given measure of merit with respect to control parameters other than those pertaining to geometry. The procedure is then applied to the steady 2–D compressible Euler and incompressible Navier–Stokes flow equations. Finally, the results are compared with sensitivities obtained by finite differences and theoretical values for validation.

Keywords: adjoint method, aerodynamics, sensitivity theory, non-geometric sensitivities

Procedia PDF Downloads 521
1841 New Insight into Fluid Mechanics of Lorenz Equations

Authors: Yu-Kai Ting, Jia-Ying Tu, Chung-Chun Hsiao

Abstract:

New physical insights into the nonlinear Lorenz equations related to flow resistance is discussed in this work. The chaotic dynamics related to Lorenz equations has been studied in many papers, which is due to the sensitivity of Lorenz equations to initial conditions and parameter uncertainties. However, the physical implication arising from Lorenz equations about convectional motion attracts little attention in the relevant literature. Therefore, as a first step to understand the related fluid mechanics of convectional motion, this paper derives the Lorenz equations again with different forced conditions in the model. Simulation work of the modified Lorenz equations without the viscosity or buoyancy force is discussed. The time-domain simulation results may imply that the states of the Lorenz equations are related to certain flow speed and flow resistance. The flow speed of the underlying fluid system increases as the flow resistance reduces. This observation would be helpful to analyze the coupling effects of different fluid parameters in a convectional model in future work.

Keywords: Galerkin method, Lorenz equations, Navier-Stokes equations, convectional motion

Procedia PDF Downloads 367
1840 Hybrid Direct Numerical Simulation and Large Eddy Simulating Wall Models Approach for the Analysis of Turbulence Entropy

Authors: Samuel Ahamefula

Abstract:

Turbulent motion is a highly nonlinear and complex phenomenon, and its modelling is still very challenging. In this study, we developed a hybrid computational approach to accurately simulate fluid turbulence phenomenon. The focus is coupling and transitioning between Direct Numerical Simulation (DNS) and Large Eddy Simulating Wall Models (LES-WM) regions. In the framework, high-order fidelity fluid dynamical methods are utilized to simulate the unsteady compressible Navier-Stokes equations in the Eulerian format on the unstructured moving grids. The coupling and transitioning of DNS and LES-WM are conducted through the linearly staggered Dirichlet-Neumann coupling scheme. The high-fidelity framework is verified and validated based on namely, DNS ability for capture full range of turbulent scales, giving accurate results and LES-WM efficiency in simulating near-wall turbulent boundary layer by using wall models.

Keywords: computational methods, turbulence modelling, turbulence entropy, navier-stokes equations

Procedia PDF Downloads 74
1839 On the Relation between λ-Symmetries and μ-Symmetries of Partial Differential Equations

Authors: Teoman Ozer, Ozlem Orhan

Abstract:

This study deals with symmetry group properties and conservation laws of partial differential equations. We give a geometrical interpretation of notion of μ-prolongations of vector fields and of the related concept of μ-symmetry for partial differential equations. We show that these are in providing symmetry reduction of partial differential equations and systems and invariant solutions.

Keywords: λ-symmetry, μ-symmetry, classification, invariant solution

Procedia PDF Downloads 289
1838 Linear Evolution of Compressible Görtler Vortices Subject to Free-Stream Vortical Disturbances

Authors: Samuele Viaro, Pierre Ricco

Abstract:

Görtler instabilities generate in boundary layers from an unbalance between pressure and centrifugal forces caused by concave surfaces. Their spatial streamwise evolution influences transition to turbulence. It is therefore important to understand even the early stages where perturbations, still small, grow linearly and could be controlled more easily. This work presents a rigorous theoretical framework for compressible flows using the linearized unsteady boundary region equations, where only the streamwise pressure gradient and streamwise diffusion terms are neglected from the full governing equations of fluid motion. Boundary and initial conditions are imposed through an asymptotic analysis in order to account for the interaction of the boundary layer with free-stream turbulence. The resulting parabolic system is discretize with a second-order finite difference scheme. Realistic flow parameters are chosen from wind tunnel studies performed at supersonic and subsonic conditions. The Mach number ranges from 0.5 to 8, with two different radii of curvature, 5 m and 10 m, frequencies up to 2000 Hz, and vortex spanwise wavelengths from 5 mm to 20 mm. The evolution of the perturbation flow is shown through velocity, temperature, pressure profiles relatively close to the leading edge, where non-linear effects can still be neglected, and growth rate. Results show that a global stabilizing effect exists with the increase of Mach number, frequency, spanwise wavenumber and radius of curvature. In particular, at high Mach numbers curvature effects are less pronounced and thermal streaks become stronger than velocity streaks. This increase of temperature perturbations saturates at approximately Mach 4 flows, and is limited in the early stage of growth, near the leading edge. In general, Görtler vortices evolve closer to the surface with respect to a flat plate scenario but their location shifts toward the edge of the boundary layer as the Mach number increases. In fact, a jet-like behavior appears for steady vortices having small spanwise wavelengths (less than 10 mm) at Mach 8, creating a region of unperturbed flow close to the wall. A similar response is also found at the highest frequency considered for a Mach 3 flow. Larger vortices are found to have a higher growth rate but are less influenced by the Mach number. An eigenvalue approach is also employed to study the amplification of the perturbations sufficiently downstream from the leading edge. These eigenvalue results are compared with the ones obtained through the initial value approach with inhomogeneous free-stream boundary conditions. All of the parameters here studied have a significant influence on the evolution of the instabilities for the Görtler problem which is indeed highly dependent on initial conditions.

Keywords: compressible boundary layers, Görtler instabilities, receptivity, turbulence transition

Procedia PDF Downloads 234
1837 Equations of Pulse Propagation in Three-Layer Structure of As2S3 Chalcogenide Plasmonic Nano-Waveguides

Authors: Leila Motamed-Jahromi, Mohsen Hatami, Alireza Keshavarz

Abstract:

This research aims at obtaining the equations of pulse propagation in nonlinear plasmonic waveguides created with As2S3 chalcogenide materials. Via utilizing Helmholtz equation and first-order perturbation theory, two components of electric field are determined within frequency domain. Afterwards, the equations are formulated in time domain. The obtained equations include two coupled differential equations that considers nonlinear dispersion.

Keywords: nonlinear optics, plasmonic waveguide, chalcogenide, propagation equation

Procedia PDF Downloads 384
1836 Development of Extended Trapezoidal Method for Numerical Solution of Volterra Integro-Differential Equations

Authors: Fuziyah Ishak, Siti Norazura Ahmad

Abstract:

Volterra integro-differential equations appear in many models for real life phenomena. Since analytical solutions for this type of differential equations are hard and at times impossible to attain, engineers and scientists resort to numerical solutions that can be made as accurately as possible. Conventionally, numerical methods for ordinary differential equations are adapted to solve Volterra integro-differential equations. In this paper, numerical solution for solving Volterra integro-differential equation using extended trapezoidal method is described. Formulae for the integral and differential parts of the equation are presented. Numerical results show that the extended method is suitable for solving first order Volterra integro-differential equations.

Keywords: accuracy, extended trapezoidal method, numerical solution, Volterra integro-differential equations

Procedia PDF Downloads 400
1835 Reduced Differential Transform Methods for Solving the Fractional Diffusion Equations

Authors: Yildiray Keskin, Omer Acan, Murat Akkus

Abstract:

In this paper, the solution of fractional diffusion equations is presented by means of the reduced differential transform method. Fractional partial differential equations have special importance in engineering and sciences. Application of reduced differential transform method to this problem shows the rapid convergence of the sequence constructed by this method to the exact solution. The numerical results show that the approach is easy to implement and accurate when applied to fractional diffusion equations. The method introduces a promising tool for solving many fractional partial differential equations.

Keywords: fractional diffusion equations, Caputo fractional derivative, reduced differential transform method, partial

Procedia PDF Downloads 497