Search results for: non-linear finite element modelling
5933 Experimental and Finite Element Forming Limit Diagrams for Interstitial Free Steels
Authors: Basavaraj Vadavadagi, Satishkumar Shekhawat
Abstract:
Interstitial free steels posses better formability and have many applications in automotive industries. Forming limit diagrams (FLDs) indicate the formability of materials which can be determined by experimental and finite element (FE) simulations. FLDs were determined experimentally by LDH test, utilizing optical strain measurement system for measuring the strains in different width specimens and by FE simulations in Interstitial Free (IF) and Interstitial Free High Strength (IFHS) steels. In this study, the experimental and FE simulated FLDs are compared and also the stress based FLDs were investigated.Keywords: forming limit diagram, limiting dome height, optical strain measurement, interstitial
Procedia PDF Downloads 2335932 Understanding Surface Failures in Thick Asphalt Pavement: A 3-D Finite Element Model Analysis
Authors: Hana Gebremariam Liliso
Abstract:
This study investigates the factors contributing to the deterioration of thick asphalt pavements, such as rutting and cracking. We focus on the combined influence of traffic loads and pavement structure. This study uses a three-dimensional finite element model with a Mohr-Coulomb failure criterion to analyze the stress levels near the pavement's surface under realistic conditions. Our model considers various factors, including tire-pavement contact stresses, asphalt properties, moving loads, and dynamic analysis. This research suggests that cracking tends to occur between dual tires. Some key discoveries include the risk of cracking increases as temperatures rise; surface cracking at high temperatures is associated with distortional deformation; using a uniform contact stress distribution underestimates the risk of failure compared to realistic three-dimensional tire contact stress, particularly at high temperatures; the risk of failure is higher near the surface when there is a negative temperature gradient in the asphalt layer; and debonding beneath the surface layer leads to increased shear stress and premature failure around the interface.Keywords: asphalt pavement, surface failure, 3d finite element model, multiaxial stress states, Mohr-Coulomb failure criterion
Procedia PDF Downloads 595931 Numerical Analysis of Gas-Particle Mixtures through Pipelines
Authors: G. Judakova, M. Bause
Abstract:
The ability to model and simulate numerically natural gas flow in pipelines has become of high importance for the design of pipeline systems. The understanding of the formation of hydrate particles and their dynamical behavior is of particular interest, since these processes govern the operation properties of the systems and are responsible for system failures by clogging of the pipelines under certain conditions. Mathematically, natural gas flow can be described by multiphase flow models. Using the two-fluid modeling approach, the gas phase is modeled by the compressible Euler equations and the particle phase is modeled by the pressureless Euler equations. The numerical simulation of compressible multiphase flows is an important research topic. It is well known that for nonlinear fluxes, even for smooth initial data, discontinuities in the solution are likely to occur in finite time. They are called shock waves or contact discontinuities. For hyperbolic and singularly perturbed parabolic equations the standard application of the Galerkin finite element method (FEM) leads to spurious oscillations (e.g. Gibb's phenomenon). In our approach, we use stabilized FEM, the streamline upwind Petrov-Galerkin (SUPG) method, where artificial diffusion acting only in the direction of the streamlines and using a special treatment of the boundary conditions in inviscid convective terms, is added. Numerical experiments show that the numerical solution obtained and stabilized by SUPG captures discontinuities or steep gradients of the exact solution in layers. However, within this layer the approximate solution may still exhibit overshoots or undershoots. To suitably reduce these artifacts we add a discontinuity capturing or shock capturing term. The performance properties of our numerical scheme are illustrated for two-phase flow problem.Keywords: two-phase flow, gas-particle mixture, inviscid two-fluid model, euler equation, finite element method, streamline upwind petrov-galerkin, shock capturing
Procedia PDF Downloads 3115930 Finite Element Method for Modal Analysis of FGM
Authors: S. J. Shahidzadeh Tabatabaei, A. M. Fattahi
Abstract:
Modal analysis of a FGM plate containing the ceramic phase of Al2O3 and metal phase of stainless steel 304 was performed using ABAQUS, with the assumptions that the material has an elastic mechanical behavior and its Young modulus and density are varying in thickness direction. For this purpose, a subroutine was written in FOTRAN and linked with ABAQUS. First, a simulation was performed in accordance to other researcher’s model, and then after comparing the obtained results, the accuracy of the present study was verified. The obtained results for natural frequency and mode shapes indicate good performance of user-written subroutine as well as FEM model used in present study. After verification of obtained results, the effect of clamping condition and the material type (i.e. the parameter n) was investigated. In this respect, finite element analysis was carried out in fully clamped condition for different values of n. The results indicate that the natural frequency decreases with increase of n, since with increase of n, the amount of ceramic phase in FGM plate decreases, while the amount of metal phase increases, leading to decrease of the plate stiffness and hence, natural frequency, as the Young modulus of Al2O3 is equal to 380 GPa and the Young modulus of stainless steel 304 is equal to 207 GPa.Keywords: FGM plates, modal analysis, natural frequency, finite element method
Procedia PDF Downloads 3175929 Development of Tensile Stress-Strain Relationship for High-Strength Steel Fiber Reinforced Concrete
Authors: H. A. Alguhi, W. A. Elsaigh
Abstract:
This paper provides a tensile stress-strain (σ-ε) relationship for High-Strength Steel Fiber Reinforced Concrete (HSFRC). Load-deflection (P-δ) behavior of HSFRC beams tested under four-point flexural load were used with inverse analysis to calculate the tensile σ-ε relationship for various tested concrete grades (70 and 90MPa) containing 60 kg/m3 (0.76 %) of hook-end steel fibers. A first estimate of the tensile (σ-ε) relationship is obtained using RILEM TC 162-TDF and other methods available in literature, frequently used for determining tensile σ-ε relationship of Normal-Strength Concrete (NSC) Non-Linear Finite Element Analysis (NLFEA) package ABAQUS® is used to model the beam’s P-δ behavior. The results have shown that an element-size dependent tensile σ-ε relationship for HSFRC can be successfully generated and adopted for further analyzes involving HSFRC structures.Keywords: tensile stress-strain, flexural response, high strength concrete, steel fibers, non-linear finite element analysis
Procedia PDF Downloads 3605928 Triangulations via Iterated Largest Angle Bisection
Authors: Yeonjune Kang
Abstract:
A triangulation of a planar region is a partition of that region into triangles. In the finite element method, triangulations are often used as the grid underlying a computation. In order to be suitable as a finite element mesh, a triangulation must have well-shaped triangles, according to criteria that depend on the details of the particular problem. For instance, most methods require that all triangles be small and as close to the equilateral shape as possible. Stated differently, one wants to avoid having either thin or flat triangles in the triangulation. There are many triangulation procedures, a particular one being the one known as the longest edge bisection algorithm described below. Starting with a given triangle, locate the midpoint of the longest edge and join it to the opposite vertex of the triangle. Two smaller triangles are formed; apply the same bisection procedure to each of these triangles. Continuing in this manner after n steps one obtains a triangulation of the initial triangle into 2n smaller triangles. The longest edge algorithm was first considered in the late 70’s. It was shown by various authors that this triangulation has the desirable properties for the finite element method: independently of the number of iterations the angles of these triangles cannot get too small; moreover, the size of the triangles decays exponentially. In the present paper we consider a related triangulation algorithm we refer to as the largest angle bisection procedure. As the name suggests, rather than bisecting the longest edge, at each step we bisect the largest angle. We study the properties of the resulting triangulation and prove that, while the general behavior resembles the one in the longest edge bisection algorithm, there are several notable differences as well.Keywords: angle bisectors, geometry, triangulation, applied mathematics
Procedia PDF Downloads 4015927 Development of Numerical Method for Mass Transfer across the Moving Membrane with Selective Permeability: Approximation of the Membrane Shape by Level Set Method for Numerical Integral
Authors: Suguru Miyauchi, Toshiyuki Hayase
Abstract:
Biological membranes have selective permeability, and the capsules or cells enclosed by the membrane show the deformation by the osmotic flow. This mass transport phenomenon is observed everywhere in a living body. For the understanding of the mass transfer in a body, it is necessary to consider the mass transfer phenomenon across the membrane as well as the deformation of the membrane by a flow. To our knowledge, in the numerical analysis, the method for mass transfer across the moving membrane has not been established due to the difficulty of the treating of the mass flux permeating through the moving membrane with selective permeability. In the existing methods for the mass transfer across the membrane, the approximate delta function is used to communicate the quantities on the interface. The methods can reproduce the permeation of the solute, but cannot reproduce the non-permeation. Moreover, the computational accuracy decreases with decreasing of the permeable coefficient of the membrane. This study aims to develop the numerical method capable of treating three-dimensional problems of mass transfer across the moving flexible membrane. One of the authors developed the numerical method with high accuracy based on the finite element method. This method can capture the discontinuity on the membrane sharply due to the consideration of the jumps in concentration and concentration gradient in the finite element discretization. The formulation of the method takes into account the membrane movement, and both permeable and non-permeable membranes can be treated. However, searching the cross points of the membrane and fluid element boundaries and splitting the fluid element into sub-elements are needed for the numerical integral. Therefore, cumbersome operation is required for a three-dimensional problem. In this paper, we proposed an improved method to avoid the search and split operations, and confirmed its effectiveness. The membrane shape was treated implicitly by introducing the level set function. As the construction of the level set function, the membrane shape in one fluid element was expressed by the shape function of the finite element method. By the numerical experiment, it was found that the shape function with third order appropriately reproduces the membrane shapes. The same level of accuracy compared with the previous method using search and split operations was achieved by using a number of sampling points of the numerical integral. The effectiveness of the method was confirmed by solving several model problems.Keywords: finite element method, level set method, mass transfer, membrane permeability
Procedia PDF Downloads 2515926 Fatigue Life Estimation of Tubular Joints - A Comparative Study
Authors: Jeron Maheswaran, Sudath C. Siriwardane
Abstract:
In fatigue analysis, the structural detail of tubular joint has taken great attention among engineers. The DNV-RP-C203 is covering this topic quite well for simple and clear joint cases. For complex joint and geometry, where joint classification isn’t available and limitation on validity range of non-dimensional geometric parameters, the challenges become a fact among engineers. The classification of joint is important to carry out through the fatigue analysis. These joint configurations are identified by the connectivity and the load distribution of tubular joints. To overcome these problems to some extent, this paper compare the fatigue life of tubular joints in offshore jacket according to the stress concentration factors (SCF) in DNV-RP-C203 and finite element method employed Abaqus/CAE. The paper presents the geometric details, material properties and considered load history of the jacket structure. Describe the global structural analysis and identification of critical tubular joints for fatigue life estimation. Hence fatigue life is determined based on the guidelines provided by design codes. Fatigue analysis of tubular joints is conducted using finite element employed Abaqus/CAE [4] as next major step. Finally, obtained SCFs and fatigue lives are compared and their significances are discussed.Keywords: fatigue life, stress-concentration factor, finite element analysis, offshore jacket structure
Procedia PDF Downloads 4535925 Numerical Investigation of Multiphase Flow in Pipelines
Authors: Gozel Judakova, Markus Bause
Abstract:
We present and analyze reliable numerical techniques for simulating complex flow and transport phenomena related to natural gas transportation in pipelines. Such kind of problems are of high interest in the field of petroleum and environmental engineering. Modeling and understanding natural gas flow and transformation processes during transportation is important for the sake of physical realism and the design and operation of pipeline systems. In our approach a two fluid flow model based on a system of coupled hyperbolic conservation laws is considered for describing natural gas flow undergoing hydratization. The accurate numerical approximation of two-phase gas flow remains subject of strong interest in the scientific community. Such hyperbolic problems are characterized by solutions with steep gradients or discontinuities, and their approximation by standard finite element techniques typically gives rise to spurious oscillations and numerical artefacts. Recently, stabilized and discontinuous Galerkin finite element techniques have attracted researchers’ interest. They are highly adapted to the hyperbolic nature of our two-phase flow model. In the presentation a streamline upwind Petrov-Galerkin approach and a discontinuous Galerkin finite element method for the numerical approximation of our flow model of two coupled systems of Euler equations are presented. Then the efficiency and reliability of stabilized continuous and discontinous finite element methods for the approximation is carefully analyzed and the potential of the either classes of numerical schemes is investigated. In particular, standard benchmark problems of two-phase flow like the shock tube problem are used for the comparative numerical study.Keywords: discontinuous Galerkin method, Euler system, inviscid two-fluid model, streamline upwind Petrov-Galerkin method, twophase flow
Procedia PDF Downloads 3315924 Calculating Stress Intensity Factor of Cracked Axis by Using a Meshless Method
Authors: S. Shahrooi, A. Talavari
Abstract:
Numeral study on the crack and discontinuity using element-free methods has been widely spread in recent years. In this study, for stress intensity factor calculation of the cracked axis under torsional loading has been used from a new element-free method as MLPG method. Region range is discretized by some dispersed nodal points. From method of moving least square (MLS) utilized to create the functions using these nodal points. Then, results of meshless method and finite element method (FEM) were compared. The results is shown which the element-free method was of good accuracy.Keywords: stress intensity factor, crack, torsional loading, meshless method
Procedia PDF Downloads 5665923 Comparison of the Material Response Based on Production Technologies of Metal Foams
Authors: Tamas Mankovits
Abstract:
Lightweight cellular-type structures like metal foams have excellent mechanical properties, therefore the interest in these materials is widely spreading as load-bearing structural elements, e.g. as implants. Numerous technologies are available to produce metal foams. In this paper the material response of closed cell foam structures produced by direct foaming and additive technology is compared. The production technology circumstances are also investigated. Geometrical variations are developed for foam structures produced by additive manufacturing and simulated by finite element method to be able to predict the mechanical behavior.Keywords: additive manufacturing, direct foaming, finite element method, metal foam
Procedia PDF Downloads 1975922 Seismic Performance of Various Grades of Steel Columns through Finite Element Analysis
Authors: Asal Pournaghshband, Roham Maher
Abstract:
This study presents a numerical analysis of the cyclic behavior of H-shaped steel columns, focusing on different steel grades, including austenitic, ferritic, duplex stainless steel, and carbon steel. Finite Element (FE) models were developed and validated against experimental data, demonstrating a predictive accuracy of up to 6.5%. The study examined key parameters such as energy dissipation and failure modes. Results indicate that duplex stainless steel offers the highest strength, with superior energy dissipation but a tendency for brittle failure at maximum strains of 0.149. Austenitic stainless steel demonstrated balanced performance with excellent ductility and energy dissipation, showing a maximum strain of 0.122, making it highly suitable for seismic applications. Ferritic stainless steel, while stronger than carbon steel, exhibited reduced ductility and energy absorption. Carbon steel displayed the lowest performance in terms of energy dissipation and ductility, with significant strain concentrations leading to earlier failure. These findings provide critical insights into optimizing material selection for earthquake-resistant structures, balancing strength, ductility, and energy dissipation under seismic conditions.Keywords: energy dissipation, finite element analysis, H-shaped columns, seismic performance, stainless steel grades
Procedia PDF Downloads 295921 Multi-Fidelity Fluid-Structure Interaction Analysis of a Membrane Wing
Authors: M. Saeedi, R. Wuchner, K.-U. Bletzinger
Abstract:
In order to study the aerodynamic performance of a semi-flexible membrane wing, Fluid-Structure Interaction simulations have been performed. The fluid problem has been modeled using two different approaches which are the numerical solution of the Navier-Stokes equations and the vortex panel method. Nonlinear analysis of the structural problem is performed using the Finite Element Method. Comparison between the two fluid solvers has been made. Aerodynamic performance of the wing is discussed regarding its lift and drag coefficients and they are compared with those of the equivalent rigid wing.Keywords: CFD, FSI, Membrane wing, Vortex panel method
Procedia PDF Downloads 4865920 Dynamic Modeling of Orthotropic Cracked Materials by X-FEM
Authors: S. Houcine Habib, B. Elkhalil Hachi, Mohamed Guesmi, Mohamed Haboussi
Abstract:
In this paper, dynamic fracture behaviors of cracked orthotropic structure are modeled using extended finite element method (X-FEM). In this approach, the finite element method model is first created and then enriched by special orthotropic crack tip enrichments and Heaviside functions in the framework of partition of unity. The mixed mode stress intensity factor (SIF) is computed using the interaction integral technique based on J-integral in order to predict cracking behavior of the structure. The developments of these procedures are programmed and introduced in a self-software platform code. To assess the accuracy of the developed code, results obtained by the proposed method are compared with those of literature.Keywords: X-FEM, composites, stress intensity factor, crack, dynamic orthotropic behavior
Procedia PDF Downloads 5715919 Elastoplastic Collapse Analysis of Pipe Bends Using Finite Element Analysis
Authors: Tawanda Mushiri, Charles Mbohwa
Abstract:
When an external load is applied to one of its ends, a pipe’s bends cross section tends to deform significantly both in and out of its end plane. This shell type behaviour characteristic of pipe bends and mainly due to their curves geometry accounts for their greater flexibility. This added flexibility is also accompanied by stressed and strains that are much higher than those present in a straight pipe. The primary goal of this research is to study the elastic-plastic behaviour of pipe bends under out of plane moment loading. It is also required to study the effects of changing the value of the pipe bend factor and the value of the internal pressure on that behaviour and to determine the value of the limit moments in each case. The results of these analyses are presented in the form of load deflection plots for each load case belonging to each model. From the load deflection curves, the limit moments of each case are obtained. The limit loads are then compared to those computed using some of the analytical and empirical equation available in the literature. The effects of modelling parameters are also studied. The results obtained from small displacement and large displacement analyses are compared and the effects of using a strain hardened material model are also investigated. To better understand the behaviour of pipe elbows under out of plane bending and internal pressure, it was deemed important to know how the cross section deforms and to study the distribution of stresses that cause it to deform in a particular manner. An elbow with pipe bend factor h=0.1 to h=1 is considered and the results of the detailed analysis are thereof examined.Keywords: elasto-plastic, finite element analysis, pipe bends, simulation
Procedia PDF Downloads 3255918 An Evaluation of Discontinuities in Rock Mass Using Coupled Hydromechanical Finite Element and Discrete Element Analyses
Authors: Mohammad Moridzadeh, Aaron Gallant
Abstract:
The paper will present the design and construction of the underground excavations of a pump station forebay and its related components including connector tunnels, access shaft, riser shaft and well shafts. The underground openings include an 8 m-diameter riser shaft, an 8-m-diameter access shaft, 34 2.4-m-diameter well shafts, a 107-m-long forebay with a cross section having a height of 11 m and width of 10 m, and a 6 m by 6 m stub connector tunnel between the access shaft and a future forebay extension. The riser shaft extends down from the existing forebay connector tunnel at elevation 247 m to the crown of the forebay at elevation 770.0 feet. The access shaft will extend from the platform at the surface down to El. 223.5 m. The pump station will have the capacity to deliver 600 million gallons per day. The project is located on an uplifted horst consisting of a mass of Precambrian metamorphic rock trending in a north-south direction. The eastern slope of the area is very steep and pronounced and is likely the result of high-angle normal faulting. Toward the west, the area is bordered by a high angle normal fault and recent alluvial, lacustrine, and colluvial deposits. An evaluation of rock mass properties, fault and discontinuities, foliation and joints, and in situ stresses was performed. The response of the rock mass was evaluated in 3DEC using Discrete Element Method (DEM) by explicitly accounting for both major and minor discontinuities within the rock mass (i.e. joints, shear zones, faults). Moreover, the stability of the entire subsurface structure including the forebay, access and riser shafts, future forebay, well shafts, and connecting tunnels and their interactions with each other were evaluated using a 3D coupled hydromechanical Finite Element Analysis (FEA).Keywords: coupled hydromechanical analysis, discontinuities, discrete element, finite element, pump station
Procedia PDF Downloads 2645917 Induction Heating Process Design Using Comsol® Multiphysics Software Version 4.2a
Authors: K. Djellabi, M. E. H. Latreche
Abstract:
Induction heating computer simulation is a powerful tool for process design and optimization, induction coil design, equipment selection, as well as education and business presentations. The authors share their vast experience in the practical use of computer simulation for different induction heating and heat treating processes. In this paper deals with mathematical modeling and numerical simulation of induction heating furnaces with axisymmetric geometries. For the numerical solution, we propose finite element methods combined with boundary (FEM) for the electromagnetic model using COMSOL® Multiphysics Software. Some numerical results for an industrial furnace are shown with high frequency.Keywords: numerical methods, induction furnaces, induction heating, finite element method, Comsol multiphysics software
Procedia PDF Downloads 4515916 Die Design for Flashless Forging of a Polymer Insulator Fitting
Authors: Pedram Khazaie, Sajjad Moein
Abstract:
In the conventional hot forging of Tongue, which is a fitting for polymer insulator, the material wasted to flash accounts for 20-30% of workpiece. In order to reduce the cost of forged products, this waste material must be minimized. In this study, a flashless forging die is designed and simulated using the finite element method (FEM). A solution to avoid overloading the die with a simple preform is also presented. Moreover, since in flashless forging, burr is formed on the edge of workpiece, a controlled flash forging method is proposed to solve this problem. The simulation results have been validated by experiments; achieving close agreement between simulated and experimental data. It was shown that numerical modeling is helpful in reducing cost and time in the manufacturing process.Keywords: burr formation, die design, finite element method, flashless forging
Procedia PDF Downloads 1595915 Modal Analysis of FGM Plates Using Finite Element Method
Authors: S. J. Shahidzadeh Tabatabaei, A. M. Fattahi
Abstract:
Modal analysis of an FGM plate containing the ceramic phase of Al2O3 and metal phase of stainless steel 304 was performed using ABAQUS, with the assumptions that the material has an elastic mechanical behavior and its Young modulus and density are varying in thickness direction. For this purpose, a subroutine was written in FORTRAN and linked with ABAQUS. First, a simulation was performed in accordance to other researcher’s model, and then after comparing the obtained results, the accuracy of the present study was verified. The obtained results for natural frequency and mode shapes indicate good performance of user-written subroutine as well as FEM model used in present study. After verification of obtained results, the effect of clamping condition and the material type (i.e. the parameter n) was investigated. In this respect, finite element analysis was carried out in fully clamped condition for different values of n. The results indicate that the natural frequency decreases with increase of n, since with increase of n, the amount of ceramic phase in FGM plate decreases, while the amount of metal phase increases, leading to decrease of the plate stiffness and hence, natural frequency, as the Young modulus of Al2O3 is equal to 380 GPa and the Young modulus of stainless steel 304 is equal to 207 GPa.Keywords: FGM plates, modal analysis, natural frequency, finite element method
Procedia PDF Downloads 3425914 Numerical Study on the Ultimate Load of Offshore Two-Planar Tubular KK-Joints at Fire-Induced Elevated Temperatures
Authors: Hamid Ahmadi, Neda Azari-Dodaran
Abstract:
A total of 270 nonlinear steady-state finite element (FE) analyses were performed on 54 FE models of two-planar circular hollow section (CHS) KK-joints subjected to axial loading at five different temperatures (20 ºC, 200 ºC, 400 ºC, 550 ºC, and 700 ºC). The primary goal was to investigate the effects of temperature and geometrical characteristics on the ultimate strength, modes of failure, and initial stiffness of the KK-joints. Results indicated that on an average basis, the ultimate load of a two-planar tubular KK-joint at 200 ºC, 400 ºC, 550 ºC, and 700 ºC is 90%, 75%, 45%, and 16% of the joint’s ultimate load at ambient temperature, respectively. Outcomes of the parametric study showed that replacing the yield stress at ambient temperature with the corresponding value at elevated temperature to apply the EN 1993-1-8 equations for the calculation of the joint’s ultimate load at elevated temperatures may lead to highly unconservative results that might endanger the safety of the structure. Results of the parametric study were then used to develop a set of design formulas, through nonlinear regression analyses, to calculate the ultimate load of two-planar tubular KK-joints subjected to axial loading at elevated temperatures.Keywords: ultimate load, two-planar tubular KK-joint, axial loading, elevated temperature, parametric equation
Procedia PDF Downloads 1605913 Dynamic Relaxation and Isogeometric Analysis for Finite Deformation Elastic Sheets with Combined Bending and Stretching
Authors: Nikhil Padhye, Ellen Kintz, Dan Dorci
Abstract:
Recent years have seen a rising interest in study and applications of materially uniform thin-structures (plates/shells) subject to finite-bending and stretching deformations. We introduce a well-posed 2D-model involving finite-bending and stretching of thin-structures to approximate the three-dimensional equilibria. Key features of this approach include: Non-Uniform Rational B-Spline (NURBS)-based spatial discretization for finite elements, method of dynamic relaxation to predict stable equilibria, and no a priori kinematic assumption on the deformation fields. The approach is validated against the benchmark problems,and the use of NURBS for spatial discretization facilitates exact spatial representation and computation of curvatures (due to C1-continuity of interpolated displacements) for this higher-order accuracy 2D-model.Keywords: Isogeometric Analysis, Plates/Shells , Finite Element Methods, Dynamic Relaxation
Procedia PDF Downloads 1685912 Peridynamic Modeling of an Isotropic Plate under Tensile and Flexural Loading
Authors: Eda Gök
Abstract:
Peridynamics is a new modeling concept of non-local interactions for solid structures. The formulations of Peridynamic (PD) theory are based on integral equations rather than differential equations. Through, undefined equations of associated problems are avoided. PD theory might be defined as continuum version of molecular dynamics. The medium is usually modeled with mass particles bonded together. Particles interact with each other directly across finite distances through central forces named as bonds. The main assumption of this theory is that the body is composed of material points which interact with other material points within a finite distance. Although, PD theory developed for discontinuities, it gives good results for structures which have no discontinuities. In this paper, displacement control of the isotropic plate under the effect of tensile and bending loading has been investigated by means of PD theory. A MATLAB code is generated to create PD bonds and corresponding surface correction factors. Using generated MATLAB code the geometry of the specimen is generated, and the code is implemented in Finite Element Software. The results obtained from non-local continuum theory are compared with the Finite Element Analysis results and analytical solution. The results show good agreement.Keywords: non-local continuum mechanics, peridynamic theory, solid structures, tensile loading, flexural loading
Procedia PDF Downloads 1225911 Finite Element Modeling and Mechanical Properties of Aluminum Proceed by Equal Channel Angular Pressing Process
Authors: F. Al-Mufadi, F. Djavanroodi
Abstract:
During the last decade ultrafine grained (UFG) and nano-structured (NS) materials have experienced a rapid development. In this research work finite element analysis has been carried out to investigate the plastic strain distribution in equal channel angular process (ECAP). The magnitudes of standard deviation (S. D.) and inhomogeneity index (Ci) were compared for different ECAP passes. Verification of a three-dimensional finite element model was performed with experimental tests. Finally the mechanical property including impact energy of ultrafine grained pure commercially pure Aluminum produced by severe plastic deformation method has been examined. For this aim, equal channel angular pressing die with the channel angle, outer corner angle and channel diameter of 90°, 20° and 20 mm had been designed and manufactured. Commercial pure Aluminum billets were ECAPed up to four passes by route BC at the ambient temperature. The results indicated that there is a great improvement at the hardness measurement, yield strength and ultimate tensile strength after ECAP process. It is found that the magnitudes of HV reach 67 HV from 21 HV after the final stage of process. Also, about 330% and 285% enhancement at the YS and UTS values have been obtained after the fourth pass as compared to the as-received conditions, respectively. On the other hand, the elongation to failure and impact energy have been reduced by 23% and 50% after imposing four passes of ECAP process, respectively.Keywords: SPD, ECAP, FEM, pure Al, mechanical properties
Procedia PDF Downloads 1815910 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 4745909 Influence of Behavior Models on the Response of a Reinforced Concrete Frame: Multi-Fiber Approach
Authors: A. Kahil, A. Nekmouche, N. Khelil, I. Hamadou, M. Hamizi, Ne. Hannachi
Abstract:
The objective of this work is to study the influence of the nonlinear behavior models of the concrete (concrete_BAEL and concrete_UNI) as well as the confinement brought by the transverse reinforcement on the seismic response of reinforced concrete frame (RC/frame). These models as well as the confinement are integrated in the Cast3m finite element calculation code. The consideration of confinement (TAC, taking into account the confinement) provided by the transverse reinforcement and the non-consideration of confinement (without consideration of containment, WCC) in the presence and absence of a vertical load is studied. The application was made on a reinforced concrete frame (RC/frame) with 3 levels and 2 spans. The results show that on the one hand, the concrete_BAEL model slightly underestimates the resistance of the RC/frame in the plastic field, whereas the concrete_uni model presents the best results compared to the simplified model "concrete_BAEL", on the other hand, for the concrete-uni model, taking into account the confinement has no influence on the behavior of the RC/frame under imposed displacement up to a vertical load of 500 KN.Keywords: reinforced concrete, nonlinear calculation, behavior laws, fiber model confinement, numerical simulation
Procedia PDF Downloads 1645908 Numerical Modeling of Geogrid Reinforced Soil Bed under Strip Footings Using Finite Element Analysis
Authors: Ahmed M. Gamal, Adel M. Belal, S. A. Elsoud
Abstract:
This article aims to study the effect of reinforcement inclusions (geogrids) on the sand dunes bearing capacity under strip footings. In this research experimental physical model was carried out to study the effect of the first geogrid reinforcement depth (u/B), the spacing between the reinforcement (h/B) and its extension relative to the footing length (L/B) on the mobilized bearing capacity. This paper presents the numerical modeling using the commercial finite element package (PLAXIS version 8.2) to simulate the laboratory physical model, studying the same parameters previously handled in the experimental work (u/B, L/B & h/B) for the purpose of validation. In this study the soil, the geogrid, the interface element and the boundary condition are discussed with a set of finite element results and the validation. Then the validated FEM used for studying real material and dimensions of strip foundation. Based on the experimental and numerical investigation results, a significant increase in the bearing capacity of footings has occurred due to an appropriate location of the inclusions in sand. The optimum embedment depth of the first reinforcement layer (u/B) is equal to 0.25. The optimum spacing between each successive reinforcement layer (h/B) is equal to 0.75 B. The optimum Length of the reinforcement layer (L/B) is equal to 7.5 B. The optimum number of reinforcement is equal to 4 layers. The study showed a directly proportional relation between the number of reinforcement layer and the Bearing Capacity Ratio BCR, and an inversely proportional relation between the footing width and the BCR.Keywords: reinforced soil, geogrid, sand dunes, bearing capacity
Procedia PDF Downloads 4225907 Influence of Random Fibre Packing on the Compressive Strength of Fibre Reinforced Plastic
Authors: Y. Wang, S. Zhang, X. Chen
Abstract:
The longitudinal compressive strength of fibre reinforced plastic (FRP) possess a large stochastic variability, which limits efficient application of composite structures. This study aims to address how the random fibre packing affects the uncertainty of FRP compressive strength. An novel approach is proposed to generate random fibre packing status by a combination of Latin hypercube sampling and random sequential expansion. 3D nonlinear finite element model is built which incorporates both the matrix plasticity and fibre geometrical instability. The matrix is modeled by isotropic ideal elasto-plastic solid elements, and the fibres are modeled by linear-elastic rebar elements. Composite with a series of different nominal fibre volume fractions are studied. Premature fibre waviness at different magnitude and direction is introduced in the finite element model. Compressive tests on uni-directional CFRP (carbon fibre reinforced plastic) are conducted following the ASTM D6641. By a comparison of 3D FE models and compressive tests, it is clearly shown that the stochastic variation of compressive strength is partly caused by the random fibre packing, and normal or lognormal distribution tends to be a good fit the probabilistic compressive strength. Furthermore, it is also observed that different random fibre packing could trigger two different fibre micro-buckling modes while subjected to longitudinal compression: out-of-plane buckling and twisted buckling. The out-of-plane buckling mode results much larger compressive strength, and this is the major reason why the random fibre packing results a large uncertainty in the FRP compressive strength. This study would contribute to new approaches to the quality control of FRP considering higher compressive strength or lower uncertainty.Keywords: compressive strength, FRP, micro-buckling, random fibre packing
Procedia PDF Downloads 2735906 Determination of the Friction Coefficient of AL5754 Alloy by Ring Compression Test: Experimental and Numerical Survey
Authors: P. M. Keshtiban, M. Zadshakoyan
Abstract:
One of the important factors that alter different process and geometrical parameters on metal forming processes is friction between contacting surfaces. Some important factors that effected directly by friction are: stress, strain, required load, wear of surfaces and then geometrical parameters. In order to control friction effects permanent lubrication is necessary. In this article, the friction coefficient is elicited by the most effective method, ring compression tests. The tests were done by both finite element method and practical tests. Different friction curves that extracted by finite element simulations and has good conformity with published results, used for obtaining final friction coefficient. In this study Mos2 is used as the lubricant and Al5754 alloy used as the specimens material.Keywords: experiment, FEM, friction coefficient, ring compression
Procedia PDF Downloads 4635905 Elastohydrodynamic Lubrication Study Using Discontinuous Finite Volume Method
Authors: Prawal Sinha, Peeyush Singh, Pravir Dutt
Abstract:
Problems in elastohydrodynamic lubrication have attracted a lot of attention in the last few decades. Solving a two-dimensional problem has always been a big challenge. In this paper, a new discontinuous finite volume method (DVM) for two-dimensional point contact Elastohydrodynamic Lubrication (EHL) problem has been developed and analyzed. A complete algorithm has been presented for solving such a problem. The method presented is robust and easily parallelized in MPI architecture. GMRES technique is implemented to solve the matrix obtained after the formulation. A new approach is followed in which discontinuous piecewise polynomials are used for the trail functions. It is natural to assume that the advantages of using discontinuous functions in finite element methods should also apply to finite volume methods. The nature of the discontinuity of the trail function is such that the elements in the corresponding dual partition have the smallest support as compared with the Classical finite volume methods. Film thickness calculation is done using singular quadrature approach. Results obtained have been presented graphically and discussed. This method is well suited for solving EHL point contact problem and can probably be used as commercial software.Keywords: elastohydrodynamic, lubrication, discontinuous finite volume method, GMRES technique
Procedia PDF Downloads 2585904 Parameter Estimation via Metamodeling
Authors: Sergio Haram Sarmiento, Arcady Ponosov
Abstract:
Based on appropriate multivariate statistical methodology, we suggest a generic framework for efficient parameter estimation for ordinary differential equations and the corresponding nonlinear models. In this framework classical linear regression strategies is refined into a nonlinear regression by a locally linear modelling technique (known as metamodelling). The approach identifies those latent variables of the given model that accumulate most information about it among all approximations of the same dimension. The method is applied to several benchmark problems, in particular, to the so-called ”power-law systems”, being non-linear differential equations typically used in Biochemical System Theory.Keywords: principal component analysis, generalized law of mass action, parameter estimation, metamodels
Procedia PDF Downloads 518