Search results for: Sudoku solver
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 244

Search results for: Sudoku solver

214 Numerical Simulation of Fluid-Structure Interaction on Wedge Slamming Impact by Using Particle Method

Authors: Sung-Chul Hwang, Di Ren, Sang-Moon Yoon, Jong-Chun Park, Abbas Khayyer, Hitoshi Gotoh

Abstract:

The slamming impact problem has a very important engineering background. For seaplane landing, recycling for the satellite re-entry capsule, and the impact load of the bow in the adverse sea conditions, the slamming problem always plays the important role. Due to its strong nonlinear effect, however, it seems to be not easy to obtain the accurate simulation results. Combined with the strong interaction between the fluid field and the elastic structure, the difficulty for the simulation leads to a new level for challenging. This paper presents a fully Lagrangian coupled solver for simulations of fluid-structure interactions, which is based on the Moving Particle Semi-implicit (MPS) method to solve the governing equations corresponding to incompressible flows as well as elastic structures. The developed solver is verified by reproducing the high velocity impact loads of deformable thin wedges with two different materials such as aluminum and steel on water entry. The present simulation results are compared with analytical solution derived using the hydrodynamic Wagner model and linear theory by Wan.

Keywords: fluid-structure interaction, moving particle semi-implicit (MPS) method, elastic structure, incompressible flow, wedge slamming impact

Procedia PDF Downloads 575
213 Development of an Implicit Coupled Partitioned Model for the Prediction of the Behavior of a Flexible Slender Shaped Membrane in Interaction with Free Surface Flow under the Influence of a Moving Flotsam

Authors: Mahtab Makaremi Masouleh, Günter Wozniak

Abstract:

This research is part of an interdisciplinary project, promoting the design of a light temporary installable textile defence system against flood. In case river water levels increase abruptly especially in winter time, one can expect massive extra load on a textile protective structure in term of impact as a result of floating debris and even tree trunks. Estimation of this impulsive force on such structures is of a great importance, as it can ensure the reliability of the design in critical cases. This fact provides the motivation for the numerical analysis of a fluid structure interaction application, comprising flexible slender shaped and free-surface water flow, where an accelerated heavy flotsam tends to approach the membrane. In this context, the analysis on both the behavior of the flexible membrane and its interaction with moving flotsam is conducted by finite elements based solvers of the explicit solver and implicit Abacus solver available as products of SIMULIA software. On the other hand, a study on how free surface water flow behaves in response to moving structures, has been investigated using the finite volume solver of Star CCM+ from Siemens PLM Software. An automatic communication tool (CSE, SIMULIA Co-Simulation Engine) and the implementation of an effective partitioned strategy in form of an implicit coupling algorithm makes it possible for partitioned domains to be interconnected powerfully. The applied procedure ensures stability and convergence in the solution of these complicated issues, albeit with high computational cost; however, the other complexity of this study stems from mesh criterion in the fluid domain, where the two structures approach each other. This contribution presents the approaches for the establishment of a convergent numerical solution and compares the results with experimental findings.

Keywords: co-simulation, flexible thin structure, fluid-structure interaction, implicit coupling algorithm, moving flotsam

Procedia PDF Downloads 368
212 Parallel Pipelined Conjugate Gradient Algorithm on Heterogeneous Platforms

Authors: Sergey Kopysov, Nikita Nedozhogin, Leonid Tonkov

Abstract:

The article presents a parallel iterative solver for large sparse linear systems which can be used on a heterogeneous platform. Traditionally, the problem of solving linear systems does not scale well on multi-CPU/multi-GPUs clusters. For example, most of the attempts to implement the classical conjugate gradient method were at best counted in the same amount of time as the problem was enlarged. The paper proposes the pipelined variant of the conjugate gradient method (PCG), a formulation that is potentially better suited for hybrid CPU/GPU computing since it requires only one synchronization point per one iteration instead of two for standard CG. The standard and pipelined CG methods need the vector entries generated by the current GPU and other GPUs for matrix-vector products. So the communication between GPUs becomes a major performance bottleneck on multi GPU cluster. The article presents an approach to minimize the communications between parallel parts of algorithms. Additionally, computation and communication can be overlapped to reduce the impact of data exchange. Using the pipelined version of the CG method with one synchronization point, the possibility of asynchronous calculations and communications, load balancing between the CPU and GPU for solving the large linear systems allows for scalability. The algorithm is implemented with the combined use of technologies: MPI, OpenMP, and CUDA. We show that almost optimum speed up on 8-CPU/2GPU may be reached (relatively to a one GPU execution). The parallelized solver achieves a speedup of up to 5.49 times on 16 NVIDIA Tesla GPUs, as compared to one GPU.

Keywords: conjugate gradient, GPU, parallel programming, pipelined algorithm

Procedia PDF Downloads 136
211 An Analytical Approach of Computational Complexity for the Method of Multifluid Modelling

Authors: A. K. Borah, A. K. Singh

Abstract:

In this paper we deal building blocks of the computer simulation of the multiphase flows. Whole simulation procedure can be viewed as two super procedures; The implementation of VOF method and the solution of Navier Stoke’s Equation. Moreover, a sequential code for a Navier Stoke’s solver has been studied.

Keywords: Bi-conjugate gradient stabilized (Bi-CGSTAB), ILUT function, krylov subspace, multifluid flows preconditioner, simple algorithm

Procedia PDF Downloads 506
210 Development of an Implicit Physical Influence Upwind Scheme for Cell-Centered Finite Volume Method

Authors: Shidvash Vakilipour, Masoud Mohammadi, Rouzbeh Riazi, Scott Ormiston, Kimia Amiri, Sahar Barati

Abstract:

An essential component of a finite volume method (FVM) is the advection scheme that estimates values on the cell faces based on the calculated values on the nodes or cell centers. The most widely used advection schemes are upwind schemes. These schemes have been developed in FVM on different kinds of structured and unstructured grids. In this research, the physical influence scheme (PIS) is developed for a cell-centered FVM that uses an implicit coupled solver. Results are compared with the exponential differencing scheme (EDS) and the skew upwind differencing scheme (SUDS). Accuracy of these schemes is evaluated for a lid-driven cavity flow at Re = 1000, 3200, and 5000 and a backward-facing step flow at Re = 800. Simulations show considerable differences between the results of EDS scheme with benchmarks, especially for the lid-driven cavity flow at high Reynolds numbers. These differences occur due to false diffusion. Comparing SUDS and PIS schemes shows relatively close results for the backward-facing step flow and different results in lid-driven cavity flow. The poor results of SUDS in the lid-driven cavity flow can be related to its lack of sensitivity to the pressure difference between cell face and upwind points, which is critical for the prediction of such vortex dominant flows.

Keywords: cell-centered finite volume method, coupled solver, exponential differencing scheme (EDS), physical influence scheme (PIS), pressure weighted interpolation method (PWIM), skew upwind differencing scheme (SUDS)

Procedia PDF Downloads 262
209 Numerical Investigation of the Needle Opening Process in a High Pressure Gas Injector

Authors: Matthias Banholzer, Hagen Müller, Michael Pfitzner

Abstract:

Gas internal combustion engines are widely used as propulsion systems or in power plants to generate heat and electricity. While there are different types of injection methods including the manifold port fuel injection and the direct injection, the latter has more potential to increase the specific power by avoiding air displacement in the intake and to reduce combustion anomalies such as backfire or pre-ignition. During the opening process of the injector, multiple flow regimes occur: subsonic, transonic and supersonic. To cover the wide range of Mach numbers a compressible pressure-based solver is used. While the standard Pressure Implicit with Splitting of Operators (PISO) method is used for the coupling between velocity and pressure, a high-resolution non-oscillatory central scheme established by Kurganov and Tadmor calculates the convective fluxes. A blending function based on the local Mach- and CFL-number switches between the compressible and incompressible regimes of the developed model. As the considered operating points are well above the critical state of the used fluids, the ideal gas assumption is not valid anymore. For the real gas thermodynamics, the models based on the Soave-Redlich-Kwong equation of state were implemented. The caloric properties are corrected using a departure formalism, for the viscosity and the thermal conductivity the empirical correlation of Chung is used. For the injector geometry, the dimensions of a diesel injector were adapted. Simulations were performed using different nozzle and needle geometries and opening curves. It can be clearly seen that there is a significant influence of all three parameters.

Keywords: high pressure gas injection, hybrid solver, hydrogen injection, needle opening process, real-gas thermodynamics

Procedia PDF Downloads 440
208 A Two-Phase Flow Interface Tracking Algorithm Using a Fully Coupled Pressure-Based Finite Volume Method

Authors: Shidvash Vakilipour, Scott Ormiston, Masoud Mohammadi, Rouzbeh Riazi, Kimia Amiri, Sahar Barati

Abstract:

Two-phase and multi-phase flows are common flow types in fluid mechanics engineering. Among the basic and applied problems of these flow types, two-phase parallel flow is the one that two immiscible fluids flow in the vicinity of each other. In this type of flow, fluid properties (e.g. density, viscosity, and temperature) are different at the two sides of the interface of the two fluids. The most challenging part of the numerical simulation of two-phase flow is to determine the location of interface accurately. In the present work, a coupled interface tracking algorithm is developed based on Arbitrary Lagrangian-Eulerian (ALE) approach using a cell-centered, pressure-based, coupled solver. To validate this algorithm, an analytical solution for fully developed two-phase flow in presence of gravity is derived, and then, the results of the numerical simulation of this flow are compared with analytical solution at various flow conditions. The results of the simulations show good accuracy of the algorithm despite using a nearly coarse and uniform grid. Temporal variations of interface profile toward the steady-state solution show that a greater difference between fluids properties (especially dynamic viscosity) will result in larger traveling waves. Gravity effect studies also show that favorable gravity will result in a reduction of heavier fluid thickness and adverse gravity leads to increasing it with respect to the zero gravity condition. However, the magnitude of variation in favorable gravity is much more than adverse gravity.

Keywords: coupled solver, gravitational force, interface tracking, Reynolds number to Froude number, two-phase flow

Procedia PDF Downloads 293
207 Haemodynamics Study in Subject Specific Carotid Bifurcation Using FSI

Authors: S. M. Abdul Khader, Anurag Ayachit, Raghuvir Pai, K. A. Ahmed, V. R. K Rao, S. Ganesh Kamath

Abstract:

The numerical simulation has made tremendous advances in investigating the blood flow phenomenon through elastic arteries. Such study can be useful in demonstrating the disease progression and haemodynamics of cardiovascular diseases such as atherosclerosis. In the present study, patient specific case diagnosed with partially stenosed complete right ICA and normal left carotid bifurcation without any atherosclerotic plaque formation is considered. 3D patient specific carotid bifurcation model is generated based on CT scan data using MIMICS-4.0 and numerical analysis is performed using FSI solver in ANSYS-14.5. The blood flow is assumed to be incompressible, homogenous and Newtonian, while the artery wall is assumed to be linearly elastic. The two-way sequentially-coupled transient FSI analysis is performed using FSI solver for three pulse cycles. The haemodynamic parameters such as flow pattern, Wall Shear Stress, pressure contours and arterial wall deformation are studied at the bifurcation and critical zones such as stenosis. The variation in flow behavior is studied throughout the pulse cycle. Also, the simulation results reveals that there is a considerable increase in the flow behavior in stenosed carotid in contrast to the normal carotid bifurcation system. The investigation also demonstrates the disturbed flow pattern especially at the bifurcation and stenosed zone elevating the haemodynamics, particularly during peak systole and later part of the pulse cycle. The results obtained agree well with the clinical observation and demonstrates the potential of patient specific numerical studies in prognosis of disease progression and plaque rupture.

Keywords: fluid-structure interaction, arterial stenosis, wall shear stress, carotid artery bifurcation

Procedia PDF Downloads 556
206 Aerodynamic Optimum Nose Shape Change of High-Speed Train by Design Variable Variation

Authors: Minho Kwak, Suhwan Yun, Choonsoo Park

Abstract:

Nose shape optimizations of high-speed train are performed for the improvement of aerodynamic characteristics. Based on the commercial train, KTX-Sancheon, multi-objective optimizations are conducted for the improvement of the side wind stability and the micro-pressure wave following the optimization for the reduction of aerodynamic drag. 3D nose shapes are modelled by the Vehicle Modeling Function. Aerodynamic drag and side wind stability are calculated by three-dimensional compressible Navier-Stokes solver, and micro pressure wave is done by axi-symmetric compressible Navier-Stokes solver. The Maxi-min Latin Hypercube Sampling method is used to extract sampling points to construct the approximation model. The kriging model is constructed for the approximation model and the NSGA-II algorithm was used as the multi-objective optimization algorithm. Nose length, nose tip height, and lower surface curvature are design variables. Because nose length is a dominant variable for aerodynamic characteristics of train nose, two optimization processes are progressed respectively with and without the design variable, nose length. Each pareto set was obtained and each optimized nose shape is selected respectively considering Honam high-speed rail line infrastructure in South Korea. Through the optimization process with the nose length, when compared to KTX Sancheon, aerodynamic drag was reduced by 9.0%, side wind stability was improved by 4.5%, micro-pressure wave was reduced by 5.4% whereas aerodynamic drag by 7.3%, side wind stability by 3.9%, micro-pressure wave by 3.9%, without the nose length. As a result of comparison between two optimized shapes, similar shapes are extracted other than the effect of nose length.

Keywords: aerodynamic characteristics, design variable, multi-objective optimization, train nose shape

Procedia PDF Downloads 330
205 The Hidden Characteristics That Tutors Hope Dundee Mmed Graduates Might Have after Graduation

Authors: Afnan Khoja, Ittisak Subrungruang, Kritchaya Ritruechai, Linda Jones, David Wall

Abstract:

Background: Some characteristics might be stated as an objective of the curriculum and some might be hidden. The hidden curriculum is the unwritten and unintended lessons and perspectives that students absorb in school. Though, the hidden characteristics are expected that tutors hope students might have in order to become medical educators. We suspected our faculty hoped we would develop skills, know and develop beyond the written outcomes. Our research question aimed to explore the hidden curriculum; as part of our learning; we had to design and report findings. Summary of Work: We undertook semi-structured interviews with a sample of the centre for medical education faculty at Dundee. Participants answered the question , of what are the hidden characteristics that they hope Dundee MMed graduates might have after graduation. Thematic analysis was carried out on the interview scripts. Summary of Results: A thematic analysis was carried out on the interview transcripts. Three main themes were identified from all respondents' comments. These were lifelong learners, being flexible and problem solvers. In addition individual respondents also described sense of humour, collaboration, humility, role model, inquisitiveness, optimism, and ability to express oneself clearly. Discussion: Tutors put great value on three behaviours lifelong learner, flexible, and problem solver, which are part of professional characteristics in leadership. Therefore, leadership characteristics is incorporated as the outcomes of hidden characteristics that tutors would like to see. Conclusion: Tutors in the Master's program of medical education at the University of Dundee hope that medical education students should present the three main hidden characteristics, which are lifelong learner, flexible, and problem solver after graduation. Take-home Messages: These hidden characteristics are considered as informal unless a change has been made to the formal curriculum. Therefore, to reach the tutors’ expectations, further studies might be held to make this personal characteristics transformation more accessible.

Keywords: characteristics, hidden curriculum, transformation, informal

Procedia PDF Downloads 63
204 Decision Making for Industrial Engineers: From Phenomenon to Value

Authors: Ali Abbas

Abstract:

Industrial Engineering is a broad multidisciplinary field with intersections and applications in numerous areas. In out current environment, the path from a phenomenon to value involves numerous people with expertise in various areas including domain knowledge of a field and the ability to make decisions within an operating environment that lead to value creation. We propose some skills that industrial engineering programs should focus on, and argue that an industrial engineer is a decision maker instead of a problem solver.

Keywords: decision analysis, problem-solving, value creation, industrial engineering

Procedia PDF Downloads 350
203 3D Codes for Unsteady Interaction Problems of Continuous Mechanics in Euler Variables

Authors: M. Abuziarov

Abstract:

The designed complex is intended for the numerical simulation of fast dynamic processes of interaction of heterogeneous environments susceptible to the significant formability. The main challenges in solving such problems are associated with the construction of the numerical meshes. Currently, there are two basic approaches to solve this problem. One is using of Lagrangian or Lagrangian Eulerian grid associated with the boundaries of media and the second is associated with the fixed Eulerian mesh, boundary cells of which cut boundaries of the environment medium and requires the calculation of these cut volumes. Both approaches require the complex grid generators and significant time for preparing the code’s data for simulation. In this codes these problems are solved using two grids, regular fixed and mobile local Euler Lagrange - Eulerian (ALE approach) accompanying the contact and free boundaries, the surfaces of shock waves and phase transitions, and other possible features of solutions, with mutual interpolation of integrated parameters. For modeling of both liquids and gases, and deformable solids the Godunov scheme of increased accuracy is used in Lagrangian - Eulerian variables, the same for the Euler equations and for the Euler- Cauchy, describing the deformation of the solid. The increased accuracy of the scheme is achieved by using 3D spatial time dependent solution of the discontinuity problem (3D space time dependent Riemann's Problem solver). The same solution is used to calculate the interaction at the liquid-solid surface (Fluid Structure Interaction problem). The codes does not require complex 3D mesh generators, only the surfaces of the calculating objects as the STL files created by means of engineering graphics are given by the user, which greatly simplifies the preparing the task and makes it convenient to use directly by the designer at the design stage. The results of the test solutions and applications related to the generation and extension of the detonation and shock waves, loading the constructions are presented.

Keywords: fluid structure interaction, Riemann's solver, Euler variables, 3D codes

Procedia PDF Downloads 419
202 Inviscid Steady Flow Simulation Around a Wing Configuration Using MB_CNS

Authors: Muhammad Umar Kiani, Muhammad Shahbaz, Hassan Akbar

Abstract:

Simulation of a high speed inviscid steady ideal air flow around a 2D/axial-symmetry body was carried out by the use of mb_cns code. mb_cns is a program for the time-integration of the Navier-Stokes equations for two-dimensional compressible flows on a multiple-block structured mesh. The flow geometry may be either planar or axisymmetric and multiply-connected domains can be modeled by patching together several blocks. The main simulation code is accompanied by a set of pre and post-processing programs. The pre-processing programs scriptit and mb_prep start with a short script describing the geometry, initial flow state and boundary conditions and produce a discretized version of the initial flow state. The main flow simulation program (or solver as it is sometimes called) is mb_cns. It takes the files prepared by scriptit and mb_prep, integrates the discrete form of the gas flow equations in time and writes the evolved flow data to a set of output files. This output data may consist of the flow state (over the whole domain) at a number of instants in time. After integration in time, the post-processing programs mb_post and mb_cont can be used to reformat the flow state data and produce GIF or postscript plots of flow quantities such as pressure, temperature and Mach number. The current problem is an example of supersonic inviscid flow. The flow domain for the current problem (strake configuration wing) is discretized by a structured grid and a finite-volume approach is used to discretize the conservation equations. The flow field is recorded as cell-average values at cell centers and explicit time stepping is used to update conserved quantities. MUSCL-type interpolation and one of three flux calculation methods (Riemann solver, AUSMDV flux splitting and the Equilibrium Flux Method, EFM) are used to calculate inviscid fluxes across cell faces.

Keywords: steady flow simulation, processing programs, simulation code, inviscid flux

Procedia PDF Downloads 410
201 Flow and Heat Transfer over a Shrinking Sheet: A Stability Analysis

Authors: Anuar Ishak

Abstract:

The characteristics of fluid flow and heat transfer over a permeable shrinking sheet is studied. The governing partial differential equations are transformed into a set of ordinary differential equations, which are then solved numerically using MATLAB routine boundary value problem solver bvp4c. Numerical results show that dual solutions are possible for a certain range of the suction parameter. A stability analysis is performed to determine which solution is linearly stable and physically realizable.

Keywords: dual solutions, heat transfer, shrinking sheet, stability analysis

Procedia PDF Downloads 393
200 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 394
199 Simulation of Flow Patterns in Vertical Slot Fishway with Cylindrical Obstacles

Authors: Mohsen Solimani Babarsad, Payam Taheri

Abstract:

Numerical results of vertical slot fishways with and without cylinders study are presented. The simulated results and the measured data in the fishways are compared to validate the application of the model. This investigation is made using FLUENT V.6.3, a Computational Fluid Dynamics solver. Advantages of using these types of numerical tools are the possibility of avoiding the St.-Venant equations’ limitations, and turbulence can be modeled by means of different models such as the k-ε model. In general, the present study has demonstrated that the CFD model could be useful for analysis and design of vertical slot fishways with cylinders.

Keywords: slot Fish-way, CFD, k-ε model, St.-Venant equations’

Procedia PDF Downloads 335
198 Aeroelastic Stability Analysis in Turbomachinery Using Reduced Order Aeroelastic Model Tool

Authors: Chandra Shekhar Prasad, Ludek Pesek Prasad

Abstract:

In the present day fan blade of aero engine, turboprop propellers, gas turbine or steam turbine low-pressure blades are getting bigger, lighter and thus, become more flexible. Therefore, flutter, forced blade response and vibration related failure of the high aspect ratio blade are of main concern for the designers, thus need to be address properly in order to achieve successful component design. At the preliminary design stage large number of design iteration is need to achieve the utter free safe design. Most of the numerical method used for aeroelastic analysis is based on field-based methods such as finite difference method, finite element method, finite volume method or coupled. These numerical schemes are used to solve the coupled fluid Flow-Structural equation based on full Naiver-Stokes (NS) along with structural mechanics’ equations. These type of schemes provides very accurate results if modeled properly, however, they are computationally very expensive and need large computing recourse along with good personal expertise. Therefore, it is not the first choice for aeroelastic analysis during preliminary design phase. A reduced order aeroelastic model (ROAM) with acceptable accuracy and fast execution is more demanded at this stage. Similar ROAM are being used by other researchers for aeroelastic and force response analysis of turbomachinery. In the present paper new medium fidelity ROAM is successfully developed and implemented in numerical tool to simulated the aeroelastic stability phenomena in turbomachinery and well as flexible wings. In the present, a hybrid flow solver based on 3D viscous-inviscid coupled 3D panel method (PM) and 3d discrete vortex particle method (DVM) is developed, viscous parameters are estimated using boundary layer(BL) approach. This method can simulate flow separation and is a good compromise between accuracy and speed compared to CFD. In the second phase of the research work, the flow solver (PM) will be coupled with ROM non-linear beam element method (BEM) based FEM structural solver (with multibody capabilities) to perform the complete aeroelastic simulation of a steam turbine bladed disk, propellers, fan blades, aircraft wing etc. The partitioned based coupling approach is used for fluid-structure interaction (FSI). The numerical results are compared with experimental data for different test cases and for the blade cascade test case, experimental data is obtained from in-house lab experiments at IT CAS. Furthermore, the results from the new aeroelastic model will be compared with classical CFD-CSD based aeroelastic models. The proposed methodology for the aeroelastic stability analysis of gas turbine or steam turbine blades, or propellers or fan blades will provide researchers and engineers a fast, cost-effective and efficient tool for aeroelastic (classical flutter) analysis for different design at preliminary design stage where large numbers of design iteration are required in short time frame.

Keywords: aeroelasticity, beam element method (BEM), discrete vortex particle method (DVM), classical flutter, fluid-structure interaction (FSI), panel method, reduce order aeroelastic model (ROAM), turbomachinery, viscous-inviscid coupling

Procedia PDF Downloads 244
197 Partial Knowledge Transfer Between the Source Problem and the Target Problem in Genetic Algorithms

Authors: Terence Soule, Tami Al Ghamdi

Abstract:

To study how the partial knowledge transfer may affect the Genetic Algorithm (GA) performance, we model the Transfer Learning (TL) process using GA as the model solver. The objective of the TL is to transfer the knowledge from one problem to another related problem. This process imitates how humans think in their daily life. In this paper, we proposed to study a case where the knowledge transferred from the S problem has less information than what the T problem needs. We sampled the transferred population using different strategies of TL. The results showed transfer part of the knowledge is helpful and speeds the GA process of finding a solution to the problem.

Keywords: transfer learning, partial transfer, evolutionary computation, genetic algorithm

Procedia PDF Downloads 109
196 Effect of Springback Analysis on Influences of the Steel Demoulding Using FEM

Authors: Byeong-Sam Kim, Jongmin Park

Abstract:

The present work is motivated by the industrial challenge to produce complex composite shapes cost-effectively. The model used an anisotropical thermoviscoelastic is analyzed by an implemented finite element solver. The stress relaxation can be constructed by Prony series for the nonlinear thermoviscoelastic model. The calculation of process induced internal stresses relaxation during the cooling stage of the manufacturing cycle was carried out by the spring back phenomena observed from the part containing a cylindrical segment. The finite element results obtained from the present formulation are compared with experimental data, and the results show good correlations.

Keywords: thermoviscoelastic, springback phenomena, FEM analysis, thermoplastic composite structures

Procedia PDF Downloads 340
195 Numerical Modeling of Large Scale Dam Break Flows

Authors: Amanbek Jainakov, Abdikerim Kurbanaliev

Abstract:

The work presents the results of mathematical modeling of large-scale flows in areas with a complex topographic relief. The Reynolds-averaged Navier—Stokes equations constitute the basis of the three-dimensional unsteady modeling. The well-known Volume of Fluid method implemented in the solver interFoam of the open package OpenFOAM 2.3 is used to track the free-boundary location. The mathematical model adequacy is checked by comparing with experimental data. The efficiency of the applied technology is illustrated by the example of modeling the breakthrough of the dams of the Andijan (Uzbekistan) and Papan (near the Osh town, Kyrgyzstan) reservoir.

Keywords: three-dimensional modeling, free boundary, the volume-of-fluid method, dam break, flood, OpenFOAM

Procedia PDF Downloads 378
194 Signs-Only Compressed Row Storage Format for Exact Diagonalization Study of Quantum Fermionic Models

Authors: Michael Danilov, Sergei Iskakov, Vladimir Mazurenko

Abstract:

The present paper describes a high-performance parallel realization of an exact diagonalization solver for quantum-electron models in a shared memory computing system. The proposed algorithm contains a storage format for efficient computing eigenvalues and eigenvectors of a quantum electron Hamiltonian matrix. The results of the test calculations carried out for 15 sites Hubbard model demonstrate reduction in the required memory and good multiprocessor scalability, while maintaining performance of the same order as compressed row storage.

Keywords: sparse matrix, compressed format, Hubbard model, Anderson model

Procedia PDF Downloads 377
193 CFD Effect of the Tidal Grating in Opposite Directions

Authors: N. M. Thao, I. Dolguntseva, M. Leijon

Abstract:

Flow blockages referring to the increase in flow are considered as a vital equipment for marine current energy conversion. However, the shape of these devices will result in extracted energy under the operation. The present work investigates the effect of two configurations of a grating, convergent and divergent that located upstream, to the water flow velocity. Computational Fluid Dynamic simulation studies the flow characteristics by using the ANSYS Fluent solver for these specified arrangements of the grating. The results indicate that distinct features of flow velocity between “convergent” and “divergent” grating placements are up to in confined conditions. Furthermore, the velocity in case of granting is higher than that of the divergent grating.

Keywords: marine current energy, converter, turbine granting, RANS simulation, water flow velocity

Procedia PDF Downloads 388
192 Study on a Family of Optimal Fourth-Order Multiple-Root Solver

Authors: Young Hee Geum

Abstract:

In this paper,we develop the complex dynamics of a family of optimal fourth-order multiple-root solvers and plot their basins of attraction. Mobius conjugacy maps and extraneous fixed points applied to a prototype quadratic polynomial raised to the power of the known integer multiplicity m are investigated. A 300 x 300 uniform grid centered at the origin covering 3 x 3 square region is chosen to visualize the initial values on each basin of attraction in accordance with a coloring scheme based on their dynamical behavior. The illustrative basins of attractions applied to various test polynomials and the corresponding statistical data for convergence are shown to confirm the theoretical convergence.

Keywords: basin of attraction, conjugacy, fourth-order, multiple-root finder

Procedia PDF Downloads 270
191 Energy and Exergy Performance Optimization on a Real Gas Turbine Power Plant

Authors: Farhat Hajer, Khir Tahar, Cherni Rafik, Dakhli Radhouen, Ammar Ben Brahim

Abstract:

This paper presents the energy and exergy optimization of a real gas turbine power plant performance of 100 MW of power, installed in the South East of Tunisia. A simulation code is established using the EES (Engineering Equation Solver) software. The parameters considered are those of the actual operating conditions of the gas turbine thermal power station under study. The results show that thermal and exergetic efficiency decreases with the increase of the ambient temperature. Air excess has an important effect on the thermal efficiency. The emission of NOx rises in the summer and decreases in the winter. The obtained rates of NOx are compared with measurements results.

Keywords: efficiency, exergy, gas turbine, temperature

Procedia PDF Downloads 265
190 Dual Solutions in Mixed Convection Boundary Layer Flow: A Stability Analysis

Authors: Anuar Ishak

Abstract:

The mixed convection stagnation point flow toward a vertical plate is investigated. The external flow impinges normal to the heated plate and the surface temperature is assumed to vary linearly with the distance from the stagnation point. The governing partial differential equations are transformed into a set of ordinary differential equations, which are then solved numerically using MATLAB routine boundary value problem solver bvp4c. Numerical results show that dual solutions are possible for a certain range of the mixed convection parameter. A stability analysis is performed to determine which solution is linearly stable and physically realizable.

Keywords: dual solutions, heat transfer, mixed convection, stability analysis

Procedia PDF Downloads 370
189 Spline Solution of Singularly Perturbed Boundary Value Problems

Authors: Reza Mohammadi

Abstract:

Using quartic spline, we develop a method for numerical solution of singularly perturbed two-point boundary-value problems. The purposed method is fourth-order accurate and applicable to problems both in singular and non-singular cases. The convergence analysis of the method is given. The resulting linear system of equations has been solved by using a tri-diagonal solver. We applied the presented method to test problems which have been solved by other existing methods in references, for comparison of presented method with the existing methods. Numerical results are given to illustrate the efficiency of our methods.

Keywords: second-order ordinary differential equation, singularly-perturbed, quartic spline, convergence analysis

Procedia PDF Downloads 274
188 Finite Element Approximation of the Heat Equation under Axisymmetry Assumption

Authors: Raphael Zanella

Abstract:

This works deals with the finite element approximation of axisymmetric problems. The weak formulation of the heat equation under the axisymmetry assumption is established for continuous finite elements. The weak formulation is implemented in a C++ solver with implicit march-in-time. The code is verified by space and time convergence tests using a manufactured solution. The solving of an example problem with an axisymmetric formulation is compared to that with a full-3D formulation. Both formulations lead to the same result, but the code based on the axisymmetric formulation is much faster due to the lower number of degrees of freedom. This confirms the correctness of our approach and the interest in using an axisymmetric formulation when it is possible.

Keywords: axisymmetric problem, continuous finite elements, heat equation, weak formulation

Procedia PDF Downloads 174
187 New Fourth Order Explicit Group Method in the Solution of the Helmholtz Equation

Authors: Norhashidah Hj Mohd Ali, Teng Wai Ping

Abstract:

In this paper, the formulation of a new group explicit method with a fourth order accuracy is described in solving the two-dimensional Helmholtz equation. The formulation is based on the nine-point fourth-order compact finite difference approximation formula. The complexity analysis of the developed scheme is also presented. Several numerical experiments were conducted to test the feasibility of the developed scheme. Comparisons with other existing schemes will be reported and discussed. Preliminary results indicate that this method is a viable alternative high accuracy solver to the Helmholtz equation.

Keywords: explicit group method, finite difference, Helmholtz equation, five-point formula, nine-point formula

Procedia PDF Downloads 476
186 Optimization of Maritime Platform Transport Problem of Solid, Special and Dangerous Waste

Authors: Ocotlán Díaz-Parra, Jorge A. Ruiz-Vanoye, Alejandro Fuentes-Penna, Beatriz Bernabe-Loranca, Patricia Ambrocio-Cruz, José J. Hernández-Flores

Abstract:

The Maritime Platform Transport Problem of Solid, Special and Dangerous Waste consist of to minimize the monetary value of carry different types of waste from one location to another location using ships. We offer a novel mathematical, the characterization of the problem and the use CPLEX to find the optimal values to solve the Solid, Special and Hazardous Waste Transportation Problem of offshore platforms instances of Mexican state-owned petroleum company (PEMEX). The set of instances used are WTPLib real instances and the tool CPLEX solver to solve the MPTPSSDW problem.

Keywords: oil platform, transport problem, waste, solid waste

Procedia PDF Downloads 448
185 An Encapsulation of a Navigable Tree Position: Theory, Specification, and Verification

Authors: Nicodemus M. J. Mbwambo, Yu-Shan Sun, Murali Sitaraman, Joan Krone

Abstract:

This paper presents a generic data abstraction that captures a navigable tree position. The mathematical modeling of the abstraction encapsulates the current tree position, which can be used to navigate and modify the tree. The encapsulation of the tree position in the data abstraction specification avoids the use of explicit references and aliasing, thereby simplifying verification of (imperative) client code that uses the data abstraction. To ease the tasks of such specification and verification, a general tree theory, rich with mathematical notations and results, has been developed. The paper contains an example to illustrate automated verification ramifications. With sufficient tree theory development, automated proving seems plausible even in the absence of a special-purpose tree solver.

Keywords: automation, data abstraction, maps, specification, tree, verification

Procedia PDF Downloads 142