You are on page 1of 4

Method of Weighted Residuals on the Base of

Neuronets Approximations for Computer


Simulation of Hydrodynamics Problems
A.V. Kretinin, Yu. A. Bulygin, and M.I. Kirpichev
Voronezh State Technical University, Russia

e-mail: avk-vrn@mail.ru

Abstract The algorithm of the numerical decision of the


hydrodynamics equations with representation of the
decision on method of weighted residuals on the base of
general neuronet's approximation in the whole flow area is
developed. The algorithm is tested on decision of the twodimensional Navier-Stokes equations.

I. INTRODUCTION
The numerical solutions of fluid dynamics problem can
be considered using the method of weighted residuals
(MWR) which origin from the supposition about the
capability of analytical presentation of flow equation. The
type of representative testing functions (form- functions)
determines the specific version of MWR such as subareas, collocations, minimum squares and Galerkin
methods [1]. As a rule, MWR algorithm realization is
transformed to variation problem, through which solution
of the total residuals minimization of hydrodynamics by
the way of trial solution parameter selection. The solution
accuracy of MWR is determined by approximating
characteristics of testing functions and by degree
equivalence to the original partial differential equations
for continuum solution of fluid flow.
The neural network training is the change of its inner
parameters in the way that the outlet data of neural
networks gradually approach the required ones. Neural
network training is the movement along the surface of
errors, and the argument of the error surface is the inner
structure of neural networks. Neural network outlet is the
surface being continuously determined for the whole real
space of inlet population set. Artificial neural networks
(ANN) are powerful means of approximation. The idea of
application of ANN methodology for the mathematical
physics equation solution is not a new one and it is
presented in the number of publications, which are
reviewed in the reference book [2]. It is also noted there
that the application of ANN for hydrodynamics problem
simulation is very limited. In particular, among of 2342
publications mentioned in [2], only one [3] deals with
hydrodynamics. The computational algorithm, described
in this article, allows to use neural networks structure for
continuous solution in the computational area,
Manuscript received August 30, 2008

corresponding to hydrodynamics equations in contrast to


the standard procedure of neural network training
according to the given number of reference values in
discrete points.
II. NEURAL NETWORKS COMPUTATIONAL
ARCHITECTURE
To investigate the ANN approximated capabilities the
perceptron with the single hidden layer (SLP) has been
chosen as a basic model which performs nonlinear
transformation of the input space into the output space in
accordance with the formula:
q
n

y (w, x) = vi f bi + wij x j + b0 ,
i =1
j =1

(1)

where x R n network input vector, made up of the


values x j ; q the neuron number of the single hidden
layer; w R s all weights and network thresholds
vector; wij weight entering the model nonlinearly
between j-m input and i-m neuron of the hidden layer;
vi output layer neuron weight corresponding to the ineuron of the hidden layer; bi ,b0 thresholds of neurons
of the hidden layer and output neuron; f activation
function (in our case the logistic sigmoid is used). ANN
of this structure already has the universal approximation
capability, in other words it gives the opportunity to
approximate the arbitrary analog function with any given
accuracy. The main stage of using ANN for resolving of
practical issues is the neural network model training,
which is the process of the network weight iterative
adjustment on the basis of the learning set (sample)
{x i , yi }, x i R n , i = 1,..., k in order to minimize the
network error quality functional
k

J (w ) = Q( f (w, i) ) ,
i =1

(2)

where w ANN weight vector; Q( f (w, i ) ) = f (w , i )


ANN quality criterion as per the i-training example;
2

f (w, i ) = y (w , x i ) y i i-example error. For training


purposes the statistically distributed approximation
algorithms may be used based on the back error
propagation or the numerical methods of the
differentiable function optimization.
Suppose that some equation with exact solution y(x)
L( y ) = 0

(3)

for not digital value ys (3) presents an arbitrary xs in


learning sample. We have L(y)=R with substitution of
approximate solution (1) into (3), where R is equation
residual. R is continuous function R=f(w,x) and it is a
function of SHL inner parameters. Thus, ANN training
under outlet functional consists in inner parameters
definition through trial solution (1) for meeting the
equation (3) goal and its solution is realized through the
corresponding modification of functional quality (2)
training.
Usually total squared error at net outlets is presented as
a objective function at neural net training and an
argument is the difference between the resulted s net
outlet and the real value that is known a priori. This
approach to neural net utilization is generally applied to
the problems of statistical set transformation and the
reveal of the unknown a priori function values (net outlet)
from the argument (net inlet). As for simulation
problems, they are connected with mathematical
representation of physical laws and modification of them
to the form being applied in practice. Usually; it is
connected with the necessity of development of digital
description of the process to be modeled. Under such
conditions we meet the necessity to exclude from
objective function the computation result known a priori
and the transfer to its functional task. Then the objective
function during known law simulation will be defined
only by the inlet data and the law which we simulate:

E=

( ))

1
s
s 2
.
y f x
2S

(4)

III. MWR FORMULATION FOR THE SOLUTION OF


NAVIER-STOKES EQUATIONS
Computational capabilities of the developed algorithm
can be illustrated by the example of the solution of
Navier-Stokes equations, describing two-dimensional
isothermal flows of viscous incompressible fluid [1]:
u v
+
= 0;
x y

1 2 u 2 u
p
u
u
+u
+v

+
=0;

x
x
y Re x 2 y 2
p
v
v 1 2 v 2 v
+u
+v

+
=0.

y Re x 2 y 2
y
x

(5)

(6)
(7)

Here u,v velocity components, Re Reinolds number.


Hydrodynamic equation set is written in dimensionless

form; i.e. they include reduced quantities u *r =

ur
,
u

u
r
p
, r* =
, p* =
.
2
u
D
u
As for u and D , for their values one can chose any
values of velocity and of linear dimension in the flow
area, for example fluid velocity value on the channel inlet
and channel width h.
Let on the plane XY there is rectangular region
[a,b][c,d], and on it there is a rectangular analytical grid,
specified by Cartesian product of two one-dimensional
grids {xk}, k=l,,n and {yl}, l=l,,m.
u * =

We will understand
neural net
functions
u, v, p = f NET (w , x, y ) as the (5)-(7) system solution
giving minimum of the total squered residual in the knot
set of computational grid. We present the trial solution of
the system (5)-(7) u, v, p in the form (1):
q

u (w , x, y ) = vi f (bi + wi1x + wi 2 y ) + bu ;

(8)

v(w , x, y ) = vi f (bi + wi1x + wi 2 y ) + bv ;

(9)

i =1
2q

i = q +1

p(w, x, y ) =

3q

vi f (bi
i = 2 q +1

+ wi1x + wi 2 y ) + b p .

(10)

Here, as it early w is the vector of all the weights and


thresholds of the net. In this case the amount of q neurons
in the trial solutions for each decision variable set is
defined the same. This is the parameter which
approximated capabilities of neural net trial solution
depend on. Computational algorithm functioning should
have its result the achievement of the necessary level of
the accuracy of solution at the q minimum value.
Let us mark the residuals of equations (5)-(7) R1, R2
R3 correspondingly, then for the vase of MWR realization
for parameters setup of the trial solution it is necessary to
minimize three objective functions R12 ; R22 ; R32 min .
In the simplest case the only solution of the multicriterion problem of minimization can be generated at the
substitution of three criterions by one, presented in the
form
of
compression,
for
example

R 2 = R12 + R22 + R32 min . Presenting of the trial


solution in the form of continuous functions (8)-(10)
allows to define analytically the first and the second
differential coefficient in the equations (5)-(7), knowing
which one can generate analytic expressions of the
function of residuals Rs(w,x,y) and further for antigradient
component of the total residual in the s-reference point at
R
R
R
ANN inner parameters
,
and
, being later
v j wij
b j
used in the minimization algorithm in accordance with
antigradient direction [4].
Other versions of multi-criterion search are based on
different methods of generating of the number of

solutions, satisfying Pareto conditions. The choice of


candidate solution out of Pareto-optimal population must
be based on the analysis of hydrodynamic process and is
similar to identification procedure of mathematical
model. In any case the procedure of multi-criterion
optimization comes to the solution of composition of
single-criterion problems, out of which a lot of possible
solutions are formed. At the same time particularities of
some computational approaches of fluid dynamics allows
to use iteration algorithms, on each step of which the
solution at only one physical magnitude is generated. The
computational procedure, described below, is analogous
to the MAC method [1], in which the possibility of MWR
application is investigated on the basis of neural net trial
functions.
Let us consider the flow of incompressible fluid in the
channel with the turning point (Fig. 1).

=0
y

=1
y

1
F n = f NET ( x, y )
t
with the implementation of neural net trial functions.
2 p n +1 =

The vector F ( F , G )T entering this algorithm can be


defined out of momentum equation [1], or to find the
pressures one can use Poisson equation in the form of
2 p
x

2 p
y

u v v u
.
= 2

x y x y

Thus, the solution for the pressure generated from


Poisson equation, leads to the fulfillment of continuity
equation at the time n + 1 . When p n +1 is generated, the
substitution of these values into the formula
u n +1 = F n t p n +1 allows to define u n+1 and v n+1 .

Iteration process continues till velocity distribution does


not change (becomes steady).

2 2
+
=0
x 2 y 2

=0
x

where pressure distribution on each iteration step is


generated out of the solution of Poisson equation

=0
y

Fig. 1. Computational area

Stating of boundary conditions is carried out in the


following way: on the solid walls u=v=0, on the inflow
boundary u=0, v=1, on the outflow boundary
u v
=
= 0 . There are no boundary conditions for
x x
pressure except for one reference point, where p=0 is
specified (in the absolute values p=p0), with regard to
which indication of incoming into the momentum
p
p
equation
and
is realized.
x
y
For solution of flow equations by the predictor method
it is necessary to specify initial velocity distribution in the
computational area, satisfying the equation of continuity.
For this purpose velocity potential (x, y ) is introduced

.
and v =
and u =
x
y
As a result of Laplas equation solution, there is
generated velocity distribution, which can be called freevortex component of the sought quantity. The final
velocity and pressure distribution is generated as a result
of momentum equation solution in accordance with the
following algorithm.
Velocity distribution on the following time layer is
generated according to the formula
u n +1 = F n t p n +1 ,

We will show some results of system solution (5)-(7)


for Re=100. In Fig. 2 the steady velocity distribution is
presented in the computational area (there is a fragment
of flow area with the flow turning point). The total
residual at ~10000 computational points did not exceed
R=0.1, what proves algorithm efficiency for solution of
the system of nonlinear differential Navier-Stokes
equations.
The analysis shows that numerical scheme application
on the basis of net trial solutions leads to several

Fig. 2. Net velocity distribution

important advantages in comparison with traditional


computational methods of hydrodynamics. The most
evident of them is the independent choice of computation
points, arbitrarily located in flow field, which serve for
adjustment of net trial solution. Implementation
possibilities of this numerical algorithm are limited only
by accuracy of the generation of the global net
approximation of the analyzed functional continuum.

IV. CONCLUSION
The presented results reveal one of the possible
apparatus applications of artificial neuron nets
numerical solution of equations including differential
ones, similar to method of weighted residuals, but with
the implementation of specific net approximation. Minor
modification of standard training algorithm of neural
network allows using computational points arbitrarily
designed in the computational field for insetting as
supplement the continuous solution.
REFERENCES
[1]
[2]
[3]
[4]

[5]

K. Fletcher, Computational techniques for fluid dynamics, In 2


volumes. M.: Mir, 1991.
A.I. Galushkin, Neuromathematics. Moscow, IPRJR. 2002.
C.J. Richardson and D.J. Barlow, Neural network computer
simulation of medical aerosols, J. Pharm. and Pharmacol., 1996,
vol. 48. No.6, p. 581-591.
A.V. Kretinin, Yu.A. Bulygin and S.G. Valyuhov, Intelligent
Algorithm for Forecasting of Optimum Neurons Quantity in
Perceptron with One Hidden Layer, Proceedings of 2008
International Joint Conference on Neural Networks, Hong Kong.
p. 907-912
A.V. Kretinin, The weighted residuals method based on neuronet
approximations for simulation of hydrodynamics problems,
Siberian J. Num. Math, 2006, vol. 9, No.1, p. 23-35.

You might also like