ls.auto_direct
: The automatically selected linear direct solver.ls.auto_iterative
: The automatically selected linear iterative solver.
ts.adaptive
: Implicit time stepping solver with an adaptive time step.ts.bathe
: Solve elastodynamics problems by the Bathe method.ts.central_difference
: Solve elastodynamics problems by the explicit central difference method.ts.euler
: Simple forward euler methodts.generalized_alpha
: Solve elastodynamics problems by the generalized \alpha method.ts.multistaged
: Explicit time stepping solver with multistage solve_step methodts.newmark
: Solve elastodynamics problems by the Newmark method.ts.runge_kutta_4
: Classical 4th order Runge-Kutta method,ts.simple
: Implicit time stepping solver with a fixed time step.ts.stationary
: Solver for stationary problems without time stepping.ts.tvd_runge_kutta_3
: 3rd order Total Variation Diminishing Runge-Kutta methodts.velocity_verlet
: Solve elastodynamics problems by the explicit velocity-Verlet method.
tsc.ed_basic
: Adaptive time step I-controller for elastodynamics.tsc.ed_linear
: Adaptive time step controller for elastodynamics and linear problems.tsc.ed_pid
: Adaptive time step PID controller for elastodynamics.tsc.fixed
: Fixed (do-nothing) time step controller.tsc.time_sequence
: Given times sequence time step controller.
nls.newton
: Solves a nonlinear system f(x) = 0 using the Newton method.nls.oseen
: The Oseen solver for Navier-Stokes equations.nls.petsc
: Interface to PETSc SNES (Scalable Nonlinear Equations Solvers).nls.scipy_root
: Interface toscipy.optimize.root()
.nls.semismooth_newton
: The semi-smooth Newton method.
ls.cholesky
: Interface to scikit-sparse.cholesky solver.ls.cm_pb
: Conjugate multiple problems.ls.mumps
: Interface to MUMPS solver.ls.petsc
: PETSc Krylov subspace solver.ls.pyamg
: Interface to PyAMG solvers.ls.pyamg_krylov
: Interface to PyAMG Krylov solvers.ls.pypardiso
: PyPardiso direct solver.ls.rmm
: Special solver for explicit transient elastodynamics.ls.schur_mumps
: Mumps Schur complement solver.ls.scipy_direct
: Direct sparse solver from SciPy.ls.scipy_iterative
: Interface to SciPy iterative solvers.ls.scipy_superlu
: SuperLU - direct sparse solver from SciPy.ls.scipy_umfpack
: UMFPACK - direct sparse solver from SciPy.
eig.matlab
: Matlab eigenvalue problem solver.eig.octave
: Octave eigenvalue problem solver.eig.primme
: PRIMME eigenvalue problem solver.eig.scipy
: SciPy-based solver for both dense and sparse problems.eig.scipy_lobpcg
: SciPy-based LOBPCG solver for sparse symmetric problems.eig.sgscipy
: SciPy-based solver for dense symmetric problems.eig.slepc
: General SLEPc eigenvalue problem solver.
eig.qevp
: Quadratic eigenvalue problem solver based on the problem linearization.
nls.scipy_fmin_like
: Interface to SciPy optimization solvers scipy.optimize.fmin_*.opt.fmin_sd
: Steepest descent optimization solver.