Search results for: compressible lattice Boltzmann method
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 18639

Search results for: compressible lattice Boltzmann method

18369 Influence of Optimization Method on Parameters Identification of Hyperelastic Models

Authors: Bale Baidi Blaise, Gilles Marckmann, Liman Kaoye, Talaka Dya, Moustapha Bachirou, Gambo Betchewe, Tibi Beda

Abstract:

This work highlights the capabilities of particles swarm optimization (PSO) method to identify parameters of hyperelastic models. The study compares this method with Genetic Algorithm (GA) method, Least Squares (LS) method, Pattern Search Algorithm (PSA) method, Beda-Chevalier (BC) method and the Levenberg-Marquardt (LM) method. Four classic hyperelastic models are used to test the different methods through parameters identification. Then, the study compares the ability of these models to reproduce experimental Treloar data in simple tension, biaxial tension and pure shear.

Keywords: particle swarm optimization, identification, hyperelastic, model

Procedia PDF Downloads 135
18368 First Principle Studies on the Structural, Electronic and Magnetic Properties of Some BaMn-Based Double Perovskites

Authors: Amel Souidi, S. Bentata, B. Bouadjemi, T. Lantri, Z. Aziz

Abstract:

Perovskite materials which include magnetic elements have relevance due to the technological perspectives in the spintronics industry. In this work, we have investigated the structural, electronic and magnetic properties of double perovskites Ba2MnXO6 with X= Mo and W by using the full-potential linearized augmented plane wave (FP-LAPW) method based on Density Functional Theory (DFT) [1, 2] as implemented in the WIEN2K [3] code. The interchange-correlation potential was included through the generalized gradient approximation (GGA) [4] as well as taking into account the on-site coulomb repulsive interaction in (GGA+U) approach. We have analyzed the structural parameters, charge and spin densities, total and partial densities of states. The results show that the materials crystallize in the 225 space group (Fm-3m) and have a lattice parameter of about 7.97 Å and 7.95 Å for Ba2MnMoO6 and Ba2MnWO6, respectively. The band structures reveal a metallic ferromagnetic (FM) ground state in Ba2MnMoO6 and half-metallic (HM) ferromagnetic (FM) ground state in the Ba2MnWO6 compound, with total magnetic moment equal 2.9951μB (Ba2MnMoO6 ) and 4.0001μB (Ba2MnWO6 ). The GGA+U calculations predict an energy gap in the spin-up bands in Ba2MnWO6. So we estimate that this material with HM-FM nature implies a promising application in spin-electronics technology.

Keywords: double perovskites, electronic structure, first-principles, semiconductors

Procedia PDF Downloads 335
18367 Density functional (DFT), Study of the Structural and Phase Transition of ThC and ThN: LDA vs GGA Computational

Authors: Hamza Rekab Djabri, Salah Daoud

Abstract:

The present paper deals with the computational of structural and electronic properties of ThC and ThN compounds using density functional theory within generalized-gradient (GGA) apraximation and local density approximation (LDA). We employ the full potential linear muffin-tin orbitals (FP-LMTO) as implemented in the Lmtart code. We have used to examine structure parameter in eight different structures such as in NaCl (B1), CsCl (B2), ZB (B3), NiAs (B8), PbO (B10), Wurtzite (B4) , HCP (A3) βSn (A5) structures . The equilibrium lattice parameter, bulk modulus, and its pressure derivative were presented for all calculated phases. The calculated ground state properties are in good agreement with available experimental and theoretical results.

Keywords: DFT, GGA, LDA, properties structurales, ThC, ThN

Procedia PDF Downloads 66
18366 Unsteadiness Effects on Variable Thrust Nozzle Performance

Authors: A. M. Tahsini, S. Tadayon Mousavi

Abstract:

The purpose of this paper is to elucidate the flow unsteady behavior for moving plug in convergent-divergent variable thrust nozzle. Compressible axisymmetric Navier-Stokes equations are used to study this physical phenomenon. Different velocities are set for plug to investigate the effect of plug movement on flow unsteadiness. Variation of mass flow rate and thrust are compared under two conditions: First, the plug is placed at different positions and flow is simulated to reach the steady state (quasi steady simulation) and second, the plug is moved with assigned velocity and flow simulation is coupled with plug movement (unsteady simulation). If plug speed is high enough and its movement time scale is at the same order of the flow time scale, variation of the mass flow rate and thrust level versus plug position demonstrate a vital discrepancy under the quasi steady and unsteady conditions. This phenomenon should be considered especially from response time viewpoints in thrusters design.

Keywords: nozzle, numerical study, unsteady, variable thrust

Procedia PDF Downloads 320
18365 Mathematical Reconstruction of an Object Image Using X-Ray Interferometric Fourier Holography Method

Authors: M. K. Balyan

Abstract:

The main principles of X-ray Fourier interferometric holography method are discussed. The object image is reconstructed by the mathematical method of Fourier transformation. The three methods are presented – method of approximation, iteration method and step by step method. As an example the complex amplitude transmission coefficient reconstruction of a beryllium wire is considered. The results reconstructed by three presented methods are compared. The best results are obtained by means of step by step method.

Keywords: dynamical diffraction, hologram, object image, X-ray holography

Procedia PDF Downloads 361
18364 Modified Approximation Methods for Finding an Optimal Solution for the Transportation Problem

Authors: N. Guruprasad

Abstract:

This paper presents a modification of approximation method for transportation problems. The initial basic feasible solution can be computed using either Russel's or Vogel's approximation methods. Russell’s approximation method provides another excellent criterion that is still quick to implement on a computer (not manually) In most cases Russel's method yields a better initial solution, though it takes longer than Vogel's method (finding the next entering variable in Russel's method is in O(n1*n2), and in O(n1+n2) for Vogel's method). However, Russel's method normally has a lesser total running time because less pivots are required to reach the optimum for all but small problem sizes (n1+n2=~20). With this motivation behind we have incorporated a variation of the same – what we have proposed it has TMC (Total Modified Cost) to obtain fast and efficient solutions.

Keywords: computation, efficiency, modified cost, Russell’s approximation method, transportation, Vogel’s approximation method

Procedia PDF Downloads 494
18363 Steepest Descent Method with New Step Sizes

Authors: Bib Paruhum Silalahi, Djihad Wungguli, Sugi Guritman

Abstract:

Steepest descent method is a simple gradient method for optimization. This method has a slow convergence in heading to the optimal solution, which occurs because of the zigzag form of the steps. Barzilai and Borwein modified this algorithm so that it performs well for problems with large dimensions. Barzilai and Borwein method results have sparked a lot of research on the method of steepest descent, including alternate minimization gradient method and Yuan method. Inspired by previous works, we modified the step size of the steepest descent method. We then compare the modification results against the Barzilai and Borwein method, alternate minimization gradient method and Yuan method for quadratic function cases in terms of the iterations number and the running time. The average results indicate that the steepest descent method with the new step sizes provide good results for small dimensions and able to compete with the results of Barzilai and Borwein method and the alternate minimization gradient method for large dimensions. The new step sizes have faster convergence compared to the other methods, especially for cases with large dimensions.

Keywords: steepest descent, line search, iteration, running time, unconstrained optimization, convergence

Procedia PDF Downloads 514
18362 Simulation of 1D Dielectric Barrier Discharge in Argon Mixtures

Authors: Lucas Wilman Crispim, Patrícia Hallack, Maikel Ballester

Abstract:

This work aims at modeling electric discharges in gas mixtures. The mathematical model mimics the ignition process in a commercial spark-plug when a high voltage is applied to the plug terminals. A longitudinal unidimensional Cartesian domain is chosen for the simulation region. Energy and mass transfer are considered for a macroscopic fluid representation, while energy transfer in molecular collisions and chemical reactions are contemplated at microscopic level. The macroscopic model is represented by a set of uncoupled partial differential equations. Microscopic effects are studied within a discrete model for electronic and molecular collisions in the frame of ZDPlasKin, a plasma modeling numerical tool. The BOLSIG+ solver is employed in solving the electronic Boltzmann equation. An operator splitting technique is used to separate microscopic and macroscopic models. The simulation gas is a mixture of atomic Argon neutral, excited and ionized. Spatial and temporal evolution of such species and temperature are presented and discussed.

Keywords: CFD, electronic discharge, ignition, spark plug

Procedia PDF Downloads 128
18361 Theoretical Study of Structural and Electronic Properties of Matlockite CaFX (X = I and Br) Compounds

Authors: Meriem Harmel, Houari Khachai

Abstract:

The full potential linearized augmented plane wave (FP-LAPW)method within density functional theory is applied to study, for the first time, the structural and electronic properties of CaFI and to compare them with CaFCl and CaFBr, all compounds belonging to the tetragonal PbFCl structure group with space group P4/nmm. We used the generalized gradient approximation (GGA) based on exchange–correlation energy optimization to calculate the total energy and also the Engel– Vosko GGA formalism, which optimizes the corresponding potential for band structure calculations. Ground state properties such as the lattice parameters, c/a ratio, bulk modulus, pressure derivative of the bulk modulus and cohesive energy are calculated, as well as the optimized internal parameters, by relaxing the atomic position in the force directions. The variations of the calculated interatomic distances and angles between different atomic bonds are discussed. CaFCl was found to have a direct band gap at whereas CaFBr and BaFI have indirect band gaps. From these computed bands, all three materials are found to be insulators having band gaps of 6.28, 5.46, and 4.50 eV, respectively. We also calculated the valence charge density and the total density of states at equilibrium volume for each compound. The results are in reasonable agreement with the available experimental data.

Keywords: DFT, matlockite, structural properties, electronic structure

Procedia PDF Downloads 289
18360 Ab Initio Study of Co2ZrGe and Co2NbB Full Heusler Compounds

Authors: A. Abada, S. Hiadsi, T. Ouahrani, B. Amrani, K. Amara

Abstract:

Using the first-principles full-potential linearized augmented plane wave plus local orbital (FP-LAPW+lo) method based on density functional theory (DFT), we have investigated the electronic structure and magnetism of some Co2- based full Heusler alloys, namely Co2ZrGe and Co2NbB. The calculations show that these compounds are to be half-metallic ferromagnets (HMFs) with a total magnetic moment of 2.000 µB per formula unit, well consistent with the Slater-Pauling rule. Our calculations show indirect band gaps of 0.58 eV and 0.47 eV in the minority spin channel of density of states (DOS) for Co2ZrGe and Co2NbB, respectively. Analysis of the DOS and magnetic moments indicates that their magnetism is mainly related to the d-d hybridization between the Co and Zr (or Nb) atoms. The half metallicity is found to be robust against volume changes and the two alloys kept a 100% of spin polarization at the Fermi level. In addition, an atom inside molecule AIM formalism and an electron localization function ELF were also adopted to study the bonding properties of these compounds, building a bridge between their electronic and bonding behavior. As they have a good crystallographic compatibility with the lattice of semiconductors used industrially and negative calculated cohesive energies with considerable absolute values these two alloys could be promising magnetic materials in the spintronics field.

Keywords: half-metallic ferromagnets, full Heusler alloys, magnetic properties, electronic properties

Procedia PDF Downloads 378
18359 Downscaling Daily Temperature with Neuroevolutionary Algorithm

Authors: Min Shi

Abstract:

State of the art research with Artificial Neural Networks for the downscaling of General Circulation Models (GCMs) mainly uses back-propagation algorithm as a training approach. This paper introduces another training approach of ANNs, Evolutionary Algorithm. The combined algorithm names neuroevolutionary (NE) algorithm. We investigate and evaluate the use of the NE algorithms in statistical downscaling by generating temperature estimates at interior points given information from a lattice of surrounding locations. The results of our experiments indicate that NE algorithms can be efficient alternative downscaling methods for daily temperatures.

Keywords: temperature, downscaling, artificial neural networks, evolutionary algorithms

Procedia PDF Downloads 318
18358 The Modification of the Mixed Flow Pump with Respect to Stability of the Head Curve

Authors: Roman Klas, František Pochylý, Pavel Rudolf

Abstract:

This paper is focused on the CFD simulation of the radiaxial pump (i.e. mixed flow pump) with the aim to detect the reasons of Y-Q characteristic instability. The main reasons of pressure pulsations were detected by means of the analysis of velocity and pressure fields within the pump combined with the theoretical approach. Consequently, the modifications of spiral case and pump suction area were made based on the knowledge of flow conditions and the shape of dissipation function. The primary design of pump geometry was created as the base model serving for the comparison of individual modification influences. The basic experimental data are available for this geometry. This approach replaced the more complicated and with respect to convergence of all computational tasks more difficult calculation for the compressible liquid flow. The modification of primary pump consisted in inserting the three fins types. Subsequently, the evaluation of pressure pulsations, specific energy curves and visualization of velocity fields were chosen as the criterion for successful design.

Keywords: CFD, radiaxial pump, spiral case, stability

Procedia PDF Downloads 364
18357 Mechanical Properties of Ternary Metal Nitride Ti1-xTaxN Alloys from First-Principles

Authors: M. Benhamida, Kh. Bouamama, P. Djemia

Abstract:

We investigate by first-principles pseudo-potential calculations the composition dependence of lattice parameter, hardness and elastic properties of ternary disordered solid solutions Ti(1-x)Ta(x)N (1>=x>=0) with B1-rocksalt structure. Calculations use the coherent potential approximation with the exact muffin-tin orbitals (EMTO) and hardness formula for multicomponent covalent solid solution proposed. Bulk modulus B shows a nearly linear behaviour whereas not C44 and C’=(C11-C12)/2 that are not monotonous. Influences of vacancies on hardness of off-stoichiometric transition-metal nitrides TiN(1−x) and TaN(1−x) are also considered.

Keywords: transition metal nitride materials, elastic constants, hardness, EMTO

Procedia PDF Downloads 399
18356 Electronic and Optical Properties of YNi4Si-Type DyNi4Si Compound: A Full Potential Study

Authors: Dinesh Kumar Maurya, Sapan Mohan Saini

Abstract:

A theoretical formalism to calculate the structural, electronic and optical properties of orthorhombic crystals from first principle calculations is described. This is applied first time to new YNi4Si-type DyNi4Si compound. Calculations are performed using full-potential augmented plane wave (FPLAPW) method in the framework of density functional theory (DFT). The Coulomb corrected local-spin density approximation (LSDA+U) in the self-interaction correction (SIC) has been used for exchange-correlation potential. Our optimized results of lattice parameters show good agreement to the previously reported experimental study. Analysis of the calculated band structure of DyNi4Si compound demonstrates their metallic character. We found Ni-3d states mainly contribute to density of states from -5.0 eV to the Fermi level while the Dy-f states peak stands tall in comparison to the small contributions made by the Ni-d and R-d states above Fermi level, which is consistent with experiment, in DNi4Si compound. Our calculated optical conductivity compares well with the experimental data and the results are analyzed in the light of band-to-band transitions. We also report the frequency-dependent refractive index n(ω) and the extinction coefficient k(ω) of the compound.

Keywords: band structure, density of states, optical properties, LSDA+U approximation, YNi4Si- type DyNi4Si compound

Procedia PDF Downloads 326
18355 Structural and Electronic Properties of the Rock-salt BaxSr1−xS Alloys

Authors: B. Bahloul, K. Babesse, A. Dkhira, Y. Bahloul, L. Amirouche

Abstract:

Structural and electronic properties of the rock-salt BaxSr1−xS are calculated using the first-principles calculations based on the density functional theory (DFT) within the generalized gradient approximation (GGA), the local density approximation (LDA) and the virtual-crystal approximation (VCA). The calculated lattice parameters at equilibrium volume for x=0 and x=1 are in good agreement with the literature data. The BaxSr1−xS alloys are found to be an indirect band gap semiconductor. Moreoever, for the composition (x) ranging between [0-1], we think that our results are well discussed and well predicted.

Keywords: semiconductor, Ab initio calculations, rocksalt, band structure, BaxSr1−xS

Procedia PDF Downloads 363
18354 Calculating Stress Intensity Factor of Cracked Axis by Using a Meshless Method

Authors: S. Shahrooi, A. Talavari

Abstract:

Numeral study on the crack and discontinuity using element-free methods has been widely spread in recent years. In this study, for stress intensity factor calculation of the cracked axis under torsional loading has been used from a new element-free method as MLPG method. Region range is discretized by some dispersed nodal points. From method of moving least square (MLS) utilized to create the functions using these nodal points. Then, results of meshless method and finite element method (FEM) were compared. The results is shown which the element-free method was of good accuracy.

Keywords: stress intensity factor, crack, torsional loading, meshless method

Procedia PDF Downloads 531
18353 Grid Based Traffic Vulnerability Model Using Betweenness Centrality for Urban Disaster Management Information

Authors: Okyu Kwon, Dongho Kang, Byungsik Kim, Seungkwon Jung

Abstract:

We propose a technique to measure the impact of loss of traffic function in a particular area to surrounding areas. The proposed method is applied to the city of Seoul, which is the capital of South Korea, with a population of about ten million. Based on the actual road network in Seoul, we construct an abstract road network between 1kmx1km grid cells. The link weight of the abstract road network is re-adjusted considering traffic volume measured at several survey points. On the modified abstract road network, we evaluate the traffic vulnerability by calculating a network measure of betweenness centrality (BC) for every single grid cells. This study analyzes traffic impacts caused by road dysfunction due to heavy rainfall in urban areas. We could see the change of the BC value in all other grid cells by calculating the BC value once again when the specific grid cell lost its traffic function, that is, when the node disappeared on the grid-based road network. The results show that it is appropriate to use the sum of the BC variation of other cells as the influence index of each lattice cell on traffic. This research was supported by a grant (2017-MOIS31-004) from Fundamental Technology Development Program for Extreme Disaster Response funded by Korean Ministry of Interior and Safety (MOIS).

Keywords: vulnerability, road network, beweenness centrality, heavy rainfall, road impact

Procedia PDF Downloads 63
18352 Effect of Velocity-Slip in Nanoscale Electroosmotic Flows: Molecular and Continuum Transport Perspectives

Authors: Alper T. Celebi, Ali Beskok

Abstract:

Electroosmotic (EO) slip flows in nanochannels are investigated using non-equilibrium molecular dynamics (MD) simulations, and the results are compared with analytical solution of Poisson-Boltzmann and Stokes (PB-S) equations with slip contribution. The ultimate objective of this study is to show that well-known continuum flow model can accurately predict the EO velocity profiles in nanochannels using the slip lengths and apparent viscosities obtained from force-driven flow simulations performed at various liquid-wall interaction strengths. EO flow of aqueous NaCl solution in silicon nanochannels are simulated under realistic electrochemical conditions within the validity region of Poisson-Boltzmann theory. A physical surface charge density is determined for nanochannels based on dissociations of silanol functional groups on channel surfaces at known salt concentration, temperature and local pH. First, we present results of density profiles and ion distributions by equilibrium MD simulations, ensuring that the desired thermodynamic state and ionic conditions are satisfied. Next, force-driven nanochannel flow simulations are performed to predict the apparent viscosity of ionic solution between charged surfaces and slip lengths. Parabolic velocity profiles obtained from force-driven flow simulations are fitted to a second-order polynomial equation, where viscosity and slip lengths are quantified by comparing the coefficients of the fitted equation with continuum flow model. Presence of charged surface increases the viscosity of ionic solution while the velocity-slip at wall decreases. Afterwards, EO flow simulations are carried out under uniform electric field for different liquid-wall interaction strengths. Velocity profiles present finite slips near walls, followed with a conventional viscous flow profile in the electrical double layer that reaches a bulk flow region in the center of the channel. The EO flow enhances with increased slip at the walls, which depends on wall-liquid interaction strength and the surface charge. MD velocity profiles are compared with the predictions from analytical solutions of the slip modified PB-S equation, where the slip length and apparent viscosity values are obtained from force-driven flow simulations in charged silicon nano-channels. Our MD results show good agreements with the analytical solutions at various slip conditions, verifying the validity of PB-S equation in nanochannels as small as 3.5 nm. In addition, the continuum model normalizes slip length with the Debye length instead of the channel height, which implies that enhancement in EO flows is independent of the channel height. Further MD simulations performed at different channel heights also shows that the flow enhancement due to slip is independent of the channel height. This is important because slip enhanced EO flow is observable even in micro-channels experiments by using a hydrophobic channel with large slip and high conductivity solutions with small Debye length. The present study provides an advanced understanding of EO flows in nanochannels. Correct characterization of nanoscale EO slip flow is crucial to discover the extent of well-known continuum models, which is required for various applications spanning from ion separation to drug delivery and bio-fluidic analysis.

Keywords: electroosmotic flow, molecular dynamics, slip length, velocity-slip

Procedia PDF Downloads 114
18351 An Efficient Approach to Optimize the Cost and Profit of a Tea Garden by Using Branch and Bound Method

Authors: Abu Hashan Md Mashud, M. Sharif Uddin, Aminur Rahman Khan

Abstract:

In this paper, we formulate a new problem as a linear programming and Integer Programming problem and maximize profit within the limited budget and limited resources based on the construction of a tea garden problem. It describes a new idea about how to optimize profit and focuses on the practical aspects of modeling and the challenges of providing a solution to a complex real life problem. Finally, a comparative study is carried out among Graphical method, Simplex method and Branch and bound method.

Keywords: integer programming, tea garden, graphical method, simplex method, branch and bound method

Procedia PDF Downloads 579
18350 Synthesis and Characterisation of Bi-Substituted Magnetite Nanoparticles by Mechanochemical Processing (MCP)

Authors: Morteza Mohri Esfahani, Amir S. H. Rozatian, Morteza Mozaffari

Abstract:

Single phase magnetite nanoparticles and Bi-substituted ones were prepared by mechanochemical processing (MCP). The effects of Bi-substitution on the structural and magnetic properties of the nanoparticles were studied by X-ray Diffraction (XRD) and magnetometry techniques, respectively. The XRD results showed that all samples have spinel phase and by increasing Bi content, the main diffraction peaks were shifted to higher angles, which means the lattice parameter decreases from 0.843 to 0.838 nm and then increases to 0.841 nm. Also, the results revealed that increasing Bi content lead to a decrease in saturation magnetization (Ms) from 74.9 to 48.8 emu/g and an increase in coercivity (Hc) from 96.8 to 137.1 Oe.

Keywords: bi-substituted magnetite nanoparticles, mechanochemical processing, X-ray diffraction, magnetism

Procedia PDF Downloads 504
18349 Investigation of Physical Properties of W-Doped CeO₂ and Mo-Doped CeO₂: A Density Functional Theory Study

Authors: Aicha Bouhlala, Sabah Chettibi

Abstract:

A systematic investigation on structural, electronic, and magnetic properties of Ce₀.₇₅A₀.₂₅O₂ (A = W, Mo) is performed using first-principles calculations within the framework Full-Potential Linear Augmented Plane Wave (FP-LAPW) method based on the Density Functional Theory (DFT). The exchange-correlation potential has been treated using the generalized gradient approximation (WC-GGA) developed by Wu-Cohen. The host compound CeO2 was doped with transition metal atoms W and Mo in the doping concentration of 25% to replace the Ce atom. In structural properties, the equilibrium lattice constant is observed for the W-doped CeO₂ compound which exists within the value of 5.314 A° and the value of 5.317 A° for Mo-doped CeO2. The present results show that Ce₀.₇₅A₀.₂₅O₂ (A=W, Mo) systems exhibit semiconducting behavior in both spin channels. Although undoped CeO₂ is a non-magnetic semiconductor. The band structure of these doped compounds was plotted and they exhibit direct band gap at the Fermi level (EF) in the majority and minority spin channels. In the magnetic properties, the doped atoms W and Mo play a vital role in increasing the magnetic moments of the supercell and the values of the total magnetic moment are found to be 1.998 μB for Ce₀.₇₅W₀.₂₅O₂ and to be 2.002 μB for Ce₀.₇₅Mo₀.₂₅O₂ compounds. Calculated results indicate that the magneto-electronic properties of the Ce₁₋ₓAₓO₂(A= W, Mo) oxides supply a new way to the experimentalist for the potential applications in spintronics devices.

Keywords: FP-LAPW, DFT, CeO₂, properties

Procedia PDF Downloads 184
18348 Understanding Magnetic Properties of Cd1-xSnxCr2Se4 Using Local Structure Probes

Authors: P. Suchismita Behera, V. G. Sathe, A. K. Nigam, P. A. Bhobe

Abstract:

Co-existence of long-range ferromagnetism and semi-conductivity with correlated behavior of structural, magnetic, optical and electrical properties in various sites doping at CdCr2Se4 makes it a most promising candidate for spin-based electronic applications and magnetic devices. It orders ferromagnetically below TC = 130 K with a direct band gap of ~ 1.5 eV. The magnetic ordering is believed to result from strong competition between the direct antiferromagnetic Cr-Cr spin couplings and the ferromagnetic Cr-Se-Cr exchange interactions. With an aim of understanding the influence of crystal structure on its magnetic properties without disturbing the magnetic site, we investigated four compositions with 3%, 5%, 7% and 10% of Sn-substitution at Cd-site. Partial substitution of Cd2+ (0.78Å) by small sized nonmagnetic ion, Sn4+ (0.55Å), is expected to bring about local lattice distortion as well as a change in electronic charge distribution. The structural disorder would affect the Cd/Sn – Se bonds thus affecting the Cr-Cr and Cr-Se-Cr bonds. Whereas, the charge imbalance created due to Sn4+ substitution at Cd2+ leads to the possibility of Cr mixed valence state. Our investigation of the local crystal structure using the EXAFS, Raman spectroscopy and magnetic properties using SQUID magnetometry of the Cd1-xSnxCr2Se4 series reflects this premise. All compositions maintain the Fd3m cubic symmetry with tetrahedral distribution of Sn at Cd-site, as confirmed by XRD analysis. Lattice parameters were determined from the Rietveld refinement technique of the XRD data and further confirmed from the EXAFS spectra recorded at Cr K-edge. Presence of five Raman-active phonon vibrational modes viz. (T2g (1), T2g (2), T2g (3), Eg, A1g) in the Raman spectra further confirms the crystal symmetry. Temperature dependence of the Raman data provides interesting insight to the spin– phonon coupling, known to dominate the magneto-capacitive properties in the parent compound. Below the magnetic ordering temperature, the longitudinal damping of Eg mode associated with Se-Cd/Sn-Se bending and T2g (2) mode associated to Cr-Se-Cr interaction, show interesting deviations with respect to increase in Sn substitution. Besides providing the estimate of TC, the magnetic measurements recorded as a function of field provide the values of total magnetic moment for all the studied compositions indicative of formation of multiple Cr valences.

Keywords: exchange interactions, EXAFS, ferromagnetism, Raman spectroscopy, spinel chalcogenides

Procedia PDF Downloads 245
18347 Investigation of Adaptable Winglets for Improved UAV Control and Performance

Authors: E. Kaygan, A. Gatto

Abstract:

An investigation of adaptable winglets for morphing aircraft control and performance is described in this paper. The concepts investigated consist of various winglet configurations fundamentally centred on a baseline swept wing. The impetus for the work was to identify and optimize winglets to enhance controllability and the aerodynamic efficiency of a small unmanned aerial vehicle. All computations were performed with Athena Vortex Lattice modelling with varying degrees of twist, swept, and dihedral angle considered. The results from this work indicate that if adaptable winglets were employed on small scale UAV’s improvements in both aircraft control and performance could be achieved.

Keywords: aircraft, rolling, wing, winglet

Procedia PDF Downloads 432
18346 Thorium-Doped PbS Thin Films for Radiation Damage Studies

Authors: Michael Shandalov, Tzvi Templeman, Michael Schmidt, Itzhak Kelson, Eyal Yahel

Abstract:

We present a new method to produce a model system for the study of radiation damage in non-radioactive materials. The method is based on homogeneously incorporating 228Th ions in PbS thin films using a small volume chemical bath deposition (CBD) technique. The common way to alloy metals with radioactive elements is by melting pure elements, which requires considerable amounts of radioactive material with its safety consequences such as high sample activity. Controlled doping of the thin films with (very) small amounts (100-200ppm) of radioactive elements such as thorium is expected to provide a unique path for studying radiation damage in materials due to decay processes without the need of sealed enclosure. As a first stage, we developed CBD process for controlled doping of PbS thin films (~100 nm thick) with the stable isotope (t1/2~106 years), 232Th. Next, we developed CBD process for controlled doping of PbS thin films with active 228Th isotope. This was achieved by altering deposition parameters such as temperature, pH, reagent concentrations and time. The 228Th-doped films were characterized using X-ray diffraction, which indicated a single phase material. Film morphology and thickness were determined using scanning electron microscopy (SEM). Energy dispersive spectroscopy (EDS) mapping in the analytical transmission electron microscope (A-TEM), X-ray photoelectron spectroscopy (XPS) depth profiles and autoradiography indicated that the Th ions were homogeneously distributed throughout the films, suggesting Pb substitution by Th ions in the crystal lattice. The properties of the PbS (228Th) film activity were investigated by using alpha-spectroscopy and gamma spectroscopy. The resulting films are applicable for isochronal annealing of resistivity measurements and currently under investigation. This work shows promise as a model system for the analysis of dilute defect systems in semiconductor thin films.

Keywords: thin films, doping, radiation damage, chemical bath deposition

Procedia PDF Downloads 359
18345 The Design of a Phase I/II Trial of Neoadjuvant RT with Interdigitated Multiple Fractions of Lattice RT for Large High-grade Soft-Tissue Sarcoma

Authors: Georges F. Hatoum, Thomas H. Temple, Silvio Garcia, Xiaodong Wu

Abstract:

Soft Tissue Sarcomas (STS) represent a diverse group of malignancies with heterogeneous clinical and pathological features. The treatment of extremity STS aims to achieve optimal local tumor control, improved survival, and preservation of limb function. The National Comprehensive Cancer Network guidelines, based on the cumulated clinical data, recommend radiation therapy (RT) in conjunction with limb-sparing surgery for large, high-grade STS measuring greater than 5 cm in size. Such treatment strategy can offer a cure for patients. However, when recurrence occurs (in nearly half of patients), the prognosis is poor, with a median survival of 12 to 15 months and with only palliative treatment options available. The spatially-fractionated-radiotherapy (SFRT), with a long history of treating bulky tumors as a non-mainstream technique, has gained new attention in recent years due to its unconventional therapeutic effects, such as bystander/abscopal effects. Combining single fraction of GRID, the original form of SFRT, with conventional RT was shown to have marginally increased the rate of pathological necrosis, which has been recognized to have a positive correlation to overall survival. In an effort to consistently increase the pathological necrosis rate over 90%, multiple fractions of Lattice RT (LRT), a newer form of 3D SFRT, interdigitated with the standard RT as neoadjuvant therapy was conducted in a preliminary clinical setting. With favorable results of over 95% of necrosis rate in a small cohort of patients, a Phase I/II clinical study was proposed to exam the safety and feasibility of this new strategy. Herein the design of the clinical study is presented. In this single-arm, two-stage phase I/II clinical trial, the primary objectives are >80% of the patients achieving >90% tumor necrosis and to evaluation the toxicity; the secondary objectives are to evaluate the local control, disease free survival and overall survival (OS), as well as the correlation between clinical response and the relevant biomarkers. The study plans to accrue patients over a span of two years. All patient will be treated with the new neoadjuvant RT regimen, in which one of every five fractions of conventional RT is replaced by a LRT fraction with vertices receiving dose ≥10Gy while keeping the tumor periphery at or close to 2 Gy per fraction. Surgical removal of the tumor is planned to occur 6 to 8 weeks following the completion of radiation therapy. The study will employ a Pocock-style early stopping boundary to ensure patient safety. The patients will be followed and monitored for a period of five years. Despite much effort, the rarity of the disease has resulted in limited novel therapeutic breakthroughs. Although a higher rate of treatment-induced tumor necrosis has been associated with improved OS, with the current techniques, only 20% of patients with large, high-grade tumors achieve a tumor necrosis rate exceeding 50%. If this new neoadjuvant strategy is proven effective, an appreciable improvement in clinical outcome without added toxicity can be anticipated. Due to the rarity of the disease, it is hoped that such study could be orchestrated in a multi-institutional setting.

Keywords: lattice RT, necrosis, SFRT, soft tissue sarcoma

Procedia PDF Downloads 33
18344 Size Distribution Effect of InAs/InP Self–Organized Quantum Dots on Optical Properties

Authors: Abdelkader Nouri, M’hamed Bouslama, Faouzi Saidi, Hassan Maaref, Michel Gendry

Abstract:

Self-organized InAs quantum dots (QDs) have been grown on 3,1% InP (110) lattice mismatched substrate by Solid Source Molecular Beam Epitaxy (SSMBE). Stranski-Krastanov mode growth has been used to create self-assembled 3D islands on InAs wetting layer (WL). The optical quality depending on the temperature and power is evaluated. In addition, Atomic Force Microscopy (AFM) images shows inhomogeneous island dots size distribution due to temperature coalescence. The quantum size effect was clearly observed through the spectra photoluminescence (PL) shape.

Keywords: AFM, InAs QDs, PL, SSMBE

Procedia PDF Downloads 651
18343 Sewer Culvert Installation Method to Accommodate Underground Construction in an Urban Area with Narrow Streets

Authors: Osamu Igawa, Hiroshi Kouchiwa, Yuji Ito

Abstract:

In recent years, a reconstruction project for sewer pipelines has been progressing in Japan with the aim of renewing old sewer culverts. However, it is difficult to secure a sufficient base area for shafts in an urban area because many streets are narrow with a complex layout. As a result, construction in such urban areas is generally very demanding. In urban areas, there is a strong requirement for a safe, reliable and economical construction method that does not disturb the public’s daily life and urban activities. With this in mind, we developed a new construction method called the 'shield switching type micro-tunneling method' which integrates the micro-tunneling method and shield method. In this method, pipeline is constructed first for sections that are gently curved or straight using the economical micro-tunneling method, and then the method is switched to the shield method for sections with a sharp curve or a series of curves without establishing an intermediate shaft. This paper provides the information, features and construction examples of this newly developed method.

Keywords: micro-tunneling method, secondary lining applied RC segment, sharp curve, shield method, switching type

Procedia PDF Downloads 368
18342 Direct Transient Stability Assessment of Stressed Power Systems

Authors: E. Popov, N. Yorino, Y. Zoka, Y. Sasaki, H. Sugihara

Abstract:

This paper discusses the performance of critical trajectory method (CTrj) for power system transient stability analysis under various loading settings and heavy fault condition. The method obtains Controlling Unstable Equilibrium Point (CUEP) which is essential for estimation of power system stability margins. The CUEP is computed by applying the CTrjto the boundary controlling unstable equilibrium point (BCU) method. The Proposed method computes a trajectory on the stability boundary that starts from the exit point and reaches CUEP under certain assumptions. The robustness and effectiveness of the method are demonstrated via six power system models and five loading conditions. As benchmark is used conventional simulation method whereas the performance is compared with and BCU Shadowing method.

Keywords: power system, transient stability, critical trajectory method, energy function method

Procedia PDF Downloads 354
18341 Structural and Morphological Study of Europium Doped ZnO

Authors: Abdelhak Nouri

Abstract:

Europium doped zinc oxide nanocolumns (ZnO:Eu) were deposited on indium tin oxide (ITO) substrate from an aqueous solution of 10⁻³M Zn(NO₃)₂ and 0.5M KNO₃ with different concentration of europium ions. The deposition was performed in a classical three-electrode electrochemical cell. The structural, morphology and optical properties have been characterized by x-ray diffraction (XRD), scanning electron microscopy (SEM), atomic force microscopy (AFM). The XRD results show high quality of crystallite with preferential orientation along c-axis. SEM images speculate ZnO: Eu has nanocolumnar form with hexagonal shape. The diameter of nanocolumns is around 230 nm. Furthermore, it was found that tail of crystallite, roughness, and band gap energy is highly influenced with increasing Eu ions concentration. The average grain size is about 102 nm to 125 nm.

Keywords: deterioration lattice, doping, nanostructures, Eu:ZnO

Procedia PDF Downloads 147
18340 Multilevel Two-Phase Structuring in the Nitrogen Supersaturated AISI316 Stainless Steel

Authors: Tatsuhiko Aizawa, Yohei Suzuki, Tomomi Shiratori

Abstract:

The austenitic stainless steel type AISI316 has been widely utilized as structural members and mold die substrates. The low temperature plasma nitriding has been utilized to harden these AISI316 members, parts, and dies without loss of intrinsic corrosion resistance to AISI316 stainless steels. Formation of CrN precipitates by normal plasma nitriding processes resulted in severe deterioration of corrosion toughness. Most previous studies on this low temperature nitriding of AISI316 only described the lattice expansion of original AISI316 lattices by the occupation of nitrogen interstitial solutes into octahedral vacancy sites, the significant hardening by nitrogen solid solution, and the enhancement of corrosion toughness. In addition to those engineering items, this low temperature nitriding process was characterized by the nitrogen supersaturation and nitrogen diffusion processes. The nitrogen supersaturated zones expanded by the nitrogen solute occupation to octahedral vacancy sites, and the un-nitrided surroundings to these zones were plastically strained to compensate for the mismatch strains across these nitrided and nitrided zones. The microstructure of nitrided AISI316 was refined by this plastic straining. The nitrogen diffusion process was enhanced to transport nitrogen solute atoms through the refined zone boundaries. This synergetic collaboration among the nitrogen supersaturation, the lattice expansion, the plastic straining, and the grain refinement yielded a thick nitrogen supersaturated layer. This synergetic relation was also characterized by the multilevel two-phase structuring. In XRD (X-Ray Diffraction) analysis, the nitrided AISI316 layer had - and -phases with the peak shifts from original lattices. After EBSD (Electron Back Scattering Diffraction) analysis, -grains and -grains homogeneously distributed in the nitrided layer. The scanning transmission electron microscopy (STEM) revealed that g-phase zone is N-poor cluster and a-phase zone is N-rich cluster. This proves that nitrogen supersaturated AISI316 stainless steels have multi-level two-phase structure in a very fine granular system.

Keywords: AISI316 stainless steels, chemical affinity to nitrogen solutes, multi-level two-phase structuring, nitrogen supersaturation

Procedia PDF Downloads 69