Esempio n. 1
0
def d03pfc(npde, ts, tout, pdedef, numflx, bndary, u, npts, x, acc, tsmax, rsave, lrsave, isave, lisave, itask, itrace, outfile, ind, comm, saved, fail):
    """
    General system of convection-diffusion PDEs with source terms in
    conservative form, method of lines, upwind scheme using numerical flux
    function based on Riemann solver, one space variable.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d03/d03pfc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        ts, u, x, acc, rsave, isave, ind
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        ts, u, x, acc, rsave
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        isave, ind
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _ts = nag_double_type_check_and_cast('d03pfc', ts, 'ts')
    _u = nag_double_type_check_and_cast('d03pfc', u, 'u')
    _x = nag_double_type_check_and_cast('d03pfc', x, 'x')
    _acc = nag_double_type_check_and_cast('d03pfc', acc, 'acc')
    _rsave = nag_double_type_check_and_cast('d03pfc', rsave, 'rsave')
    _isave = nag_integer_type_check_and_cast('d03pfc', isave, 'isave')
    _ind = nag_integer_type_check_and_cast('d03pfc', ind, 'ind')
    d03pfc_ctypes(npde, _ts, tout, pdedef, numflx, bndary, _u, npts, _x, _acc, tsmax, _rsave, lrsave, _isave, lisave, itask, itrace, outfile, _ind, comm, saved, fail)
Esempio n. 2
0
def f04mcc(selct, n, nrhs, al, lal, d, row, b, tdb, x, tdx, fail):
    """
    Approximate solution of real symmetric positive definite variable-
    bandwidth simultaneous linear equations (coefficient matrix already
    factorized by f01mcc).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04mcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        al, d, row, b, x
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        al, d, b, x
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        row
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _al = nag_double_type_check_and_cast('f04mcc', al, 'al')
    _d = nag_double_type_check_and_cast('f04mcc', d, 'd')
    _row = nag_integer_type_check_and_cast('f04mcc', row, 'row')
    _b = nag_double_type_check_and_cast('f04mcc', b, 'b')
    _x = nag_double_type_check_and_cast('f04mcc', x, 'x')
    f04mcc_ctypes(selct, n, nrhs, _al, lal, _d, _row, _b, tdb, _x, tdx, fail)
Esempio n. 3
0
def d06dac(mode, nv, nedge, nelt, ntrans, itype, trans, coori, edgei, conni, cooro, edgeo, conno, itrace, outfile, fail):
    """
    Generates a mesh resulting from an affine transformation of a given
    mesh.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d06/d06dac.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        itype, trans, coori, edgei, conni, cooro, edgeo, conno
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        trans, coori, cooro
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        itype, edgei, conni, edgeo, conno
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _itype = nag_integer_type_check_and_cast('d06dac', itype, 'itype')
    _trans = nag_double_type_check_and_cast('d06dac', trans, 'trans')
    _coori = nag_double_type_check_and_cast('d06dac', coori, 'coori')
    _edgei = nag_integer_type_check_and_cast('d06dac', edgei, 'edgei')
    _conni = nag_integer_type_check_and_cast('d06dac', conni, 'conni')
    _cooro = nag_double_type_check_and_cast('d06dac', cooro, 'cooro')
    _edgeo = nag_integer_type_check_and_cast('d06dac', edgeo, 'edgeo')
    _conno = nag_integer_type_check_and_cast('d06dac', conno, 'conno')
    d06dac_ctypes(mode, nv, nedge, nelt, ntrans, _itype, _trans, _coori, _edgei, _conni, _cooro, _edgeo, _conno, itrace, outfile, fail)
Esempio n. 4
0
def e01aec(m, xmin, xmax, x, y, p, itmin, itmax, a, perf, numiter, fail):
    """
    Interpolating functions, polynomial interpolant, data may include
    derivative values, one variable.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/e01/e01aec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, y, p, a, perf, numiter
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, y, a, perf
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        p, numiter
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _x = nag_double_type_check_and_cast('e01aec', x, 'x')
    _y = nag_double_type_check_and_cast('e01aec', y, 'y')
    _p = nag_integer_type_check_and_cast('e01aec', p, 'p')
    _a = nag_double_type_check_and_cast('e01aec', a, 'a')
    _perf = nag_double_type_check_and_cast('e01aec', perf, 'perf')
    _numiter = nag_integer_type_check_and_cast('e01aec', numiter, 'numiter')
    e01aec_ctypes(m, xmin, xmax, _x, _y, _p, itmin, itmax, _a, _perf, _numiter, fail)
Esempio n. 5
0
def f04cgc(order, n, nrhs, d, e, b, pdb, rcond, errbnd, fail):
    """
    Computes the solution, estimated condition number and error-bound to a
    complex Hermitian positive definite tridiagonal system of linear
    equations.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04cgc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        d, e, b, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        d, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    Complex:
        e, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    _d = nag_double_type_check_and_cast('f04cgc', d, 'd')
    _e = nag_complex_type_check_and_cast('f04cgc', e, 'e')
    _b = nag_complex_type_check_and_cast('f04cgc', b, 'b')
    _rcond = nag_double_type_check_and_cast('f04cgc', rcond, 'rcond')
    _errbnd = nag_double_type_check_and_cast('f04cgc', errbnd, 'errbnd')
    f04cgc_ctypes(order, n, nrhs, _d, _e, _b, pdb, _rcond, _errbnd, fail)
Esempio n. 6
0
def f12aec(niter, nconv, ritzr, ritzi, rzest, icomm, comm):
    """
    Provides monitoring information for f12abc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12aec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        niter, nconv, ritzr, ritzi, rzest, icomm, comm
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        ritzr, ritzi, rzest, comm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        niter, nconv, icomm
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _niter = nag_integer_type_check_and_cast('f12aec', niter, 'niter')
    _nconv = nag_integer_type_check_and_cast('f12aec', nconv, 'nconv')
    _ritzr = nag_double_type_check_and_cast('f12aec', ritzr, 'ritzr')
    _ritzi = nag_double_type_check_and_cast('f12aec', ritzi, 'ritzi')
    _rzest = nag_double_type_check_and_cast('f12aec', rzest, 'rzest')
    _icomm = nag_integer_type_check_and_cast('f12aec', icomm, 'icomm')
    _comm = nag_double_type_check_and_cast('f12aec', comm, 'comm')
    f12aec_ctypes(_niter, _nconv, _ritzr, _ritzi, _rzest, _icomm, _comm)
Esempio n. 7
0
def g07dbc(sigmaest, n, x, psifun, c, h1, h2, h3, dchi, theta, sigma, maxit, tol, rs, nit, sortedx, fail):
    """
    Robust estimation, M-estimates for location and scale parameters,
    standard weight functions.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g07/g07dbc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, theta, sigma, rs, nit, sortedx
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, theta, sigma, rs, sortedx
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        nit
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _x = nag_double_type_check_and_cast('g07dbc', x, 'x')
    _theta = nag_double_type_check_and_cast('g07dbc', theta, 'theta')
    _sigma = nag_double_type_check_and_cast('g07dbc', sigma, 'sigma')
    _rs = nag_double_type_check_and_cast('g07dbc', rs, 'rs')
    _nit = nag_integer_type_check_and_cast('g07dbc', nit, 'nit')
    _sortedx = nag_double_type_check_and_cast('g07dbc', sortedx, 'sortedx')
    g07dbc_ctypes(sigmaest, n, _x, psifun, c, h1, h2, h3, dchi, _theta, _sigma, maxit, tol, _rs, _nit, _sortedx, fail)
Esempio n. 8
0
def d02gbc(neq, fcnf, fcng, a, b, c, d, gam, mnp, np, x, y, tol, comm, fail):
    """
    Ordinary differential equations solver, for general linear two-point
    boundary value problems, using a finite difference technique with
    deferred correction.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d02/d02gbc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        c, d, gam, np, x, y
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        c, d, gam, x, y
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        np
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _c = nag_double_type_check_and_cast('d02gbc', c, 'c')
    _d = nag_double_type_check_and_cast('d02gbc', d, 'd')
    _gam = nag_double_type_check_and_cast('d02gbc', gam, 'gam')
    _np = nag_integer_type_check_and_cast('d02gbc', np, 'np')
    _x = nag_double_type_check_and_cast('d02gbc', x, 'x')
    _y = nag_double_type_check_and_cast('d02gbc', y, 'y')
    d02gbc_ctypes(neq, fcnf, fcng, a, b, _c, _d, _gam, mnp, _np, _x, _y, tol, comm, fail)
Esempio n. 9
0
def d02rac(neq, deleps, fcn, numbeg, nummix, g, init, mnp, np, x, y, tol, abt, jacobf, jacobg, jaceps, jacgep, comm, fail):
    """
    Ordinary differential equations solver, for general nonlinear two-point
    boundary value problems, using a finite difference technique with
    deferred correction.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d02/d02rac.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        deleps, np, x, y, abt
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        deleps, x, y, abt
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        np
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _deleps = nag_double_type_check_and_cast('d02rac', deleps, 'deleps')
    _np = nag_integer_type_check_and_cast('d02rac', np, 'np')
    _x = nag_double_type_check_and_cast('d02rac', x, 'x')
    _y = nag_double_type_check_and_cast('d02rac', y, 'y')
    _abt = nag_double_type_check_and_cast('d02rac', abt, 'abt')
    d02rac_ctypes(neq, _deleps, fcn, numbeg, nummix, g, init, mnp, _np, _x, _y, tol, _abt, jacobf, jacobg, jaceps, jacgep, comm, fail)
Esempio n. 10
0
def c09ebc(m, n, ca, pdca, ch, pdch, cv, pdcv, cd, pdcd, b, pdb, icomm, fail):
    """
    Two-dimensional inverse discrete wavelet transform.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/c09/c09ebc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        ca, ch, cv, cd, b, icomm
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        ca, ch, cv, cd, b
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        icomm
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _ca = nag_double_type_check_and_cast("c09ebc", ca, "ca")
    _ch = nag_double_type_check_and_cast("c09ebc", ch, "ch")
    _cv = nag_double_type_check_and_cast("c09ebc", cv, "cv")
    _cd = nag_double_type_check_and_cast("c09ebc", cd, "cd")
    _b = nag_double_type_check_and_cast("c09ebc", b, "b")
    _icomm = nag_integer_type_check_and_cast("c09ebc", icomm, "icomm")
    c09ebc_ctypes(m, n, _ca, pdca, _ch, pdch, _cv, pdcv, _cd, pdcd, _b, pdb, _icomm, fail)
Esempio n. 11
0
def d02gac(neq, fcn, a, b, u, v, mnp, np, x, y, tol, comm, fail):
    """
    Ordinary differential equations solver, for simple nonlinear two-point
    boundary value problems, using a finite difference technique with
    deferred correction.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d02/d02gac.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        u, v, np, x, y
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        u, x, y
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        v, np
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _u = nag_double_type_check_and_cast('d02gac', u, 'u')
    _v = nag_integer_type_check_and_cast('d02gac', v, 'v')
    _np = nag_integer_type_check_and_cast('d02gac', np, 'np')
    _x = nag_double_type_check_and_cast('d02gac', x, 'x')
    _y = nag_double_type_check_and_cast('d02gac', y, 'y')
    d02gac_ctypes(neq, fcn, a, b, _u, _v, mnp, _np, _x, _y, tol, comm, fail)
Esempio n. 12
0
def h02buc(mpsfile, minimize, n, m, a, bl, bu, intvar, cvec, x, options, fail):
    """
    Read MPSX data for IP, LP or QP problem from a file.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/h/h02buc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        n, m, a, bl, bu, cvec, x
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a, bl, bu, cvec, x
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        n, m
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _n = nag_integer_type_check_and_cast('h02buc', n, 'n')
    _m = nag_integer_type_check_and_cast('h02buc', m, 'm')
    _a = nag_double_type_check_and_cast('h02buc', a, 'a')
    _bl = nag_double_type_check_and_cast('h02buc', bl, 'bl')
    _bu = nag_double_type_check_and_cast('h02buc', bu, 'bu')
    _cvec = nag_double_type_check_and_cast('h02buc', cvec, 'cvec')
    _x = nag_double_type_check_and_cast('h02buc', x, 'x')
    h02buc_ctypes(mpsfile, minimize, _n, _m, _a, _bl, _bu, intvar, _cvec, _x, options, fail)
Esempio n. 13
0
def g04bcc(nrep, nrow, ncol, y, nt, it, gmean, tmean, table, c, tdc, irep, rpmean, rmean, cmean, r, ef, tol, irdf, fail):
    """
    Analysis of variance, general row and column design, treatment means and
    standard errors.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g04/g04bcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        y, it, gmean, tmean, table, c, irep, rpmean, rmean, cmean, r, ef
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        y, gmean, tmean, table, c, rpmean, rmean, cmean, r, ef
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        it, irep
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _y = nag_double_type_check_and_cast('g04bcc', y, 'y')
    _it = nag_integer_type_check_and_cast('g04bcc', it, 'it')
    _gmean = nag_double_type_check_and_cast('g04bcc', gmean, 'gmean')
    _tmean = nag_double_type_check_and_cast('g04bcc', tmean, 'tmean')
    _table = nag_double_type_check_and_cast('g04bcc', table, 'table')
    _c = nag_double_type_check_and_cast('g04bcc', c, 'c')
    _irep = nag_integer_type_check_and_cast('g04bcc', irep, 'irep')
    _rpmean = nag_double_type_check_and_cast('g04bcc', rpmean, 'rpmean')
    _rmean = nag_double_type_check_and_cast('g04bcc', rmean, 'rmean')
    _cmean = nag_double_type_check_and_cast('g04bcc', cmean, 'cmean')
    _r = nag_double_type_check_and_cast('g04bcc', r, 'r')
    _ef = nag_double_type_check_and_cast('g04bcc', ef, 'ef')
    g04bcc_ctypes(nrep, nrow, ncol, _y, nt, _it, _gmean, _tmean, _table, _c, tdc, _irep, _rpmean, _rmean, _cmean, _r, _ef, tol, irdf, fail)
Esempio n. 14
0
def f01emc(order, n, a, pda, f, comm, iflag, imnorm, fail):
    """
    Function of a real matrix (using user-supplied derivatives).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f01/f01emc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, iflag, imnorm
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a, imnorm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        iflag
    ImportError will be raised for this function on Mac.
    """
    from platform import system
    if system() == 'Darwin':
        from nag4py.util import nagImportErrorMessage
        raise ImportError(nagImportErrorMessage('f01emc', system()))
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _a = nag_double_type_check_and_cast('f01emc', a, 'a')
    _iflag = nag_integer_type_check_and_cast('f01emc', iflag, 'iflag')
    _imnorm = nag_double_type_check_and_cast('f01emc', imnorm, 'imnorm')
    f01emc_ctypes(order, n, _a, pda, f, comm, _iflag, _imnorm, fail)
Esempio n. 15
0
def f02wgc(order, m, n, k, ncv, av, nconv, sigma, u, pdu, v, pdv, resid, comm, fail):
    """
    Computes leading terms in the singular value decomposition of a real
    general matrix; also computes corresponding left and right singular
    vectors.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02wgc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        nconv, sigma, u, v, resid
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        sigma, u, v, resid
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        nconv
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _nconv = nag_integer_type_check_and_cast("f02wgc", nconv, "nconv")
    _sigma = nag_double_type_check_and_cast("f02wgc", sigma, "sigma")
    _u = nag_double_type_check_and_cast("f02wgc", u, "u")
    _v = nag_double_type_check_and_cast("f02wgc", v, "v")
    _resid = nag_double_type_check_and_cast("f02wgc", resid, "resid")
    f02wgc_ctypes(order, m, n, k, ncv, av, _nconv, _sigma, _u, pdu, _v, pdv, _resid, comm, fail)
Esempio n. 16
0
def g03adc(n, m, z, tdz, isz, nx, ny, wt, e, tde, ncv, cvx, tdcvx, cvy, tdcvy, tol, fail):
    """
    Canonical correlation analysis.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g03/g03adc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        z, isz, wt, e, ncv, cvx, cvy
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        z, wt, e, cvx, cvy
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        isz, ncv
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _z = nag_double_type_check_and_cast('g03adc', z, 'z')
    _isz = nag_integer_type_check_and_cast('g03adc', isz, 'isz')
    _wt = nag_double_type_check_and_cast('g03adc', wt, 'wt')
    _e = nag_double_type_check_and_cast('g03adc', e, 'e')
    _ncv = nag_integer_type_check_and_cast('g03adc', ncv, 'ncv')
    _cvx = nag_double_type_check_and_cast('g03adc', cvx, 'cvx')
    _cvy = nag_double_type_check_and_cast('g03adc', cvy, 'cvy')
    g03adc_ctypes(n, m, _z, tdz, _isz, nx, ny, _wt, _e, tde, _ncv, _cvx, tdcvx, _cvy, tdcvy, tol, fail)
Esempio n. 17
0
def f02xec(m, n, a, tda, ncolb, b, tdb, wantq, q, tdq, sv, wantp, ph, tdph, _iter, e, failinfo, fail):
    """
    SVD of complex matrix.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02xec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, b, q, sv, ph, _iter, e, failinfo
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        sv, e
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        _iter, failinfo
    TypeError will be raised when the following arguments are not of data type
    Complex:
        a, b, q, ph
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _a = nag_complex_type_check_and_cast("f02xec", a, "a")
    _b = nag_complex_type_check_and_cast("f02xec", b, "b")
    _q = nag_complex_type_check_and_cast("f02xec", q, "q")
    _sv = nag_double_type_check_and_cast("f02xec", sv, "sv")
    _ph = nag_complex_type_check_and_cast("f02xec", ph, "ph")
    __iter = nag_integer_type_check_and_cast("f02xec", _iter, "_iter")
    _e = nag_double_type_check_and_cast("f02xec", e, "e")
    _failinfo = nag_integer_type_check_and_cast("f02xec", failinfo, "failinfo")
    f02xec_ctypes(m, n, _a, tda, ncolb, _b, tdb, wantq, _q, tdq, _sv, wantp, _ph, tdph, __iter, _e, _failinfo, fail)
Esempio n. 18
0
def g03efc(n, m, x, tdx, isx, nvar, k, cmeans, tdc, wt, inc, nic, css, csw, maxit, fail):
    """
    K-means.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g03/g03efc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, isx, cmeans, wt, inc, nic, css, csw
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, cmeans, wt, css, csw
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        isx, inc, nic
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _x = nag_double_type_check_and_cast('g03efc', x, 'x')
    _isx = nag_integer_type_check_and_cast('g03efc', isx, 'isx')
    _cmeans = nag_double_type_check_and_cast('g03efc', cmeans, 'cmeans')
    _wt = nag_double_type_check_and_cast('g03efc', wt, 'wt')
    _inc = nag_integer_type_check_and_cast('g03efc', inc, 'inc')
    _nic = nag_integer_type_check_and_cast('g03efc', nic, 'nic')
    _css = nag_double_type_check_and_cast('g03efc', css, 'css')
    _csw = nag_double_type_check_and_cast('g03efc', csw, 'csw')
    g03efc_ctypes(n, m, _x, tdx, _isx, nvar, k, _cmeans, tdc, _wt, _inc, _nic, _css, _csw, maxit, fail)
Esempio n. 19
0
def f12fcc(nconv, d, z, sigma, resid, v, comm, icomm, fail):
    """
    Selected eigenvalues and, optionally, eigenvectors of a real symmetric
    sparse eigenproblem, postprocessing for f12fbc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12fcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        nconv, d, z, resid, v, comm, icomm
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        d, z, resid, v, comm
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        nconv, icomm
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _nconv = nag_integer_type_check_and_cast('f12fcc', nconv, 'nconv')
    _d = nag_double_type_check_and_cast('f12fcc', d, 'd')
    _z = nag_double_type_check_and_cast('f12fcc', z, 'z')
    _resid = nag_double_type_check_and_cast('f12fcc', resid, 'resid')
    _v = nag_double_type_check_and_cast('f12fcc', v, 'v')
    _comm = nag_double_type_check_and_cast('f12fcc', comm, 'comm')
    _icomm = nag_integer_type_check_and_cast('f12fcc', icomm, 'icomm')
    f12fcc_ctypes(_nconv, _d, _z, sigma, _resid, _v, _comm, _icomm, fail)
Esempio n. 20
0
def g03acc(weight, n, m, x, tdx, isx, nx, ing, ng, wt, nig, cvm, tdcvm, e, tde, ncv, cvx, tdcvx, tol, irankx, fail):
    """
    Canonical variate analysis.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g03/g03acc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, isx, ing, wt, nig, cvm, e, ncv, cvx, irankx
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, wt, cvm, e, cvx
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        isx, ing, nig, ncv, irankx
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _x = nag_double_type_check_and_cast('g03acc', x, 'x')
    _isx = nag_integer_type_check_and_cast('g03acc', isx, 'isx')
    _ing = nag_integer_type_check_and_cast('g03acc', ing, 'ing')
    _wt = nag_double_type_check_and_cast('g03acc', wt, 'wt')
    _nig = nag_integer_type_check_and_cast('g03acc', nig, 'nig')
    _cvm = nag_double_type_check_and_cast('g03acc', cvm, 'cvm')
    _e = nag_double_type_check_and_cast('g03acc', e, 'e')
    _ncv = nag_integer_type_check_and_cast('g03acc', ncv, 'ncv')
    _cvx = nag_double_type_check_and_cast('g03acc', cvx, 'cvx')
    _irankx = nag_integer_type_check_and_cast('g03acc', irankx, 'irankx')
    g03acc_ctypes(weight, n, m, _x, tdx, _isx, nx, _ing, ng, _wt, _nig, _cvm, tdcvm, _e, tde, _ncv, _cvx, tdcvx, tol, _irankx, fail)
Esempio n. 21
0
def e01skc(m, x, y, f, triang, grads, px, py, pf, fail):
    """
    A function to evaluate, at a set of points, the two-dimensional
    interpolant function generated by e01sjc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/e01/e01skc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, y, f, triang, grads, pf
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, y, f, grads, pf
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        triang
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _x = nag_double_type_check_and_cast('e01skc', x, 'x')
    _y = nag_double_type_check_and_cast('e01skc', y, 'y')
    _f = nag_double_type_check_and_cast('e01skc', f, 'f')
    _triang = nag_integer_type_check_and_cast('e01skc', triang, 'triang')
    _grads = nag_double_type_check_and_cast('e01skc', grads, 'grads')
    _pf = nag_double_type_check_and_cast('e01skc', pf, 'pf')
    e01skc_ctypes(m, _x, _y, _f, _triang, _grads, px, py, _pf, fail)
Esempio n. 22
0
def e02gcc(order, m, n, a, b, tol, relerr, x, resmax, rank, _iter, fail):
    """
    L_infinity-approximation by general linear function.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/e02/e02gcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, b, relerr, x, resmax, rank, _iter
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a, b, relerr, x, resmax
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        rank, _iter
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _a = nag_double_type_check_and_cast('e02gcc', a, 'a')
    _b = nag_double_type_check_and_cast('e02gcc', b, 'b')
    _relerr = nag_double_type_check_and_cast('e02gcc', relerr, 'relerr')
    _x = nag_double_type_check_and_cast('e02gcc', x, 'x')
    _resmax = nag_double_type_check_and_cast('e02gcc', resmax, 'resmax')
    _rank = nag_integer_type_check_and_cast('e02gcc', rank, 'rank')
    __iter = nag_integer_type_check_and_cast('e02gcc', _iter, '_iter')
    e02gcc_ctypes(order, m, n, _a, _b, tol, _relerr, _x, _resmax, _rank, __iter, fail)
Esempio n. 23
0
def f04ccc(order, n, nrhs, dl, d, du, du2, ipiv, b, pdb, rcond, errbnd, fail):
    """
    Computes the solution, estimated condition number and error-bound to a
    complex tridiagonal system of linear equations.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04ccc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        dl, d, du, du2, ipiv, b, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        ipiv
    TypeError will be raised when the following arguments are not of data type
    Complex:
        dl, d, du, du2, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _dl = nag_complex_type_check_and_cast('f04ccc', dl, 'dl')
    _d = nag_complex_type_check_and_cast('f04ccc', d, 'd')
    _du = nag_complex_type_check_and_cast('f04ccc', du, 'du')
    _du2 = nag_complex_type_check_and_cast('f04ccc', du2, 'du2')
    _ipiv = nag_integer_type_check_and_cast('f04ccc', ipiv, 'ipiv')
    _b = nag_complex_type_check_and_cast('f04ccc', b, 'b')
    _rcond = nag_double_type_check_and_cast('f04ccc', rcond, 'rcond')
    _errbnd = nag_double_type_check_and_cast('f04ccc', errbnd, 'errbnd')
    f04ccc_ctypes(order, n, nrhs, _dl, _d, _du, _du2, _ipiv, _b, pdb, _rcond, _errbnd, fail)
Esempio n. 24
0
def g11bcc(stat, table, ncells, ndim, idim, isdim, subtable, maxst, mcells, mdim, mlevel, commar, fail):
    """
    Computes marginal tables for multiway table computed by g11bac or
    g11bbc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g11/g11bcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        table, idim, isdim, subtable, mcells, mdim, mlevel, commar
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        table, subtable, commar
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        idim, isdim, mcells, mdim, mlevel
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _table = nag_double_type_check_and_cast('g11bcc', table, 'table')
    _idim = nag_integer_type_check_and_cast('g11bcc', idim, 'idim')
    _isdim = nag_integer_type_check_and_cast('g11bcc', isdim, 'isdim')
    _subtable = nag_double_type_check_and_cast('g11bcc', subtable, 'subtable')
    _mcells = nag_integer_type_check_and_cast('g11bcc', mcells, 'mcells')
    _mdim = nag_integer_type_check_and_cast('g11bcc', mdim, 'mdim')
    _mlevel = nag_integer_type_check_and_cast('g11bcc', mlevel, 'mlevel')
    _commar = nag_double_type_check_and_cast('g11bcc', commar, 'commar')
    g11bcc_ctypes(stat, _table, ncells, ndim, _idim, _isdim, _subtable, maxst, _mcells, _mdim, _mlevel, _commar, fail)
Esempio n. 25
0
def f04djc(order, uplo, n, nrhs, ap, ipiv, b, pdb, rcond, errbnd, fail):
    """
    Computes the solution, estimated condition number and error-bound to a
    complex symmetric system of linear equations, packed storage.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f04/f04djc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        ap, ipiv, b, rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        rcond, errbnd
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        ipiv
    TypeError will be raised when the following arguments are not of data type
    Complex:
        ap, b
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _ap = nag_complex_type_check_and_cast('f04djc', ap, 'ap')
    _ipiv = nag_integer_type_check_and_cast('f04djc', ipiv, 'ipiv')
    _b = nag_complex_type_check_and_cast('f04djc', b, 'b')
    _rcond = nag_double_type_check_and_cast('f04djc', rcond, 'rcond')
    _errbnd = nag_double_type_check_and_cast('f04djc', errbnd, 'errbnd')
    f04djc_ctypes(order, uplo, n, nrhs, _ap, _ipiv, _b, pdb, _rcond, _errbnd, fail)
Esempio n. 26
0
def g11bbc(_type, n, nfac, sf, lfac, factor, tdf, percnt, y, wt, table, maxt, ncells, ndim, idim, count, fail):
    """
    Computes multiway table from set of classification factors using given
    percentile/quantile.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g11/g11bbc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        sf, lfac, factor, y, wt, table, ncells, ndim, idim, count
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        y, wt, table
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        sf, lfac, factor, ncells, ndim, idim, count
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _sf = nag_integer_type_check_and_cast('g11bbc', sf, 'sf')
    _lfac = nag_integer_type_check_and_cast('g11bbc', lfac, 'lfac')
    _factor = nag_integer_type_check_and_cast('g11bbc', factor, 'factor')
    _y = nag_double_type_check_and_cast('g11bbc', y, 'y')
    _wt = nag_double_type_check_and_cast('g11bbc', wt, 'wt')
    _table = nag_double_type_check_and_cast('g11bbc', table, 'table')
    _ncells = nag_integer_type_check_and_cast('g11bbc', ncells, 'ncells')
    _ndim = nag_integer_type_check_and_cast('g11bbc', ndim, 'ndim')
    _idim = nag_integer_type_check_and_cast('g11bbc', idim, 'idim')
    _count = nag_integer_type_check_and_cast('g11bbc', count, 'count')
    g11bbc_ctypes(_type, n, nfac, _sf, _lfac, _factor, tdf, percnt, _y, _wt, _table, maxt, _ncells, _ndim, _idim, _count, fail)
Esempio n. 27
0
def d06bac(nlines, coorch, lined, fbnd, crus, sdcrus, rate, ncomp, nlcomp, lcomp, nvmax, nedmx, nvb, coor, nedge, edge, itrace, outfile, comm, fail):
    """
    Generates a boundary mesh.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d06/d06bac.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        coorch, lined, crus, rate, nlcomp, lcomp, nvb, coor, nedge, edge
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        coorch, crus, rate, coor
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        lined, nlcomp, lcomp, nvb, nedge, edge
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _coorch = nag_double_type_check_and_cast('d06bac', coorch, 'coorch')
    _lined = nag_integer_type_check_and_cast('d06bac', lined, 'lined')
    _crus = nag_double_type_check_and_cast('d06bac', crus, 'crus')
    _rate = nag_double_type_check_and_cast('d06bac', rate, 'rate')
    _nlcomp = nag_integer_type_check_and_cast('d06bac', nlcomp, 'nlcomp')
    _lcomp = nag_integer_type_check_and_cast('d06bac', lcomp, 'lcomp')
    _nvb = nag_integer_type_check_and_cast('d06bac', nvb, 'nvb')
    _coor = nag_double_type_check_and_cast('d06bac', coor, 'coor')
    _nedge = nag_integer_type_check_and_cast('d06bac', nedge, 'nedge')
    _edge = nag_integer_type_check_and_cast('d06bac', edge, 'edge')
    d06bac_ctypes(nlines, _coorch, _lined, fbnd, _crus, sdcrus, _rate, ncomp, _nlcomp, _lcomp, nvmax, nedmx, _nvb, _coor, _nedge, _edge, itrace, outfile, comm, fail)
Esempio n. 28
0
def f02bjc(n, a, tda, b, tdb, tol, alfa, beta, wantv, v, tdv, _iter, fail):
    """
    Computes all eigenvalues and, optionally, eigenvectors of real
    generalized eigenproblem, by QZ algorithm.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f02/f02bjc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        a, b, alfa, beta, v, _iter
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        a, b, beta, v
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        _iter
    TypeError will be raised when the following arguments are not of data type
    Complex:
        alfa
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast

    _a = nag_double_type_check_and_cast("f02bjc", a, "a")
    _b = nag_double_type_check_and_cast("f02bjc", b, "b")
    _alfa = nag_complex_type_check_and_cast("f02bjc", alfa, "alfa")
    _beta = nag_double_type_check_and_cast("f02bjc", beta, "beta")
    _v = nag_double_type_check_and_cast("f02bjc", v, "v")
    __iter = nag_integer_type_check_and_cast("f02bjc", _iter, "_iter")
    f02bjc_ctypes(n, _a, tda, _b, tdb, tol, _alfa, _beta, wantv, _v, tdv, __iter, fail)
Esempio n. 29
0
def d06dbc(eps, nv1, nelt1, nedge1, coor1, edge1, conn1, reft1, nv2, nelt2, nedge2, coor2, edge2, conn2, reft2, nv3, nelt3, nedge3, coor3, edge3, conn3, reft3, itrace, outfile, fail):
    """
    Joins together two given adjacent (possibly overlapping) meshes.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d06/d06dbc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        coor1, edge1, conn1, reft1, coor2, edge2, conn2, reft2, nv3, nelt3, nedge3, coor3, edge3, conn3, reft3
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        coor1, coor2, coor3
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        edge1, conn1, reft1, edge2, conn2, reft2, nv3, nelt3, nedge3, edge3, conn3, reft3
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _coor1 = nag_double_type_check_and_cast('d06dbc', coor1, 'coor1')
    _edge1 = nag_integer_type_check_and_cast('d06dbc', edge1, 'edge1')
    _conn1 = nag_integer_type_check_and_cast('d06dbc', conn1, 'conn1')
    _reft1 = nag_integer_type_check_and_cast('d06dbc', reft1, 'reft1')
    _coor2 = nag_double_type_check_and_cast('d06dbc', coor2, 'coor2')
    _edge2 = nag_integer_type_check_and_cast('d06dbc', edge2, 'edge2')
    _conn2 = nag_integer_type_check_and_cast('d06dbc', conn2, 'conn2')
    _reft2 = nag_integer_type_check_and_cast('d06dbc', reft2, 'reft2')
    _nv3 = nag_integer_type_check_and_cast('d06dbc', nv3, 'nv3')
    _nelt3 = nag_integer_type_check_and_cast('d06dbc', nelt3, 'nelt3')
    _nedge3 = nag_integer_type_check_and_cast('d06dbc', nedge3, 'nedge3')
    _coor3 = nag_double_type_check_and_cast('d06dbc', coor3, 'coor3')
    _edge3 = nag_integer_type_check_and_cast('d06dbc', edge3, 'edge3')
    _conn3 = nag_integer_type_check_and_cast('d06dbc', conn3, 'conn3')
    _reft3 = nag_integer_type_check_and_cast('d06dbc', reft3, 'reft3')
    d06dbc_ctypes(eps, nv1, nelt1, nedge1, _coor1, _edge1, _conn1, _reft1, nv2, nelt2, nedge2, _coor2, _edge2, _conn2, _reft2, _nv3, _nelt3, _nedge3, _coor3, _edge3, _conn3, _reft3, itrace, outfile, fail)
Esempio n. 30
0
def d03pec(npde, ts, tout, pdedef, bndary, u, npts, x, nleft, acc, rsave, lrsave, isave, lisave, itask, itrace, outfile, ind, comm, saved, fail):
    """
    General system of first-order PDEs, method of lines, Keller box
    discretization, one space variable.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d03/d03pec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        ts, u, x, rsave, isave, ind
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        ts, u, x, rsave
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        isave, ind
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _ts = nag_double_type_check_and_cast('d03pec', ts, 'ts')
    _u = nag_double_type_check_and_cast('d03pec', u, 'u')
    _x = nag_double_type_check_and_cast('d03pec', x, 'x')
    _rsave = nag_double_type_check_and_cast('d03pec', rsave, 'rsave')
    _isave = nag_integer_type_check_and_cast('d03pec', isave, 'isave')
    _ind = nag_integer_type_check_and_cast('d03pec', ind, 'ind')
    d03pec_ctypes(npde, _ts, tout, pdedef, bndary, _u, npts, _x, nleft, acc, _rsave, lrsave, _isave, lisave, itask, itrace, outfile, _ind, comm, saved, fail)