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

Search results for: Sudoku solver

97 A Hybrid Algorithm for Collaborative Transportation Planning among Carriers

Authors: Elham Jelodari Mamaghani, Christian Prins, Haoxun Chen

Abstract:

In this paper, there is concentration on collaborative transportation planning (CTP) among multiple carriers with pickup and delivery requests and time windows. This problem is a vehicle routing problem with constraints from standard vehicle routing problems and new constraints from a real-world application. In the problem, each carrier has a finite number of vehicles, and each request is a pickup and delivery request with time window. Moreover, each carrier has reserved requests, which must be served by itself, whereas its exchangeable requests can be outsourced to and served by other carriers. This collaboration among carriers can help them to reduce total transportation costs. A mixed integer programming model is proposed to the problem. To solve the model, a hybrid algorithm that combines Genetic Algorithm and Simulated Annealing (GASA) is proposed. This algorithm takes advantages of GASA at the same time. After tuning the parameters of the algorithm with the Taguchi method, the experiments are conducted and experimental results are provided for the hybrid algorithm. The results are compared with those obtained by a commercial solver. The comparison indicates that the GASA significantly outperforms the commercial solver.

Keywords: Centralized collaborative transportation, collaborative transportation with pickup and delivery, collaborative transportation with time windows, hybrid algorithm of GA and SA.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 786
96 2D Validation of a High-order Adaptive Cartesian-grid finite-volume Characteristic- flux Model with Embedded Boundaries

Authors: C. Leroy, G. Oger, D. Le Touzé, B. Alessandrini

Abstract:

A Finite Volume method based on Characteristic Fluxes for compressible fluids is developed. An explicit cell-centered resolution is adopted, where second and third order accuracy is provided by using two different MUSCL schemes with Minmod, Sweby or Superbee limiters for the hyperbolic part. Few different times integrator is used and be describe in this paper. Resolution is performed on a generic unstructured Cartesian grid, where solid boundaries are handled by a Cut-Cell method. Interfaces are explicitely advected in a non-diffusive way, ensuring local mass conservation. An improved cell cutting has been developed to handle boundaries of arbitrary geometrical complexity. Instead of using a polygon clipping algorithm, we use the Voxel traversal algorithm coupled with a local floodfill scanline to intersect 2D or 3D boundary surface meshes with the fixed Cartesian grid. Small cells stability problem near the boundaries is solved using a fully conservative merging method. Inflow and outflow conditions are also implemented in the model. The solver is validated on 2D academic test cases, such as the flow past a cylinder. The latter test cases are performed both in the frame of the body and in a fixed frame where the body is moving across the mesh. Adaptive Cartesian grid is provided by Paramesh without complex geometries for the moment.

Keywords: Finite volume method, cartesian grid, compressible solver, complex geometries, Paramesh.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1574
95 PeliGRIFF: A Parallel DEM-DLM/FD Method for DNS of Particulate Flows with Collisions

Authors: Anthony Wachs, Guillaume Vinay, Gilles Ferrer, Jacques Kouakou, Calin Dan, Laurence Girolami

Abstract:

An original Direct Numerical Simulation (DNS) method to tackle the problem of particulate flows at moderate to high concentration and finite Reynolds number is presented. Our method is built on the framework established by Glowinski and his coworkers [1] in the sense that we use their Distributed Lagrange Multiplier/Fictitious Domain (DLM/FD) formulation and their operator-splitting idea but differs in the treatment of particle collisions. The novelty of our contribution relies on replacing the simple artificial repulsive force based collision model usually employed in the literature by an efficient Discrete Element Method (DEM) granular solver. The use of our DEM solver enables us to consider particles of arbitrary shape (at least convex) and to account for actual contacts, in the sense that particles actually touch each other, in contrast with the simple repulsive force based collision model. We recently upgraded our serial code, GRIFF 1 [2], to full MPI capabilities. Our new code, PeliGRIFF 2, is developed under the framework of the full MPI open source platform PELICANS [3]. The new MPI capabilities of PeliGRIFF open new perspectives in the study of particulate flows and significantly increase the number of particles that can be considered in a full DNS approach: O(100000) in 2D and O(10000) in 3D. Results on the 2D/3D sedimentation/fluidization of isometric polygonal/polyedral particles with collisions are presented.

Keywords: Particulate flow, distributed lagrange multiplier/fictitious domain method, discrete element method, polygonal shape, sedimentation, distributed computing, MPI

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2065
94 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 do not scale well on cluster containing multiple Central Processing Units (multi-CPUs cluster) or cluster containing multiple Graphics Processing Units (multi-GPUs cluster). 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 (Conjugate Gradient). The standard and pipelined CG methods need the vector entries generated by current GPU and other GPUs for matrix-vector product. So the communication between GPUs becomes a major performance bottleneck on miltiGPU 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 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 319
93 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 967
92 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 hemodynamics 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 hemodynamic 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 reveal 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 hemodynamics, 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2256
91 A New Algorithm for Solving Isothermal Carbonization of Wood Particle

Authors: Ahmed Mahmoudi, Imen Mejri, Mohamed A. Abbassi, Ahmed Omri

Abstract:

A new algorithm based on the lattice Boltzmann method (LBM) is proposed as a potential solver for one-dimensional heat and mass transfer for isothermal carbonization of wood particles. To check the validity of this algorithm, the LBM results have been compared with the published data and a good agreement is obtained. Then, the model is used to study the effect of reactor temperature and particle size on the evolution of the local temperature and mass loss inside the wood particle.

Keywords: Lattice Boltzmann Method, pyrolysis, conduction, carbonization.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1585
90 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1959
89 Application of 0-1 Fuzzy Programming in Optimum Project Selection

Authors: S. Sadi-Nezhad, K. Khalili Damghani, N. Pilevari

Abstract:

In this article, a mathematical programming model for choosing an optimum portfolio of investments is developed. The investments are considered as investment projects. The uncertainties of the real world are associated through fuzzy concepts for coefficients of the proposed model (i. e. initial investment costs, profits, resource requirement, and total available budget). Model has been coded by using LINGO 11.0 solver. The results of a full analysis of optimistic and pessimistic derivative models are promising for selecting an optimum portfolio of projects in presence of uncertainty.

Keywords: Fuzzy Programming, Fuzzy Knapsack, FuzzyCapital Budgeting, Fuzzy Project Selection

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1678
88 Evolutionary Search Techniques to Solve Set Covering Problems

Authors: Darwin Gouwanda, S. G. Ponnambalam

Abstract:

Set covering problem is a classical problem in computer science and complexity theory. It has many applications, such as airline crew scheduling problem, facilities location problem, vehicle routing, assignment problem, etc. In this paper, three different techniques are applied to solve set covering problem. Firstly, a mathematical model of set covering problem is introduced and solved by using optimization solver, LINGO. Secondly, the Genetic Algorithm Toolbox available in MATLAB is used to solve set covering problem. And lastly, an ant colony optimization method is programmed in MATLAB programming language. Results obtained from these methods are presented in tables. In order to assess the performance of the techniques used in this project, the benchmark problems available in open literature are used.

Keywords: Set covering problem, genetic algorithm, ant colony optimization, LINGO.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3574
87 Modeling Language for Constructing Solvers in Machine Learning: Reductionist Perspectives

Authors: Tsuyoshi Okita

Abstract:

For a given specific problem an efficient algorithm has been the matter of study. However, an alternative approach orthogonal to this approach comes out, which is called a reduction. In general for a given specific problem this reduction approach studies how to convert an original problem into subproblems. This paper proposes a formal modeling language to support this reduction approach in order to make a solver quickly. We show three examples from the wide area of learning problems. The benefit is a fast prototyping of algorithms for a given new problem. It is noted that our formal modeling language is not intend for providing an efficient notation for data mining application, but for facilitating a designer who develops solvers in machine learning.

Keywords: Formal language, statistical inference problem, reduction.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1283
86 Performance Boundaries for Interactive Finite Element Applications

Authors: Jaewon Jang, Gregory R. Miller

Abstract:

This paper presents work characterizing finite element performance boundaries within which live, interactive finite element modeling is feasible on current and emerging systems. These results are based on wide-ranging tests performed using a prototype finite element program implemented specifically for this study, thereby enabling the unified investigation of numerous direct and iterative solver strategies and implementations in a variety of modeling contexts. The results are intended to be useful for researchers interested in interactive analysis by providing baseline performance estimates, to give guidance in matching solution strategies to problem domains, and to spur further work addressing the challenge of extending the present boundaries.

Keywords: Finite Elements, Interactive Modeling, NumericalAnalysis.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1306
85 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2424
84 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 549
83 Simulation of Dam Break using Finite Volume Method

Authors: A.Roshandel, N.Hedayat, H.kiamanesh

Abstract:

Today, numerical simulation is a powerful tool to solve various hydraulic engineering problems. The aim of this research is numerical solutions of shallow water equations using finite volume method for Simulations of dam break over wet and dry bed. In order to solve Riemann problem, Roe-s approximate solver is used. To evaluate numerical model, simulation was done in 1D and 2D states. In 1D state, two dam break test over dry bed (with and without friction) were studied. The results showed that Structural failure around the dam and damage to the downstream constructions in bed without friction is more than friction bed. In 2D state, two tests for wet and dry beds were done. Generally in wet bed case, waves are propagated to canal sides but in dry bed it is not significant. Therefore, damage to the storage facilities and agricultural lands in wet bed case is more than in dry bed.

Keywords: dam break, dry bed, finite volume method, shallow water equations.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2448
82 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 axisymmetry assumption is established for continuous finite elements. The weak formulation is implemented in a C++ solver with implicit time marching. The code is verified by space and time convergence tests using a manufactured solution. An example problem is solved with an axisymmetric formulation and with a 3D formulation. Both formulations lead to the same result but the code based on the axisymmetric formulation is mush faster due to the lower number of degrees of freedom. This confirms the correctness of our approach and the interest of using an axisymmetric formulation when it is possible.

Keywords: Axisymmetric problem, continuous finite elements, heat equation, weak formulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 285
81 The Problem of Using the Calculation of the Critical Path to Solver Instances of the Job Shop Scheduling Problem

Authors: Marco Antonio Cruz-Chávez, Juan Frausto-Solís, Fernando Ramos-Quintana

Abstract:

A procedure commonly used in Job Shop Scheduling Problem (JSSP) to evaluate the neighborhoods functions that use the non-deterministic algorithms is the calculation of the critical path in a digraph. This paper presents an experimental study of the cost of computation that exists when the calculation of the critical path in the solution for instances in which a JSSP of large size is involved. The results indicate that if the critical path is use in order to generate neighborhoods in the meta-heuristics that are used in JSSP, an elevated cost of computation exists in spite of the fact that the calculation of the critical path in any digraph is of polynomial complexity.

Keywords: Job Shop, CPM, critical path, neighborhood, meta-heuristic.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2246
80 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2029
79 Collaboration of Multi-Agent and Hyper-Heuristics Systems for Production Scheduling Problem

Authors: C. E. Nugraheni, L. Abednego

Abstract:

This paper introduces a framework based on the collaboration of multi agent and hyper-heuristics to find a solution of the real single machine production problem. There are many techniques used to solve this problem. Each of it has its own advantages and disadvantages. By the collaboration of multi agent system and hyper-heuristics, we can get more optimal solution. The hyper-heuristics approach operates on a search space of heuristics rather than directly on a search space of solutions. The proposed framework consists of some agents, i.e. problem agent, trainer agent, algorithm agent (GPHH, GAHH, and SAHH), optimizer agent, and solver agent. Some low level heuristics used in this paper are MRT, SPT, LPT, EDD, LDD, and MON

Keywords: Hyper-heuristics, multi-agent systems, scheduling problem.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2105
78 2D and 3D Finite Element Method Packages of CEMTool for Engineering PDE Problems

Authors: Choon Ki Ahn, Jung Hun Park, Wook Hyun Kwon

Abstract:

CEMTool is a command style design and analyzing package for scientific and technological algorithm and a matrix based computation language. In this paper, we present new 2D & 3D finite element method (FEM) packages for CEMTool. We discuss the detailed structures and the important features of pre-processor, solver, and post-processor of CEMTool 2D & 3D FEM packages. In contrast to the existing MATLAB PDE Toolbox, our proposed FEM packages can deal with the combination of the reserved words. Also, we can control the mesh in a very effective way. With the introduction of new mesh generation algorithm and fast solving technique, our FEM packages can guarantee the shorter computational time than MATLAB PDE Toolbox. Consequently, with our new FEM packages, we can overcome some disadvantages or limitations of the existing MATLAB PDE Toolbox.

Keywords: CEMTool, Finite element method (FEM), Numericalanalysis, Partial differential equation (PDE)

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3754
77 Vortex Wake Formation and Its Effects on Thrust and Propulsive Efficiency of an Oscillating Airfoil

Authors: Ahmet Selim Durna, Bayram Celik, Aydin Misirlioglu

Abstract:

Flows over a harmonically oscillating NACA 0012 airfoil are simulated here using a two-dimensional, unsteady, incompressibleNavier-Stokes solver.Both pure-plunging and pitching-plunging combined oscillations are considered at a Reynolds number of 5000. Special attention is paid to the vortex shedding and interaction mechanism of the motions. For all the simulations presented here, the reduced frequency (k) is fixed at a value of 2.5 and plunging amplitude (h) is selected to be in the range of 0.2-0.5. The simulation results show that the interaction mechanism between the leading and trailing edge vortices has a decisive effect on the values of the resulting thrust and propulsive efficiency.

Keywords: pithing and plunging airfoil, leading edge vortex, trailing edge vortex, vortex interaction, wake structure.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1365
76 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 being 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. The flow characteristics are studied by Computational Fluid Dynamic simulation by using the ANSYS Fluent solver for these specified arrangements of the grating. The results indicate that distinguished characteristics of flow velocity between “convergent” and “divergent” grating placements is up to 10% in confined conditions. Furthermore, the velocity in case of convergent grating is higher than that of divergent grating.

Keywords: Marine current energy, marine current energy converter, turbine grating, RANS simulation, water flow velocity.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1673
75 Laminar Impinging Jet Heat Transfer for Curved Plates

Authors: A. M. Tahsini, S. Tadayon Mousavi

Abstract:

The purpose of the present study is to analyze the effect of the target plate-s curvature on the heat transfer in laminar confined impinging jet flows. Numerical results from two dimensional compressible finite volume solver are compared between three different shapes of impinging plates: Flat, Concave and Convex plates. The remarkable result of this study proves that the stagnation Nusselt number in laminar range of Reynolds number based on the slot width is maximum in convex surface and is minimum in concave plate. These results refuse the previous data in literature stating the amount of the stagnation Nusselt number is greater in concave surface related to flat plate configuration.

Keywords: Concave, Convex, Heat transfer, Impinging jet, Laminar flow.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2958
74 Loss Reduction and Reliability Improvement of Industrial Distribution System through Network Reconfiguration

Authors: Ei Ei Phyu, Kyaw Myo Lin, Thin Thin Moe

Abstract:

The paper presents an approach to improve the reliability and reduce line losses of practical distribution system applying network reconfiguration. The change of the topology redirects the power flow within the distribution network to obtain better performance of the system. Practical distribution network (Pyigyitagon Industrial Zone (I)) is used as the case study network. The detailed calculations of the reliability indices are done by using analytical method and power flow calculation is performed by Newton-Rephason solver. The comparison of various network reconfiguration techniques are described with respect to power loss and reliability index levels. Finally, the optimal reconfigured network is selected among difference cases based on the two factors: the most reliable network and the least loss minimization.

Keywords: Distribution system reliability, loss reduction, network reconfiguration, reliability enhancement, reliability indices.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 838
73 Numerical Study of Microscale Gas Flow-Separation Using Explicit Finite Volume Method

Authors: A. Chaudhuri, C. Guha, T. K. Dutta

Abstract:

Pressure driven microscale gas flow-separation has been investigated by solving the compressible Navier-Stokes (NS) system of equations. A two dimensional explicit finite volume (FV) compressible flow solver has been developed using modified advection upwind splitting methods (AUSM+) with no-slip/first order Maxwell-s velocity slip conditions to predict the flowseparation behavior in microdimensions. The effects of scale-factor of the flow geometry and gas species on the microscale gas flowseparation have been studied in this work. The intensity of flowseparation gets reduced with the decrease in scale of the flow geometry. In reduced dimension, flow-separation may not at all be present under similar flow conditions compared to the larger flow geometry. The flow-separation patterns greatly depend on the properties of the medium under similar flow conditions.

Keywords: AUSM+, FVM, Flow-separation, Microflow.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1561
72 Warning about the Risk of Blood Flow Stagnation after Transcatheter Aortic Valve Implantation

Authors: Aymen Laadhari, Gábor Székely

Abstract:

In this work, the hemodynamics in the sinuses of Valsalva after Transcatheter Aortic Valve Implantation is numerically examined. We focus on the physical results in the two-dimensional case. We use a finite element methodology based on a Lagrange multiplier technique that enables to couple the dynamics of blood flow and the leaflets’ movement. A massively parallel implementation of a monolithic and fully implicit solver allows more accuracy and significant computational savings. The elastic properties of the aortic valve are disregarded, and the numerical computations are performed under physiologically correct pressure loads. Computational results depict that blood flow may be subject to stagnation in the lower domain of the sinuses of Valsalva after Transcatheter Aortic Valve Implantation.

Keywords: Hemodynamics, Transcatheter Aortic Valve Implantation, blood flow stagnation, numerical simulations.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1040
71 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 APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 275
70 Design and Performance Analysis of a Supersonic Diffuser for Plasma Wing Tunnel

Authors: R.S Pugazenthi, Andy C. McIntosh

Abstract:

Plasma Wind Tunnels (PWT) are extensively used for screening and qualification of re-entry Thermel Protection System (TPS) materials. Proper design of a supersonic diffuser for plasma wind tunnel is of importance for achieving good pressurerecovery (thereby reducing vacuum pumping requirement & run time costs) and isolating downstream stream fluctuations from propagating costs) and isolating downstream stream fluctuationnts the details of a rapid design methodology successfully employed for designing supersonic diffuser for high power (several megawatts)plasma wind tunnels and numerical performance analysis of a diffuser configuration designed for one megawatt power rated plasma wind tunnel(enthalpy ~ 30 MJ/kg) using FLUENT 6.3® solver for different diffuser operating sub-atmospheric back-pressures.

Keywords: Compressible flow, plasma wind tunnel, re-entry, supersonic diffuser

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3836
69 Transfer Knowledge from Multiple Source Problems to a Target Problem in Genetic Algorithm

Authors: Tami Alghamdi, Terence Soule

Abstract:

To study how to transfer knowledge from multiple source problems to the target problem, we modeled the Transfer Learning (TL) process using Genetic Algorithms as the model solver. TL is the process that aims to transfer learned data from one problem to another problem. The TL process aims to help Machine Learning (ML) algorithms find a solution to the problems. The Genetic Algorithms (GA) give researchers access to information that we have about how the old problem is solved. In this paper, we have five different source problems, and we transfer the knowledge to the target problem. We studied different scenarios of the target problem. The results showed that combined knowledge from multiple source problems improves the GA performance. Also, the process of combining knowledge from several problems results in promoting diversity of the transferred population.

Keywords: Transfer Learning, Multiple Sources, Knowledge Transfer, Domain Adaptation, Source, Target.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 269
68 CFD of Oscillating Airfoil Pitch Cycle by using PISO Algorithm

Authors: Muhammad Amjad Sohail, Rizwan Ullah

Abstract:

This research paper presents the CFD analysis of oscillating airfoil during pitch cycle. Unsteady subsonic flow is simulated for pitching airfoil at Mach number 0.283 and Reynolds number 3.45 millions. Turbulent effects are also considered for this study by using K-ω SST turbulent model. Two-dimensional unsteady compressible Navier-Stokes code including two-equation turbulence model and PISO pressure velocity coupling is used. Pressure based implicit solver with first order implicit unsteady formulation is used. The simulated pitch cycle results are compared with the available experimental data. The results have a good agreement with the experimental data. Aerodynamic characteristics during pitch cycles have been studied and validated.

Keywords: Angle of attack, Centre of pressure, subsonic flow, pitching moment coefficient, turbulence mode

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2347