Big Chemical Encyclopedia

Chemical substances, components, reactions, process design ...

Articles Figures Tables About

Numerical solutions

In the numerical solution of the one-dimensional system, we used a three-point central differencing scheme such that the first and second spatial derivatives of C at point i (for a grid with non-uniform spacing) were [Pg.181]

In the i2-direction there are two finite bomidaries that must be considered, namely the R = 0 axis, and the singularity where the outer edge of the electrode meets the insulating smface, at i = 1. The spatial grid must therefore expand outwards from these two points, giving a high density of points at both edges of the electrode and a lower density in the middle of it [1]  [Pg.182]

We apply the same three-point central differencing scheme as was used in the one-dimensional case to this two-dimensional space, which gives the form of the derivatives for the concentration at point i, j) as [Pg.183]

In Chapter 3, we chose to use an implicit method of solution, as opposed to an explicit one for reasons of stability and simulation efHciency (despite the greater complexity of the implicit method). The implicit discretisation [Pg.183]

In the ADI method [4-6], the explicit and implicit methods are combined. The timesteps, AT, are divided into two half-timesteps, ATf2. For the first of these half-timesteps, the derivatives along the. -coordinate [Pg.184]

A great many stagnation-flow solutions have been shown in the previous sections. The solution algorithms are similar to those discussed in Chapter 16. However, there are some differences and some complications that arise to deal with the special needs of stagnation flows. One issue has to do with computing the pressure-gradient eigenvalue in finite-gap problems. Another has to do with velocity reversal in opposed flows (Section 6.10). [Pg.276]

Consider first how the eigenvalue can be determined, which is mainly concerned with the continuity and momentum equations. The continuity equation [Pg.277]

This difference formula propagates axial-velocity u information from the lower boundary (e.g., stagnation surface) up toward the inlet-manifold boundary. At the stagnation surface, a boundary value of the axial velocity is known, u = 0. A dilemma occurs at the upper boundary, however. At the upper boundary, Eq. 6.106 can be evaluated to determine a value for the inlet velocity u j. However, in the finite-gap problem, the inlet velocity is specified as a boundary condition. In general, the velocity evaluated from the discrete continuity equation is not equal to the known boundary condition, which is a temporary contradiction. The dilemma must be resolved through the eigenvalue, which is coupled to the continuity equation through the V velocity and the radial-momentum equation. [Pg.277]

It is easy to see that changing the value of Ar produces a different V profile through the solution of the momentum equation. Then, in turn, different V profiles produce different u profiles through the solution of the continuity equation. It is possible to find a value of Ar such that the continuity equation is satisfied at the top boundary and the known axial-velocity boundary conditions is satisfied, that is, uj = f/iniet However, it is inefficient to carry out such an iteration explicitly. Rather, it it is more efficient to implement an implicit boundary condition. [Pg.277]

To maintain a banded Jacobian structure, the eigenvalue is represented through a trivial differential equation, [Pg.277]

and (2.31) with Eq. (2.9) can be solved simultaneously without simplification. Since the analytical solution of the preceding simultaneous differential equations are not possible, we need to solve them numerically by using a computer. Among many software packages that solve simultaneous differential equations, Advanced Continuous Simulation Language (ACSL, 1975) is very powerful and easy to use. [Pg.19]

The heart of ACSL is the integration operator, INTEG, that is, [Pg.19]

Original set of differential equations are converted to a set of first-order equations, and solved directly by integrating. For example, Eq. (2.14) can be solved by integrating as [Pg.19]

For more details of this simulation language, please refer to the ACSL User Guide (ACSL, 1975). [Pg.19]

You can also use Mathematica (Wolfram Research, Inc., Champaign, IL) or MathCad (MathSoft, Inc., Cambridge, MA), to solve the above problem, though they are not as powerful as ACSL. [Pg.20]

The mathematical model developed in the preceding section consists of six coupled, three-dimensional, nonlinear partial differential equations along with nonlinear algebraic boundary conditions, which must be solved to obtain the temperature profiles in the gas, catalyst, and thermal well the concentration profiles and the velocity profile. Numerical solution of these equations is required. [Pg.129]

A comparison of the benefits and drawbacks of common numerical solution techniques for complex, nonlinear partial differential equation models is given in Table II. Note that it is common and in some cases necessary to use a combination of the techniques in the different dimensions of the model. [Pg.129]

Numerical Solution Techniques for Partial Differential Equations Arising in Packed Bed Reactor Modeling [Pg.129]

Finite difference Has simple construction Is easily extended to multiple dimensions Solution is stable for sharp gradients or in response to a concentration or temperature front Leads directly to state-space representation Is often computationally prohibitive since accurate solutions may require a large number of grid points [Pg.129]

Methods of Generally needs few grid Can have difficulties with [Pg.129]

We employ the Newton-Raphson method to iterate toward a set of values for the unknown variables (nw, mi, mp)r for which the residual functions become vanishingly small. [Pg.147]

To do so, we calculate the Jacobian matrix, which is composed of the partial derivatives of the residual functions with respect to the unknown variables. Differentiating the mass action equations for aqueous species Aj (Eqn. 4.2), we note that, [Pg.147]

For the K and Freundlich models, as mentioned, there is no basis entry Ap and hence we do not write a residual function of the form Equation 9.42, nor do we carry Jacobian entries for Equations 9.46 or 9.49-9.52. [Pg.148]

To evaluate the Jacobian matrix, we need to compute values for dmq/dnw, dmq/dnii, and dmq/dmp. For the Kt and Freundlich models, [Pg.148]

No value for dmq/dmp is needed to evaluate the and Freundlich models. For the Langmuir model and the ion exchange model under the Gaines-Thomas and Gapon conventions, [Pg.148]

The procedure for solving the governing equations parallels the technique described in Chapter 5, with the added complication of accounting for electrostatic effects. We begin as before by identifying the nonlinear portion of the problem to form the reduced basis [Pg.135]

For each basis entry we cast a residual function, which is the difference between the right and left sides of the mass balance equations (Eqns. 8.11a, b, and e) [Pg.135]

At each step in the iteration, we evaluate the residual functions and Jacobian matrix. We then calculate a correction vector as the solution to the matrix equation [Pg.136]

Quasi-single models typically set the axial velocity at the inlet to the gas punch velocity thus, [Pg.331]

Two-phase models typically assume that only the gas enters the bath at the nozzle such that, [Pg.331]

Assuming a 10-pct turbulence intensity generated by the incoming gas bubbles, Schwarz and Turner [40] and Ilegbusi et al. [8] used the following boundary condition for the k and e at the nozzle  [Pg.331]

Integration of the governing partial differential equations presented in Sect. 9.3 over a control volume leads to an algebraic equation of the form  [Pg.331]

In multi-fluid models, there is a separate solution field for each phase. Transported quantities interact via interphase terms. The pressure in both phases is assumed to be the same within a computational cell. Field equations for each phase are weighted with the volume fraction of that phase. The model is solved using the inter-phase slip algorithm (IPSA) embodied in the PHOENICS computational code with modifications for the interfacial parameters and other source terms. This approach and its derivatives have been adopted in other commercial computational codes. [Pg.332]

Process engineering and design using Visual Basic [Pg.84]

The theoretically calculated values and values obtained through numerical analysis are presented in Table 1.11. [Pg.84]


No a priori information about the unknown profile is used in this algorithm, and the initial profile to start the iterative process is chosen as (z) = 1. Moreover, the solution of the forward problem at each iteration can be obtained with the use of the scattering matrices concept [8] instead of a numerical solution of the Riccati equation (4). This allows to perform reconstruction in a few seconds of a microcomputer time. The whole algorithm can be summarized as follows ... [Pg.129]

The deconvolution is the numerical solution of this convolution integral. The theory of the inverse problem that we exposed in the previous paragraph shows an idealistic character because it doesn t integrate the frequency restrictions introduced by the electro-acoustic set-up and the mechanical system. To attenuate the effect of filtering, we must deconvolve the emitted signal and received signal. [Pg.746]

Lane improved on these tables with accurate polynomial fits to numerical solutions of Eq. 11-17 [16]. Two equations result the first is applicable when rja 2... [Pg.15]

We will describe integral equation approximations for the two-particle correlation fiinctions. There is no single approximation that is equally good for all interatomic potentials in the 3D world, but the solutions for a few important models can be obtained analytically. These include the Percus-Yevick (PY) approximation [27, 28] for hard spheres and the mean spherical (MS) approximation for charged hard spheres, for hard spheres with point dipoles and for atoms interacting with a Yukawa potential. Numerical solutions for other approximations, such as the hypemetted chain (EfNC) approximation for charged systems, are readily obtained by fast Fourier transfonn methods... [Pg.478]

The solutions to this approximation are obtained numerically. Fast Fourier transfonn methods and a refomuilation of the FINC (and other integral equation approximations) in tenns of the screened Coulomb potential by Allnatt [M are especially useful in the numerical solution. Figure A2.3.12 compares the osmotic coefficient of a 1-1 RPM electrolyte at 25°C with each of the available Monte Carlo calculations of Card and Valleau [ ]. [Pg.495]

Using the Omstein-Zemicke equation, numerical solutions for the restricted primitive model can be. [Pg.583]

Shampine S 1994 Numerical Solutions of Ordinary Differential Equations (New York Chapman and Hall)... [Pg.1085]

Numerical solution of this set of close-coupled equations is feasible only for a limited number of close target states. For each N, several sets of independent solutions F.. of the resulting close-coupled equations are detennined subject to F.. = 0 at r = 0 and to the reactance A-matrix asymptotic boundary conditions,... [Pg.2049]

Wlien describing the interactions between two charged flat plates in an electrolyte solution, equation (C2.6.6) cannot be solved analytically, so in the general case a numerical solution will have to be used. Several equations are available, however, to describe the behaviour in a number of limiting cases (see [41] for a detailed discussion). Here we present two limiting cases for the interactions between two charged spheres, surrounded by their counterions and added electrolyte, which will be referred to in further sections. This pair interaction is always repulsive in the theory discussed here. [Pg.2678]

Theorem 1 ([8]). Let H be analytic. There exists some r > 0, so that for all T < Tt the numerical solution Xk = ) Xo and the exact solution x of the perturbed system H (the sum being truncated after N = 0 1/t) terms) with x(0) = Xq remain exponentially close in the sense that... [Pg.101]

The typical dependence of the stable stationary solutions to (4) on the control parameter of the model Xe is presented in Fig. 1. These results have been obtained as numerical solutions of (4) with equal to... [Pg.122]

D. Beglov and B. Roux. Numerical solutions of the hypernetted chain equation for a solute of arbitrary geometry in three dimensions. J. Chem. Phys., 103 360-364, 1995. [Pg.259]

We further discuss how quantities typically measured in the experiment (such as a rate constant) can be computed with the new formalism. The computations are based on stochastic path integral formulation [6]. Two different sources for stochasticity are considered. The first (A) is randomness that is part of the mathematical modeling and is built into the differential equations of motion (e.g. the Langevin equation, or Brownian dynamics). The second (B) is the uncertainty in the approximate numerical solution of the exact equations of motion. [Pg.264]

Consider a numerical solution of the Newton s differential equation with a finite time step - At. In principle, since the Newton s equations of motion are deterministic the conditional probability should be a delta function... [Pg.268]

We have in mind trajectory calculations in which the time step At is large and therefore the computed trajectory is unlikely to be the exact solution. Let Xnum. t) be the numerical solution as opposed to the true solution Xexact t)- A plausible estimate of the errors in X um t) can be obtained by plugging it back into the differential equation. [Pg.268]

The last approximation is for finite At. When the equations of motions are solved exactly, the model provides the correct answer (cr = 0). When the time step is sufficiently large we argue below that equation (10) is still reasonable. The essential assumption is for the intermediate range of time steps for which the errors may maintain correlation. We do not consider instabilities of the numerical solution which are easy to detect, and in which the errors are clearly correlated even for large separation in time. Calculation of the correlation of the errors (as defined in equation (9)) can further test the assumption of no correlation of Q t)Q t )). [Pg.268]

L.R. Petzold, L.O. Jay, and J. Yen. Numerical solution of highly oscillatory ordinary differential equations. Acta Numerica, pages 437-484, 1997. [Pg.296]

Computational issues that are pertinent in MD simulations are time complexity of the force calculations and the accuracy of the particle trajectories including other necessary quantitative measures. These two issues overwhelm computational scientists in several ways. MD simulations are done for long time periods and since numerical integration techniques involve discretization errors and stability restrictions which when not put in check, may corrupt the numerical solutions in such a way that they do not have any meaning and therefore, no useful inferences can be drawn from them. Different strategies such as globally stable numerical integrators and multiple time steps implementations have been used in this respect (see [27, 31]). [Pg.484]

The weighted residual method provides a flexible mathematical framework for the construction of a variety of numerical solution schemes for the differential equations arising in engineering problems. In particular, as is shown in the followmg section, its application in conjunction with the finite element discretizations yields powerful solution algorithms for field problems. To outline this technique we consider a steady-state boundary value problem represented by the following mathematical model... [Pg.41]

The comparison between the finite element and analytical solutions for a relatively small value of a - 1 is shown in Figure 2.25. As can be seen the standard Galerkin method has yielded an accurate and stable solution for the differential Equation (2.80). The accuracy of this solution is expected to improve even further with mesh refinement. As Figmre 2.26 shows using a = 10 a stable result can still be obtained, however using the present mesh of 10 elements, for larger values of this coefficient the numerical solution produced by the standard... [Pg.57]

The finite element results obtained for various values of (3 are compared with the analytical solution in Figure 2.27. As can be seen using a value of /3 = 0.5 a stable numerical solution is obtained. However, this solution is over-damped and inaccurate. Therefore the main problem is to find a value of upwinding parameter that eliminates oscillations without generating over-damped results. To illustrate this concept let us consider the following convection-diffusion equation... [Pg.61]

Johnson, C., 1987. Numerical Solution of Partial Deferential Equations by the Finite Element Method, Cambridge University Press, Cambridge. [Pg.68]

Lapidus, L. and Pinder, G. F., 1982. Numerical Solution of Partial Differential Equations in Science and Engineering, Wiley, New York. [Pg.68]

Taylor, C. and Hood, P., 1973. A numerical solution of the Navier-Stokes equations using the finite element technique. Comput. Fluids 1, 73-100. [Pg.69]

Further details of the BB, sometimes referred to as Ladyzhenskaya-Babuska-Brezi (LBB) condition and its importance in the numerical solution of incompressible flow equations can be found in textbooks dealing with the theoretical aspects of the finite element method (e.g. see Reddy, 1986), In practice, the instability (or checker-boarding) of pressure in the U-V-P method can be avoided using a variety of strategies. [Pg.73]

Morton, K. W., 1996. Numerical Solution of Convection Diffusion Problems, Chapman Hall, London. [Pg.109]


See other pages where Numerical solutions is mentioned: [Pg.115]    [Pg.127]    [Pg.484]    [Pg.957]    [Pg.1062]    [Pg.2829]    [Pg.213]    [Pg.132]    [Pg.248]    [Pg.283]    [Pg.319]    [Pg.409]    [Pg.429]    [Pg.443]    [Pg.74]    [Pg.180]    [Pg.17]    [Pg.18]    [Pg.41]    [Pg.61]    [Pg.63]    [Pg.63]    [Pg.79]    [Pg.109]   
See also in sourсe #XX -- [ Pg.386 , Pg.387 , Pg.494 ]

See also in sourсe #XX -- [ Pg.226 , Pg.228 , Pg.420 , Pg.521 ]

See also in sourсe #XX -- [ Pg.236 ]

See also in sourсe #XX -- [ Pg.541 ]

See also in sourсe #XX -- [ Pg.183 , Pg.184 , Pg.186 , Pg.187 ]

See also in sourсe #XX -- [ Pg.560 , Pg.577 ]

See also in sourсe #XX -- [ Pg.104 ]

See also in sourсe #XX -- [ Pg.64 , Pg.65 , Pg.68 , Pg.69 , Pg.144 ]

See also in sourсe #XX -- [ Pg.140 , Pg.142 , Pg.158 , Pg.243 , Pg.245 ]

See also in sourсe #XX -- [ Pg.18 , Pg.46 , Pg.433 ]

See also in sourсe #XX -- [ Pg.162 ]




SEARCH



A Numerical Solution of Ordinary Differential Equations

A Numerical Solution to Equation

A numeric solution to the problem

Accuracy of numerical solutions

Advection numerical solution

Advection-dispersion equation numerical solution

Algebraic equations numerical solution methods

Algebraic equations, numerical solution

Analytical and Numerical Solutions of Balance Equations for Three-Phase Reactors

Analytical and Numerical Solutions of the Kinetic Models

Approximate and Numerical Solution Methods for PDEs

Boundary layer equations laminar, numerical solution

Boundary layer, laminar forced numerical solution

Boundary value problems numerical solutions

Breakthrough curve numerical solution

Bubble numerical solutions

Building Blocks of a Numerical Solution Method

Capillary numerical solutions

Collision dynamics numerical solution

Combined convection numerical solution

Condensed-phase system quantum numerical solution

Continuity equation numerical solution

Convection numerical solution

Couette flow numerical solution

Differential equations numerical solution

Differential equations numerical solution, 29-31 Runge-Kutta

Diffusion numerical solutions

Direct numerical solution

Discussion of the Model and Numerical Solution

Enzyme numerical solution

Equilibria numerical solution

Equilibrium-dispersive model numerical solution

Exact numerical solution

Finite Cell Current, Numerical Solution

Finite difference techniques numerical solutions

Formulation for Numerical Solution

Further study in the numerical solution of BVPs

General Numerical Solutions (Multicomponent Systems)

General Numerical Solutions (One Adsorbable Component)

General rate model numerical solution

Generalized population balance equation numerical solution

Initial value problem, solutions NUMERICAL COMPUTER METHODS

Initial value problem, solutions NUMERICAL INTEGRATION

Initial value, problems, numerical solution

Instability explicit numerical solution

Integral equations numerical solution

Interaction site fluids numerical solutions

Kinetic equation numerical solution

Kinetic model numerical solutions

Kinetic reaction path numerical solution

Kinetics numerical solutions

Kramers equation numerical solution

Laminar boundary layer numerical solution

Langevin equation numerical solutions

Lumped pore diffusion model numerical solution

Master equation numerical solution

Moment-transport equation numerical solution

Navier-Stokes equation numerical solutions

Nonlinear equations numerical solutions

Numerical Discretization and Solution Techniques

Numerical Iterative Methods of Solution

Numerical Methods for Solution of Partial Differential Equations

Numerical Solution Methods (Initial Value Problems)

Numerical Solution Skin Supersolidity

Numerical Solution Strategies

Numerical Solution and Impedance

Numerical Solution for Heat Transfer in a Rectangle

Numerical Solution for Orifice Flow

Numerical Solution for the Catalytic Pellet BVP

Numerical Solution of Algebraic Equations

Numerical Solution of Boltzmann Equation

Numerical Solution of Chemical Transport Models

Numerical Solution of Equations

Numerical Solution of Gas-Liquid Reactor Balances

Numerical Solution of Integral Equations

Numerical Solution of Linear Equations

Numerical Solution of Matrix Equations

Numerical Solution of Nonlinear Equations in One Variable

Numerical Solution of Optimal Control Problems

Numerical Solution of Ordinary Differential Equations

Numerical Solution of Partial Differential Equations

Numerical Solution of SECM Diffusion Problems Using PDEase2 Program Package

Numerical Solution of Schrodingers Equation

Numerical Solution of Simultaneous Linear Algebraic Equations

Numerical Solution of Stiff Equations

Numerical Solution of Three-Dimensional Eulerian Reactive Flow

Numerical Solution of Two-Dimensional Eulerian Reactive Flow

Numerical Solution of the Column Reactor Model

Numerical Solution of the Direct Problem in Chemical Kinetics

Numerical Solution of the Governing Equations

Numerical Solution of the Lumped Pore Diffusion Model

Numerical Solution of the Model Equations

Numerical Solution of the Model System

Numerical Solution of the One-Dimensional Time-Independent Schrodinger Equation

Numerical Solution of the Population Balance Equation

Numerical Solution of the Radial Schrodinger Equation

Numerical Solution of the Resulting Initial Value Problem

Numerical Solution of the Time-Dependent Schrodinger Equation

Numerical Solution of the Two-dimensional Model

Numerical Solution of the diffusion equation

Numerical Solutions Finite Element Method

Numerical Solutions for Diagenetic Models

Numerical Solutions for Nonlinear Systems

Numerical Solutions for Nonlinear, Nonideal SMB

Numerical Solutions for Schrodingers Equation

Numerical Solutions of Differential Equations

Numerical Solutions of Nonlinear Equations

Numerical Solutions of Nonlinear Gradient Elution

Numerical Solutions of the Equilibrium-Dispersive Model

Numerical Solutions to Ordinary Differential Equations

Numerical Solutions to Sets of First-Order ODEs

Numerical Solutions to Two-Point Boundary Value Problems

Numerical Solutions to the Poisson-Boltzmann Equation

Numerical analysis algebraic equation systems, solution

Numerical analysis differential equation solutions

Numerical implementation of diagonalization solutions

Numerical modelling 5% NaCl solution

Numerical modelling solution

Numerical solution alternating direction implicit

Numerical solution as functions of time for two

Numerical solution average molecular weight

Numerical solution calculated average molecular weight

Numerical solution different parameters

Numerical solution different sets

Numerical solution effect

Numerical solution methods

Numerical solution of Eq

Numerical solution of ODEs

Numerical solution of SCF equations

Numerical solution of SECM diffusion

Numerical solution of cavity mode

Numerical solution of heat conduction

Numerical solution of heat conduction problems

Numerical solution of mathematical

Numerical solution of model

Numerical solution of the PBE

Numerical solution of the Percus-Yevick equation

Numerical solution of the equations

Numerical solution of the optimization problem

Numerical solution procedure

Numerical solution procedure advantage

Numerical solution process

Numerical solution redox kinetics

Numerical solution scheme

Numerical solution scission

Numerical solution surface complexation calculations

Numerical solution techniques

Numerical solution, of complex

Numerical solution, of complex flow models

Numerical solution, of model equations

Numerical solutions boundary layer

Numerical solutions calculations using Slater orbitals

Numerical solutions enclosure

Numerical solutions fluid model equations

Numerical solutions full equations

Numerical solutions functions

Numerical solutions general values

Numerical solutions implicit finite-difference algorithm

Numerical solutions including transfer calculation

Numerical solutions laminar pipe flow

Numerical solutions mass transfer model equations

Numerical solutions porous media

Numerical solutions to equations

Numerical solutions to heat conduction problems

Numerical solutions turbulent boundary layer

Numerical solutions turbulent pipe flow

Numerical solutions, ferromagnetic

Numerical versus Symbolic Solutions

Numerically exact solution

Optimization using numerical solutions

Ordinary differential equations numerical solution techniques

Ordinary differential equations numerical solutions

Ordinary differential equations, boundary value numerical solutions

Ordinary differential equations, initial value numerical solution

Pair correlation function numerical solutions

Partial differential equations numerical solution

Percus-Yevick equation numerical solutions

Poiseuille flow numerical solution

Population-balance equation numerical solution

Rate equations numerical solutions

Reactive transport model numerical solution

Remark on Numerical Solutions

Schmidt numerical solution

Screening numerical solution

Smoluchowski equation numerical solution

Solutions to numerical problems

Sparse numerical solution

Stability explicit numerical solution

Stagnation flow numerical solution

Stokes problem numerical solution

Techniques for the numerical solution of partial differential equations

The Fokker-Planck approach Numerical solutions

Time-Dependent PFR-Complete and Numerical Solutions

Time-dependent Schrodinger equation, numerical solution

© 2019 chempedia.info