Search results for: molecular dynamics simulation
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 4251

Search results for: molecular dynamics simulation

3861 Shear Layer Investigation through a High-Load Cascade in Low-Pressure Gas Turbine Conditions

Authors: Mehdi Habibnia Rami, Shidvash Vakilipour, Mohammad H. Sabour, Rouzbeh Riazi, Hossein Hassannia

Abstract:

This paper deals with the steady and unsteady flow behavior on the separation bubble occurring on the rear portion of the suction side of T106A blade. The first phase was to implement the steady condition capturing the separation bubble. To accurately predict the separated region, the effects of three different turbulence models and computational grids were separately investigated. The results of Large Eddy Simulation (LES) model on the finest grid structure are acceptably in a good agreement with its relevant experimental results. The second phase is mainly to address the effects of wake entrance on bubble disappearance in unsteady situation. In the current simulations, from what was suggested in an experiment, simulating the flow unsteadiness, with concentrations on small scale disturbances instead of simulating a complete oncoming wake, is the key issue. Subsequently, the results from the current strategy to apply the effects of the wake and two other experimental work were compared to be in a good agreement. Between the two experiments, one of them deals with wake passing unsteady flow, and the other one implements experimentally the same approach as the current Computational Fluid Dynamics (CFD) simulation.

Keywords: T106A turbine cascade, shear-layer separation, steady and unsteady conditions, turbulence models, OpenFOAM.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 696
3860 Software Digital Phase-locked Loop for Induction Motor Speed Control

Authors: Benmabrouk. Zaineb, Ben Hamed. Mouna, Lassad. Sbita

Abstract:

This article deals to describe the simulation investigation of the digital phase locked loop implemented in software (SDPLL). SDPLL has been developed for speed drives of an induction motor in scalar strategy. A drive was implemented and simulation results are presented to verify the robustness against motor parameter variation and regulation speed.

Keywords: Induction motor, Software Digital Phase LockedLoop, Speed control, Simulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2485
3859 The Boundary Element Method in Excel for Teaching Vector Calculus and Simulation

Authors: Stephen Kirkup

Abstract:

This paper discusses the implementation of the boundary element method (BEM) on an Excel spreadsheet and how it can be used in teaching vector calculus and simulation. There are two separate spreadheets, within which Laplace equation is solved by the BEM in two dimensions (LIBEM2) and axisymmetric three dimensions (LBEMA). The main algorithms are implemented in the associated programming language within Excel, Visual Basic for Applications (VBA). The BEM only requires a boundary mesh and hence it is a relatively accessible method. The BEM in the open spreadsheet environment is demonstrated as being useful as an aid to teaching and learning. The application of the BEM implemented on a spreadsheet for educational purposes in introductory vector calculus and simulation is explored. The development of assignment work is discussed, and sample results from student work are given. The spreadsheets were found to be useful tools in developing the students’ understanding of vector calculus and in simulating heat conduction.

Keywords: Boundary element method, laplace equation, vector calculus, simulation, education.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 947
3858 An Approach for Integration of Industrial Robot with Vision System and Simulation Software

Authors: Ahmed Sh. Khusheef, Ganesh Kothapalli, Majid Tolouei-Rad

Abstract:

Utilization of various sensors has made it possible to extend capabilities of industrial robots. Among these are vision sensors that are used for providing visual information to assist robot controllers. This paper presents a method of integrating a vision system and a simulation program with an industrial robot. The vision system is employed to detect a target object and compute its location in the robot environment. Then, the target object-s information is sent to the robot controller via parallel communication port. The robot controller uses the extracted object information and the simulation program to control the robot arm for approaching, grasping and relocating the object. This paper presents technical details of system components and describes the methodology used for this integration. It also provides a case study to prove the validity of the methodology developed.

Keywords: industrial robot, integration, simulation, vision system

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2188
3857 Real-Time Image Encryption Using a 3D Discrete Dual Chaotic Cipher

Authors: M. F. Haroun, T. A. Gulliver

Abstract:

In this paper, an encryption algorithm is proposed for real-time image encryption. The scheme employs a dual chaotic generator based on a three dimensional (3D) discrete Lorenz attractor. Encryption is achieved using non-autonomous modulation where the data is injected into the dynamics of the master chaotic generator. The second generator is used to permute the dynamics of the master generator using the same approach. Since the data stream can be regarded as a random source, the resulting permutations of the generator dynamics greatly increase the security of the transmitted signal. In addition, a technique is proposed to mitigate the error propagation due to the finite precision arithmetic of digital hardware. In particular, truncation and rounding errors are eliminated by employing an integer representation of the data which can easily be implemented. The simple hardware architecture of the algorithm makes it suitable for secure real-time applications.

Keywords: Chaotic systems, image encryption, 3D Lorenz attractor, non-autonomous modulation, FPGA.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1182
3856 How Social Network Structure Affects the Dynamics of Evolution of Cooperation?

Authors: Mohammad Akbarpour, Reza Nasiri Mahalati, Caro Lucas

Abstract:

The existence of many biological systems, especially human societies, is based on cooperative behavior [1, 2]. If natural selection favors selfish individuals, then what mechanism is at work that we see so many cooperative behaviors? One answer is the effect of network structure. On a graph, cooperators can evolve by forming network bunches [2, 3, 4]. In a research, Ohtsuki et al used the idea of iterated prisoners- dilemma on a graph to model an evolutionary game. They showed that the average number of neighbors plays an important role in determining whether cooperation is the ESS of the system or not [3]. In this paper, we are going to study the dynamics of evolution of cooperation in a social network. We show that during evolution, the ratio of cooperators among individuals with fewer neighbors to cooperators among other individuals is greater than unity. The extent to which the fitness function depends on the payoff of the game determines this ratio.

Keywords: Evolution of cooperation, Iterated prisoner's dilemma, Model dynamics, Social network structure, Intensity of selection.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1323
3855 Unsupervised Feature Learning by Pre-Route Simulation of Auto-Encoder Behavior Model

Authors: Youngjae Jin, Daeshik Kim

Abstract:

This paper describes a cycle accurate simulation results of weight values learned by an auto-encoder behavior model in terms of pre-route simulation. Given the results we visualized the first layer representations with natural images. Many common deep learning threads have focused on learning high-level abstraction of unlabeled raw data by unsupervised feature learning. However, in the process of handling such a huge amount of data, the learning method’s computation complexity and time limited advanced research. These limitations came from the fact these algorithms were computed by using only single core CPUs. For this reason, parallel-based hardware, FPGAs, was seen as a possible solution to overcome these limitations. We adopted and simulated the ready-made auto-encoder to design a behavior model in VerilogHDL before designing hardware. With the auto-encoder behavior model pre-route simulation, we obtained the cycle accurate results of the parameter of each hidden layer by using MODELSIM. The cycle accurate results are very important factor in designing a parallel-based digital hardware. Finally this paper shows an appropriate operation of behavior model based pre-route simulation. Moreover, we visualized learning latent representations of the first hidden layer with Kyoto natural image dataset.

Keywords: Auto-encoder, Behavior model simulation, Digital hardware design, Pre-route simulation, Unsupervised feature learning.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2653
3854 The Dynamics of Oil Bodies in A. thaliana Seeds: A Mathematical Model of Biogenesis and Coalescence

Authors: G. Trigui, B. Laroche, M. Miquel, B. Dubreucq, A. Trubuil

Abstract:

The subcellular organelles called oil bodies (OBs) are lipid-filled quasi-spherical droplets produced from the endoplasmic reticulum (ER) and then released into the cytoplasm during seed development. It is believed that an OB grows by coalescence with other OBs and that its stability depends on the composition of oleosins, major proteins inserted in the hemi membrane that covers OBs. In this study, we measured the OB-volume distribution from different genotypes of A. thaliana after 7, 8, 9, 10 and 11 days of seed development. In order to test the hypothesis of OBs dynamics, we developed a simple mathematical model using non-linear differential equations inspired from the theory of coagulation. The model describes the evolution of OB-volume distribution during the first steps of seed development by taking into consideration the production of OBs, the increase of triacylglycerol volume to be stored, and the growth by coalescence of OBs. Fitted parameters values show an increase in the OB production and coalescence rates in A. thaliana oleosin mutants compared to wild type.

Keywords: Biogenesis, coalescence, oil body, oleosin, population dynamics.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1717
3853 Numerical Simulation of Flow Past an Infinite Row of Equispaced Square Cylinders Using the Multi- Relaxation-Time Lattice Boltzmann Method

Authors: S. Ul. Islam, H. Rahman, W. S. Abbasi, N. Rathore

Abstract:

In this research numerical simulations are performed, using the multi-relaxation-time lattice Boltzmann method, in the range 3 ≤ β = w[d] ≤ 30 at Re = 100, 200 and 300, where β the blockage ratio, w is the equispaced distance between centers of cylinders, d is the diameter of the cylinder and Re is the Reynolds number, respectively. Special attention is paid to the effect of the equispaced distance between centers of cylinders. Visualization of the vorticity contour visualization are presented for some simulation showing the flow dynamics and patterns for blockage effect. Results show that the drag and mean drag coefficients, and Strouhal number, in general, decrease with the increase of β for fixed Re. It is found that the decreasing rate of drag and mean drag coefficients and Strouhal number is more distinct in the range 3 ≤ β ≤ 15. We found that when β > 15, the blockage effect almost diminishes. Our results further indicate that the drag and mean drag coefficients, peak value of the lift coefficient, root-mean-square value of the lift and drag coefficients and the ratio between lift and drag coefficients decrease with the increase of Re. The results indicate that symmetry boundary condition have more blockage effect as compared to periodic boundary condition.

Keywords: Blockage ratio, Multi-relaxation-time lattice Boltzmann method, Square cylinder, Vortex formation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2031
3852 Effect of Fault Depth on Near-Fault Peak Ground Velocity

Authors: Yanyan Yu, Haiping Ding, Pengjun Chen, Yiou Sun

Abstract:

Fault depth is an important parameter to be determined in ground motion simulation, and peak ground velocity (PGV) demonstrates good application prospect. Using numerical simulation method, the variations of distribution and peak value of near-fault PGV with different fault depth were studied in detail, and the reason of some phenomena were discussed. The simulation results show that the distribution characteristics of PGV of fault-parallel (FP) component and fault-normal (FN) component are distinctly different; the value of PGV FN component is much larger than that of FP component. With the increase of fault depth, the distribution region of the FN component strong PGV moves forward along the rupture direction, while the strong PGV zone of FP component becomes gradually far away from the fault trace along the direction perpendicular to the strike. However, no matter FN component or FP component, the strong PGV distribution area and its value are both quickly reduced with increased fault depth. The results above suggest that the fault depth have significant effect on both FN component and FP component of near-fault PGV.

Keywords: Fault depth, near-fault, PGV, numerical simulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 752
3851 VHL, PBRM1 and SETD2 Genes in Kidney Cancer: A Molecular Investigation

Authors: Rozhgar A. Khailany, Mehri Igci, Emine Bayraktar, Sakip Erturhan, Metin Karakok, Ahmet Arslan

Abstract:

Kidney cancer is the most lethal urological cancer accounting for 3% of adult malignancies. VHL, a tumor-suppressor gene, is best known to be associated with renal cell carcinoma (RCC). The VHL functions as negative regulator of hypoxia inducible factors. Recent sequencing efforts have identified several novel frequent mutations of histone modifying and chromatin remodeling genes in ccRCC (clear cell RCC) including PBRM1 and SETD2. The PBRM1 gene encodes the BAF180 protein, which involved in transcriptional activation and repression of selected genes. SETD2 encodes a histone methyltransferase, which may play a role in suppressing tumor development. In this study, RNAs of 30 paired tumor and normal samples that were grouped according to the types of kidney cancer and clinical characteristics of patients, including gender and average age were examined by RT-PCR, SSCP and sequencing techniques. VHL, PBRM1 and SETD2 expressions were relatively down-regulated. However, statistically no significance was found (Wilcoxon signed rank test, p>0.05). Interestingly, no mutation was observed on the contrary of previous studies. Understanding the molecular mechanisms involved in the pathogenesis of RCC has aided the development of molecular-targeted drugs for kidney cancer. Further analysis is required to identify the responsible genes rather than VHL, PBRM1 and SETD2 in kidney cancer.

Keywords: Kidney cancer, molecular biomarker, expression analysis, mutation screening.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1981
3850 Contact Drying Simulation of Particulate Materials: A Comprehensive Approach

Authors: Marco Intelvi, Apolinar Picado, Joaquín Martínez

Abstract:

In this work, simulation algorithms for contact drying of agitated particulate materials under vacuum and at atmospheric pressure were developed. The implementation of algorithms gives a predictive estimation of drying rate curves and bulk bed temperature during contact drying. The calculations are based on the penetration model to describe the drying process, where all process parameters such as heat and mass transfer coefficients, effective bed properties, gas and liquid phase properties are estimated with proper correlations. Simulation results were compared with experimental data from the literature. In both cases, simulation results were in good agreement with experimental data. Few deviations were identified and the limitations of the predictive capabilities of the models are discussed. The programs give a good insight of the drying behaviour of the analysed powders.

Keywords: Agitated bed, Atmospheric pressure, Penetrationmodel, Vacuum

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2203
3849 Study of a Four-Bed Pressure Swing Adsorption for Oxygen Separation from Air

Authors: Moghadazadeh Zahra, Towfighi Jafar, Mofarahi Masoud

Abstract:

This article is presented an experimental and modeling study of a four-bed pressure swing adsorption process using zeolite13X to provide oxygen-enriched air. The binary mixture N2/O2 (79/21 vol %) was used as a feed stream. The effects of purge/feed ratio (P/F), adsorption pressure, cyclic time and product flow rate on product purity and recovery under nonisothermal condition were studied. The adsorption dynamics of process were determined using a mathematical model incorporated mass and energy balances. A Mathlab code using finite difference method was developed to solve the set of coupled differential-algebraic equations, and the simulation results are agreed well with experimental results.

Keywords: Pressure swing adsorption (PSA), Oxygen, Zeolite 13X.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3816
3848 Tomographic Images Reconstruction Simulation for Defects Detection in Specimen

Authors: Kedit J.

Abstract:

This paper is the tomographic images reconstruction simulation for defects detection in specimen. The specimen is the thin cylindrical steel contained with low density materials. The defects in material are simulated in three shapes.The specimen image function will be transformed to projection data. Radon transform and its inverse provide the mathematical for reconstructing tomographic images from projection data. The result of the simulation show that the reconstruction images is complete for defect detection.

Keywords: Tomography, Tomography Reconstruction, Radon Transform

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1397
3847 Dynamics In Production Processes

Authors: Marco Kennemann, Steffen C. Eickemeyer, Peter Nyhuis

Abstract:

An increasingly dynamic and complex environment poses huge challenges to production enterprises, especially with regards to logistics. The Logistic Operating Curve Theory, developed at the Institute of Production Systems and Logistics (IFA) of the Leibniz University of Hanover, is a recognized approach to describing logistic interactions, nevertheless, it reaches its limits when it comes to the dynamic aspects. In order to facilitate a timely and optimal Logistic Positioning a method is developed for quickly and reliably identifying dynamic processing states.

Keywords: Dynamics, Logistic Operating Curves, Production Logistics, Production Planning and Control

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1474
3846 Characterization of Electrohydrodynamic Force on Dielectric-Barrier-Discharge Plasma Actuator Using Fluid Simulation

Authors: Hiroyuki Nishida, Taku Nonomura, Takashi Abe

Abstract:

Wall-surface jet induced by the dielectric barrier discharge (DBD) has been proposed as an actuator for active flow control in aerodynamic applications. Discharge plasma evolution of the DBD plasma actuator was simulated based on a simple fluid model, in which the electron, one type of positive ion and negative ion were taken into account. Two-dimensional simulation was conducted, and the results are in agreement with the insights obtained from experimental studies. The simulation results indicate that the discharge mode changes depending on applied voltage slope; when the applied voltage is positive-going with high applied voltage slope, the corona-type discharge mode turns into the streamer-type discharge mode and the threshold voltage slope is around 300 kV/ms in this simulation. The characteristics of the electrohydrodynamic (EHD) force, which is the source of the wall-surface jet, also change depending on the discharge mode; the tentative peak value of the EHD force during the positive-going voltage phase is saturated by the periodical formation of the streamer-type discharge.

Keywords: Dielectric barrier discharge, Plasma actuator, Fluid simulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2429
3845 CFD Simulation of Non-Newtonian Fluid Flow in Arterial Stenoses with Surface Irregularities

Authors: R. Manimaran

Abstract:

CFD simulations are carried out in arterial stenoses with 48 % areal occlusion. Non-newtonian fluid model is selected for the blood flow as the same problem has been solved before with Newtonian fluid model. Studies on flow resistance with the presence of surface irregularities are carried out. Investigations are also performed on the pressure drop at various Reynolds numbers. The present study revealed that the pressure drop across a stenosed artery is practically unaffected by surface irregularities at low Reynolds numbers, while flow features are observed and discussed at higher Reynolds numbers.

Keywords: Blood flow, Roughness, Computational fluid dynamics, Bio fluid mechanics.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 4455
3844 AGENTMAP: A Conceptual Meta-Model of Interacting Simulations

Authors: Thomas M. Prinz Wilhelm R. Rossak, Kai Gebhardt

Abstract:

A straightforward and intuitive combination of single simulations into an aggregated master-simulation is not trivial. There are lots of problems, which trigger-specific difficulties during the modeling and execution of such a simulation. In this paper we identify these problems and aim to solve them by mapping the task to the field of multi agent systems. The solution is a new meta-model named AGENTMAP, which is able to mitigate most of the problems and to support intuitive modeling at the same time. This meta-model will be introduced and explained on basis of an example from the e-commerce domain.

Keywords: Multi Agent System, Agent-based Simulation, Distributed Systems, Meta-models.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1842
3843 Stabilization of a New Configurable Two- Wheeled Machine Using a PD-PID and a Hybrid FL Control Strategies: A Comparative Study

Authors: M. Almeshal, M. O. Tokhi, K. M. Goher

Abstract:

A novel design of two-wheeled robotic vehicle with moving payload is presented in this paper. A mathematical model describing the vehicle dynamics is derived and simulated in Matlab Simulink environment. Two control strategies were developed to stabilise the vehicle in the upright position. A robust Proportional- Integral-Derivative (PID) control strategy has been implemented and initially tested to measure the system performance, while the second control strategy is to use a hybrid fuzzy logic controller (FLC). The results are given on a comparative basis for the system performance in terms of disturbance rejection, control algorithms robustness as well as the control effort in terms of input torque.

Keywords: double inverted pendulum, modelling, robust control, simulation,

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1505
3842 A New Method for Rapid DNA Extraction from Artemia (Branchiopoda, Crustacea)

Authors: R. Manaffar, R. Maleki, S. Zare, N. Agh, S. Soltanian, B. Sehatnia, P. Sorgeloos, P. Bossier, G. Van Stappen

Abstract:

Artemia is one of the most conspicuous invertebrates associated with aquaculture. It can be considered as a model organism, offering numerous advantages for comprehensive and multidisciplinary studies using morphologic or molecular methods. Since DNA extraction is an important step of any molecular experiment, a new and a rapid method of DNA extraction from adult Artemia was described in this study. Besides, the efficiency of this technique was compared with two widely used alternative techniques, namely Chelex® 100 resin and SDS-chloroform methods. Data analysis revealed that the new method is the easiest and the most cost effective method among the other methods which allows a quick and efficient extraction of DNA from the adult animal.

Keywords: APD, Artemia, DNA extraction, Molecularexperiments

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3153
3841 MONARC: A Case Study on Simulation Analysis for LHC Activities

Authors: Ciprian Dobre

Abstract:

The scale, complexity and worldwide geographical spread of the LHC computing and data analysis problems are unprecedented in scientific research. The complexity of processing and accessing this data is increased substantially by the size and global span of the major experiments, combined with the limited wide area network bandwidth available. We present the latest generation of the MONARC (MOdels of Networked Analysis at Regional Centers) simulation framework, as a design and modeling tool for large scale distributed systems applied to HEP experiments. We present simulation experiments designed to evaluate the capabilities of the current real-world distributed infrastructure to support existing physics analysis processes and the means by which the experiments bands together to meet the technical challenges posed by the storage, access and computing requirements of LHC data analysis within the CMS experiment.

Keywords: Modeling and simulation, evaluation, large scale distributed systems, LHC experiments, CMS.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1779
3840 Modeling and Simulation of Two-Phase Interleaved Boost Converter Using Open-Source Software Scilab/Xcos

Authors: Yin Yin Phyo, Tun Lin Naing

Abstract:

This paper investigated the simulation of two-phase interleaved boost converter (IBC) with free and open-source software Scilab/Xcos. By using interleaved method, it can reduce current stress on components, components size, input current ripple and output voltage ripple. The required mathematical model is obtained from the equivalent circuit of its different four modes of operation for simulation. The equivalent circuits are considered in continuous conduction mode (CCM). The average values of the system variables are derived from the state-space equation to find the equilibrium point. Scilab is now becoming more and more popular among students, engineers and scientists because it is open-source software and free of charge. It gives a great convenience because it has powerful computation and simulation function. The waveforms of output voltage, input current and inductors current are obtained by using Scilab/Xcos.

Keywords: Two-phase boost converter, continuous conduction mode, free and open-source, interleaved method, dynamic simulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 899
3839 Evaluation of Hydrocarbons in Tissues of Bivalve Mollusks from the Red Sea Coast

Authors: A. Aljohani, M. Orif

Abstract:

The concentration of polycyclic aromatic hydrocarbons (PAH) in clams (A. glabrata) was examined in samples collected from Alseef Beach, 30 km south of Jeddah city. Gas chromatography-mass spectrometry (GC-MS) was used to analyze the 14 PAHs. The concentration of total PAHs was found to range from 11.521 to 40.149 ng/gdw with a mean concentration of 21.857 ng/gdw, which is lower compared to similar studies. The lower molecular weight PAHs with three rings comprised 18.14% of the total PAH concentrations in the clams, while the high molecular weight PAHs with four rings, five rings, and six rings account for 81.86%. Diagnostic ratios for PAH source distinction suggested pyrogenic or anthropogenic sources.

Keywords: Bivalves, biomonitoring, hydrocarbons, PAHs.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 119
3838 Design of Nonlinear Robust Control in a Class of Structurally Stable Functions

Authors: V. Ten

Abstract:

An approach of design of stable of control systems with ultimately wide ranges of uncertainly disturbed parameters is offered. The method relies on using of nonlinear structurally stable functions from catastrophe theory as controllers. Theoretical part presents an analysis of designed nonlinear second-order control systems. As more important the integrators in series, canonical controllable form and Jordan forms are considered. The analysis resumes that due to added controllers systems become stable and insensitive to any disturbance of parameters. Experimental part presents MATLAB simulation of design of control systems of epidemic spread, aircrafts angular motion and submarine depth. The results of simulation confirm the efficiency of offered method of design. KeywordsCatastrophes, robust control, simulation, uncertain parameters.

Keywords: Catastrophes, robust control, simulation, uncertain parameters.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1262
3837 Sliding Mode Control Based on Backstepping Approach for an UAV Type-Quadrotor

Authors: H. Bouadi, M. Bouchoucha, M. Tadjine

Abstract:

In this paper; we are interested principally in dynamic modelling of quadrotor while taking into account the high-order nonholonomic constraints in order to develop a new control scheme as well as the various physical phenomena, which can influence the dynamics of a flying structure. These permit us to introduce a new state-space representation. After, the use of Backstepping approach for the synthesis of tracking errors and Lyapunov functions, a sliding mode controller is developed in order to ensure Lyapunov stability, the handling of all system nonlinearities and desired tracking trajectories. Finally simulation results are also provided in order to illustrate the performances of the proposed controller.

Keywords: Dynamic modeling, nonholonomic constraints, Backstepping, sliding mode.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 5785
3836 More Realistic Model for Simulating Min Protein Dynamics: Lattice Boltzmann Method Incorporating the Role of Nucleoids

Authors: J.Yojina, W. Ngamsaad, N. Nuttavut, D.Triampo, Y. Lenbury, W. Triampo, P. Kanthang, S.Sriyab

Abstract:

The dynamics of Min proteins plays a center role in accurate cell division. Although the nucleoids may presumably play an important role in prokaryotic cell division, there is a lack of models to account for its participation. In this work, we apply the lattice Boltzmann method to investigate protein oscillation based on a mesoscopic model that takes into account the nucleoid-s role. We found that our numerical results are in reasonably good agreement with the previous experimental results On comparing with the other computational models without the presence of nucleoids, the highlight of our finding is that the local densities of MinD and MinE on the cytoplasmic membrane increases, especially along the cell width, when the size of the obstacle increases, leading to a more distinct cap-like structure at the poles. This feature indicated the realistic pattern and reflected the combination of Min protein dynamics and nucleoid-s role.

Keywords: lattice Boltzmann method, cell division, Minproteins oscillation, nucleoid

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1216
3835 Chaotic Properties of Hemodynamic Responsein Functional Near Infrared Spectroscopic Measurement of Brain Activity

Authors: Ni Ni Soe , Masahiro Nakagawa

Abstract:

Functional near infrared spectroscopy (fNIRS) is a practical non-invasive optical technique to detect characteristic of hemoglobin density dynamics response during functional activation of the cerebral cortex. In this paper, fNIRS measurements were made in the area of motor cortex from C4 position according to international 10-20 system. Three subjects, aged 23 - 30 years, were participated in the experiment. The aim of this paper was to evaluate the effects of different motor activation tasks of the hemoglobin density dynamics of fNIRS signal. The chaotic concept based on deterministic dynamics is an important feature in biological signal analysis. This paper employs the chaotic properties which is a novel method of nonlinear analysis, to analyze and to quantify the chaotic property in the time series of the hemoglobin dynamics of the various motor imagery tasks of fNIRS signal. Usually, hemoglobin density in the human brain cortex is found to change slowly in time. An inevitable noise caused by various factors is to be included in a signal. So, principle component analysis method (PCA) is utilized to remove high frequency component. The phase pace is reconstructed and evaluated the Lyapunov spectrum, and Lyapunov dimensions. From the experimental results, it can be conclude that the signals measured by fNIRS are chaotic.

Keywords: Chaos, hemoglobin, Lyapunov spectrum, motorimagery, near infrared spectroscopy (NIRS), principal componentanalysis (PCA).

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1697
3834 Obtaining Constants of Johnson-Cook Material Model Using a Combined Experimental, Numerical Simulation and Optimization Method

Authors: F. Rahimi Dehgolan, M. Behzadi, J. Fathi Sola

Abstract:

In this article, the Johnson-Cook material model’s constants for structural steel ST.37 have been determined by a method which integrates experimental tests, numerical simulation, and optimization. In the first step, a quasi-static test was carried out on a plain specimen. Next, the constants were calculated for it by minimizing the difference between the results acquired from the experiment and numerical simulation. Then, a quasi-static tension test was performed on three notched specimens with different notch radii. At last, in order to verify the results, they were used in numerical simulation of notched specimens and it was observed that experimental and simulation results are in good agreement. Changing the diameter size of the plain specimen in the necking area was set as the objective function in the optimization step. For final validation of the proposed method, diameter variation was considered as a parameter and its sensitivity to a change in any of the model constants was examined and the results were completely corroborating.

Keywords: Constants, Johnson-Cook material model, notched specimens, quasi-static test, sensitivity.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3570
3833 Improved Fuzzy Neural Modeling for Underwater Vehicles

Authors: O. Hassanein, Sreenatha G. Anavatti, Tapabrata Ray

Abstract:

The dynamics of the Autonomous Underwater Vehicles (AUVs) are highly nonlinear and time varying and the hydrodynamic coefficients of vehicles are difficult to estimate accurately because of the variations of these coefficients with different navigation conditions and external disturbances. This study presents the on-line system identification of AUV dynamics to obtain the coupled nonlinear dynamic model of AUV as a black box. This black box has an input-output relationship based upon on-line adaptive fuzzy model and adaptive neural fuzzy network (ANFN) model techniques to overcome the uncertain external disturbance and the difficulties of modelling the hydrodynamic forces of the AUVs instead of using the mathematical model with hydrodynamic parameters estimation. The models- parameters are adapted according to the back propagation algorithm based upon the error between the identified model and the actual output of the plant. The proposed ANFN model adopts a functional link neural network (FLNN) as the consequent part of the fuzzy rules. Thus, the consequent part of the ANFN model is a nonlinear combination of input variables. Fuzzy control system is applied to guide and control the AUV using both adaptive models and mathematical model. Simulation results show the superiority of the proposed adaptive neural fuzzy network (ANFN) model in tracking of the behavior of the AUV accurately even in the presence of noise and disturbance.

Keywords: AUV, AUV dynamic model, fuzzy control, fuzzy modelling, adaptive fuzzy control, back propagation, system identification, neural fuzzy model, FLNN.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2119
3832 Study on Optimization of Air Infiltration at Entrance of a Commercial Complex in Zhejiang Province

Authors: Yujie Zhao, Jiantao Weng

Abstract:

In the past decade, with the rapid development of China's economy, the purchasing power and physical demand of residents have been improved, which results in the vast emergence of public buildings like large shopping malls. However, the architects usually focus on the internal functions and streamlines of these buildings, ignoring the impact of the environment on the subjective feelings of building users. Only in Zhejiang province, the infiltration of cold air in winter frequently occurs at the entrance of sizeable commercial complex buildings that have been in operation, which will affect the environmental comfort of the building lobby and internal public spaces. At present, to reduce these adverse effects, it is usually adopted to add active equipment, such as setting air curtains to block air exchange or adding heating air conditioners. From the perspective of energy consumption, the infiltration of cold air into the entrance will increase the heat consumption of indoor heating equipment, which will indirectly cause considerable economic losses during the whole winter heating stage. Therefore, it is of considerable significance to explore the suitable entrance forms for improving the environmental comfort of commercial buildings and saving energy. In this paper, a commercial complex with apparent cold air infiltration problem in Hangzhou is selected as the research object to establish a model. The environmental parameters of the building entrance, including temperature, wind speed, and infiltration air volume, are obtained by Computational Fluid Dynamics (CFD) simulation, from which the heat consumption caused by the natural air infiltration in the winter and its potential economic loss is estimated as the objective metric. This study finally obtains the optimization direction of the building entrance form of the commercial complex by comparing the simulation results of other local commercial complex projects with different entrance forms. The conclusions will guide the entrance design of the same type of commercial complex in this area.

Keywords: Air infiltration, commercial complex, heat consumption, CFD simulation.

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