Search results for: matrix equation
Commenced in January 2007
Frequency: Monthly
Edition: International
Paper Count: 2022

Search results for: matrix equation

1782 Alternating Implicit Block FDTD Method For Scalar Wave Equation

Authors: N. M. Nusi, M. Othman, M. Suleiman, F. Ismail, N. Alias

Abstract:

In this paper, an alternating implicit block method for solving two dimensional scalar wave equation is presented. The new method consist of two stages for each time step implemented in alternating directions which are very simple in computation. To increase the speed of computation, a group of adjacent points is computed simultaneously. It is shown that the presented method increase the maximum time step size and more accurate than the conventional finite difference time domain (FDTD) method and other existing method of natural ordering.

Keywords: FDTD, Scalar wave equation, alternating direction implicit (ADI), alternating group explicit (AGE), asymmetric approximation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1850
1781 Efficient Antenna Array Beamforming with Robustness against Random Steering Mismatch

Authors: Ju-Hong Lee, Ching-Wei Liao, Kun-Che Lee

Abstract:

This paper deals with the problem of using antenna sensors for adaptive beamforming in the presence of random steering mismatch. We present an efficient adaptive array beamformer with robustness to deal with the considered problem. The robustness of the proposed beamformer comes from the efficient designation of the steering vector. Using the received array data vector, we construct an appropriate correlation matrix associated with the received array data vector and a correlation matrix associated with signal sources. Then, the eigenvector associated with the largest eigenvalue of the constructed signal correlation matrix is designated as an appropriate estimate of the steering vector. Finally, the adaptive weight vector required for adaptive beamforming is obtained by using the estimated steering vector and the constructed correlation matrix of the array data vector. Simulation results confirm the effectiveness of the proposed method.

Keywords: Adaptive beamforming, antenna array, linearly constrained minimum variance, robustness, steering vector.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 647
1780 Numerical Solution for Elliptical Crack with Developing Cusps Subject to Shear Loading

Authors: Nik Mohd Asri Nik Long, Koo Lee Feng, Zainidin K. Eshkuvatov, A. A. Khaldjigitov

Abstract:

This paper study the behavior of the solution at the crack edges for an elliptical crack with developing cusps, Ω in the plane elasticity subjected to shear loading. The problem of finding the resulting shear stress can be formulated as a hypersingular integral equation over Ω and it is then transformed into a similar equation over a circular region, D, using conformal mapping. An appropriate collocation points are chosen on the region D to reduce the hypersingular integral equation into a system of linear equations with (2N+1)(N+1) unknown coefficients, which will later be used in the determination of shear stress intensity factors and maximum shear stress intensity. Numerical solution for the considered problem are compared with the existing asymptotic solution, and displayed graphically. Our results give a very good agreement to the existing asymptotic solutions.

Keywords: Elliptical crack, stress intensity factors, hyper singular integral equation, shear loading, conformal mapping.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1650
1779 Parameters Optimization of the Laminated Composite Plate for Sound Transmission Problem

Authors: Yu T. Tsai, Jin H. Huang

Abstract:

In this paper, the specific sound Transmission Loss (TL) of the Laminated Composite Plate (LCP) with different material properties in each layer is investigated. The numerical method to obtain the TL of the LCP is proposed by using elastic plate theory. The transfer matrix approach is novelty presented for computational efficiency in solving the numerous layers of dynamic stiffness matrix (D-matrix) of the LCP. Besides the numerical simulations for calculating the TL of the LCP, the material properties inverse method is presented for the design of a laminated composite plate analogous to a metallic plate with a specified TL. As a result, it demonstrates that the proposed computational algorithm exhibits high efficiency with a small number of iterations for achieving the goal. This method can be effectively employed to design and develop tailor-made materials for various applications.

Keywords: Sound transmission loss, laminated composite plate, transfer matrix approach, inverse problem, elastic plate theory, material properties.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1928
1778 Molecular Docking on Recomposed versus Crystallographic Structures of Zn-Dependent Enzymes and their Natural Inhibitors

Authors: Tudor Petreuş, Andrei Neamţu, Cristina Dascălu, Paul Dan Sîrbu, Carmen E. Cotrutz

Abstract:

Matrix metalloproteinases (MMP) are a class of structural and functional related enzymes involved in altering the natural elements of the extracellular matrix. Most of the MMP structures are cristalographycally determined and published in WorldWide ProteinDataBank, isolated, in full structure or bound to natural or synthetic inhibitors. This study proposes an algorithm to replace missing crystallographic structures in PDB database. We have compared the results of a chosen docking algorithm with a known crystallographic structure in order to validate enzyme sites reconstruction there where crystallographic data are missing.

Keywords: matrix metalloproteinases, molecular docking, structure superposition, surface complementarity.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1562
1777 Color Image Edge Detection using Pseudo-Complement and Matrix Operations

Authors: T. N. Janakiraman, P. V. S. S. R. Chandra Mouli

Abstract:

A color image edge detection algorithm is proposed in this paper using Pseudo-complement and matrix rotation operations. First, pseudo-complement method is applied on the image for each channel. Then, matrix operations are applied on the output image of the first stage. Dominant pixels are obtained by image differencing between the pseudo-complement image and the matrix operated image. Median filtering is carried out to smoothen the image thereby removing the isolated pixels. Finally, the dominant or core pixels occurring in at least two channels are selected. On plotting the selected edge pixels, the final edge map of the given color image is obtained. The algorithm is also tested in HSV and YCbCr color spaces. Experimental results on both synthetic and real world images show that the accuracy of the proposed method is comparable to other color edge detectors. All the proposed procedures can be applied to any image domain and runs in polynomial time.

Keywords: Color edge detection, dominant pixels, matrixrotation/shift operations, pseudo-complement.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2285
1776 Passivity Analysis of Stochastic Neural Networks With Multiple Time Delays

Authors: Biao Qin, Jin Huang, Jiaojiao Ren, Wei Kang

Abstract:

This paper deals with the problem of passivity analysis for stochastic neural networks with leakage, discrete and distributed delays. By using delay partitioning technique, free weighting matrix method and stochastic analysis technique, several sufficient conditions for the passivity of the addressed neural networks are established in terms of linear matrix inequalities (LMIs), in which both the time-delay and its time derivative can be fully considered. A numerical example is given to show the usefulness and effectiveness of the obtained results.

Keywords: Passivity, Stochastic neural networks, Multiple time delays, Linear matrix inequalities (LMIs).

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1660
1775 Finite Element Approximation of the Heat Equation under Axisymmetry Assumption

Authors: Raphael Zanella

Abstract:

This works deals with the finite element approximation of axisymmetric problems. The weak formulation of the heat equation under axisymmetry assumption is established for continuous finite elements. The weak formulation is implemented in a C++ solver with implicit time marching. The code is verified by space and time convergence tests using a manufactured solution. An example problem is solved with an axisymmetric formulation and with a 3D formulation. Both formulations lead to the same result but the code based on the axisymmetric formulation is mush faster due to the lower number of degrees of freedom. This confirms the correctness of our approach and the interest of using an axisymmetric formulation when it is possible.

Keywords: Axisymmetric problem, continuous finite elements, heat equation, weak formulation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 280
1774 Multivariable System Reduction Using Stability Equation Method and SRAM

Authors: D. Bala Bhaskar

Abstract:

An algorithm is proposed for the order reduction of large scale linear dynamic multi variable systems where the reduced order model denominator is obtained by using Stability equation method and numerator coefficients are obtained by using SRAM. The proposed algorithm produces a lower order model for an original stable high order multivariable system. The reduction procedure is easy to understand, efficient and computer oriented. To highlight the advantages of the approach, the algorithm is illustrated with the help of a numerical example and the results are compared with the other existing techniques in literature.

Keywords: Multi variable systems, order reduction, stability equation method, SRAM, time domain characteristics, ISE.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 669
1773 Algorithms for the Fast Computation of PWL and PHL Transforms

Authors: Fituri H Belgassem, Abdulbasit Nigrat, Seddeeq Ghrari

Abstract:

In this paper, the construction of fast algorithms for the computation of Periodic Walsh Piecewise-Linear PWL transform and the Periodic Haar Piecewise-Linear PHL transform will be presented. Algorithms for the computation of the inverse transforms are also proposed. The matrix equation of the PWL and PHL transforms are introduced. Comparison of the computational requirements for the periodic piecewise-linear transforms and other orthogonal transforms shows that the periodic piecewise-linear transforms require less number of operations than some orthogonal transforms such as the Fourier, Walsh and the Discrete Cosine transforms.

Keywords: Piece wise linear transforms, Fast transforms, Fast algorithms.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1616
1772 Measuring the CSR Company-Stakeholder Fit

Authors: Armando Calabrese, Roberta Costa, Tamara Menichini, Francesco Rosati

Abstract:

As a company competitiveness depends more and more on the relationship with its stakeholders, the topic of companystakeholder fit is becoming increasingly important. This fit affects the extent to which a stakeholder perceives CSR company commitment, values and behaviors and, therefore, stakeholder identification in a company and his/her loyalty to it. Consequently, it is important to measure the alignment or the gap between stakeholder CSR demands, values, preferences and perceptions, and the company CSR disclosed commitment, values and policies. In this paper, in order to assess the company-stakeholder fit about corporate responsibility, an innovative CSR fit positioning matrix is proposed. This matrix is based on the measurement of a company CSR disclosed commitment and stakeholder perceived and required commitment. The matrix is part of a more complex methodology based on Global Reporting Initiative (GRI) indicators, content analysis and stakeholder questionnaires. This methodology provides appropriate indications for helping companies to achieve CSR company-stakeholder fit, by leveraging both CSR commitment and communication. Moreover, it could be used by top management for comparing different companies and stakeholders, and for planning specific CSR strategies, policies and activities.

Keywords: Company-Stakeholder fit, Corporate Social Responsibility (CSR), CSR Positioning Matrix, Global Reporting Initiative (GRI), Stakeholder Orientation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2899
1771 Solitary Wave Solutions for Burgers-Fisher type Equations with Variable Coefficients

Authors: Amit Goyal, Alka, Rama Gupta, C. Nagaraja Kumar

Abstract:

We have solved the Burgers-Fisher (BF) type equations, with time-dependent coefficients of convection and reaction terms, by using the auxiliary equation method. A class of solitary wave solutions are obtained, and some of which are derived for the first time. We have studied the effect of variable coefficients on physical parameters (amplitude and velocity) of solitary wave solutions. In some cases, the BF equations could be solved for arbitrary timedependent coefficient of convection term.

Keywords: Solitary wave solution, Variable coefficient Burgers- Fisher equation, Auxiliary equation method.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1571
1770 Development of Predictive Model for Surface Roughness in End Milling of Al-SiCp Metal Matrix Composites using Fuzzy Logic

Authors: M. Chandrasekaran, D. Devarasiddappa

Abstract:

Metal matrix composites have been increasingly used as materials for components in automotive and aerospace industries because of their improved properties compared with non-reinforced alloys. During machining the selection of appropriate machining parameters to produce job for desired surface roughness is of great concern considering the economy of manufacturing process. In this study, a surface roughness prediction model using fuzzy logic is developed for end milling of Al-SiCp metal matrix composite component using carbide end mill cutter. The surface roughness is modeled as a function of spindle speed (N), feed rate (f), depth of cut (d) and the SiCp percentage (S). The predicted values surface roughness is compared with experimental result. The model predicts average percentage error as 4.56% and mean square error as 0.0729. It is observed that surface roughness is most influenced by feed rate, spindle speed and SiC percentage. Depth of cut has least influence.

Keywords: End milling, fuzzy logic, metal matrix composites, surface roughness

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2118
1769 Solving One-dimensional Hyperbolic Telegraph Equation Using Cubic B-spline Quasi-interpolation

Authors: Marzieh Dosti, Alireza Nazemi

Abstract:

In this paper, the telegraph equation is solved numerically by cubic B-spline quasi-interpolation .We obtain the numerical scheme, by using the derivative of the quasi-interpolation to approximate the spatial derivative of the dependent variable and a low order forward difference to approximate the temporal derivative of the dependent variable. The advantage of the resulting scheme is that the algorithm is very simple so it is very easy to implement. The results of numerical experiments are presented, and are compared with analytical solutions by calculating errors L2 and L∞ norms to confirm the good accuracy of the presented scheme.

Keywords: Cubic B-spline, quasi-interpolation, collocation method, second-order hyperbolic telegraph equation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2738
1768 Comparative Analysis of DTC Based Switched Reluctance Motor Drive Using Torque Equation and FEA Models

Authors: P. Srinivas, P. V. N. Prasad

Abstract:

Since torque ripple is the main cause of noise and vibrations, the performance of Switched Reluctance Motor (SRM) can be improved by minimizing its torque ripple using a novel control technique called Direct Torque Control (DTC). In DTC technique, torque is controlled directly through control of magnitude of the flux and change in speed of the stator flux vector. The flux and torque are maintained within set hysteresis bands.

The DTC of SRM is analyzed by two methods. In one method, the actual torque is computed by conducting Finite Element Analysis (FEA) on the design specifications of the motor. In the other method, the torque is computed by Simplified Torque Equation. The variation of peak current, average current, torque ripple and speed settling time with Simplified Torque Equation model is compared with FEA based model.

Keywords: Direct Toque Control, Simplified Torque Equation, Finite Element Analysis, Torque Ripple.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3454
1767 Schrödinger Equation with Position-Dependent Mass: Staggered Mass Distributions

Authors: J. J. Peña, J. Morales, J. García-Ravelo, L. Arcos-Díaz

Abstract:

The Point canonical transformation method is applied for solving the Schrödinger equation with position-dependent mass. This class of problem has been solved for continuous mass distributions. In this work, a staggered mass distribution for the case of a free particle in an infinite square well potential has been proposed. The continuity conditions as well as normalization for the wave function are also considered. The proposal can be used for dealing with other kind of staggered mass distributions in the Schrödinger equation with different quantum potentials.

Keywords: Free particle, point canonical transformation method, position-dependent mass, staggered mass distribution.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1511
1766 Research on the Correlation of the Fluctuating Density Gradient of the Compressible Flows

Authors: Yasuo Obikane

Abstract:

This work is to study a roll of the fluctuating density gradient in the compressible flows for the computational fluid dynamics (CFD). A new anisotropy tensor with the fluctuating density gradient is introduced, and is used for an invariant modeling technique to model the turbulent density gradient correlation equation derived from the continuity equation. The modeling equation is decomposed into three groups: group proportional to the mean velocity, and that proportional to the mean strain rate, and that proportional to the mean density. The characteristics of the correlation in a wake are extracted from the results by the two dimensional direct simulation, and shows the strong correlation with the vorticity in the wake near the body. Thus, it can be concluded that the correlation of the density gradient is a significant parameter to describe the quick generation of the turbulent property in the compressible flows.

Keywords: Turbulence Modeling , Density Gradient Correlation, Compressible

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1388
1765 Instability of Soliton Solutions to the Schamel-nonlinear Schrödinger Equation

Authors: Sarun Phibanchon, Michael A. Allen

Abstract:

A variational method is used to obtain the growth rate of a transverse long-wavelength perturbation applied to the soliton solution of a nonlinear Schr¨odinger equation with a three-half order potential. We demonstrate numerically that this unstable perturbed soliton will eventually transform into a cylindrical soliton.

Keywords: Soliton, instability, variational method, spectral method.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 3632
1764 A NXM Version of 5X5 Playfair Cipher for any Natural Language (Urdu as Special Case)

Authors: Muhammad Salam, Nasir Rashid, Shah Khalid, Muhammad Raees Khan

Abstract:

In this paper a modified version NXM of traditional 5X5 playfair cipher is introduced which enable the user to encrypt message of any Natural language by taking appropriate size of the matrix depending upon the size of the natural language. 5X5 matrix has the capability of storing only 26 characters of English language and unable to store characters of any language having more than 26 characters. To overcome this limitation NXM matrix is introduced which solve this limitation. In this paper a special case of Urdu language is discussed. Where # is used for completing odd pair and * is used for repeating letters.

Keywords: cryptography, decryption, encryption, playfair cipher, traditional cipher.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2110
1763 Some Solitary Wave Solutions of Generalized Pochhammer-Chree Equation via Exp-function Method

Authors: Kourosh Parand, Jamal Amani Rad

Abstract:

In this paper, Exp-function method is used for some exact solitary solutions of the generalized Pochhammer-Chree equation. It has been shown that the Exp-function method, with the help of symbolic computation, provides a very effective and powerful mathematical tool for solving nonlinear partial differential equations. As a result, some exact solitary solutions are obtained. It is shown that the Exp-function method is direct, effective, succinct and can be used for many other nonlinear partial differential equations.

Keywords: Exp-function method, generalized Pochhammer- Chree equation, solitary wave solution, ODE's.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1539
1762 On-line and Off-line POD Assisted Projective Integral for Non-linear Problems: A Case Study with Burgers-Equation

Authors: Montri Maleewong, Sirod Sirisup

Abstract:

The POD-assisted projective integration method based on the equation-free framework is presented in this paper. The method is essentially based on the slow manifold governing of given system. We have applied two variants which are the “on-line" and “off-line" methods for solving the one-dimensional viscous Bergers- equation. For the on-line method, we have computed the slow manifold by extracting the POD modes and used them on-the-fly along the projective integration process without assuming knowledge of the underlying slow manifold. In contrast, the underlying slow manifold must be computed prior to the projective integration process for the off-line method. The projective step is performed by the forward Euler method. Numerical experiments show that for the case of nonperiodic system, the on-line method is more efficient than the off-line method. Besides, the online approach is more realistic when apply the POD-assisted projective integration method to solve any systems. The critical value of the projective time step which directly limits the efficiency of both methods is also shown.

Keywords: Projective integration, POD method, equation-free.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1308
1761 A New Approach to Solve Blasius Equation using Parameter Identification of Nonlinear Functions based on the Bees Algorithm (BA)

Authors: E. Assareh, M.A. Behrang, M. Ghalambaz, A.R. Noghrehabadi, A. Ghanbarzadeh

Abstract:

In this paper, a new approach is introduced to solve Blasius equation using parameter identification of a nonlinear function which is used as approximation function. Bees Algorithm (BA) is applied in order to find the adjustable parameters of approximation function regarding minimizing a fitness function including these parameters (i.e. adjustable parameters). These parameters are determined how the approximation function has to satisfy the boundary conditions. In order to demonstrate the presented method, the obtained results are compared with another numerical method. Present method can be easily extended to solve a wide range of problems.

Keywords: Bees Algorithm (BA); Approximate Solutions; Blasius Differential Equation.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1754
1760 Defect Modes in Multilayered Piezoelectric Structures

Authors: D. G. Piliposyan

Abstract:

Propagation of electro-elastic waves in a piezoelectric waveguide with finite stacks and a defect layer is studied using a modified transfer matrix method. The dispersion equation for a periodic structure consisting of unit cells made up from two piezoelectric materials with metallized interfaces is obtained. An analytical expression, for the transmission coefficient for a waveguide with finite stacks and a defect layer, that is found can be used to accurately detect and control the position of the passband within a stopband. The result can be instrumental in constructing a tunable waveguide made of layers of different or identical piezoelectric crystals and separated by metallized interfaces.

Keywords: Defect mode, Bloch waves, periodic phononic crystal, piezoelectric composite waveguide.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1053
1759 Stabilization of the Bernoulli-Euler Plate Equation: Numerical Analysis

Authors: Carla E. O. de Moraes, Gladson O. Antunes, Mauro A. Rincon

Abstract:

The aim of this paper is to study the internal stabilization of the Bernoulli-Euler equation numerically. For this, we consider a square plate subjected to a feedback/damping force distributed only in a subdomain. An algorithm for obtaining an approximate solution to this problem was proposed and implemented. The numerical method used was the Finite Difference Method. Numerical simulations were performed and showed the behavior of the solution, confirming the theoretical results that have already been proved in the literature. In addition, we studied the validation of the numerical scheme proposed, followed by an analysis of the numerical error; and we conducted a study on the decay of the energy associated.

Keywords: Bernoulli-Euler Plate Equation, Numerical Simulations, Stability, Energy Decay, Finite Difference Method.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1986
1758 High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

Authors: Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang

Abstract:

This paper deals with a high-order accurate Runge Kutta Discontinuous Galerkin (RKDG) method for the numerical solution of the wave equation, which is one of the simple case of a linear hyperbolic partial differential equation. Nodal DG method is used for a finite element space discretization in 'x' by discontinuous approximations. This method combines mainly two key ideas which are based on the finite volume and finite element methods. The physics of wave propagation being accounted for by means of Riemann problems and accuracy is obtained by means of high-order polynomial approximations within the elements. High order accurate Low Storage Explicit Runge Kutta (LSERK) method is used for temporal discretization in 't' that allows the method to be nonlinearly stable regardless of its accuracy. The resulting RKDG methods are stable and high-order accurate. The L1 ,L2 and L∞ error norm analysis shows that the scheme is highly accurate and effective. Hence, the method is well suited to achieve high order accurate solution for the scalar wave equation and other hyperbolic equations.

Keywords: Nodal Discontinuous Galerkin Method, RKDG, Scalar Wave Equation, LSERK

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2428
1757 Proposal of Design Method in the Semi-Acausal System Model

Authors: Junji Kaneko, Shigeyuki Haruyama, Ken Kaminishi, Tadayuki Kyoutani, Siti Ruhana Omar, Oke Oktavianty

Abstract:

This study is used as a definition method to the value and function in manufacturing sector. In concurrence of discussion about present condition of modeling method, until now definition of 1D-CAE is ambiguity and not conceptual. Across all the physic fields, those methods are defined with the formulation of differential algebraic equation which only applied time derivation and simulation. At the same time, we propose semi-acausal modeling concept and differential algebraic equation method as a newly modeling method which the efficiency has been verified through the comparison of numerical analysis result between the semi-acausal modeling calculation and FEM theory calculation.

Keywords: System Model, Physical Models, Empirical Models, Conservation Law, Differential Algebraic Equation, Object-Oriented.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 2192
1756 A C1-Conforming Finite Element Method for Nonlinear Fourth-Order Hyperbolic Equation

Authors: Yang Liu, Hong Li, Siriguleng He, Wei Gao, Zhichao Fang

Abstract:

In this paper, the C1-conforming finite element method is analyzed for a class of nonlinear fourth-order hyperbolic partial differential equation. Some a priori bounds are derived using Lyapunov functional, and existence, uniqueness and regularity for the weak solutions are proved. Optimal error estimates are derived for both semidiscrete and fully discrete schemes.

Keywords: Nonlinear fourth-order hyperbolic equation, Lyapunov functional, existence, uniqueness and regularity, conforming finite element method, optimal error estimates.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1836
1755 Exploiting Non Circularity for Angle Estimation in Bistatic MIMO Radar Systems

Authors: Ebregbe David, Deng Weibo

Abstract:

The traditional second order statistics approach of using only the hermitian covariance for non circular signals, does not take advantage of the information contained in the complementary covariance of these signals. Radar systems often use non circular signals such as Binary Phase Shift Keying (BPSK) signals. Their noncicular property can be exploited together with the dual centrosymmetry of the bistatic MIMO radar system to improve angle estimation performance. We construct an augmented matrix from the received data vectors using both the positive definite hermitian covariance matrix and the complementary covariance matrix. The Unitary ESPRIT technique is then applied to the signal subspace of the augmented covariance matrix for automatically paired Direction-of-arrival (DOA) and Direction-of-Departure (DOD) angle estimates. The number of targets that can be detected is twice that obtainable with the conventional ESPRIT approach. Simulation results show the effectiveness of this method in terms of increase in resolution and the number of targets that can be detected.

Keywords: Bistatic MIMO Radar, Unitary Esprit, Non circular signals.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 1863
1754 Unified Gas-Kinetic Scheme for Gas-Particle Flow in Shock-Induced Fluidization of Particles Bed

Authors: Zhao Wang, Hong Yan

Abstract:

In this paper, a unified-gas kinetic scheme (UGKS) for the gas-particle flow is constructed. UGKS is a direct modeling method for both continuum and rarefied flow computations. The dynamics of particle and gas are described as rarefied and continuum flow, respectively. Therefore, we use the Bhatnagar-Gross-Krook (BGK) equation for the particle distribution function. For the gas phase, the gas kinetic scheme for Navier-Stokes equation is solved. The momentum transfer between gas and particle is achieved by the acceleration term added to the BGK equation. The new scheme is tested by a 2cm-in-thickness dense bed comprised of glass particles with 1.5mm in diameter, and reasonable agreement is achieved.

Keywords: Gas-particle flow, unified gas-kinetic scheme, momentum transfer, shock-induced fluidization.

Procedia APA BibTeX Chicago EndNote Harvard JSON MLA RIS XML ISO 690 PDF Downloads 567
1753 Photon Localization inside a Waveguide Modeled by Uncertainty Principle

Authors: Shilpa N. Kulkarni, Sujata R. Patrikar

Abstract:

In the present work, an attempt is made to understand electromagnetic field confinement in a subwavelength waveguide structure using concepts of quantum mechanics. Evanescent field in the waveguide is looked as inability of the photon to get confined in the waveguide core and uncertainty of position is assigned to it. The momentum uncertainty is calculated from position uncertainty. Schrödinger wave equation for the photon is written by incorporating position-momentum uncertainty. The equation is solved and field distribution in the waveguide is obtained. The field distribution and power confinement is compared with conventional waveguide theory. They were found in good agreement with each other.

Keywords: photon localization in waveguide, photon tunneling, quantum confinement of light, Schrödinger wave equation, uncertainty principle.

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