183 resultados para Solving Equations


Relevância:

20.00% 20.00%

Publicador:

Resumo:

Nonlinear equations in mathematical physics and engineering are solved by linearizing the equations and forming various iterative procedures, then executing the numerical simulation. For strongly nonlinear problems, the solution obtained in the iterative process can diverge due to numerical instability. As a result, the application of numerical simulation for strongly nonlinear problems is limited. Helicopter aeroelasticity involves the solution of systems of nonlinear equations in a computationally expensive environment. Reliable solution methods which do not need Jacobian calculation at each iteration are needed for this problem. In this paper, a comparative study is done by incorporating different methods for solving the nonlinear equations in helicopter trim. Three different methods based on calculating the Jacobian at the initial guess are investigated. (C) 2011 Elsevier Masson SAS. All rights reserved.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

An operator-splitting finite element method for solving high-dimensional parabolic equations is presented. The stability and the error estimates are derived for the proposed numerical scheme. Furthermore, two variants of fully-practical operator-splitting finite element algorithms based on the quadrature points and the nodal points, respectively, are presented. Both the quadrature and the nodal point based operator-splitting algorithms are validated using a three-dimensional (3D) test problem. The numerical results obtained with the full 3D computations and the operator-split 2D + 1D computations are found to be in a good agreement with the analytical solution. Further, the optimal order of convergence is obtained in both variants of the operator-splitting algorithms. (C) 2012 Elsevier Inc. All rights reserved.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

A methodology for measurement of planar liquid volume fraction in dense sprays using a combination of Planar Laser-Induced Fluorescence (PLIF) and Particle/Droplet Imaging Analysis (PDIA) is presented in this work. The PLIF images are corrected for loss of signal intensity due to laser sheet scattering, absorption and auto-absorption. The key aspect of this work pertains to simultaneously solving the equations involving the corrected PLIF signal and liquid volume fraction. From this, a quantitative estimate of the planar liquid volume fraction is obtained. The corrected PLIF signal and the corrected planar Mie scattering can be also used together to obtain the Sauter Mean Diameter (SMD) distribution by using data from the PDIA technique at a particular location for calibration. This methodology is applied to non-evaporating sprays of diesel and a more viscous pure plant oil at an injection pressure of 1000 bar and a gas pressure of 30 bar in a high pressure chamber. These two fuels are selected since their viscosity values are very different with a consequently very different spray structure. The spatial distribution of liquid volume fraction and SMD is obtained for two fuels. The proposed method is validated by comparing liquid volume fraction obtained by the current method with data from PDIA technique. (C) 2012 Elsevier Inc. All rights reserved.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

We propose a new set of input voltage equations (IVEs) for independent double-gate MOSFET by solving the governing bipolar Poisson equation (PE) rigorously. The proposed IVEs, which involve the Legendre's incomplete elliptic integral of the first kind and Jacobian elliptic functions and are valid from accumulation to inversion regimes, are shown to have good agreement with the numerical solution of the same PE for all bias conditions.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

With the unique quasi-linear relationship between the surface potentials along the channel, recently we have proposed a quasi-static terminal charge model for common double-gate MOSFETs, which might have asymmetric gate oxide thickness. In this brief, we extend this concept to develop the nonquasi-static (NQS) charge model for the same by solving the governing continuity equations. The proposed NQS model shows good agreement against TCAD simulations and appears to be useful for efficient circuit simulation.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

Exponential compact higher-order schemes have been developed for unsteady convection-diffusion equation (CDE). One of the developed scheme is sixth-order accurate which is conditionally stable for the Peclet number 0 <= Pe <= 2.8 and the other is fourth-order accurate which is unconditionally stable. Schemes for two-dimensional (2D) problems are made to use alternate direction implicit (ADI) algorithm. Example problems are solved and the numerical solutions are compared with the analytical solutions for each case.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

The issue of intermittency in numerical solutions of the 3D Navier-Stokes equations on a periodic box 0, L](3) is addressed through four sets of numerical simulations that calculate a new set of variables defined by D-m(t) = (pi(-1)(0) Omega(m))(alpha m) for 1 <= m <= infinity where alpha(m) = 2m/(4m - 3) and Omega(m)(t)](2m) = L-3 integral(v) vertical bar omega vertical bar(2m) dV with pi(0) = vL(-2). All four simulations unexpectedly show that the D-m are ordered for m = 1,..., 9 such that Dm+1 < D-m. Moreover, the D-m squeeze together such that Dm+1/D-m NE arrow 1 as m increases. The values of D-1 lie far above the values of the rest of the D-m, giving rise to a suggestion that a depletion of nonlinearity is occurring which could be the cause of Navier-Stokes regularity. The first simulation is of very anisotropic decaying turbulence; the second and third are of decaying isotropic turbulence from random initial conditions and forced isotropic turbulence at fixed Grashof number respectively; the fourth is of very-high-Reynolds-number forced, stationary, isotropic turbulence at up to resolutions of 4096(3).

Relevância:

20.00% 20.00%

Publicador:

Resumo:

The problem of finding a satisfying assignment that minimizes the number of variables that are set to 1 is NP-complete even for a satisfiable 2-SAT formula. We call this problem MIN ONES 2-SAT. It generalizes the well-studied problem of finding the smallest vertex cover of a graph, which can be modeled using a 2-SAT formula with no negative literals. The natural parameterized version of the problem asks for a satisfying assignment of weight at most k. In this paper, we present a polynomial-time reduction from MIN ONES 2-SAT to VERTEX COVER without increasing the parameter and ensuring that the number of vertices in the reduced instance is equal to the number of variables of the input formula. Consequently, we conclude that this problem also has a simple 2-approximation algorithm and a 2k - c logk-variable kernel subsuming (or, in the case of kernels, improving) the results known earlier. Further, the problem admits algorithms for the parameterized and optimization versions whose runtimes will always match the runtimes of the best-known algorithms for the corresponding versions of vertex cover. Finally we show that the optimum value of the LP relaxation of the MIN ONES 2-SAT and that of the corresponding VERTEX COVER are the same. This implies that the (recent) results of VERTEX COVER version parameterized above the optimum value of the LP relaxation of VERTEX COVER carry over to the MIN ONES 2-SAT version parameterized above the optimum of the LP relaxation of MIN ONES 2-SAT. (C) 2013 Elsevier B.V. All rights reserved.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

Three codes, that can solve three dimensional linear elastostatic problems using constant boundary elements while ignoring body forces, are provided here. The file 'bemconst.m' contains a MATLAB code for solving three dimensional linear elastostatic problems using constant boundary elements while ignoring body forces. The file 'bemconst.f90' is a Fortran translation of the MATLAB code contained in the file 'bemconst.m'. The file 'bemconstp.f90' is a parallelized version of the Fortran code contained in the file 'bemconst.f90'. The file 'inbem96.txt' is the input file for the Fortran codes contained in the files 'bemconst.f90' and 'bemconstp.f90'. Author hereby declares that the present codes are the original works of the author. Further, author hereby declares that any of the present codes, in full or in part, is not a translation or a copy of any of the existing codes written by someone else. Author's institution (Indian Institute of Science) has informed the author in writing that the institution is not interested in claiming any copyright on the present codes. Author is hereby distributing the present codes under the MIT License; full text of the license is included in each of the files that contain the codes.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

An attempt to study the fluid dynamic behavior of two phase flow comprising of solid and liquid with nearly equal density in a geometrical case that has an industrial significance in theareas like processing of polymers, food, pharma ceutical, paints. In this work,crystalline silica is considered as the dispersed medium in glycerin. In the CFD analysis carried out,the two phase components are considered to be premixed homogeneously at the initial state. The flow in a cylinder that has an axially driven bi-lobe rotor, a typical blender used in polymer industry for mixing or kneading to render the multi-component mixture to homogeneous condition is considered. A viscous, incompressible, isothermal flow is considered with an assumption that the components do not undergo any physical change and the solids are rigid and mix in fully wetting conditions. Silica with a particle diameter of 0.4 mm is considered and flow is analyzed for different mixing fractions. An industry standard CFD code is used for solving 3D-RANS equations. As the outcome of the study the torque demand by the bi-lobe rotor for different mixture fractions which are estimated show a behavioral consistency to the expected physical phenomena occurring in the domain considered.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

We generalize the method of A. M. Polyakov, Phys. Rev. E 52, 6183 (1995)] for obtaining structure-function relations in turbulence in the stochastically forced Burgers equation, to develop structure-function hierarchies for turbulence in three models for magnetohydrodynamics (MHD). These are the Burgers analogs of MHD in one dimension Eur. Phys. J.B 9, 725 (1999)], and in three dimensions (3DMHD and 3D Hall MHD). Our study provides a convenient and unified scheme for the development of structure-function hierarchies for turbulence in a variety of coupled hydrodynamical equations. For turbulence in the three sets of MHD equations mentioned above, we obtain exact relations for third-order structure functions and their derivatives; these expressions are the analogs of the von Karman-Howarth relations for fluid turbulence. We compare our work with earlier studies of such relations in 3DMHD and 3D Hall MHD.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

This paper presents a simple technique for reducing the computational effort while solving any geotechnical stability problem by using the upper bound finite element limit analysis and linear optimization. In the proposed method, the problem domain is discretized into a number of different regions in which a particular order (number of sides) of the polygon is chosen to linearize the Mohr-Coulomb yield criterion. A greater order of the polygon needs to be selected only in that region wherein the rate of the plastic strains becomes higher. The computational effort required to solve the problem with this implementation reduces considerably. By using the proposed method, the bearing capacity has been computed for smooth and rough strip footings and the results are found to be quite satisfactory.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

A numerical formulation has been proposed for solving an axisymmetric stability problem in geomechanics with upper bound limit analysis, finite elements, and linear optimization. The Drucker-Prager yield criterion is linearized by simulating a sphere with a circumscribed truncated icosahedron. The analysis considers only the velocities and plastic multiplier rates, not the stresses, as the basic unknowns. The formulation is simple to implement, and it has been employed for finding the collapse loads of a circular footing placed over the surface of a cohesive-frictional material. The formulation can be used to solve any general axisymmetric geomechanics stability problem.

Relevância:

20.00% 20.00%

Publicador:

Resumo:

This paper deals with the Schrodinger equation i partial derivative(s)u(z, t; s) - Lu(z, t; s) = 0; where L is the sub-Laplacian on the Heisenberg group. Assume that the initial data f satisfies vertical bar f(z, t)vertical bar less than or similar to q(alpha)(z, t), where q(s) is the heat kernel associated to L. If in addition vertical bar u(z, t; s(0))vertical bar less than or similar to q(beta)(z, t), for some s(0) is an element of R \textbackslash {0}, then we prove that u(z, t; s) = 0 for all s is an element of R whenever alpha beta < s(0)(2). This result holds true in the more general context of H-type groups. We also prove an analogous result for the Grushin operator on Rn+1.