Search results for: non-linear curve fitting
2106 Nonlinear Pollution Modelling for Polymeric Outdoor Insulator
Authors: Rahisham Abd Rahman
Abstract:
In this paper, a nonlinear pollution model has been proposed to compute electric field distribution over the polymeric insulator surface under wet contaminated conditions. A 2D axial-symmetric insulator geometry, energized with 11kV was developed and analysed using Finite Element Method (FEM). A field-dependent conductivity with simplified assumptions was established to characterize the electrical properties of the pollution layer. Comparative field studies showed that simulation of dynamic pollution model results in a more realistic field profile, offering better understanding on how the electric field behaves under wet polluted conditions.Keywords: electric field distributions, pollution layer, dynamic model, polymeric outdoor insulators, finite element method (FEM)
Procedia PDF Downloads 3982105 Development of IDF Curves for Precipitation in Western Watershed of Guwahati, Assam
Authors: Rajarshi Sharma, Rashidul Alam, Visavino Seleyi, Yuvila Sangtam
Abstract:
The Intensity-Duration-Frequency (IDF) relationship of rainfall amounts is one of the most commonly used tools in water resources engineering for planning, design and operation of water resources project, or for various engineering projects against design floods. The establishment of such relationships was reported as early as in 1932 (Bernard). Since then many sets of relationships have been constructed for several parts of the globe. The objective of this research is to derive IDF relationship of rainfall for western watershed of Guwahati, Assam. These relationships are useful in the design of urban drainage works, e.g. storm sewers, culverts and other hydraulic structures. In the study, rainfall depth for 10 years viz. 2001 to 2010 has been collected from the Regional Meteorological Centre Borjhar, Guwahati. Firstly, the data has been used to construct the mass curve for duration of more than 7 hours rainfall to calculate the maximum intensity and to form the intensity duration curves. Gumbel’s frequency analysis technique has been used to calculate the probable maximum rainfall intensities for a period of 2 yr, 5 yr, 10 yr, 50 yr, 100 yr from the maximum intensity. Finally, regression analysis has been used to develop the intensity-duration-frequency (IDF) curve. Thus, from the analysis the values for the constants ‘a’,‘b’ &‘c’ have been found out. The values of ‘a’ for which the sum of the squared deviation is minimum has been found out to be 40 and when the corresponding value of ‘c’ and ‘b’ for the minimum squared deviation of ‘a’ are 0.744 and 1981.527 respectively. The results obtained showed that in all the cases the correlation coefficient is very high indicating the goodness of fit of the formulae to estimate IDF curves in the region of interest.Keywords: intensity-duration-frequency relationship, mass curve, regression analysis, correlation coefficient
Procedia PDF Downloads 2432104 Revealing Single Crystal Quality by Insight Diffraction Imaging Technique
Authors: Thu Nhi Tran Caliste
Abstract:
X-ray Bragg diffraction imaging (“topography”)entered into practical use when Lang designed an “easy” technical setup to characterise the defects / distortions in the high perfection crystals produced for the microelectronics industry. The use of this technique extended to all kind of high quality crystals, and deposited layers, and a series of publications explained, starting from the dynamical theory of diffraction, the contrast of the images of the defects. A quantitative version of “monochromatic topography” known as“Rocking Curve Imaging” (RCI) was implemented, by using synchrotron light and taking advantage of the dramatic improvement of the 2D-detectors and computerised image processing. The rough data is constituted by a number (~300) of images recorded along the diffraction (“rocking”) curve. If the quality of the crystal is such that a one-to-onerelation between a pixel of the detector and a voxel within the crystal can be established (this approximation is very well fulfilled if the local mosaic spread of the voxel is < 1 mradian), a software we developped provides, from the each rocking curve recorded on each of the pixels of the detector, not only the “voxel” integrated intensity (the only data provided by the previous techniques) but also its “mosaic spread” (FWHM) and peak position. We will show, based on many examples, that this new data, never recorded before, open the field to a highly enhanced characterization of the crystal and deposited layers. These examples include the characterization of dislocations and twins occurring during silicon growth, various growth features in Al203, GaNand CdTe (where the diffraction displays the Borrmannanomalous absorption, which leads to a new type of images), and the characterisation of the defects within deposited layers, or their effect on the substrate. We could also observe (due to the very high sensitivity of the setup installed on BM05, which allows revealing these faint effects) that, when dealing with very perfect crystals, the Kato’s interference fringes predicted by dynamical theory are also associated with very small modifications of the local FWHM and peak position (of the order of the µradian). This rather unexpected (at least for us) result appears to be in keeping with preliminary dynamical theory calculations.Keywords: rocking curve imaging, X-ray diffraction, defect, distortion
Procedia PDF Downloads 1302103 Integrating the Modbus SCADA Communication Protocol with Elliptic Curve Cryptography
Authors: Despoina Chochtoula, Aristidis Ilias, Yannis Stamatiou
Abstract:
Modbus is a protocol that enables the communication among devices which are connected to the same network. This protocol is, often, deployed in connecting sensor and monitoring units to central supervisory servers in Supervisory Control and Data Acquisition, or SCADA, systems. These systems monitor critical infrastructures, such as factories, power generation stations, nuclear power reactors etc. in order to detect malfunctions and ignite alerts and corrective actions. However, due to their criticality, SCADA systems are vulnerable to attacks that range from simple eavesdropping on operation parameters, exchanged messages, and valuable infrastructure information to malicious modification of vital infrastructure data towards infliction of damage. Thus, the SCADA research community has been active over strengthening SCADA systems with suitable data protection mechanisms based, to a large extend, on cryptographic methods for data encryption, device authentication, and message integrity protection. However, due to the limited computation power of many SCADA sensor and embedded devices, the usual public key cryptographic methods are not appropriate due to their high computational requirements. As an alternative, Elliptic Curve Cryptography has been proposed, which requires smaller key sizes and, thus, less demanding cryptographic operations. Until now, however, no such implementation has been proposed in the SCADA literature, to the best of our knowledge. In order to fill this gap, our methodology was focused on integrating Modbus, a frequently used SCADA communication protocol, with Elliptic Curve based cryptography and develop a server/client application to demonstrate the proof of concept. For the implementation we deployed two C language libraries, which were suitably modify in order to be successfully integrated: libmodbus (https://github.com/stephane/libmodbus) and ecc-lib https://www.ceid.upatras.gr/webpages/faculty/zaro/software/ecc-lib/). The first library provides a C implementation of the Modbus/TCP protocol while the second one offers the functionality to develop cryptographic protocols based on Elliptic Curve Cryptography. These two libraries were combined, after suitable modifications and enhancements, in order to give a modified version of the Modbus/TCP protocol focusing on the security of the data exchanged among the devices and the supervisory servers. The mechanisms we implemented include key generation, key exchange/sharing, message authentication, data integrity check, and encryption/decryption of data. The key generation and key exchange protocols were implemented with the use of Elliptic Curve Cryptography primitives. The keys established by each device are saved in their local memory and are retained during the whole communication session and are used in encrypting and decrypting exchanged messages as well as certifying entities and the integrity of the messages. Finally, the modified library was compiled for the Android environment in order to run the server application as an Android app. The client program runs on a regular computer. The communication between these two entities is an example of the successful establishment of an Elliptic Curve Cryptography based, secure Modbus wireless communication session between a portable device acting as a supervisor station and a monitoring computer. Our first performance measurements are, also, very promising and demonstrate the feasibility of embedding Elliptic Curve Cryptography into SCADA systems, filling in a gap in the relevant scientific literature.Keywords: elliptic curve cryptography, ICT security, modbus protocol, SCADA, TCP/IP protocol
Procedia PDF Downloads 2702102 Oil Displacement by Water in Hauterivian Sandstone Reservoir of Kashkari Oil Field
Authors: A. J. Nazari, S. Honma
Abstract:
This paper evaluates oil displacement by water in Hauterivian sandstone reservoir of Kashkari oil field in North of Afghanistan. The core samples of this oil field were taken out from well No-21st, and the relative permeability and fractional flow are analyzed. Steady state flow laboratory experiments are performed to empirically obtain the fractional flow curves and relative permeability in different water saturation ratio. The relative permeability represents the simultaneous flow behavior in the reservoir. The fractional flow approach describes the individual phases as fractional of the total flow. The fractional flow curve interprets oil displacement by water, and from the tangent of fractional flow curve can find out the average saturation behind the water front flow saturation. Therefore, relative permeability and fractional flow curves are suitable for describing the displacement of oil by water in a petroleum reservoir. The effects of irreducible water saturation, residual oil saturation on the displaceable amount of oil are investigated through Buckley-Leveret analysis.Keywords: fractional flow, oil displacement, relative permeability, simultaneously flow
Procedia PDF Downloads 3892101 Measure-Valued Solutions to a Class of Nonlinear Parabolic Equations with Degenerate Coercivity and Singular Initial Data
Authors: Flavia Smarrazzo
Abstract:
Initial-boundary value problems for nonlinear parabolic equations having a Radon measure as initial data have been widely investigated, looking for solutions which for positive times take values in some function space. On the other hand, if the diffusivity degenerates too fast at infinity, it is well known that function-valued solutions may not exist, singularities may persist, and it looks very natural to consider solutions which, roughly speaking, for positive times describe an orbit in the space of the finite Radon measures. In this general framework, our purpose is to introduce a concept of measure-valued solution which is consistent with respect to regularizing and smoothing approximations, in order to develop an existence theory which does not depend neither on the level of degeneracy of diffusivity at infinity nor on the choice of the initial measures. In more detail, we prove existence of suitably defined measure-valued solutions to the homogeneous Dirichlet initial-boundary value problem for a class of nonlinear parabolic equations without strong coerciveness. Moreover, we also discuss some qualitative properties of the constructed solutions concerning the evolution of their singular part, including conditions (depending both on the initial data and on the strength of degeneracy) under which the constructed solutions are in fact unction-valued or not.Keywords: degenerate parabolic equations, measure-valued solutions, Radon measures, young measures
Procedia PDF Downloads 2812100 A Robust and Efficient Segmentation Method Applied for Cardiac Left Ventricle with Abnormal Shapes
Authors: Peifei Zhu, Zisheng Li, Yasuki Kakishita, Mayumi Suzuki, Tomoaki Chono
Abstract:
Segmentation of left ventricle (LV) from cardiac ultrasound images provides a quantitative functional analysis of the heart to diagnose disease. Active Shape Model (ASM) is a widely used approach for LV segmentation but suffers from the drawback that initialization of the shape model is not sufficiently close to the target, especially when dealing with abnormal shapes in disease. In this work, a two-step framework is proposed to improve the accuracy and speed of the model-based segmentation. Firstly, a robust and efficient detector based on Hough forest is proposed to localize cardiac feature points, and such points are used to predict the initial fitting of the LV shape model. Secondly, to achieve more accurate and detailed segmentation, ASM is applied to further fit the LV shape model to the cardiac ultrasound image. The performance of the proposed method is evaluated on a dataset of 800 cardiac ultrasound images that are mostly of abnormal shapes. The proposed method is compared to several combinations of ASM and existing initialization methods. The experiment results demonstrate that the accuracy of feature point detection for initialization was improved by 40% compared to the existing methods. Moreover, the proposed method significantly reduces the number of necessary ASM fitting loops, thus speeding up the whole segmentation process. Therefore, the proposed method is able to achieve more accurate and efficient segmentation results and is applicable to unusual shapes of heart with cardiac diseases, such as left atrial enlargement.Keywords: hough forest, active shape model, segmentation, cardiac left ventricle
Procedia PDF Downloads 3352099 Magnetohydrodynamic Flow over an Exponentially Stretching Sheet
Authors: Raj Nandkeolyar, Precious Sibanda
Abstract:
The flow of a viscous, incompressible, and electrically conducting fluid under the influence of aligned magnetic field acting along the direction of fluid flow over an exponentially stretching sheet is investigated numerically. The nonlinear partial differential equations governing the flow model is transformed to a set of nonlinear ordinary differential equations using suitable similarity transformation and the solution is obtained using a local linearization method followed by the Chebyshev spectral collocation method. The effects of various parameters affecting the flow and heat transfer as well as the induced magnetic field are discussed using suitable graphs and tables.Keywords: aligned magnetic field, exponentially stretching sheet, induced magnetic field, magnetohydrodynamic flow
Procedia PDF Downloads 4522098 'Performance-Based' Seismic Methodology and Its Application in Seismic Design of Reinforced Concrete Structures
Authors: Jelena R. Pejović, Nina N. Serdar
Abstract:
This paper presents an analysis of the “Performance-Based” seismic design method, in order to overcome the perceived disadvantages and limitations of the existing seismic design approach based on force, in engineering practice. Bearing in mind, the specificity of the earthquake as a load and the fact that the seismic resistance of the structures solely depends on its behaviour in the nonlinear field, traditional seismic design approach based on force and linear analysis is not adequate. “Performance-Based” seismic design method is based on nonlinear analysis and can be used in everyday engineering practice. This paper presents the application of this method to eight-story high reinforced concrete building with combined structural system (reinforced concrete frame structural system in one direction and reinforced concrete ductile wall system in other direction). The nonlinear time-history analysis is performed on the spatial model of the structure using program Perform 3D, where the structure is exposed to forty real earthquake records. For considered building, large number of results were obtained. It was concluded that using this method we could, with a high degree of reliability, evaluate structural behavior under earthquake. It is obtained significant differences in the response of structures to various earthquake records. Also analysis showed that frame structural system had not performed well at the effect of earthquake records on soil like sand and gravel, while a ductile wall system had a satisfactory behavior on different types of soils.Keywords: ductile wall, frame system, nonlinear time-history analysis, performance-based methodology, RC building
Procedia PDF Downloads 3642097 Magnetic Resonance Imaging for Assessment of the Quadriceps Tendon Cross-Sectional Area as an Adjunctive Diagnostic Parameter in Patients with Patellofemoral Pain Syndrome
Authors: Jae Ni Jang, SoYoon Park, Sukhee Park, Yumin Song, Jae Won Kim, Keum Nae Kang, Young Uk Kim
Abstract:
Objectives: Patellofemoral pain syndrome (PFPS) is a common clinical condition characterized by anterior knee pain. Here, we investigated the quadriceps tendon cross-sectional area (QTCSA) as a novel predictor for the diagnosis of PFPS. By examining the association between the QTCSA and PFPS, we aimed to provide a more valuable diagnostic parameter and more equivocal assessment of the diagnostic potential of PFPS by comparing the QTCSA with the quadriceps tendon thickness (QTT), a traditional measure of quadriceps tendon hypertrophy. Patients and Methods: This retrospective study included 30 patients with PFPS and 30 healthy participants who underwent knee magnetic resonance imaging. T1-weighted turbo spin echo transverse magnetic resonance images were obtained. The QTCSA was measured on the axial-angled phases of the images by drawing outlines, and the QTT was measured at the most hypertrophied quadriceps tendon. Results: The average QTT and QTCSA for patients with PFPS (6.33±0.80 mm and 155.77±36.60 mm², respectively) were significantly greater than those for healthy participants (5.77±0.36 mm and 111.90±24.10 mm2, respectively; both P<0.001). We used a receiver operating characteristic curve to confirm the sensitivities and specificities for both the QTT and QTCSA as predictors of PFPS. The optimal diagnostic cutoff value for QTT was 5.98 mm, with a sensitivity of 66.7%, a specificity of 70.0%, and an area under the curve of 0.75 (0.62–0.88). The optimal diagnostic cutoff value for QTCSA was 121.04 mm², with a sensitivity of 73.3%, a specificity of 70.0%, and an area under the curve of 0.83 (0.74–0.93). Conclusion: The QTCSA was found to be a more reliable diagnostic indicator for PFPS than QTT.Keywords: patellofemoral pain syndrome, quadriceps muscle, hypertrophy, magnetic resonance imaging
Procedia PDF Downloads 492096 Tribological Investigation of Piston Ring Liner Assembly
Authors: Bharatkumar Sutaria, Tejaskumar Chaudhari
Abstract:
An engine performance can be increased by minimizing losses. There are various losses observed in the engines. i.e. thermal loss, heat loss and mechanical losses. Mechanical losses are in the tune of 15 to 20 % of the overall losses. Piston ring assembly contributes the highest friction in the mechanical frictional losses. The variation of piston speed in stroke length the friction force development is not uniform. In present work, comparison has been made between theoretical and experimental friction force under different operating conditions. The experiments are performed using variable operating parameters such as load, speed, temperature and lubricants. It is found that reducing trend of friction force and friction coefficient is in good nature with mixed lubrication regime of the Stribeck curve. Overall outcome from the laboratory test performance of segmented piston ring assembly using multi-grade oil offers reasonably good results at room and elevated temperatures.Keywords: friction force, friction coefficient, piston rings, Stribeck curve
Procedia PDF Downloads 4802095 Oxide Based Memristor and Its Potential Application in Analog-Digital Electronics
Authors: P. Michael Preetam Raj, Souri Banerjee, Souvik Kundu
Abstract:
Oxide based memristors were fabricated in order to establish its potential applications in analog/digital electronics. BaTiO₃-BiFeO₃ (BT-BFO) was employed as an active material, whereas platinum (Pt) and Nb-doped SrTiO₃ (Nb:STO) were served as a top and bottom electrodes, respectively. Piezoelectric force microscopy (PFM) was utilized to present the ferroelectricity and repeatable polarization inversion in the BT-BFO, demonstrating its effectiveness for resistive switching. The fabricated memristors exhibited excellent electrical characteristics, such as hysteresis current-voltage (I-V), high on/off ratio, high retention time, cyclic endurance, and low operating voltages. The band-alignment between the active material BT-BFO and the substrate Nb:STO was experimentally investigated using X-Ray photoelectron spectroscopy, and it attributed to staggered heterojunction alignment. An energy band diagram was proposed in order to understand the electrical transport in BT-BFO/Nb:STO heterojunction. It was identified that the I-V curves of these memristors have several discontinuities. Curve fitting technique was utilized to analyse the I-V characteristic, and the obtained I-V equations were found to be parabolic. Utilizing this analysis, a non-linear BT-BFO memristors equivalent circuit model was developed. Interestingly, the obtained equivalent circuit of the BT-BFO memristors mimics the identical electrical performance, those obtained in the fabricated devices. Based on the developed equivalent circuit, a finite state machine (FSM) design was proposed. Efforts were devoted to fabricate the same FSM, and the results were well matched with those in the simulated FSM devices. Its multilevel noise filtering and immunity to external noise characteristics were also studied. Further, the feature of variable negative resistance was established by controlling the current through the memristor.Keywords: band alignment, finite state machine, polarization inversion, resistive switching
Procedia PDF Downloads 1302094 Methodologies for Crack Initiation in Welded Joints Applied to Inspection Planning
Authors: Guang Zou, Kian Banisoleiman, Arturo González
Abstract:
Crack initiation and propagation threatens structural integrity of welded joints and normally inspections are assigned based on crack propagation models. However, the approach based on crack propagation models may not be applicable for some high-quality welded joints, because the initial flaws in them may be so small that it may take long time for the flaws to develop into a detectable size. This raises a concern regarding the inspection planning of high-quality welded joins, as there is no generally acceptable approach for modeling the whole fatigue process that includes the crack initiation period. In order to address the issue, this paper reviews treatment methods for crack initiation period and initial crack size in crack propagation models applied to inspection planning. Generally, there are four approaches, by: 1) Neglecting the crack initiation period and fitting a probabilistic distribution for initial crack size based on statistical data; 2) Extrapolating the crack propagation stage to a very small fictitious initial crack size, so that the whole fatigue process can be modeled by crack propagation models; 3) Assuming a fixed detectable initial crack size and fitting a probabilistic distribution for crack initiation time based on specimen tests; and, 4) Modeling the crack initiation and propagation stage separately using small crack growth theories and Paris law or similar models. The conclusion is that in view of trade-off between accuracy and computation efforts, calibration of a small fictitious initial crack size to S-N curves is the most efficient approach.Keywords: crack initiation, fatigue reliability, inspection planning, welded joints
Procedia PDF Downloads 3522093 Facial Pose Classification Using Hilbert Space Filling Curve and Multidimensional Scaling
Authors: Mekamı Hayet, Bounoua Nacer, Benabderrahmane Sidahmed, Taleb Ahmed
Abstract:
Pose estimation is an important task in computer vision. Though the majority of the existing solutions provide good accuracy results, they are often overly complex and computationally expensive. In this perspective, we propose the use of dimensionality reduction techniques to address the problem of facial pose estimation. Firstly, a face image is converted into one-dimensional time series using Hilbert space filling curve, then the approach converts these time series data to a symbolic representation. Furthermore, a distance matrix is calculated between symbolic series of an input learning dataset of images, to generate classifiers of frontal vs. profile face pose. The proposed method is evaluated with three public datasets. Experimental results have shown that our approach is able to achieve a correct classification rate exceeding 97% with K-NN algorithm.Keywords: machine learning, pattern recognition, facial pose classification, time series
Procedia PDF Downloads 3492092 Use of Gaussian-Euclidean Hybrid Function Based Artificial Immune System for Breast Cancer Diagnosis
Authors: Cuneyt Yucelbas, Seral Ozsen, Sule Yucelbas, Gulay Tezel
Abstract:
Due to the fact that there exist only a small number of complex systems in artificial immune system (AIS) that work out nonlinear problems, nonlinear AIS approaches, among the well-known solution techniques, need to be developed. Gaussian function is usually used as similarity estimation in classification problems and pattern recognition. In this study, diagnosis of breast cancer, the second type of the most widespread cancer in women, was performed with different distance calculation functions that euclidean, gaussian and gaussian-euclidean hybrid function in the clonal selection model of classical AIS on Wisconsin Breast Cancer Dataset (WBCD), which was taken from the University of California, Irvine Machine-Learning Repository. We used 3-fold cross validation method to train and test the dataset. According to the results, the maximum test classification accuracy was reported as 97.35% by using of gaussian-euclidean hybrid function for fold-3. Also, mean of test classification accuracies for all of functions were obtained as 94.78%, 94.45% and 95.31% with use of euclidean, gaussian and gaussian-euclidean, respectively. With these results, gaussian-euclidean hybrid function seems to be a potential distance calculation method, and it may be considered as an alternative distance calculation method for hard nonlinear classification problems.Keywords: artificial immune system, breast cancer diagnosis, Euclidean function, Gaussian function
Procedia PDF Downloads 4332091 Evaluation of Earthquake Induced Cost for Mid-Rise Buildings
Authors: Gulsah Olgun, Ozgur Bozdag, Yildirim Ertutar
Abstract:
This paper mainly focuses on performance assessment of buildings by associating the damage level with the damage cost. For this purpose a methodology is explained and applied to the representative mid-rise concrete building residing in Izmir. In order to consider uncertainties in occurrence of earthquakes, the structural analyses are conducted for all possible earthquakes in the region through the hazard curve. By means of the analyses, probability of the structural response being in different limit states are obtained and used to calculate expected damage cost. The expected damage cost comprises diverse cost components related to earthquake such as cost of casualties, replacement or repair cost of building etc. In this study, inter-story drift is used as an effective response variable to associate expected damage cost with different damage levels. The structural analysis methods performed to obtain inter story drifts are response spectrum method as a linear one, accurate push-over and time history methods to demonstrate the nonlinear effects on loss estimation. Comparison of the results indicates that each method provides similar values of expected damage cost. To sum up, this paper explains an approach which enables to minimize the expected damage cost of buildings and relate performance level to damage cost.Keywords: expected damage cost, limit states, loss estimation, performance based design
Procedia PDF Downloads 2672090 Sensitivity Analysis and Solitary Wave Solutions to the (2+1)-Dimensional Boussinesq Equation in Dispersive Media
Authors: Naila Nasreen, Dianchen Lu
Abstract:
This paper explores the dynamical behavior of the (2+1)-dimensional Boussinesq equation, which is a nonlinear water wave equation and is used to model wave packets in dispersive media with weak nonlinearity. This equation depicts how long wave made in shallow water propagates due to the influence of gravity. The (2+1)- dimensional Boussinesq equation combines the two-way propagation of the classical Boussinesq equation with the dependence on a second spatial variable, as that occurs in the two-dimensional Kadomstev- Petviashvili equation. This equation provides a description of head- on collision of oblique waves and it possesses some interesting properties. The governing model is discussed by the assistance of Ricatti equation mapping method, a relatively integration tool. The solutions have been extracted in different forms the solitary wave solutions as well as hyperbolic and periodic solutions. Moreover, the sensitivity analysis is demonstrated for the designed dynamical structural system’s wave profiles, where the soliton wave velocity and wave number parameters regulate the water wave singularity. In addition to being helpful for elucidating nonlinear partial differential equations, the method in use gives previously extracted solutions and extracts fresh exact solutions. Assuming the right values for the parameters, various graph in different shapes are sketched to provide information about the visual format of the earned results. This paper’s findings support the efficacy of the approach taken in enhancing nonlinear dynamical behavior. We believe this research will be of interest to a wide variety of engineers that work with engineering models. Findings show the effectiveness simplicity, and generalizability of the chosen computational approach, even when applied to complicated systems in a variety of fields, especially in ocean engineering.Keywords: (2+1)-dimensional Boussinesq equation, solitary wave solutions, Ricatti equation mapping approach, nonlinear phenomena
Procedia PDF Downloads 982089 Investigation of Leakage, Cracking and Warpage Issues Observed on Composite Valve Cover in Development Phase through FEA Simulation
Authors: Ashwini Shripatwar, Mayur Biyani, Nikhil Rao, Rajendra Bodake, Sachin Sane
Abstract:
This paper documents the correlation of valve cover sealing, cracking, and warpage Finite Element Modelling with observations on engine test development. The valve cover is a component mounted on engine head with a gasket which provides sealing against oil which flows around camshaft, valves, rockers, and other overhead components. Material nonlinearity and contact nonlinearity characteristics are taken into consideration because the valve cover is made of a composite material having temperature dependent elastic-plastic properties and because the gasket load-deformation curve is also nonlinear. The leakage is observed between the valve cover and the engine head due to the insufficient contact pressure. The crack is observed on the valve cover due to force application at a region with insufficient stiffness and with elevated temperature. The valve cover shrinkage is observed during the disassembly process on hot exhaust side bolt holes after the engine has been running. In this paper, an analytical approach is developed to correlate a Finite Element Model with the observed failures and to address the design issues associated with the failure modes in question by making design changes in the model.Keywords: cracking issue, gasket sealing analysis, nonlinearity of contact and material, valve cover
Procedia PDF Downloads 1402088 A Comparative Analysis of an All-Optical Switch Using Chalcogenide Glass and Gallium Arsenide Based on Nonlinear Photonic Crystal
Authors: Priyanka Kumari Gupta, Punya Prasanna Paltani, Shrivishal Tripathi
Abstract:
This paper proposes a nonlinear photonic crystal ring resonator-based all-optical 2 × 2 switch. The nonlinear Kerr effect is used to evaluate the essential 2 x 2 components of the photonic crystal-based optical switch, including the bar and cross states. The photonic crystal comprises a two-dimensional square lattice of dielectric rods in an air background. In the background air, two different dielectric materials are used for this comparison study separately. Initially with chalcogenide glass rods, then with GaAs rods. For both materials, the operating wavelength, bandgap diagram, operating power intensities, and performance parameters, such as the extinction ratio, insertion loss, and cross-talk of an optical switch, have also been estimated using the plane wave expansion and the finite-difference time-domain method. The chalcogenide glass material (Ag20As32Se48) has a high refractive index of 3.1 which is highly suitable for switching operations. This dielectric material is immersed in an air background with a nonlinear Kerr coefficient of 9.1 x 10-17 m2/W. The resonance wavelength is at 1552 nm, with the operating power intensities at the cross-state and bar state around 60 W/μm2 and 690 W/μm2. The extinction ratio, insertion loss, and cross-talk value for the chalcogenide glass at the cross-state are 17.19 dB, 0.051 dB, and -17.14 dB, and the bar state, the values are 11.32 dB, 0.025 dB, and -11.35 dB respectively. The gallium arsenide (GaAs) dielectric material has a high refractive index of 3.4, a direct bandgap semiconductor material highly preferred nowadays for switching operations. This dielectric material is immersed in an air background with a nonlinear Kerr coefficient of 3.1 x 10-16 m2/W. The resonance wavelength is at 1558 nm, with the operating power intensities at the cross-state and bar state around 110 W/μm2 and 200 W/μm2. The extinction ratio, insertion loss, and cross-talk value for the chalcogenide glass at the cross-state are found to be 3.36.19 dB, 2.436 dB, and -5.8 dB, and for the bar state, the values are 15.60 dB, 0.985 dB, and -16.59 dB respectively. This paper proposes an all-optical 2 × 2 switch based on a nonlinear photonic crystal using a ring resonator. The two-dimensional photonic crystal comprises a square lattice of dielectric rods in an air background. The resonance wavelength is in the range of photonic bandgap. Later, another widely used material, GaAs, is also considered, and its performance is compared with the chalcogenide glass. Our presented structure can be potentially applicable in optical integration circuits and information processing.Keywords: photonic crystal, FDTD, ring resonator, optical switch
Procedia PDF Downloads 762087 Seismic Performance Point of RC Frame Buildings Using ATC-40, FEMA 356 and FEMA 440 Guidelines
Authors: Gram Y. Rivas Sanchez
Abstract:
The seismic design codes in the world allow the analysis of structures considering an elastic-linear behavior; however, against earthquakes, the structures exhibit non-linear behaviors that induce damage to their elements. For this reason, it is necessary to use non-linear methods to analyze these structures, being the dynamic methods that provide more reliable results but require a lot of computational costs; on the other hand, non-linear static methods do not have this disadvantage and are being used more and more. In the present work, the nonlinear static analysis (pushover) of RC frame buildings of three, five, and seven stories is carried out considering models of concentrated plasticity using plastic hinges; and the seismic performance points are determined using ATC-40, FEMA 356, and FEMA 440 guidelines. Using this last standard, the highest inelastic displacements and basal shears are obtained, providing designs that are more conservative.Keywords: pushover, nonlinear, RC building, FEMA 440, ATC 40
Procedia PDF Downloads 1452086 Comparison of Seismic Response for Two RC Curved Bridges with Different Column Shapes
Authors: Nina N. Serdar, Jelena R. Pejović
Abstract:
This paper presents seismic risk assessment of two bridge structure, based on the probabilistic performance-based seismic assessment methodology. Both investigated bridges are tree span continuous RC curved bridges with the difference in column shapes. First bridge (type A) has a wall-type pier and second (type B) has a two-column bent with circular columns. Bridges are designed according to European standards: EN 1991-2, EN1992-1-1 and EN 1998-2. Aim of the performed analysis is to compare seismic behavior of these two structures and to detect the influence of column shapes on the seismic response. Seismic risk assessment is carried out by obtaining demand fragility curves. Non-linear model was constructed and time-history analysis was performed using thirty five pairs of horizontal ground motions selected to match site specific hazard. In performance based analysis, peak column drift ratio (CDR) was selected as engineering demand parameter (EDP). For seismic intensity measure (IM) spectral displacement was selected. Demand fragility curves that give probability of exceedance of certain value for chosen EDP were constructed and based on them conclusions were made.Keywords: RC curved bridge, demand fragility curve, wall type column, nonlinear time-history analysis, circular column
Procedia PDF Downloads 3392085 A New Computational Method for the Solution of Nonlinear Burgers' Equation Arising in Longitudinal Dispersion Phenomena in Fluid Flow through Porous Media
Authors: Olayiwola Moruf Oyedunsi
Abstract:
This paper discusses the Modified Variational Iteration Method (MVIM) for the solution of nonlinear Burgers’ equation arising in longitudinal dispersion phenomena in fluid flow through porous media. The method is an elegant combination of Taylor’s series and the variational iteration method (VIM). Using Maple 18 for implementation, it is observed that the procedure provides rapidly convergent approximation with less computational efforts. The result shows that the concentration C(x,t) of the contaminated water decreases as distance x increases for the given time t.Keywords: modified variational iteration method, Burger’s equation, porous media, partial differential equation
Procedia PDF Downloads 3192084 Income Inequality among Selected Entrepreneurs in Ondo State, Nigeria
Authors: O.O. Ehinmowo, A.I. Fatuase, D.F. Oke
Abstract:
Nigeria is endowed with resources that could boost the economy as well as generate income and provide jobs to the teaming populace. One of the keys of attaining this is by making the environment conducive for the entrepreneurs to excel in their respective enterprises so that more income could be accrued to the entrepreneurs. This study therefore examines income inequality among selected entrepreneurs in Ondo State, Nigeria using primary data. A multistage sampling technique was used to select 200 respondents for the study with the aid of structured questionnaire and personal interview. The data collected were subjected to descriptive statistics, Lorenz curve, Gini coefficient and Double - Log regression model. Results revealed that majority of the entrepreneurs (63%) were males and 90% were married with an average age of 44 years. About 40% of the respondents spent at most 12 years in school with 81% of the respondents had 4-6 members per household, while hair dressing (43.5%) and fashion designing (31.5%) were the most common enterprises among the sampled respondents. The findings also showed that majority of the entrepreneurs in hairdressing, fashion designing and laundry service earned below N200,000 per annum while the majority of those in restaurant and food vending earned between N400,000 – N600,000 followed by the entrepreneurs in pure water enterprise where majority earned N800,000 and above per annum. The result of the Gini coefficient (0.58) indicated that there was presence of inequality among the entrepreneurs which was also affirmed by the Lorenz curve. The Regression results showed that gender, household size and number of employees significantly affected the income of the entrepreneurs in the study area. Therefore, more female households should be encouraged into entrepreneurial businesses and government should give incentive cum conductive environment that could bridge the disparity in the income of the entrepreneurs in their various enterprises.Keywords: entrepreneurs, Gini coefficient, income inequality, Lorenz curve
Procedia PDF Downloads 3502083 Numerical Buckling of Composite Cylindrical Shells under Axial Compression Using Asymmetric Meshing Technique (AMT)
Authors: Zia R. Tahir, P. Mandal
Abstract:
This paper presents the details of a numerical study of buckling and post buckling behaviour of laminated carbon fiber reinforced plastic (CFRP) thin-walled cylindrical shell under axial compression using asymmetric meshing technique (AMT) by ABAQUS. AMT is considered to be a new perturbation method to introduce disturbance without changing geometry, boundary conditions or loading conditions. Asymmetric meshing affects both predicted buckling load and buckling mode shapes. Cylindrical shell having lay-up orientation [0°/+45°/-45°/0°] with radius to thickness ratio (R/t) equal to 265 and length to radius ratio (L/R) equal to 1.5 is analysed numerically. A series of numerical simulations (experiments) are carried out with symmetric and asymmetric meshing to study the effect of asymmetric meshing on predicted buckling behaviour. Asymmetric meshing technique is employed in both axial direction and circumferential direction separately using two different methods, first by changing the shell element size and varying the total number elements, and second by varying the shell element size and keeping total number of elements constant. The results of linear analysis (Eigenvalue analysis) and non-linear analysis (Riks analysis) using symmetric meshing agree well with analytical results. The results of numerical analysis are presented in form of non-dimensional load factor, which is the ratio of buckling load using asymmetric meshing technique to buckling load using symmetric meshing technique. Using AMT, load factor has about 2% variation for linear eigenvalue analysis and about 2% variation for non-linear Riks analysis. The behaviour of load end-shortening curve for pre-buckling is same for both symmetric and asymmetric meshing but for asymmetric meshing curve behaviour in post-buckling becomes extraordinarily complex. The major conclusions are: different methods of AMT have small influence on predicted buckling load and significant influence on load displacement curve behaviour in post buckling; AMT in axial direction and AMT in circumferential direction have different influence on buckling load and load displacement curve in post-buckling.Keywords: CFRP composite cylindrical shell, asymmetric meshing technique, primary buckling, secondary buckling, linear eigenvalue analysis, non-linear riks analysis
Procedia PDF Downloads 3512082 A Study on Approximate Controllability of Impulsive Integrodifferential Systems with Non Local Conditions
Authors: Anandhi Santhosh
Abstract:
In order to describe various real-world problems in physical and engineering sciences subject to abrupt changes at certain instants during the evolution process, impulsive differential equations has been used to describe the system model. In this article, the problem of approximate controllability for nonlinear impulsive integrodifferential equations with state-dependent delay is investigated. We study the approximate controllability for nonlinear impulsive integrodifferential system under the assumption that the corresponding linear control system is approximately controllable. Using methods of functional analysis and semigroup theory, sufficient conditions are formulated and proved. Finally, an example is provided to illustrate the proposed theory.Keywords: approximate controllability, impulsive differential system, fixed point theorem, state-dependent delay
Procedia PDF Downloads 3822081 A Stochastic Model to Predict Earthquake Ground Motion Duration Recorded in Soft Soils Based on Nonlinear Regression
Authors: Issam Aouari, Abdelmalek Abdelhamid
Abstract:
For seismologists, the characterization of seismic demand should include the amplitude and duration of strong shaking in the system. The duration of ground shaking is one of the key parameters in earthquake resistant design of structures. This paper proposes a nonlinear statistical model to estimate earthquake ground motion duration in soft soils using multiple seismicity indicators. Three definitions of ground motion duration proposed by literature have been applied. With a comparative study, we select the most significant definition to use for predict the duration. A stochastic model is presented for the McCann and Shah Method using nonlinear regression analysis based on a data set for moment magnitude, source to site distance and site conditions. The data set applied is taken from PEER strong motion databank and contains shallow earthquakes from different regions in the world; America, Turkey, London, China, Italy, Chili, Mexico...etc. Main emphasis is placed on soft site condition. The predictive relationship has been developed based on 600 records and three input indicators. Results have been compared with others published models. It has been found that the proposed model can predict earthquake ground motion duration in soft soils for different regions and sites conditions.Keywords: duration, earthquake, prediction, regression, soft soil
Procedia PDF Downloads 1512080 Investigation of Overstrength of Dual System by Non-Linear Static and Dynamic Analyses
Authors: Nina Øystad-Larsen, Miran Cemalovic, Amir M. Kaynia
Abstract:
The nonlinear static and dynamic analysis procedures presented in EN 1998-1 for the structural response of a RC wall-frame building are assessed. The structure is designed according to the guidelines for high ductility (DCH) in 1998-1. The finite element packages SeismoStruct and OpenSees are utilized and evaluated. The structural response remains nearly in the elastic range even though the building was designed for high ductility. The overstrength is a result of oversized and heavily reinforced members, with emphasis on the lower storey walls. Nonlinear response history analysis in the software packages give virtually identical results for displacements.Keywords: behaviour factor, dual system, OpenSEES, overstrength, seismostruct
Procedia PDF Downloads 4052079 Influence of Hearing Aids on Non-Medically Treatable Deafness
Authors: Niragira Donatien
Abstract:
The progress of technology creates new expectations for patients. The world of deafness is no exception. In recent years, there have been considerable advances in the field of technologies aimed at assisting failing hearing. According to the usual medical vocabulary, hearing aids are actually orthotics. They do not replace an organ but compensate for a functional impairment. The amplifier hearing amplification is useful for a large number of people with hearing loss. Hearing aids restore speech audibility. However, their benefits vary depending on the quality of residual hearing. The hearing aid is not a "cure" for deafness. It cannot correct all affected hearing abilities. It should be considered as an aid to communicate who the best candidates for hearing aids are. The urge to judge from the audiogram alone should be resisted here, as audiometry only indicates the ability to detect non-verbal sounds. To prevent hearing aids from ending up in the drawer, it is important to ensure that the patient's disability situations justify the use of this type of orthosis. If the problems of receptive pre-fitting counselling are crucial, the person with hearing loss must be informed of the advantages and disadvantages of amplification in his or her case. Their expectations must be realistic. They also need to be aware that the adaptation process requires a good deal of patience and perseverance. They should be informed about the various models and types of hearing aids, including all the aesthetic, functional, and financial considerations. If the person's motivation "survives" pre-fitting counselling, we are in the presence of a good candidate for amplification. In addition to its relevance, hearing aids raise other questions: Should one or both ears be fitted? In short, all these questions show that the results found in this study significantly improve the quality of audibility in the patient, from where this technology must be made accessible everywhere in the world. So we want to progress with the technology.Keywords: audiology, influence, hearing, madicaly, treatable
Procedia PDF Downloads 502078 Development and Evaluation of a Psychological Adjustment and Adaptation Status Scale for Breast Cancer Survivors
Authors: Jing Chen, Jun-E Liu, Peng Yue
Abstract:
Objective: The objective of this study was to develop a psychological adjustment and adaptation status scale for breast cancer survivors, and to examine the reliability and validity of the scale. Method: 37 breast cancer survivors were recruited in qualitative research; a five-subject theoretical framework and an item pool of 150 items of the scale were derived from the interview data. In order to evaluate and select items and reach a preliminary validity and reliability for the original scale, the suggestions of study group members, experts and breast cancer survivors were taken, and statistical methods were used step by step in a sample of 457 breast cancer survivors. Results: An original 24-item scale was developed. The five dimensions “domestic affections”, “interpersonal relationship”, “attitude of life”, “health awareness”, “self-control/self-efficacy” explained 58.053% of the total variance. The content validity was assessed by experts, the CVI was 0.92. The construct validity was examined in a sample of 264 breast cancer survivors. The fitting indexes of confirmatory factor analysis (CFA) showed good fitting of the five dimensions model. The criterion-related validity of the total scale with PTGI was satisfactory (r=0.564, p<0.001). The internal consistency reliability and test-retest reliability were tested. Cronbach’s alpha value (0.911) showed a good internal consistency reliability, and the intraclass correlation coefficient (ICC=0.925, p<0.001) showed a satisfactory test-retest reliability. Conclusions: The scale was brief and easy to understand, was suitable for breast cancer patients whose physical strength and energy were limited.Keywords: breast cancer survivors, rehabilitation, psychological adaption and adjustment, development of scale
Procedia PDF Downloads 5122077 Modeling of the Friction Behavior of Carbon/Epoxy Prepreg Composite
Authors: David Aveiga, Carlos Gonzalez
Abstract:
Thermoforming of pre-impregnated composites (prepreg) is the most employed process to build high-performance composite structures due to their visible advantage over alternative manufacturing techniques. This method allows easy shape moulding with a simple manufacturing system and a more refined outcome. The achievement of complex geometries can be exposed to undesired defects such as wrinkles. It is known that interply and ply-mould sliding behavior governs this defect generation. This work analyses interply and ply-mould friction coefficients for UD AS4/8552 Carbon/Epoxy prepreg. Friction coefficients are determined by a pull-out test method considering actual velocity, pressure and temperature conditions employed in a thermoforming process of an aeronautical composite component. A Stribeck curve is then constructed to find a mathematical expression that relates all the friction coefficients with the test variables through the Hersey number parameter. Two expressions are proposed to model ply-ply and ply-tool friction behaviors.Keywords: friction, prepreg composite, stribeck curve, thermoforming.
Procedia PDF Downloads 182