Search results for: discontinuous finite volume method
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 21221

Search results for: discontinuous finite volume method

20921 Studying the Impact of Soil Characteristics in Displacement of Retaining Walls Using Finite Element

Authors: Mojtaba Ahmadabadi, Akbar Masoudi, Morteza Rezai

Abstract:

In this paper, using the finite element method, the effect of soil and wall characteristics was investigated. Thirty and two different models were studied by different parameters. These studies could calculate displacement at any height of the wall for frictional-cohesive soils. The main purpose of this research is to determine the most effective soil characteristics in reducing the wall displacement. Comparing different models showed that the overall increase in internal friction angle, angle of friction between soil and wall and modulus of elasticity reduce the replacement of the wall. In addition, increase in special weight of soil will increase the wall displacement. Based on results, it can be said that all wall displacements were overturning and in the backfill, soil was bulging. Results show that the highest impact is seen in reducing wall displacement, internal friction angle, and the angle friction between soil and wall. One of the advantages of this study is taking into account all the parameters of the soil and walls replacement distribution in wall and backfill soil. In this paper, using the finite element method and considering all parameters of the soil, we investigated the impact of soil parameter in wall displacement. The aim of this study is to provide the best conditions in reducing the wall displacement and displacement wall and soil distribution.

Keywords: retaining wall, fem, soil and wall interaction, angle of internal friction of the soil, wall displacement

Procedia PDF Downloads 366
20920 Effect of Baffles on the Cooling of Electronic Components

Authors: O. Bendermel, C. Seladji, M. Khaouani

Abstract:

In this work, we made a numerical study of the thermal and dynamic behaviour of air in a horizontal channel with electronic components. The influence to use baffles on the profiles of velocity and temperature is discussed. The finite volume method and the algorithm Simple are used for solving the equations of conservation of mass, momentum and energy. The results found show that baffles improve heat transfer between the cooling air and electronic components. The velocity will increase from 3 times per rapport of the initial velocity.

Keywords: electronic components, baffles, cooling, fluids engineering

Procedia PDF Downloads 272
20919 A Numerical Study of Seismic Effects on Slope Stability Using Node-Based Smooth Finite Element Method

Authors: H. C. Nguyen

Abstract:

This contribution considers seismic effects on the stability of slope and footing resting on a slope. The seismic force is simply treated as static inertial force through the values of acceleration factor. All domains are assumed to be plasticity deformations approximated using node-based smoothed finite element method (NS-FEM). The failure mechanism and safety factor were then explored using numerical procedure based on upper bound approach in which optimization problem was formed as second order cone programming (SOCP). The data obtained confirm that upper bound procedure using NS-FEM and SOCP can give stable and rapid convergence results of seismic stability factors.

Keywords: upper bound analysis, safety factor, slope stability, footing resting on slope

Procedia PDF Downloads 89
20918 Liquefaction Susceptibility of Tailing Storage Facility-Comparison of National Centre for Earthquake Engineering Research and Finite Element Methods

Authors: Mehdi Ghatei, Masoomeh Lorestani

Abstract:

Upstream Tailings Storage Facilities (TSFs) may experience slope instabilities due to soil liquefaction, especially in regions known to be seismically active. In this study, liquefaction susceptibility of an upstream-raised TSF in Western Australia was assessed using two different approaches. The first approach assessed liquefaction susceptibility using Cone Penetration Tests with pore pressure measurement (CPTu) as described by the National Centre for Earthquake Engineering Research (NCEER). This assessment was based on the four CPTu tests that were conducted on the perimeter embankment of the TSF. The second approach used the Finite Element (FE) method with application of an equivalent linear model to predict the undrained cyclic behavior, the pore water pressure and the liquefaction of the materials. The tailings parameters were estimated from the CPTu profiles and from the laboratory tests. The cyclic parameters were estimated from the literature where test results of similar material were available. The results showed that there was a good agreement, in the liquefaction susceptibility of the tailings material, between the NCEER and FE methods with equivalent linear model.

Keywords: liquefaction , CPTU, NCEER, finite element method, equivalent linear model

Procedia PDF Downloads 242
20917 Special Properties of the Zeros of the Analytic Representations of Finite Quantum Systems

Authors: Muna Tabuni

Abstract:

The paper contains an investigation on the special properties of the zeros of the analytic representations of finite quantum systems. These zeros and their paths completely define the finite quantum system. The present paper studies the construction of the analytic representation from its zeros. The analytic functions of finite quantum systems are introduced. The zeros of the analytic theta functions and their paths have been studied. The analytic function f(z) have exactly d zeros. The analytic function has been constructed from its zeros.

Keywords: construction, analytic, representation, zeros

Procedia PDF Downloads 184
20916 FEM Simulations to Study the Effects of Laser Power and Scan Speed on Molten Pool Size in Additive Manufacturing

Authors: Yee-Ting Lee, Jyun-Rong Zhuang, Wen-Hsin Hsieh, An-Shik Yang

Abstract:

Additive manufacturing (AM) is increasingly crucial in biomedical and aerospace industries. As a recently developed AM technique, selective laser melting (SLM) has become a commercial method for various manufacturing processes. However, the molten pool configuration during SLM of metal powders is a decisive issue for the product quality. It is very important to investigate the heat transfer characteristics during the laser heating process. In this work, the finite element method (FEM) software ANSYS® (work bench module 16.0) was used to predict the unsteady temperature distribution for resolving molten pool dimensions with consideration of temperature-dependent thermal physical properties of TiAl6V4 at different laser powers and scanning speeds. The simulated results of the temperature distributions illustrated that the ratio of laser power to scanning speed can greatly influence the size of molten pool of titanium alloy powder for SLM development.

Keywords: additive manufacturing, finite element method, molten pool dimensions, selective laser melting

Procedia PDF Downloads 259
20915 Large-Scale Simulations of Turbulence Using Discontinuous Spectral Element Method

Authors: A. Peyvan, D. Li, J. Komperda, F. Mashayek

Abstract:

Turbulence can be observed in a variety fluid motions in nature and industrial applications. Recent investment in high-speed aircraft and propulsion systems has revitalized fundamental research on turbulent flows. In these systems, capturing chaotic fluid structures with different length and time scales is accomplished through the Direct Numerical Simulation (DNS) approach since it accurately simulates flows down to smallest dissipative scales, i.e., Kolmogorov’s scales. The discontinuous spectral element method (DSEM) is a high-order technique that uses spectral functions for approximating the solution. The DSEM code has been developed by our research group over the course of more than two decades. Recently, the code has been improved to run large cases in the order of billions of solution points. Running big simulations requires a considerable amount of RAM. Therefore, the DSEM code must be highly parallelized and able to start on multiple computational nodes on an HPC cluster with distributed memory. However, some pre-processing procedures, such as determining global element information, creating a global face list, and assigning global partitioning and element connection information of the domain for communication, must be done sequentially with a single processing core. A separate code has been written to perform the pre-processing procedures on a local machine. It stores the minimum amount of information that is required for the DSEM code to start in parallel, extracted from the mesh file, into text files (pre-files). It packs integer type information with a Stream Binary format in pre-files that are portable between machines. The files are generated to ensure fast read performance on different file-systems, such as Lustre and General Parallel File System (GPFS). A new subroutine has been added to the DSEM code to read the startup files using parallel MPI I/O, for Lustre, in a way that each MPI rank acquires its information from the file in parallel. In case of GPFS, in each computational node, a single MPI rank reads data from the file, which is specifically generated for the computational node, and send them to other ranks on the node using point to point non-blocking MPI communication. This way, communication takes place locally on each node and signals do not cross the switches of the cluster. The read subroutine has been tested on Argonne National Laboratory’s Mira (GPFS), National Center for Supercomputing Application’s Blue Waters (Lustre), San Diego Supercomputer Center’s Comet (Lustre), and UIC’s Extreme (Lustre). The tests showed that one file per node is suited for GPFS and parallel MPI I/O is the best choice for Lustre file system. The DSEM code relies on heavily optimized linear algebra operation such as matrix-matrix and matrix-vector products for calculation of the solution in every time-step. For this, the code can either make use of its matrix math library, BLAS, Intel MKL, or ATLAS. This fact and the discontinuous nature of the method makes the DSEM code run efficiently in parallel. The results of weak scaling tests performed on Blue Waters showed a scalable and efficient performance of the code in parallel computing.

Keywords: computational fluid dynamics, direct numerical simulation, spectral element, turbulent flow

Procedia PDF Downloads 110
20914 Study of Anti-Symmetric Flexural Mode Propagation along Wedge Tip with a Crack

Authors: Manikanta Prasad Banda, Che Hua Yang

Abstract:

Anti-symmetric wave propagation along the particle motion of the wedge waves is known as anti-symmetric flexural (ASF) modes which travel along the wedge tips of the mid-plane apex with a small truncation. This paper investigates the characteristics of the ASF modes propagation with the wedge tip crack. The simulation and experimental results obtained by a three-dimensional (3-D) finite element model explained the contact acoustic non-linear (CAN) behavior in explicit dynamics in ABAQUS and the ultrasonic non-destructive testing (NDT) method is used for defect detection. The effect of various parameters on its high and low-level conversion modes are known for complex reflections and transmissions involved with direct reflections and transmissions. The results are used to predict the location of crack through complex transmission and reflection coefficients.

Keywords: ASF mode, crack detection, finite elements method, laser ultrasound technique, wedge waves

Procedia PDF Downloads 106
20913 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 166
20912 Computational Modeling of Heat Transfer from a Horizontal Array Cylinders for Low Reynolds Numbers

Authors: Ovais U. Khan, G. M. Arshed, S. A. Raza, H. Ali

Abstract:

A numerical model based on the computational fluid dynamics (CFD) approach is developed to investigate heat transfer across a longitudinal row of six circular cylinders. The momentum and energy equations are solved using the finite volume discretization technique. The convective terms are discretized using a second-order upwind methodology, whereas diffusion terms are discretized using a central differencing scheme. The second-order implicit technique is utilized to integrate time. Numerical simulations have been carried out for three different values of free stream Reynolds number (ReD) 100, 200, 300 and two different values of dimensionless longitudinal pitch ratio (SL/D) 1.5, 2.5 to demonstrate the fluid flow and heat transfer behavior. Numerical results are validated with the analytical findings reported in the literature and have been found to be in good agreement. The maximum percentage error in values of the average Nusselt number obtained from the numerical and analytical solutions is in the range of 10% for the free stream Reynolds number up to 300. It is demonstrated that the average Nusselt number for the array of cylinders increases with increasing the free stream Reynolds number and dimensionless longitudinal pitch ratio. The information generated would be useful in the design of more efficient heat exchangers or other fluid systems involving arrays of cylinders.

Keywords: computational fluid dynamics, array of cylinders, longitudinal pitch ratio, finite volume method, incompressible navier-stokes equations

Procedia PDF Downloads 49
20911 An Alternative Framework of Multi-Resolution Nested Weighted Essentially Non-Oscillatory Schemes for Solving Euler Equations with Adaptive Order

Authors: Zhenming Wang, Jun Zhu, Yuchen Yang, Ning Zhao

Abstract:

In the present paper, an alternative framework is proposed to construct a class of finite difference multi-resolution nested weighted essentially non-oscillatory (WENO) schemes with an increasingly higher order of accuracy for solving inviscid Euler equations. These WENO schemes firstly obtain a set of reconstruction polynomials by a hierarchy of nested central spatial stencils, and then recursively achieve a higher order approximation through the lower-order precision WENO schemes. The linear weights of such WENO schemes can be set as any positive numbers with a requirement that their sum equals one and they will not pollute the optimal order of accuracy in smooth regions and could simultaneously suppress spurious oscillations near discontinuities. Numerical results obtained indicate that these alternative finite-difference multi-resolution nested WENO schemes with different accuracies are very robust with low dissipation and use as few reconstruction stencils as possible while maintaining the same efficiency, achieving the high-resolution property without any equivalent multi-resolution representation. Besides, its finite volume form is easier to implement in unstructured grids.

Keywords: finite-difference, WENO schemes, high order, inviscid Euler equations, multi-resolution

Procedia PDF Downloads 122
20910 An Investigation on Electric Field Distribution around 380 kV Transmission Line for Various Pylon Models

Authors: C. F. Kumru, C. Kocatepe, O. Arikan

Abstract:

In this study, electric field distribution analyses for three pylon models are carried out by a Finite Element Method (FEM) based software. Analyses are performed in both stationary and time domains to observe instantaneous values along with the effective ones. Considering the results of the study, different line geometries is considerably affecting the magnitude and distribution of electric field although the line voltages are the same. Furthermore, it is observed that maximum values of instantaneous electric field obtained in time domain analysis are quite higher than the effective ones in stationary mode. In consequence, electric field distribution analyses should be individually made for each different line model and the limit exposure values or distances to residential buildings should be defined according to the results obtained.

Keywords: electric field, energy transmission line, finite element method, pylon

Procedia PDF Downloads 703
20909 Evaluation of Seismic Behavior of Steel Shear Wall with Opening with Hardener and Beam with Reduced Cross Section under Cycle Loading with Finite Element Analysis Method

Authors: Masoud Mahdavi

Abstract:

During an earthquake, the structure is subjected to seismic loads that cause tension in the members of the building. The use of energy dissipation elements in the structure reduces the percentage of seismic forces on the main members of the building (especially the columns). Steel plate shear wall, as one of the most widely used types of energy dissipation element, has evolved today, and regular drilling of its inner plate is one of the common cases. In the present study, using a finite element method, the shear wall of the steel plate is designed as a floor (with dimensions of 447 × 6/246 cm) with Abacus software and in three different modes on which a cyclic load has been applied. The steel shear wall has a horizontal element (beam) with a reduced beam section (RBS). The hole in the interior plate of the models is created in such a way that it has the process of increasing the area, which makes the effect of increasing the surface area of the hole on the seismic performance of the steel shear wall completely clear. In the end, it was found that with increasing the opening level in the steel shear wall (with reduced cross-section beam), total displacement and plastic strain indicators increased, structural capacity and total energy indicators decreased and the Mises Monson stress index did not change much.

Keywords: steel plate shear wall with opening, cyclic loading, reduced cross-section beam, finite element method, Abaqus software

Procedia PDF Downloads 100
20908 Numerical Wave Solutions for Nonlinear Coupled Equations Using Sinc-Collocation Method

Authors: Kamel Al-Khaled

Abstract:

In this paper, numerical solutions for the nonlinear coupled Korteweg-de Vries, (abbreviated as KdV) equations are calculated by Sinc-collocation method. This approach is based on a global collocation method using Sinc basis functions. First, discretizing time derivative of the KdV equations by a classic finite difference formula, while the space derivatives are approximated by a $\theta-$weighted scheme. Sinc functions are used to solve these two equations. Soliton solutions are constructed to show the nature of the solution. The numerical results are shown to demonstrate the efficiency of the newly proposed method.

Keywords: Nonlinear coupled KdV equations, Soliton solutions, Sinc-collocation method, Sinc functions

Procedia PDF Downloads 498
20907 Study of the Stability of Underground Mines by Numerical Method: The Mine Chaabet El Hamra, Algeria

Authors: Nakache Radouane, M. Boukelloul, M. Fredj

Abstract:

Method room and pillar sizes are key factors for safe mining and their recovery in open-stop mining. This method is advantageous due to its simplicity and requirement of little information to be used. It is probably the most representative method among the total load approach methods although it also remains a safe design method. Using a finite element software (PLAXIS 3D), analyses were carried out with an elasto-plastic model and comparisons were made with methods based on the total load approach. The results were presented as the optimization for improving the ore recovery rate while maintaining a safe working environment.

Keywords: room and pillar, mining, total load approach, elasto-plastic

Procedia PDF Downloads 311
20906 Simulation of Wave Propagation in Multiphase Medium

Authors: Edip Kemal, Sheshov Vlatko, Bojadjieva Julijana, Bogdanovic ALeksandra, Gjorgjeska Irena

Abstract:

The wave propagation phenomenon in porous domains is of great importance in the field of geotechnical earthquake engineering. In these kinds of problems, the elastic waves propagate from the interior to the exterior domain and require special treatment at the computational level since apart from displacement in the solid-state there is a p-wave that takes place in the pore water phase. In this paper, a study on the implementation of multiphase finite elements is presented. The proposed algorithm is implemented in the ANSYS finite element software and tested on one-dimensional wave propagation considering both pore pressure wave propagation and displacement fields. In the simulation of porous media such as soils, the behavior is governed largely by the interaction of the solid skeleton with water and/or air in the pores. Therefore, coupled problems of fluid flow and deformation of the solid skeleton are considered in a detailed way.

Keywords: wave propagation, multiphase model, numerical methods, finite element method

Procedia PDF Downloads 137
20905 Excitation of Guided Waves in Finite Width Plates Using a Numerical Approach

Authors: Wenbo Duan, Hossein Habibi, Vassilios Kappatos, Cem Selcuk, Tat-Hean Gan

Abstract:

Ultrasonic guided waves are often used to remove ice or fouling in different structures, such as ship hulls, wind turbine blades and so on. To achieve maximum sound power output, it is important that multiple transducers are arranged in a particular way so that a desired mode can be excited. The objective of this paper is thus to provide a theoretical basis for generating a particular mode in a finite width rectangular plate which can be used for removing potential ice or fouling on the plate. The number of transducers and their locations with respect to a particular mode will be investigated, and the link between dispersion curves and practical applications will be explored. To achieve this, a semi-analytical finite element (SAFE) method is used to study the dispersion characteristics of all the modes in the ultrasonic frequency range. The detailed modal shapes will be revealed, and from the modal analysis, the particular mode with the strongest yet continuous transverse and axial displacements on the surfaces of the plate will be chosen for the purpose of removing potential ice or fouling on the plate. The modal analysis is followed by providing information on the number, location and amplitude of transducers needed to excite this particular mode. Modal excitation is then implemented in a standard finite element commercial package, namely COMSOL Multiphysics. Wave motion is visualized in COMSOL, and the mode shapes generated in SAFE is found to be consistent with the mode shapes generated in COMSOL.

Keywords: dispersion analysis, finite width plate, guided wave, modal excitation

Procedia PDF Downloads 442
20904 Vibration Frequencies Analysis of Nanoporous Graphene Membrane

Authors: Haw-Long Lee, Win-Jin Chang, Yu-Ching Yang

Abstract:

In this study, we use the atomic-scale finite element method to investigate the vibrational behavior of the armchair- and zigzag-structured nanoporous graphene layers with different size under the SFSF and CFFF boundary conditions. The fundamental frequencies computed for the graphene layers without pore are compared with the results of previous studies. We observe very good correspondence of our results with that of the other studies in all the considered cases. For the armchair- and zigzag-structured nanoporous graphene layers under the SFSF and CFFF boundary conditions, the frequencies decrease as the size of the nanopore increase. When the positions of the pore are symmetric with respect to the center of the graphene, the frequency of the zigzag pore graphene is higher than that of the armchair one.

Keywords: atomic-scale finite element method, graphene, nanoporous, natural frequency

Procedia PDF Downloads 338
20903 Sensitivity to Misusing Verb Inflections in Both Finite and Non-Finite Clauses in Native and Non-Native Russian: A Self-Paced Reading Investigation

Authors: Yang Cao

Abstract:

Analyzing the oral production of Chinese-speaking learners of English as a second language (L2), we can find a large variety of verb inflections – Why does it seem so hard for them to use consistent correct past morphologies in obligatory past contexts? Failed Functional Features Hypothesis (FFFH) attributes the rather non-target-like performance to the absence of [±past] feature in their L1 Chinese, arguing that for post puberty learners, new features in L2 are no more accessible. By contrast, Missing Surface Inflection Hypothesis (MSIH) tends to believe that all features are actually acquirable for late L2 learners, while due to the mapping difficulties from features to forms, it is hard for them to realize the consistent past morphologies on the surface. However, most of the studies are limited to the verb morphologies in finite clauses and few studies have ever attempted to figure out these learners’ performance in non-finite clauses. Additionally, it has been discussed that Chinese learners may be able to tell the finite/infinite distinction (i.e. the [±finite] feature might be selected in Chinese, even though the existence of [±past] is denied). Therefore, adopting a self-paced reading task (SPR), the current study aims to analyze the processing patterns of Chinese-speaking learners of L2 Russian, in order to find out if they are sensitive to misuse of tense morphologies in both finite and non-finite clauses and whether they are sensitive to the finite/infinite distinction presented in Russian. The study targets L2 Russian due to its systematic morphologies in both present and past tenses. A native Russian group, as well as a group of English-speaking learners of Russian, whose L1 has definitely selected both [±finite] and [±past] features, will also be involved. By comparing and contrasting performance of the three language groups, the study is going to further examine and discuss the two theories, FFFH and MSIH. Preliminary hypotheses are: a) Russian native speakers are expected to spend longer time reading the verb forms which violate the grammar; b) it is expected that Chinese participants are, at least, sensitive to the misuse of inflected verbs in non-finite clauses, although no sensitivity to the misuse of infinitives in finite clauses might be found. Therefore, an interaction of finite and grammaticality is expected to be found, which indicate that these learners are able to tell the finite/infinite distinction; and c) having selected [±finite] and [±past], English-speaking learners of Russian are expected to behave target-likely, supporting L1 transfer.

Keywords: features, finite clauses, morphosyntax, non-finite clauses, past morphologies, present morphologies, Second Language Acquisition, self-paced reading task, verb inflections

Procedia PDF Downloads 81
20902 Theoretical Prediction of the Structural, Elastic, Electronic, Optical, and Thermal Properties of Cubic Perovskites CsXF3 (X = Ca, Sr, and Hg) under Pressure Effect

Authors: M. A. Ghebouli, A. Bouhemadou, H. Choutri, L. Louaila

Abstract:

Some physical properties of the cubic perovskites CsXF3 (X = Sr, Ca, and Hg) have been investigated using pseudopotential plane–wave (PP-PW) method based on the density functional theory (DFT). The calculated lattice constants within GGA (PBE) and LDA (CA-PZ) agree reasonably with the available experiment data. The elastic constants and their pressure derivatives are predicted using the static finite strain technique. We derived the bulk and shear moduli, Young’s modulus, Poisson’s ratio and Lamé’s constants for ideal polycrystalline aggregates. The analysis of B/G ratio indicates that CsXF3 (X = Ca, Sr, and Hg) are ductile materials. The thermal effect on the volume, bulk modulus, heat capacities CV, CP, and Debye temperature was predicted.

Keywords: perovskite, PP-PW method, elastic constants, electronic band structure

Procedia PDF Downloads 408
20901 Finite Element Analysis of Rom Silo Subjected to 5000 Tons Monotic Loads at an Anonymous Mine in Zimbabwe

Authors: T. Mushiri, K. Tengende, C. Mbohwa, T. Garikayi

Abstract:

This paper introduces finite element analysis of Run off Mine (ROM) silo subjected to dynamic loading. The proposed procedure is based on the use of theoretical equations to come up with pressure and forces exerted by Platinum Group Metals (PGMs) ore to the silo wall. Finite Element Analysis of the silo involves the use of CAD software (AutoCAD) for3D creation and CAE software (T-FLEX) for the simulation work with an optimization routine to minimize the mass and also ensure structural stiffness and stability. In this research an efficient way to design and analysis of a silo in 3D T-FLEX (CAD) program was created the silo to stay within the constrains and so as to know the points of failure due dynamic loading.

Keywords: reinforced concrete silo, finite element analysis, T-FLEX software, AutoCAD

Procedia PDF Downloads 453
20900 Strongly Coupled Finite Element Formulation of Electromechanical Systems with Integrated Mesh Morphing Using Radial Basis Functions

Authors: David Kriebel, Jan Edgar Mehner

Abstract:

The paper introduces a method to efficiently simulate nonlinear changing electrostatic fields occurring in micro-electromechanical systems (MEMS). Large deflections of the capacitor electrodes usually introduce nonlinear electromechanical forces on the mechanical system. Traditional finite element methods require a time-consuming remeshing process to capture exact results for this physical domain interaction. In order to accelerate the simulation process and eliminate the remeshing process, a formulation of a strongly coupled electromechanical transducer element will be introduced, which uses a combination of finite-element with an advanced mesh morphing technique using radial basis functions (RBF). The RBF allows large geometrical changes of the electric field domain while retaining the high element quality of the deformed mesh. Coupling effects between mechanical and electrical domains are directly included within the element formulation. Fringing field effects are described accurately by using traditional arbitrary shape functions.

Keywords: electromechanical, electric field, transducer, simulation, modeling, finite-element, mesh morphing, radial basis function

Procedia PDF Downloads 203
20899 Modeling of Transformer Winding for Transients: Frequency-Dependent Proximity and Skin Analysis

Authors: Yazid Alkraimeen

Abstract:

Precise prediction of dielectric stresses and high voltages of power transformers require the accurate calculation of frequency-dependent parameters. A lack of accuracy can result in severe damages to transformer windings. Transient conditions is stuided by digital computers, which require the implementation of accurate models. This paper analyzes the computation of frequency-dependent skin and proximity losses included in the transformer winding model, using analytical equations and Finite Element Method (FEM). A modified formula to calculate the proximity and the skin losses is presented. The results of the frequency-dependent parameter calculations are verified using the Finite Element Method. The time-domain transient voltages are obtained using Numerical Inverse Laplace Transform. The results show that the classical formula for proximity losses is overestimating the transient voltages when compared with the results obtained from the modified method on a simple transformer geometry.

Keywords: fast front transients, proximity losses, transformer winding modeling, skin losses

Procedia PDF Downloads 110
20898 Vibration Analysis and Optimization Design of Ultrasonic Horn

Authors: Kuen Ming Shu, Ren Kai Ho

Abstract:

Ultrasonic horn has the functions of amplifying amplitude and reducing resonant impedance in ultrasonic system. Its primary function is to amplify deformation or velocity during vibration and focus ultrasonic energy on the small area. It is a crucial component in design of ultrasonic vibration system. There are five common design methods for ultrasonic horns: analytical method, equivalent circuit method, equal mechanical impedance, transfer matrix method, finite element method. In addition, the general optimization design process is to change the geometric parameters to improve a single performance. Therefore, in the general optimization design process, we couldn't find the relation of parameter and objective. However, a good optimization design must be able to establish the relationship between input parameters and output parameters so that the designer can choose between parameters according to different performance objectives and obtain the results of the optimization design. In this study, an ultrasonic horn provided by Maxwide Ultrasonic co., Ltd. was used as the contrast of optimized ultrasonic horn. The ANSYS finite element analysis (FEA) software was used to simulate the distribution of the horn amplitudes and the natural frequency value. The results showed that the frequency for the simulation values and actual measurement values were similar, verifying the accuracy of the simulation values. The ANSYS DesignXplorer was used to perform Response Surface optimization, which could shows the relation of parameter and objective. Therefore, this method can be used to substitute the traditional experience method or the trial-and-error method for design to reduce material costs and design cycles.

Keywords: horn, natural frequency, response surface optimization, ultrasonic vibration

Procedia PDF Downloads 86
20897 The Effect of Choke on the Efficiency of Coaxial Antenna for Percutaneous Microwave Coagulation Therapy for Hepatic Tumor

Authors: Surita Maini

Abstract:

There are many perceived advantages of microwave ablation have driven researchers to develop innovative antennas to effectively treat deep-seated, non-resectable hepatic tumors. In this paper a coaxial antenna with a miniaturized sleeve choke has been discussed for microwave interstitial ablation therapy, in order to reduce backward heating effects irrespective of the insertion depth into the tissue. Two dimensional Finite Element Method (FEM) is used to simulate and measure the results of miniaturized sleeve choke antenna. This paper emphasizes the importance of factors that can affect simulation accuracy, which include mesh resolution, surface heating and reflection coefficient. Quarter wavelength choke effectiveness has been discussed by comparing it with the unchoked antenna with same dimensions.

Keywords: microwave ablation, tumor, finite element method, coaxial slot antenna, coaxial dipole antenna

Procedia PDF Downloads 331
20896 Interaction between the Main Crack and Dislocation in the Glass Material

Authors: A. Mezzidi, H. Hamli Benzahar

Abstract:

The present study evaluates the stress and stress intensity factor during the propagation of a crack at presence of a dislocation near of crack tip. The problem is formulated using a glass material having an equivalent elasticity modulus and a Poisson ratio. In this research work, the proposed material is a plate form with a main crack in one of these ends and a dislocation near this crack, subjected to tensile stresses according to the mode 1 opening. For each distance between the two cracks, we can determine these stresses. This study is treated by finite elements method by using the software (ABAQUS) rate. It is shown here in that obtained results agreed with those determined by other researchers

Keywords: crack, dislocation, finite element, glass

Procedia PDF Downloads 351
20895 Mechanical Properties of CNT Reinforced Composite Using Berkovich Nanoindentation Analysis

Authors: Khondaker Sakil Ahmed, Ang Kok Keng, Shah Md Muniruzzaman

Abstract:

Spherical and Berkovich indentation tests are carried out numerically using finite element method for uniformly dispersed Carbon Nanotube (CNT) in the polymer matrix in which perfectly bonded CNT/matrix interface is considered. The Large strain elasto-plastic analysis is performed to investigate the actual scenario of nanoindentation test. This study investigates how the addition of CNT in polymer matrix influences the mechanical properties like hardness, elastic modulus of the nanocomposite. Since the wall thickness to radius ratio (t/r) is significantly small for SWCNT there is a huge possibility of lateral buckling which is a function of the location of indentation tip as well as the mechanical properties of matrix. Separate finite element models are constructed to compare the result with Berkovich indentation. This study also investigates the buckling behavior of different nanotube in a different polymer matrix.

Keywords: carbon nanotube, elasto-plastic, finite element model, nano-indentation

Procedia PDF Downloads 365
20894 Optimization of Three Phase Squirrel Cage Induction Motor

Authors: Tunahan Sapmaz, Harun Etçi, İbrahim Şenol, Yasemin Öner

Abstract:

Rotor bar dimensions have a great influence on the air-gap magnetic flux density. Therefore, poor selection of this parameter during the machine design phase causes the air-gap magnetic flux density to be distorted. Thus, it causes noise, torque fluctuation, and losses in the induction motor. On the other hand, the change in rotor bar dimensions will change the resistance of the conductor, so the current will be affected. Therefore, the increase and decrease of rotor bar current affect operation, starting torque, and efficiency. The aim of this study is to examine the effect of rotor bar dimensions on the electromagnetic performance criteria of the induction motor. Modeling of the induction motor is done by the finite element method (FEM), which is a very powerful tool. In FEM, the results generally focus on performance criteria such as torque, torque fluctuation, efficiency, and current.

Keywords: induction motor, finite element method, optimization, rotor bar

Procedia PDF Downloads 99
20893 Finite Element Modelling of a 3D Woven Composite for Automotive Applications

Authors: Ahmad R. Zamani, Luigi Sanguigno, Angelo R. Maligno

Abstract:

A 3D woven composite, designed for automotive applications, is studied using Abaqus Finite Element (FE) software suite. Python scripts were developed to build FE models of the woven composite in Complete Abaqus Environment (CAE). They can read TexGen or WiseTex files and automatically generate consistent meshes of the fabric and the matrix. A user menu is provided to help define parameters for the FE models, such as type and size of the elements in fabric and matrix as well as the type of matrix-fabric interaction. Node-to-node constraints were imposed to guarantee periodicity of the deformed shapes at the boundaries of the representative volume element of the composite. Tensile loads in three axes and biaxial loads in x-y directions have been applied at different Fibre Volume Fractions (FVFs). A simple damage model was implemented via an Abaqus user material (UMAT) subroutine. Existing tools for homogenization were also used, including voxel mesh generation from TexGen as well as Abaqus Micromechanics plugin. Linear relations between homogenised elastic properties and the FVFs are given. The FE models of composite exhibited balanced behaviour with respect to warp and weft directions in terms of both stiffness and strength.

Keywords: 3D woven composite (3DWC), meso-scale finite element model, homogenisation of elastic material properties, Abaqus Python scripting

Procedia PDF Downloads 114
20892 Finite Element Modeling of Influence of Roll Form of Vertical Scale Breaker on Decreased Formation of Surface Defects during Roughing Hot Rolling

Authors: A. Pesin, D. Pustovoytov, M. Sverdlik

Abstract:

During production of rolled steel strips the quality of the surface of finished strips influences steel consumption considerably. The most critical areas for crack formation during rolling are lateral sides of slabs. Deformation behaviors of the slab edge in roughing rolling process were analyzed by the finite element method with Deform-3D. In this study our focus is the analysis of the influence of edger’s form on the possibility to decrease surface cracking during roughing hot rolling.

Keywords: roughing hot rolling, FEM, crack, bulging

Procedia PDF Downloads 361