Search results for: Polynomial approximation.
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 604

Search results for: Polynomial approximation.

274 Prediction the Deformation in Upsetting Process by Neural Network and Finite Element

Authors: H.Mohammadi Majd, M.Jalali Azizpour , Foad Saadi

Abstract:

In this paper back-propagation artificial neural network (BPANN) is employed to predict the deformation of the upsetting process. To prepare a training set for BPANN, some finite element simulations were carried out. The input data for the artificial neural network are a set of parameters generated randomly (aspect ratio d/h, material properties, temperature and coefficient of friction). The output data are the coefficient of polynomial that fitted on barreling curves. Neural network was trained using barreling curves generated by finite element simulations of the upsetting and the corresponding material parameters. This technique was tested for three different specimens and can be successfully employed to predict the deformation of the upsetting process

Keywords: Back-propagation artificial neural network(BPANN), prediction, upsetting

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1513
273 A Fast HRRP Synthesis Algorithm with Sensing Dictionary in GTD Model

Authors: R. Fan, Q. Wan, H. Chen, Y.L. Liu, Y.P. Liu

Abstract:

In the paper, a fast high-resolution range profile synthetic algorithm called orthogonal matching pursuit with sensing dictionary (OMP-SD) is proposed. It formulates the traditional HRRP synthetic to be a sparse approximation problem over redundant dictionary. As it employs a priori that the synthetic range profile (SRP) of targets are sparse, SRP can be accomplished even in presence of data lost. Besides, the computation complexity decreases from O(MNDK) flops for OMP to O(M(N + D)K) flops for OMP-SD by introducing sensing dictionary (SD). Simulation experiments illustrate its advantages both in additive white Gaussian noise (AWGN) and noiseless situation, respectively.

Keywords: GTD-based model, HRRP, orthogonal matching pursuit, sensing dictionary.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1876
272 Flexible Follower Response of a Translating Cam with Four Different Profiles for Rise-Dwell-Fall-Dwell motion

Authors: Jer-Rong Chang

Abstract:

The flexible follower response of a translating cam with four different profiles for rise-dwell-fall-dwell (RDFD) motion is investigated. The cycloidal displacement motion, the modified sinusoidal acceleration motion, the modified trapezoidal acceleration motion, and the 3-4-5 polynomial motion are employed to describe the rise and the fall motions of the follower and the associated four kinds of cam profiles are studied. Since the follower flexibility is considered, the contact point of the roller and the cam is an unknown. Two geometric constraints formulated to restrain the unknown position are substituted into Hamilton-s principle with Lagrange multipliers. Applying the assumed mode method, one can obtain the governing equations of motion as non-linear differential-algebraic equations. The equations are solved using Runge-Kutta method. Then, the responses of the flexible follower undergoing the four different motions are investigated in time domain and in frequency domain.

Keywords: translating cam, flexible follower, rise-dwell-falldwell, response

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2085
271 Packaging in a Multivariate Conceptual Design Synthesis of a BWB Aircraft

Authors: Paul Okonkwo, Howard Smith

Abstract:

A study to estimate the size of the cabin and major aircraft components as well as detect and avoid interference between internally placed components and the external surface, during the conceptual design synthesis and optimisation to explore the design space of a BWB, was conducted. Sizing of components follows the Bradley cabin sizing and rubber engine scaling procedures to size the cabin and engine respectively. The interference detection and avoidance algorithm relies on the ability of the Class Shape Transform parameterisation technique to generate polynomial functions of the surfaces of a BWB aircraft configuration from the sizes of the cabin and internal objects using few variables. Interference detection is essential in packaging of non-conventional configuration like the BWB because of the non-uniform airfoil-shaped sections and resultant varying internal space. The unique configuration increases the need for a methodology to prevent objects from being placed in locations that do not sufficiently enclose them within the geometry.

Keywords: Packaging, Optimisation, BWB, Parameterisation, Aircraft Conceptual Design.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2377
270 Application of Granular Computing Paradigm in Knowledge Induction

Authors: Iftikhar U. Sikder

Abstract:

This paper illustrates an application of granular computing approach, namely rough set theory in data mining. The paper outlines the formalism of granular computing and elucidates the mathematical underpinning of rough set theory, which has been widely used by the data mining and the machine learning community. A real-world application is illustrated, and the classification performance is compared with other contending machine learning algorithms. The predictive performance of the rough set rule induction model shows comparative success with respect to other contending algorithms.

Keywords: Concept approximation, granular computing, reducts, rough set theory, rule induction.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 785
269 LQR Based PID Controller Design for 3-DOF Helicopter System

Authors: Santosh Kr. Choudhary

Abstract:

In this article, LQR based PID controller design for 3DOF helicopter system is investigated. The 3-DOF helicopter system is a benchmark laboratory model having strongly nonlinear characteristics and unstable dynamics which make the control of such system a challenging task. This article first presents the mathematical model of the 3DOF helicopter system and then illustrates the basic idea and technical formulation for controller design. The paper explains the simple approach for the approximation of PID design parameters from the LQR controller gain matrix. The simulation results show that the investigated controller has both static and dynamic performance, therefore the stability and the quick control effect can be obtained simultaneously for the 3DOF helicopter system.

Keywords: 3DOF helicopter system, PID controller, LQR controller, modeling, simulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 5181
268 Plasmonic Absorption Enhancement in Au/CdS Nanocomposite

Authors: K. Easawi, M. Nabil, T. Abdallah, S. Negm, H. Talaat

Abstract:

Composite nanostructures of metal core/semiconductor shell (Au/CdS) configuration were prepared using organometalic method. UV-Vis spectra for the Au/CdS colloids show initially two well separated bands, corresponding to surface plasmon of the Au core, and the exciton of CdS shell. The absorption of CdS shell is enhanced, while the Au plasmon band is suppressed as the shell thickness increases. The shell sizes were estimated from the optical spectra using the effective mass approximation model (EMA), and compared to the sizes of the Au core and CdS shell measured by high resolution transmission electron microscope (HRTEM). The changes in the absorption features are discussed in terms of gradual increase in the coupling strength of the Au core surface plasmon and the exciton in the CdS. leading to charge transfer and modification of electron oscillation in Au core.

Keywords: Nanocomposites, Plasmonics.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2413
267 Evaluating some Feature Selection Methods for an Improved SVM Classifier

Authors: Daniel Morariu, Lucian N. Vintan, Volker Tresp

Abstract:

Text categorization is the problem of classifying text documents into a set of predefined classes. After a preprocessing step the documents are typically represented as large sparse vectors. When training classifiers on large collections of documents, both the time and memory restrictions can be quite prohibitive. This justifies the application of features selection methods to reduce the dimensionality of the document-representation vector. Four feature selection methods are evaluated: Random Selection, Information Gain (IG), Support Vector Machine (called SVM_FS) and Genetic Algorithm with SVM (GA_FS). We showed that the best results were obtained with SVM_FS and GA_FS methods for a relatively small dimension of the features vector comparative with the IG method that involves longer vectors, for quite similar classification accuracies. Also we present a novel method to better correlate SVM kernel-s parameters (Polynomial or Gaussian kernel).

Keywords: Features selection, learning with kernels, support vector machine, genetic algorithms and classification.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1500
266 A Study on Barreling Behavior during Upsetting Process using Artificial Neural Networks with Levenberg Algorithm

Authors: H.Mohammadi Majd, M.Jalali Azizpour

Abstract:

In this paper back-propagation artificial neural network (BPANN )with Levenberg–Marquardt algorithm is employed to predict the deformation of the upsetting process. To prepare a training set for BPANN, some finite element simulations were carried out. The input data for the artificial neural network are a set of parameters generated randomly (aspect ratio d/h, material properties, temperature and coefficient of friction). The output data are the coefficient of polynomial that fitted on barreling curves. Neural network was trained using barreling curves generated by finite element simulations of the upsetting and the corresponding material parameters. This technique was tested for three different specimens and can be successfully employed to predict the deformation of the upsetting process

Keywords: Back-propagation artificial neural network(BPANN), prediction, upsetting

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1751
265 A WIP Control Based On an Intelligent Controller

Authors: Chih-Hui Chiu, Chun-Hsien Lin

Abstract:

In this study, a robust intelligent backstepping tracking control (RIBTC) system combined with adaptive output recurrent cerebellar model articulation control (AORCMAC) and H∞ control technique is proposed for wheeled inverted pendulums (WIPs) real-time control with exact system dynamics unknown. Moreover, a robust H∞ controller is designed to attenuate the effect of the residual approximation errors and external disturbances with desired attenuation level. The experimental results indicate that the WIPs can stand upright stably when using the proposed RIBTC.

Keywords: Wheeled inverted pendulum, backsteppingtracking control, H∞ control, adaptive output recurrentcerebellar model articulation control.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1803
264 Circular Approximation by Trigonometric Bézier Curves

Authors: Maria Hussin, Malik Zawwar Hussain, Mubashrah Saddiqa

Abstract:

We present a trigonometric scheme to approximate a circular arc with its two end points and two end tangents/unit tangents. A rational cubic trigonometric Bézier curve is constructed whose end control points are defined by the end points of the circular arc. Weight functions and the remaining control points of the cubic trigonometric Bézier curve are estimated by variational approach to reproduce a circular arc. The radius error is calculated and found less than the existing techniques.

Keywords: Control points, rational trigonometric Bézier curves, radius error, shape measure, weight functions.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 4655
263 Magnetic Properties of NiO and MnO by LSDA+U

Authors: Chewa Thassana, Wicharn Techitdheera

Abstract:

The spin (ms) and orbital (mo) magnetic moment of the antiferromagnetic NiO and MnO have been studied in the local spin density approximation (LSDA+U) within full potential linear muffin-tin orbital (FP-LMTO method with in the coulomb interaction U varying from 0 to 10eV, exchange interaction J, from 0 to 1.0eV, and volume compression VC in range of 0 to 80%. Our calculated results shown that the spin magnetic moments and the orbital magnetic moments increase linearly with increasing U and J. While the interesting behaviour appears when volume compression is greater than 70% for NiO and 50% for MnO at which ms collapses. Further increase of volume compression to be at 80% leads to the disappearance of both magnetic moments.

Keywords: spin-orbital magnetic moment, Coulomb interaction U and exchange interaction J, volume compression VC, LSDA+U.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2165
262 Quick Similarity Measurement of Binary Images via Probabilistic Pixel Mapping

Authors: Adnan A. Y. Mustafa

Abstract:

In this paper we present a quick technique to measure the similarity between binary images. The technique is based on a probabilistic mapping approach and is fast because only a minute percentage of the image pixels need to be compared to measure the similarity, and not the whole image. We exploit the power of the Probabilistic Matching Model for Binary Images (PMMBI) to arrive at an estimate of the similarity. We show that the estimate is a good approximation of the actual value, and the quality of the estimate can be improved further with increased image mappings. Furthermore, the technique is image size invariant; the similarity between big images can be measured as fast as that for small images. Examples of trials conducted on real images are presented.

Keywords: Big images, binary images, similarity, matching.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 873
261 Effect of Exchange Interaction J on Magnetic Moment of MnO

Authors: C. Thassana, W. Techitdheera

Abstract:

This calculation focus on the effect of exchange interaction J and Coulomb interaction U on spin magnetic moments (ms) of MnO by using the local spin density approximation plus the Coulomb interaction (LSDA+U) method within full potential linear muffin-tin orbital (FP-LMTO). Our calculated results indicated that the spin magnetic moments correlated to J and U. The relevant results exhibited the increasing spin magnetic moments with increasing exchange interaction and Coulomb interaction. Furthermore, equations of spin magnetic moment, which h good correspondence to the experimental data 4.58μB, are defined ms = 0.11J +4.52μB and ms = 0.03U+4.52μB. So, the relation of J and U parameter is obtained, it is obviously, J = -0.249U+1.346 eV.

Keywords: exchange interaction J, the Coulomb interaction U, spin magnetic moment, LSDA+U, MnO.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1688
260 Optimal Control of Volterra Integro-Differential Systems Based On Legendre Wavelets and Collocation Method

Authors: Khosrow Maleknejad, Asyieh Ebrahimzadeh

Abstract:

In this paper, the numerical solution of optimal control problem (OCP) for systems governed by Volterra integro-differential (VID) equation is considered. The method is developed by means of the Legendre wavelet approximation and collocation method. The properties of Legendre wavelet together with Gaussian integration method are utilized to reduce the problem to the solution of nonlinear programming one. Some numerical examples are given to confirm the accuracy and ease of implementation of the method.

Keywords: Collocation method, Legendre wavelet, optimal control, Volterra integro-differential equation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2856
259 Modeling of Compaction Curves for Corn Cob Ash-Cement Stabilized Lateritic Soils

Authors: O. A. Apampa, Y. A. Jimoh, K. A. Olonade

Abstract:

The need to save time and cost of soil testing at the planning stage of road work has necessitated developing predictive models. This study proposes a model for predicting the dry density of lateritic soils stabilized with corn cob ash (CCA) and blended cement - CCA. Lateritic soil was first stabilized with CCA at 1.5, 3.0, 4.5 and 6% of the weight of soil and then stabilized with the same proportions as replacement for cement. Dry density, specific gravity, maximum degree of saturation and moisture content were determined for each stabilized soil specimen, following standard procedure. Polynomial equations containing alpha and beta parameters for CCA and blended CCA-cement were developed. Experimental values were correlated with the values predicted from the Matlab curve fitting tool, and the Solver function of Microsoft Excel 2010. The correlation coefficient (R2) of 0.86 was obtained indicating that the model could be accepted in predicting the maximum dry density of CCA stabilized soils to facilitate quick decision making in roadworks.

Keywords: Corn cob ash, lateritic soil, stabilization, maximum dry density, moisture content.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1665
258 The Effects of Biomass Parameters on the Dissolved Organic Carbon Removal in a Sponge Submerged Membrane Bioreactor

Authors: M. F. R. Zuthi, H. H. Ngo, W. S. Guo, T. T. Nguyen

Abstract:

A novel sponge submerged membrane bioreactor (SSMBR) was developed to effectively remove organics and nutrients from wastewater. Sponge is introduced within the SSMBR as a medium for the attached growth of biomass. This paper evaluates the effects of new and acclimatized sponges for dissolved organic carbon (DOC) removal from wastewater at different mixed liquor suspended solids- (MLSS) concentration of the sludge. It was observed in a series of experimental studies that the acclimatized sponge performed better than the new sponge whilst the optimum DOC removal could be achieved at 10g/L of MLSS with the acclimatized sponge. Moreover, the paper analyses the relationships between the MLSSsponge/MLSSsludge and the DOC removal efficiency of SSMBR. The results showed a non-linear relationship between the biomass parameters of the sponge and the sludge, and the DOC removal efficiency of SSMBR. A second-order polynomial function could reasonably represent these relationships.

Keywords: Acclimatization, Dissolved organic carbon, Mathematical model, Sponge submerged membrane bioreactor.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1910
257 Fourth Order Accurate Free Convective Heat Transfer Solutions from a Circular Cylinder

Authors: T. V. S. Sekhar, B. Hema Sundar Raju

Abstract:

Laminar natural-convective heat transfer from a horizontal cylinder is studied by solving the Navier-Stokes and energy equations using higher order compact scheme in cylindrical polar coordinates. Results are obtained for Rayleigh numbers of 1, 10, 100 and 1000 for a Prandtl number of 0.7. The local Nusselt number and mean Nusselt number are calculated and compared with available experimental and theoretical results. Streamlines, vorticity - lines and isotherms are plotted.

Keywords: Higher order compact scheme, Navier-Stokes equations, Energy equation, Natural convection, Boussinesq's approximation and Mean Nusselt number.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1623
256 A Design of Fractional-Order PI Controller with Error Compensation

Authors: Mazidah Tajjudin, Norhashim Mohd Arshad, Ramli Adnan

Abstract:

Fractional-order controller was proven to perform better than the integer-order controller. However, the absence of a pole at origin produced marginal error in fractional-order control system. This study demonstrated the enhancement of the fractionalorder PI over the integer-order PI in a steam temperature control. The fractional-order controller was cascaded with an error compensator comprised of a very small zero and a pole at origin to produce a zero steady-state error for the closed-loop system. Some modification on the error compensator was suggested for different order fractional integrator that can improve the overall phase margin.

Keywords: Fractional-order PI, Ziegler-Nichols tuning, Oustaloup's Recursive Approximation, steam temperature control.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2250
255 The Effects of Rain and Overland Flow Powers on Agricultural Soil Erodibility

Authors: A. Moussouni, L. Mouzai, M. Bouhadef

Abstract:

The purpose of this investigation is to relate the rain power and the overland flow power to soil erodibility to assess the effects of both parameters on soil erosion using variable rainfall intensity on remoulded agricultural soil. Six rainfall intensities were used to simulate the natural rainfall and are as follows: 12.4mm/h, 20.3mm/h, 28.6mm/h, 52mm/h, 73.5mm/h and 103mm/h. The results have shown that the relationship between overland flow power and rain power is best represented by a linear function (R2=0.99). As regards the relationships between soil erodibility factor and rain and overland flow powers, the evolution of both parameters with the erodibility factor follow a polynomial function with high coefficient of determination. From their coefficients of determination (R2=0.95) for rain power and (R2=0.96) for overland flow power, we can conclude that the flow has more power to detach particles than rain. This could be explained by the fact that the presence of particles, already detached by rain and transported by the flow, give the flow more weight and then contribute to the detachment of particles by collision.

Keywords: Laboratory experiments, soil erosion, flow power, erodibility, rainfall intensity.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2008
254 Aliveness Detection of Fingerprints using Multiple Static Features

Authors: Heeseung Choi, Raechoong Kang, Kyungtaek Choi, Jaihie Kim

Abstract:

Fake finger submission attack is a major problem in fingerprint recognition systems. In this paper, we introduce an aliveness detection method based on multiple static features, which derived from a single fingerprint image. The static features are comprised of individual pore spacing, residual noise and several first order statistics. Specifically, correlation filter is adopted to address individual pore spacing. The multiple static features are useful to reflect the physiological and statistical characteristics of live and fake fingerprint. The classification can be made by calculating the liveness scores from each feature and fusing the scores through a classifier. In our dataset, we compare nine classifiers and the best classification rate at 85% is attained by using a Reduced Multivariate Polynomial classifier. Our approach is faster and more convenient for aliveness check for field applications.

Keywords: Aliveness detection, Fingerprint recognition, individual pore spacing, multiple static features, residual noise.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1872
253 Applying Wavelet Entropy Principle in Fault Classification

Authors: S. El Safty, A. El-Zonkoly

Abstract:

The ability to detect and classify the type of fault plays a great role in the protection of power system. This procedure is required to be precise with no time consumption. In this paper detection of fault type has been implemented using wavelet analysis together with wavelet entropy principle. The simulation of power system is carried out using PSCAD/EMTDC. Different types of faults were studied obtaining various current waveforms. These current waveforms were decomposed using wavelet analysis into different approximation and details. The wavelet entropy of such decompositions is analyzed reaching a successful methodology for fault classification. The suggested approach is tested using different fault types and proven successful identification for the type of fault.

Keywords: Fault classification, wavelet transform, waveletentropy.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1896
252 A Hyperexponential Approximation to Finite-Time and Infinite-Time Ruin Probabilities of Compound Poisson Processes

Authors: Amir T. Payandeh Najafabadi

Abstract:

This article considers the problem of evaluating infinite-time (or finite-time) ruin probability under a given compound Poisson surplus process by approximating the claim size distribution by a finite mixture exponential, say Hyperexponential, distribution. It restates the infinite-time (or finite-time) ruin probability as a solvable ordinary differential equation (or a partial differential equation). Application of our findings has been given through a simulation study.

Keywords: Ruin probability, compound Poisson processes, mixture exponential (hyperexponential) distribution, heavy-tailed distributions.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1246
251 Single-Crystal Kerfless 2D Array Transducer for Volumetric Medical Imaging: Theoretical Study

Authors: Jurij Tasinkiewicz

Abstract:

The aim of this work is to present a theoretical analysis of a 2D ultrasound transducer comprised of crossed arrays of metal strips placed on both sides of thin piezoelectric layer (a). Such a structure is capable of electronic beam-steering of generated wavebeam both in elevation and azimuth. In this paper a semi-analytical model of the considered transducer is developed. It is based on generalization of the well-known BIS-expansion method. Specifically, applying the electrostatic approximation, the electric field components on the surface of the layer are expanded into fast converging series of double periodic spatial harmonics with corresponding amplitudes represented by the properly chosen Legendre polynomials. The problem is reduced to numerical solving of certain system of linear equations for unknown expansion coefficients.

Keywords: Beamforming, transducer array, BIS-expansion.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1571
250 Rotor Flow Analysis using Animplicit Harmonic Balance Method

Authors: D. Im, S. Choi, H. Kwon, S. H. Park, J. H. Kwon

Abstract:

This paper is an extension of a previous work where a diagonally implicit harmonic balance method was developed and applied to simulate oscillatory motions of pitching airfoil and wing. A more detailed study on the accuracy, convergence, and the efficiency of the method is carried out in the current paperby varying the number of harmonics in the solution approximation. As the main advantage of the method is itsusage for the design optimization of the unsteady problems, its application to more practical case of rotor flow analysis during forward flight is carried out and compared with flight test data and time-accurate computation results.

Keywords: Design optimization, Implicit harmonic balancemethod, number of harmonics, rotor flows

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1930
249 Application of Method of Symmetries at a Calculation and Planning of Circular Plate with Variable Thickness

Authors: Kirill Trapezon, Alexandr Trapezon

Abstract:

A problem is formulated for the natural oscillations of a circular plate of linearly variable thickness on the basis of the symmetry method. The equations of natural frequencies and forms for a plate are obtained, providing that it is rigidly fixed along the inner contour. The first three eigenfrequencies are calculated, and the eigenmodes of the oscillations of the acoustic element are constructed. An algorithm for applying the symmetry method and the factorization method for solving problems in the theory of oscillations for plates of variable thickness is shown. The effectiveness of the approach is demonstrated on the basis of comparison of known results and those obtained in the article. It is shown that the results are more accurate and reliable.

Keywords: Vibrations, plate, thickness, symmetry, factorization, approximation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 751
248 On the outlier Detection in Nonlinear Regression

Authors: Hossein Riazoshams, Midi Habshah, Jr., Mohamad Bakri Adam

Abstract:

The detection of outliers is very essential because of their responsibility for producing huge interpretative problem in linear as well as in nonlinear regression analysis. Much work has been accomplished on the identification of outlier in linear regression, but not in nonlinear regression. In this article we propose several outlier detection techniques for nonlinear regression. The main idea is to use the linear approximation of a nonlinear model and consider the gradient as the design matrix. Subsequently, the detection techniques are formulated. Six detection measures are developed that combined with three estimation techniques such as the Least-Squares, M and MM-estimators. The study shows that among the six measures, only the studentized residual and Cook Distance which combined with the MM estimator, consistently capable of identifying the correct outliers.

Keywords: Nonlinear Regression, outliers, Gradient, LeastSquare, M-estimate, MM-estimate.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3120
247 Suspended Matter Model on Alsat-1 Image by MLP Network and Mathematical Morphology: Prototypes by K-Means

Authors: S. Loumi, H. Merrad, F. Alilat, B. Sansal

Abstract:

In this article, we propose a methodology for the characterization of the suspended matter along Algiers-s bay. An approach by multi layers perceptron (MLP) with training by back propagation of the gradient optimized by the algorithm of Levenberg Marquardt (LM) is used. The accent was put on the choice of the components of the base of training where a comparative study made for four methods: Random and three alternatives of classification by K-Means. The samples are taken from suspended matter image, obtained by analytical model based on polynomial regression by taking account of in situ measurements. The mask which selects the zone of interest (water in our case) was carried out by using a multi spectral classification by ISODATA algorithm. To improve the result of classification, a cleaning of this mask was carried out using the tools of mathematical morphology. The results of this study presented in the forms of curves, tables and of images show the founded good of our methodology.

Keywords: Classification K-means, mathematical morphology, neural network MLP, remote sensing, suspended particulate matter

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1486
246 Physiological Effects on Scientist Astronaut Candidates: Hypobaric Training Assessment

Authors: Pedro Llanos, Diego García

Abstract:

This paper is addressed to expanding our understanding of the effects of hypoxia training on our bodies to better model its dynamics and leverage some of its implications and effects on human health. Hypoxia training is a recommended practice for military and civilian pilots that allow them to recognize their early hypoxia signs and symptoms, and Scientist Astronaut Candidates (SACs) who underwent hypobaric hypoxia (HH) exposure as part of a training activity for prospective suborbital flight applications. This observational-analytical study describes physiologic responses and symptoms experienced by a SAC group before, during and after HH exposure and proposes a model for assessing predicted versus observed physiological responses. A group of individuals with diverse Science Technology Engineering Mathematics (STEM) backgrounds conducted a hypobaric training session to an altitude up to 22,000 ft (FL220) or 6,705 meters, where heart rate (HR), breathing rate (BR) and core temperature (Tc) were monitored with the use of a chest strap sensor pre and post HH exposure. A pulse oximeter registered levels of saturation of oxygen (SpO2), number and duration of desaturations during the HH chamber flight. Hypoxia symptoms as described by the SACs during the HH training session were also registered. This data allowed to generate a preliminary predictive model of the oxygen desaturation and O2 pressure curve for each subject, which consists of a sixth-order polynomial fit during exposure, and a fifth or fourth-order polynomial fit during recovery. Data analysis showed that HR and BR showed no significant differences between pre and post HH exposure in most of the SACs, while Tc measures showed slight but consistent decrement changes. All subjects registered SpO2 greater than 94% for the majority of their individual HH exposures, but all of them presented at least one clinically significant desaturation (SpO2 < 85% for more than 5 seconds) and half of the individuals showed SpO2 below 87% for at least 30% of their HH exposure time. Finally, real time collection of HH symptoms presented temperature somatosensory perceptions (SP) for 65% of individuals, and task-focus issues for 52.5% of individuals as the most common HH indications. 95% of the subjects experienced HH onset symptoms below FL180; all participants achieved full recovery of HH symptoms within 1 minute of donning their O2 mask. The current HH study performed on this group of individuals suggests a rapid and fully reversible physiologic response after HH exposure as expected and obtained in previous studies. Our data showed consistent results between predicted versus observed SpO2 curves during HH suggesting a mathematical function that may be used to model HH performance deficiencies. During the HH study, real-time HH symptoms were registered providing evidenced SP and task focusing as the earliest and most common indicators. Finally, an assessment of HH signs of symptoms in a group of heterogeneous, non-pilot individuals showed similar results to previous studies in homogeneous populations of pilots.

Keywords: Altitude sickness, cabin pressure, hypobaric chamber training, symptoms and altitude, slow onset hypoxia.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 368
245 Generalized π-Armendariz Authentication Cryptosystem

Authors: Areej M. Abduldaim, Nadia M. G. Al-Saidi

Abstract:

Algebra is one of the important fields of mathematics. It concerns with the study and manipulation of mathematical symbols. It also concerns with the study of abstractions such as groups, rings, and fields. Due to the development of these abstractions, it is extended to consider other structures, such as vectors, matrices, and polynomials, which are non-numerical objects. Computer algebra is the implementation of algebraic methods as algorithms and computer programs. Recently, many algebraic cryptosystem protocols are based on non-commutative algebraic structures, such as authentication, key exchange, and encryption-decryption processes are adopted. Cryptography is the science that aimed at sending the information through public channels in such a way that only an authorized recipient can read it. Ring theory is the most attractive category of algebra in the area of cryptography. In this paper, we employ the algebraic structure called skew -Armendariz rings to design a neoteric algorithm for zero knowledge proof. The proposed protocol is established and illustrated through numerical example, and its soundness and completeness are proved.

Keywords: Cryptosystem, identification, skew π-Armendariz rings, skew polynomial rings, zero knowledge protocol.

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