Cython 优化根查找 API#

可以使用 Cython 直接访问以下根查找器的底层 C 函数

根查找函数的 Cython API 类似,只是没有 disp 参数。使用 cimportscipy.optimize.cython_optimize 中导入根查找函数。

from scipy.optimize.cython_optimize cimport bisect, ridder, brentq, brenth

回调签名#

cython_optimize 中的零点函数期望一个回调函数,该函数将标量自变量的双精度值作为第一个参数,并将用户定义的 struct 以及任何额外的参数作为第二个参数。

double (*callback_type)(double, void*) noexcept

示例#

使用 cython_optimize 需要 Cython 来编写回调函数,这些回调函数会编译成 C 代码。有关编译 Cython 的更多信息,请参见 Cython 文档

以下是一些基本步骤

  1. 创建一个 Cython .pyx 文件,例如:myexample.pyx

  2. cython_optimize 中导入所需的根查找器。

  3. 编写回调函数,并调用选定的根查找函数,传入回调函数、任何额外的参数以及其他求解器参数。

    from scipy.optimize.cython_optimize cimport brentq
    
    # import math from Cython
    from libc cimport math
    
    myargs = {'C0': 1.0, 'C1': 0.7}  # a dictionary of extra arguments
    XLO, XHI = 0.5, 1.0  # lower and upper search boundaries
    XTOL, RTOL, MITR = 1e-3, 1e-3, 10  # other solver parameters
    
    # user-defined struct for extra parameters
    ctypedef struct test_params:
        double C0
        double C1
    
    
    # user-defined callback
    cdef double f(double x, void *args) noexcept:
        cdef test_params *myargs = <test_params *> args
        return myargs.C0 - math.exp(-(x - myargs.C1))
    
    
    # Cython wrapper function
    cdef double brentq_wrapper_example(dict args, double xa, double xb,
                                       double xtol, double rtol, int mitr):
        # Cython automatically casts dictionary to struct
        cdef test_params myargs = args
        return brentq(
            f, xa, xb, <test_params *> &myargs, xtol, rtol, mitr, NULL)
    
    
    # Python function
    def brentq_example(args=myargs, xa=XLO, xb=XHI, xtol=XTOL, rtol=RTOL,
                       mitr=MITR):
        '''Calls Cython wrapper from Python.'''
        return brentq_wrapper_example(args, xa, xb, xtol, rtol, mitr)
    
  4. 如果要从 Python 调用函数,请创建一个 Cython 包装器,以及一个调用包装器的 Python 函数,或者使用 cpdef。然后,在 Python 中,你可以导入并运行示例。

    from myexample import brentq_example
    
    x = brentq_example()
    # 0.6999942848231314
    
  5. 如果需要导出任何 Cython 函数,请创建一个 Cython .pxd 文件。

完整输出#

cython_optimize 中的函数还可以将求解器的完整输出复制到一个 C struct 中,该 struct 作为最后一个参数传递。如果不需要完整输出,只需传递 NULL。完整输出 struct 必须是类型 zeros_full_output,该类型在 scipy.optimize.cython_optimize 中定义,具有以下字段

  • int funcalls: 函数调用次数

  • int iterations: 迭代次数

  • int error_num: 错误号

  • double root: 函数的根

根由 cython_optimize 复制到完整输出 struct 中。错误号 -1 表示符号错误,-2 表示收敛错误,0 表示求解器收敛。继续前面的示例

from scipy.optimize.cython_optimize cimport zeros_full_output


# cython brentq solver with full output
cdef zeros_full_output brentq_full_output_wrapper_example(
        dict args, double xa, double xb, double xtol, double rtol,
        int mitr):
    cdef test_params myargs = args
    cdef zeros_full_output my_full_output
    # use my_full_output instead of NULL
    brentq(f, xa, xb, &myargs, xtol, rtol, mitr, &my_full_output)
    return my_full_output


# Python function
def brent_full_output_example(args=myargs, xa=XLO, xb=XHI, xtol=XTOL,
                              rtol=RTOL, mitr=MITR):
    '''Returns full output'''
    return brentq_full_output_wrapper_example(args, xa, xb, xtol, rtol,
                                              mitr)

result = brent_full_output_example()
# {'error_num': 0,
#  'funcalls': 6,
#  'iterations': 5,
#  'root': 0.6999942848231314}