15.12.2012 Views

scipy tutorial - Baustatik-Info-Server

scipy tutorial - Baustatik-Info-Server

scipy tutorial - Baustatik-Info-Server

SHOW MORE
SHOW LESS

Create successful ePaper yourself

Turn your PDF publications into a flip-book with our unique Google optimized e-Paper software.

See Also:<br />

SciPy Reference Guide, Release 0.8.dev<br />

ble and triple integrals simps, trapz - integrators for sampled data cumtrapz - cumulative integration<br />

for sampled data ode, odeint - ODE integrators<br />

<strong>scipy</strong>.special for orthogonal polynomials (special) for Gaussian quadrature roots and weights for other weighting<br />

factors and regions.<br />

3.4.3 Integrators of ODE systems<br />

odeint(func, y0, t[, args, Dfun, col_deriv, ...]) Integrate a system of ordinary differential equations.<br />

ode(f[, jac]) A generic interface class to numeric integrators.<br />

odeint(func, y0, t, args=(), Dfun=None, col_deriv=0, full_output=0, ml=None, mu=None, rtol=None, atol=None,<br />

tcrit=None, h0=0.0, hmax=0.0, hmin=0.0, ixpr=0, mxstep=0, mxhnil=0, mxordn=12, mxords=5, printmessg=0)<br />

Integrate a system of ordinary differential equations.<br />

Solve a system of ordinary differential equations using lsoda from the FORTRAN library odepack.<br />

Solves the initial value problem for stiff or non-stiff systems of first order ode-s:<br />

dy/dt = func(y,t0,...)<br />

where y can be a vector.<br />

Parameters<br />

func : callable(y, t0, ...)<br />

Computes the derivative of y at t0.<br />

y0 : array<br />

t : array<br />

Initial condition on y (can be a vector).<br />

A sequence of time points for which to solve for y. The initial value point should be<br />

the first element of this sequence.<br />

args : tuple<br />

Extra arguments to pass to function.<br />

Dfun : callable(y, t0, ...)<br />

Gradient (Jacobian) of func.<br />

col_deriv : boolean<br />

True if Dfun defines derivatives down columns (faster), otherwise Dfun should define<br />

derivatives across rows.<br />

full_output : boolean<br />

True if to return a dictionary of optional outputs as the second output<br />

printmessg : boolean<br />

Whether to print the convergence message<br />

Returns<br />

y : array, shape (len(y0), len(t))<br />

3.4. Integration and ODEs (<strong>scipy</strong>.integrate) 185

Hooray! Your file is uploaded and ready to be published.

Saved successfully!

Ooh no, something went wrong!