当前位置: 首页>>代码示例>>Python>>正文


Python util.nag_integer_type_check_and_cast函数代码示例

本文整理汇总了Python中nag4py.util.nag_integer_type_check_and_cast函数的典型用法代码示例。如果您正苦于以下问题:Python nag_integer_type_check_and_cast函数的具体用法?Python nag_integer_type_check_and_cast怎么用?Python nag_integer_type_check_and_cast使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。


在下文中一共展示了nag_integer_type_check_and_cast函数的15个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于系统推荐出更棒的Python代码示例。

示例1: c05rcc

def c05rcc(fcn, n, x, fvec, fjac, xtol, maxfev, scalemode, diag, factor, nprint, nfev, njev, r, qtf, comm, fail):
    """
    Solution of a system of nonlinear equations using first derivatives
    (comprehensive).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/c05/c05rcc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, fvec, fjac, diag, nfev, njev, r, qtf
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, fvec, fjac, diag, r, qtf
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        nfev, njev
    """
    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('c05rcc', x, 'x')
    _fvec = nag_double_type_check_and_cast('c05rcc', fvec, 'fvec')
    _fjac = nag_double_type_check_and_cast('c05rcc', fjac, 'fjac')
    _diag = nag_double_type_check_and_cast('c05rcc', diag, 'diag')
    _nfev = nag_integer_type_check_and_cast('c05rcc', nfev, 'nfev')
    _njev = nag_integer_type_check_and_cast('c05rcc', njev, 'njev')
    _r = nag_double_type_check_and_cast('c05rcc', r, 'r')
    _qtf = nag_double_type_check_and_cast('c05rcc', qtf, 'qtf')
    c05rcc_ctypes(fcn, n, _x, _fvec, _fjac, xtol, maxfev, scalemode, _diag, factor, nprint, _nfev, _njev, _r, _qtf, comm, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:27,代码来源:c05.py

示例2: g07bec

def g07bec(cens, n, x, ic, beta, gamma, tol, maxit, sebeta, segam, corr, dev, nit, fail):
    """
    Computes maximum likelihood estimates for parameters of the Weibull
    distribution.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g07/g07bec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        x, ic, beta, gamma, sebeta, segam, corr, dev, nit
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, beta, gamma, sebeta, segam, corr, dev
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        ic, 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('g07bec', x, 'x')
    _ic = nag_integer_type_check_and_cast('g07bec', ic, 'ic')
    _beta = nag_double_type_check_and_cast('g07bec', beta, 'beta')
    _gamma = nag_double_type_check_and_cast('g07bec', gamma, 'gamma')
    _sebeta = nag_double_type_check_and_cast('g07bec', sebeta, 'sebeta')
    _segam = nag_double_type_check_and_cast('g07bec', segam, 'segam')
    _corr = nag_double_type_check_and_cast('g07bec', corr, 'corr')
    _dev = nag_double_type_check_and_cast('g07bec', dev, 'dev')
    _nit = nag_integer_type_check_and_cast('g07bec', nit, 'nit')
    g07bec_ctypes(cens, n, _x, _ic, _beta, _gamma, tol, maxit, _sebeta, _segam, _corr, _dev, _nit, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:28,代码来源:g07.py

示例3: e01aec

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)
开发者ID:jcmuddle,项目名称:naglib,代码行数:25,代码来源:e01.py

示例4: f12aqc

def f12aqc(nconv, d, z, sigma, resid, v, comm, icomm, fail):
    """
    Selected eigenvalues and, optionally, eigenvectors of a complex sparse
    eigenproblem, postprocessing for f12apc.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12aqc.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.int32 or numpy.int64:
        nconv, icomm
    TypeError will be raised when the following arguments are not of data type
    Complex:
        d, z, resid, v, comm
    """
    from nag4py.util import nag_complex_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _nconv = nag_integer_type_check_and_cast('f12aqc', nconv, 'nconv')
    _d = nag_complex_type_check_and_cast('f12aqc', d, 'd')
    _z = nag_complex_type_check_and_cast('f12aqc', z, 'z')
    _resid = nag_complex_type_check_and_cast('f12aqc', resid, 'resid')
    _v = nag_complex_type_check_and_cast('f12aqc', v, 'v')
    _comm = nag_complex_type_check_and_cast('f12aqc', comm, 'comm')
    _icomm = nag_integer_type_check_and_cast('f12aqc', icomm, 'icomm')
    f12aqc_ctypes(_nconv, _d, _z, sigma, _resid, _v, _comm, _icomm, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:26,代码来源:f12.py

示例5: f12fgc

def f12fgc(kl, ku, ab, mb, sigma, nconv, d, z, resid, v, comm, icomm, fail):
    """
    Selected eigenvalues and, optionally, eigenvectors of a real symmetric
    banded eigenproblem, driver.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/f12/f12fgc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        ab, mb, nconv, d, z, resid, v, comm, icomm
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        ab, mb, 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
    _ab = nag_double_type_check_and_cast('f12fgc', ab, 'ab')
    _mb = nag_double_type_check_and_cast('f12fgc', mb, 'mb')
    _nconv = nag_integer_type_check_and_cast('f12fgc', nconv, 'nconv')
    _d = nag_double_type_check_and_cast('f12fgc', d, 'd')
    _z = nag_double_type_check_and_cast('f12fgc', z, 'z')
    _resid = nag_double_type_check_and_cast('f12fgc', resid, 'resid')
    _v = nag_double_type_check_and_cast('f12fgc', v, 'v')
    _comm = nag_double_type_check_and_cast('f12fgc', comm, 'comm')
    _icomm = nag_integer_type_check_and_cast('f12fgc', icomm, 'icomm')
    f12fgc_ctypes(kl, ku, _ab, _mb, sigma, _nconv, _d, _z, _resid, _v, _comm, _icomm, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:28,代码来源:f12.py

示例6: g11cac

def g11cac(order, n, m, ns, z, pdz, isz, p, ic, isi, dev, b, se, sc, cov, nca, nct, tol, maxit, iprint, outfile, fail):
    """
    Returns parameter estimates for the conditional analysis of stratified
    data.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g11/g11cac.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        z, isz, ic, isi, dev, b, se, sc, cov, nca, nct
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        z, dev, b, se, sc, cov
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        isz, ic, isi, nca, nct
    """
    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('g11cac', z, 'z')
    _isz = nag_integer_type_check_and_cast('g11cac', isz, 'isz')
    _ic = nag_integer_type_check_and_cast('g11cac', ic, 'ic')
    _isi = nag_integer_type_check_and_cast('g11cac', isi, 'isi')
    _dev = nag_double_type_check_and_cast('g11cac', dev, 'dev')
    _b = nag_double_type_check_and_cast('g11cac', b, 'b')
    _se = nag_double_type_check_and_cast('g11cac', se, 'se')
    _sc = nag_double_type_check_and_cast('g11cac', sc, 'sc')
    _cov = nag_double_type_check_and_cast('g11cac', cov, 'cov')
    _nca = nag_integer_type_check_and_cast('g11cac', nca, 'nca')
    _nct = nag_integer_type_check_and_cast('g11cac', nct, 'nct')
    g11cac_ctypes(order, n, m, ns, _z, pdz, _isz, p, _ic, _isi, _dev, _b, _se, _sc, _cov, _nca, _nct, tol, maxit, iprint, outfile, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:30,代码来源:g11.py

示例7: f02xec

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)
开发者ID:jcmuddle,项目名称:naglib,代码行数:31,代码来源:f02.py

示例8: d02gac

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)
开发者ID:jcmuddle,项目名称:naglib,代码行数:25,代码来源:d02.py

示例9: d02nec

def d02nec(neq, t, tout, y, ydot, rtol, atol, itask, res, jac, icom, com, lcom, comm, fail):
    """
    Implicit ordinary differential equations/DAEs, initial value problem,
    DASSL method integrator.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/d02/d02nec.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        t, y, ydot, rtol, atol, itask, icom, com
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        t, y, ydot, rtol, atol, com
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        itask, icom
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _t = nag_double_type_check_and_cast('d02nec', t, 't')
    _y = nag_double_type_check_and_cast('d02nec', y, 'y')
    _ydot = nag_double_type_check_and_cast('d02nec', ydot, 'ydot')
    _rtol = nag_double_type_check_and_cast('d02nec', rtol, 'rtol')
    _atol = nag_double_type_check_and_cast('d02nec', atol, 'atol')
    _itask = nag_integer_type_check_and_cast('d02nec', itask, 'itask')
    _icom = nag_integer_type_check_and_cast('d02nec', icom, 'icom')
    _com = nag_double_type_check_and_cast('d02nec', com, 'com')
    d02nec_ctypes(neq, _t, tout, _y, _ydot, _rtol, _atol, _itask, res, jac, _icom, _com, lcom, comm, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:27,代码来源:d02.py

示例10: g04bcc

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)
开发者ID:jcmuddle,项目名称:naglib,代码行数:31,代码来源:g04.py

示例11: h02buc

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)
开发者ID:jcmuddle,项目名称:naglib,代码行数:25,代码来源:h02.py

示例12: g04bbc

def g04bbc(n, y, blocks, iblock, nt, it, gmean, bmean, tmean, table, c, tdc, irep, r, ef, tol, irdf, fail):
    """
    General block design or completely randomized design.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g04/g04bbc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        y, it, gmean, bmean, tmean, table, c, irep, r, ef
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        y, gmean, bmean, tmean, table, c, 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('g04bbc', y, 'y')
    _it = nag_integer_type_check_and_cast('g04bbc', it, 'it')
    _gmean = nag_double_type_check_and_cast('g04bbc', gmean, 'gmean')
    _bmean = nag_double_type_check_and_cast('g04bbc', bmean, 'bmean')
    _tmean = nag_double_type_check_and_cast('g04bbc', tmean, 'tmean')
    _table = nag_double_type_check_and_cast('g04bbc', table, 'table')
    _c = nag_double_type_check_and_cast('g04bbc', c, 'c')
    _irep = nag_integer_type_check_and_cast('g04bbc', irep, 'irep')
    _r = nag_double_type_check_and_cast('g04bbc', r, 'r')
    _ef = nag_double_type_check_and_cast('g04bbc', ef, 'ef')
    g04bbc_ctypes(n, _y, blocks, iblock, nt, _it, _gmean, _bmean, _tmean, _table, _c, tdc, _irep, _r, _ef, tol, irdf, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:28,代码来源:g04.py

示例13: g04cac

def g04cac(n, y, nfac, lfac, nblock, inter, irdf, mterm, table, tmean, maxt, e, imean, semean, bmean, r, fail):
    """
    Complete factorial design.
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/g04/g04cac.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        y, lfac, mterm, table, tmean, maxt, e, imean, semean, bmean, r
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        y, table, tmean, e, semean, bmean, r
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        lfac, mterm, maxt, imean
    """
    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('g04cac', y, 'y')
    _lfac = nag_integer_type_check_and_cast('g04cac', lfac, 'lfac')
    _mterm = nag_integer_type_check_and_cast('g04cac', mterm, 'mterm')
    _table = nag_double_type_check_and_cast('g04cac', table, 'table')
    _tmean = nag_double_type_check_and_cast('g04cac', tmean, 'tmean')
    _maxt = nag_integer_type_check_and_cast('g04cac', maxt, 'maxt')
    _e = nag_double_type_check_and_cast('g04cac', e, 'e')
    _imean = nag_integer_type_check_and_cast('g04cac', imean, 'imean')
    _semean = nag_double_type_check_and_cast('g04cac', semean, 'semean')
    _bmean = nag_double_type_check_and_cast('g04cac', bmean, 'bmean')
    _r = nag_double_type_check_and_cast('g04cac', r, 'r')
    g04cac_ctypes(n, _y, nfac, _lfac, nblock, inter, irdf, _mterm, _table, _tmean, _maxt, _e, _imean, _semean, _bmean, _r, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:29,代码来源:g04.py

示例14: c05rdc

def c05rdc(irevcm, n, x, fvec, fjac, xtol, scalemode, diag, factor, r, qtf, iwsav, rwsav, fail):
    """
    Solution of a system of nonlinear equations using first derivatives
    (reverse communication).
    http://www.nag.co.uk/numeric/CL/nagdoc_cl23/html/c05/c05rdc.html

    TypeError will be raised when the following arguments are not instances
    of numpy.ndarray:
        irevcm, x, fvec, fjac, diag, r, qtf, iwsav, rwsav
    TypeError will be raised when the following arguments are not of data type
    numpy.float:
        x, fvec, fjac, diag, r, qtf, rwsav
    TypeError will be raised when the following arguments are not of data type
    numpy.int32 or numpy.int64:
        irevcm, iwsav
    """
    from nag4py.util import nag_double_type_check_and_cast
    from nag4py.util import nag_integer_type_check_and_cast
    _irevcm = nag_integer_type_check_and_cast('c05rdc', irevcm, 'irevcm')
    _x = nag_double_type_check_and_cast('c05rdc', x, 'x')
    _fvec = nag_double_type_check_and_cast('c05rdc', fvec, 'fvec')
    _fjac = nag_double_type_check_and_cast('c05rdc', fjac, 'fjac')
    _diag = nag_double_type_check_and_cast('c05rdc', diag, 'diag')
    _r = nag_double_type_check_and_cast('c05rdc', r, 'r')
    _qtf = nag_double_type_check_and_cast('c05rdc', qtf, 'qtf')
    _iwsav = nag_integer_type_check_and_cast('c05rdc', iwsav, 'iwsav')
    _rwsav = nag_double_type_check_and_cast('c05rdc', rwsav, 'rwsav')
    c05rdc_ctypes(_irevcm, n, _x, _fvec, _fjac, xtol, scalemode, _diag, factor, _r, _qtf, _iwsav, _rwsav, fail)
开发者ID:jcmuddle,项目名称:naglib,代码行数:28,代码来源:c05.py

示例15: e02gcc

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)
开发者ID:jcmuddle,项目名称:naglib,代码行数:25,代码来源:e02.py


注:本文中的nag4py.util.nag_integer_type_check_and_cast函数示例由纯净天空整理自Github/MSDocs等开源代码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。