diff --git a/.doctrees/environment.pickle b/.doctrees/environment.pickle index 59f6f00..d585255 100644 Binary files a/.doctrees/environment.pickle and b/.doctrees/environment.pickle differ diff --git a/.doctrees/mici.adapters.doctree b/.doctrees/mici.adapters.doctree index 6362fcd..1fc986f 100644 Binary files a/.doctrees/mici.adapters.doctree and b/.doctrees/mici.adapters.doctree differ diff --git a/.doctrees/mici.integrators.doctree b/.doctrees/mici.integrators.doctree index 1c81753..6e60c08 100644 Binary files a/.doctrees/mici.integrators.doctree and b/.doctrees/mici.integrators.doctree differ diff --git a/.doctrees/mici.samplers.doctree b/.doctrees/mici.samplers.doctree index 144dd4c..6e45b2a 100644 Binary files a/.doctrees/mici.samplers.doctree and b/.doctrees/mici.samplers.doctree differ diff --git a/.doctrees/mici.stagers.doctree b/.doctrees/mici.stagers.doctree index f838822..188fbb1 100644 Binary files a/.doctrees/mici.stagers.doctree and b/.doctrees/mici.stagers.doctree differ diff --git a/.doctrees/mici.systems.doctree b/.doctrees/mici.systems.doctree index c9413d7..27f556b 100644 Binary files a/.doctrees/mici.systems.doctree and b/.doctrees/mici.systems.doctree differ diff --git a/_modules/mici/adapters.html b/_modules/mici/adapters.html index c6dc091..c75063f 100644 --- a/_modules/mici/adapters.html +++ b/_modules/mici/adapters.html @@ -185,7 +185,7 @@

Source code for mici.adapters

         An adapter which requires only local information to adapt the transition
         parameters should be classified as fast while one which requires more global
         information and so more chain iterations should be classified as slow i.e.
-        `is_fast == False`.
+        :code:`is_fast == False`.
         """
diff --git a/_modules/mici/integrators.html b/_modules/mici/integrators.html index 0a11f4c..b3a32d6 100644 --- a/_modules/mici/integrators.html +++ b/_modules/mici/integrators.html @@ -90,27 +90,28 @@

Source code for mici.integrators

 if TYPE_CHECKING:
     from typing import Any, Callable, Optional, Sequence
     from mici.states import ChainState
-    from mici.systems import System
+    from mici.systems import System, TractableFlowSystem
     from mici.types import NormFunction
 
 
 
[docs]class Integrator(ABC): - """Base class for integrators for simulating Hamiltonian dynamics. + r"""Base class for integrators for simulating Hamiltonian dynamics. - For a Hamiltonian function `h` with position variables `q` and momentum variables - `p`, the canonical Hamiltonian dynamic is defined by the ordinary differential - equation system + For a Hamiltonian function :math:`h` with position variables :math:`q` and momentum + variables :math:`p`, the canonical Hamiltonian dynamic is defined by the ordinary + differential equation system - q̇ = ∇₂h(q, p) - ṗ = -∇₁h(q, p) + .. math:: + + \dot{q} = \nabla_2 h(q, p), \qquad \dot{p} = -\nabla_1 h(q, p) with the flow map corresponding to the solution of the corresponding initial value problem a time-reversible and symplectic (and by consequence volume-preserving) map. - Derived classes implement a `step` method which approximates the flow-map over some - small time interval, while conserving the properties of being time-reversible and - symplectic, with composition of this integrator step method allowing simulation of - time-discretised trajectories of the Hamiltonian dynamics. + Derived classes implement a :py:meth:`step` method which approximates the flow-map + over some small time interval, while conserving the properties of being + time-reversible and symplectic, with composition of this integrator step method + allowing simulation of time-discretised trajectories of the Hamiltonian dynamics. """ def __init__(self, system: System, step_size: Optional[float] = None): @@ -157,23 +158,26 @@

Source code for mici.integrators

 
     The Hamiltonian function is assumed to be expressible as the sum of two analytically
     tractable components for which the corresponding Hamiltonian flows can be exactly
-    simulated. Specifically it is assumed that the Hamiltonian function `h` takes the
-    form
+    simulated. Specifically it is assumed that the Hamiltonian function :math:`h` takes
+    the form
 
-        h(q, p) = h₁(q) + h₂(q, p)
+    .. math::
 
-    where `q` and `p` are the position and momentum variables respectively, and `h₁` and
-    `h₂` are Hamiltonian component functions for which the exact flows can be computed.
+        h(q, p) = h_1(q) + h_2(q, p)
+
+    where :math:`q` and :math:`p` are the position and momentum variables respectively,
+    and :math:`h_1` and :math:`h_2` are Hamiltonian component functions for which the
+    exact flows can be computed.
     """
 
-    def __init__(self, system: System, step_size: Optional[float] = None):
+    def __init__(self, system: TractableFlowSystem, step_size: Optional[float] = None):
         """
         Args:
-            system: Hamiltonian system to integrate the dynamics of. Must define both
-                `h1_flow` and `h2_flow` methods.
-            step_size: Integrator time step. If set to `None` it is assumed that a step
-                size adapter will be used to set the step size before calling the `step`
-                method.
+            system: Hamiltonian system to integrate the dynamics of with tractable
+                Hamiltonian component flows.
+            step_size: Integrator time step. If set to :code:`None` it is assumed that a
+                step size adapter will be used to set the step size before calling the
+                :py:meth:`step` method.
         """
         if not hasattr(system, "h1_flow") or not hasattr(system, "h2_flow"):
             raise ValueError(
@@ -189,25 +193,29 @@ 

Source code for mici.integrators

 
[docs]class LeapfrogIntegrator(TractableFlowIntegrator): """Leapfrog integrator for Hamiltonian systems with tractable component flows. - For separable Hamiltonians of the form + For separable Hamiltonians of the - h(q, p) = h₁(q) + h₂(p) + .. math:: - where `h₁` is the potential energy and `h₂` is the kinetic energy, this integrator - corresponds to the classic (position) Störmer-Verlet method. + h(q, p) = h_1(q) + h_2(p) + + where :math:`h_1` is the potential energy and :math:`h_2` is the kinetic energy, + this integrator corresponds to the classic (position) Störmer-Verlet method. The integrator can also be applied to the more general Hamiltonian splitting - h(q, p) = h₁(q) + h₂(q, p) + .. math:: + + h(q, p) = h_1(q) + h_2(q, p) - providing the flows for `h₁` and `h₂` are both tractable. + providing the flows for :math:`h_1` and :math:`h_2` are both tractable. For more details see Sections 2.6 and 4.2.2 in Leimkuhler and Reich (2004). References: - Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). - Cambridge University Press. + 1. Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). + Cambridge University Press. """ def _step(self, state: ChainState, time_step: float): @@ -217,39 +225,61 @@

Source code for mici.integrators

 
 
 
[docs]class SymmetricCompositionIntegrator(TractableFlowIntegrator): - """Symmetric composition integrator for Hamiltonians with tractable component flows. + r"""Symmetric composition integrator for Hamiltonians with tractable component flows The Hamiltonian function is assumed to be expressible as the sum of two analytically tractable components for which the corresponding Hamiltonian flows can be exactly - simulated. Specifically it is assumed that the Hamiltonian function h takes the form + simulated. Specifically it is assumed that the Hamiltonian function :math:`h` takes + the form - h(q, p) = h₁(q) + h₂(q, p) + .. math:: - where `q` and `p` are the position and momentum variables respectively, and `h₁` and - `h₂` are Hamiltonian component functions for which the exact flows, respectively - `Φ₁` and `Φ₂`, can be computed. An alternating composition can then be formed as + h(q, p) = h_1(q) + h_2(q, p) + + where :math:`q` and :math:`p` are the position and momentum variables respectively, + and :math:`h_1` and :math:`h_2` are Hamiltonian component functions for which the + exact flows, respectively :math:`\Phi_1` and :math:`\Phi_2`, can be computed. An + alternating composition can then be formed as + + .. math:: - Ψ(t) = A(aₛt) ∘ B(bₛt) ∘ ⋯ ∘ A(a₁t) ∘ B(b₁t) ∘ A(a₀t) + \Psi(t) = + A(a_S t) \circ B(b_S t) \circ \dots \circ A(a_1 t) \circ B(b_1 t) \circ A(a_0 t) - where `A = Φ₁` and `B = Φ₂` or `A = Φ₂` and `B = Φ₁`, and `(a₀, ⋯, aₛ)` and - `(b₁, ⋯, bₛ)` are a set of coefficients to be determined and `s` is the number of - stages in the composition. + where :math:`A = \Phi_1` and :math:`B = \Phi_2` or :math:`A = \Phi_2` and :math:`B = + \Phi_1`, and :math:`(a_0,\dots, a_S)` and :math:`(b_1, \dots, b_S)` are a set of + coefficients to be determined and :math:`S` is the number of stages in the + composition. To ensure a consistency (i.e. the integrator is at least order one) we require that - sum(a₀, ⋯, aₛ) = sum(b₁, ⋯, bₛ) = 1 + .. math:: + + \sum_{s=0}^S a_s = \sum_{s=1}^S b_s = 1. For symmetric compositions we restrict that - aₛ₋ₘ = aₘ and bₛ₊₁₋ₘ = bₛ + .. math:: + + a_{S-m} = a_m, \quad b_{S+1-m} = b_s with symmetric consistent methods of at least order two. - The combination of the symmetry and consistency requirements mean that a `s`-stage - symmetric composition method can be described by `(s - 1)` 'free' coefficients + The combination of the symmetry and consistency requirements mean that a + :math:`S`-stage symmetric composition method can be described by :math:`S - 1` + 'free' coefficients + + .. math:: + + (a_0, b_1, a_1, \dots, a_K, b_K) + + with :math:`K = (S - 1) / 2` if :math:`S` is odd or + + .. math:: - (a₀, b₁, a₁, ⋯, aₖ, bₖ) with k = (s - 1) / 2 if s is odd or - (a₀, b₁, a₁, ⋯, aₖ) with k = (s - 2) / 2 if s is even + (a_0, b_1, a_1, \dots, a_K) + + with :math:`K = (S - 2) / 2` if :math:`S` is even. The Störmer-Verlet 'leapfrog' integrator is a special case corresponding to the unique (symmetric and consistent) 1-stage integrator. @@ -258,30 +288,33 @@

Source code for mici.integrators

 
     References:
 
-    Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14).
-    Cambridge University Press.
+      1. Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14).
+         Cambridge University Press.
     """
 
     def __init__(
         self,
-        system: System,
+        system: TractableFlowSystem,
         free_coefficients: Sequence[float],
         step_size: Optional[float] = None,
         initial_h1_flow_step: bool = True,
     ):
-        """
+        r"""
         Args:
-            system: Hamiltonian system to integrate the dynamics of.
-            free_coefficients: Sequence of `s - 1` scalar values, where `s` is the
-                number of stages in the symmetric composition, specifying the free
-                coefficients `(a₀, b₁, a₁, ⋯, aₖ, bₖ)` with `k = (s - 1) / 2` if `s` is
-                odd or `(a₀, b₁, a₁, ⋯, aₖ)` with `k = (s - 2) / 2` if `s` is even.
-            step_size: Integrator time step. If set to `None` it is assumed that a step
-                size adapter will be used to set the step size before calling the `step`
-                method.
-            initial_h1_flow_step: Whether the initial 'A' flow in the composition should
-                correspond to the flow of the `h₁` Hamiltonian component (`True`) or to
-                the flow of the `h₂` component (`False`).
+            system: Hamiltonian system to integrate the dynamics of with tractable
+                Hamiltonian component flows.
+            free_coefficients: Sequence of :math:`S - 1` scalar values, where :math:`S`
+                is the number of stages in the symmetric composition, specifying the
+                free coefficients :math:`(a_0, b_1, a_1, \dots, a_K, b_K)` with :math:`K
+                = (S - 1) / 2` if :math:`S` is odd or :math:`(a_0, b_1, a_1, \dots,
+                a_K)` with :math:`k = (S - 2) / 2` if `S` is even.
+            step_size: Integrator time step. If set to :code:`None` it is assumed that a
+                step size adapter will be used to set the step size before calling the
+                :py:meth:`step` method.
+            initial_h1_flow_step: Whether the initial :math:`A` flow in the composition
+                should correspond to the flow of the `h_1` Hamiltonian component
+                (:code:`True`) or to the flow of the :math:`h_2` component
+                (:code:`False`).
         """
         super().__init__(system, step_size)
         self.initial_h1_flow_step = initial_h1_flow_step
@@ -310,18 +343,19 @@ 

Source code for mici.integrators

 
     References:
 
-    Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014).
-    Numerical integrators for the Hybrid Monte Carlo method.
-    SIAM Journal on Scientific Computing, 36(4), A1556-A1580.
+      1. Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014).
+         Numerical integrators for the Hybrid Monte Carlo method.
+         SIAM Journal on Scientific Computing, 36(4), A1556-A1580.
     """
 
-    def __init__(self, system: System, step_size: Optional[float] = None):
+    def __init__(self, system: TractableFlowSystem, step_size: Optional[float] = None):
         """
         Args:
-            system: Hamiltonian system to integrate the dynamics  of.
-            step_size: Integrator time step. If set to `None` it is assumed that a step
-                size adapter will be used to set the step size before calling the `step`
-                method.
+            system: Hamiltonian system to integrate the dynamics of with tractable
+                Hamiltonian component flows.
+            step_size: Integrator time step. If set to :code:`None` it is assumed that a
+                step size adapter will be used to set the step size before calling the
+                :py:meth:`step` method.
         """
         a_0 = (3 - 3 ** 0.5) / 6
         super().__init__(system, (a_0,), step_size, True)
@@ -334,18 +368,19 @@

Source code for mici.integrators

 
     References:
 
-    Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014).
-    Numerical integrators for the Hybrid Monte Carlo method.
-    SIAM Journal on Scientific Computing, 36(4), A1556-A1580.
+      1. Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014).
+         Numerical integrators for the Hybrid Monte Carlo method.
+         SIAM Journal on Scientific Computing, 36(4), A1556-A1580.
     """
 
-    def __init__(self, system: System, step_size: Optional[float] = None):
+    def __init__(self, system: TractableFlowSystem, step_size: Optional[float] = None):
         """
         Args:
-            system: Hamiltonian system to integrate the dynamics  of.
-            step_size: Integrator time step. If set to `None` it is assumed that a step
-                size adapter will be used to set the step size before calling the `step`
-                method.
+            system: Hamiltonian system to integrate the dynamics of with tractable
+                Hamiltonian component flows.
+            step_size: Integrator time step. If set to :code:`None` it is assumed that a
+                step size adapter will be used to set the step size before calling the
+                :py:meth:`step` method.
         """
         a_0 = 0.11888010966548
         b_1 = 0.29619504261126
@@ -359,18 +394,19 @@ 

Source code for mici.integrators

 
     References:
 
-    Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014).
-    Numerical integrators for the Hybrid Monte Carlo method.
-    SIAM Journal on Scientific Computing, 36(4), A1556-A1580.
+      1. Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014).
+         Numerical integrators for the Hybrid Monte Carlo method.
+         SIAM Journal on Scientific Computing, 36(4), A1556-A1580.
     """
 
-    def __init__(self, system: System, step_size: Optional[float] = None):
+    def __init__(self, system: TractableFlowSystem, step_size: Optional[float] = None):
         """
         Args:
-            system: Hamiltonian system to integrate the dynamics  of.
-            step_size: Integrator time step. If set to `None` it is assumed that a step
-                size adapter will be used to set the step size before calling the `step`
-                method.
+            system: Hamiltonian system to integrate the dynamics of with tractable
+                Hamiltonian component flows.
+            step_size: Integrator time step. If set to :code:`None` it is assumed that
+                a step size adapter will be used to set the step size before calling the
+                :py:meth:`step` method.
         """
         a_0 = 0.071353913450279725904
         b_1 = 0.191667800000000000000
@@ -383,18 +419,20 @@ 

Source code for mici.integrators

 
     Also known as the generalised leapfrog method.
 
-    The Hamiltonian function `h` is assumed to take the form
+    The Hamiltonian function :math:`h` is assumed to take the form
 
-        h(q, p) = h₁(q) + h₂(q, p)
+    .. math::
 
-    where `q` and `p` are the position and momentum variables respectively, `h₁` is a
-    Hamiltonian component function for which the exact flow can be computed and `h₂` is
-    a Hamiltonian component function of the position and momentum variables, which may
-    be non-separable and for which exact simulation of the correspond Hamiltonian flow
-    may not be possible.
+        h(q, p) = h_1(q) + h_2(q, p)
+
+    where :math:`q` and :math:`p` are the position and momentum variables respectively,
+    :math:`h_1` is a Hamiltonian component function for which the exact flow can be
+    computed and :math:`h_2` is a Hamiltonian component function of the position and
+    momentum variables, which may be non-separable and for which exact simulation of the
+    correspond Hamiltonian flow may not be possible.
 
     A pair of implicit component updates are used to approximate the flow due to the
-    `h₂` Hamiltonian component, with a fixed-point iteration used to solve the
+    :math:`h_2` Hamiltonian component, with a fixed-point iteration used to solve the
     non-linear system of equations.
 
     The resulting implicit integrator is a symmetric second-order method corresponding
@@ -403,8 +441,8 @@ 

Source code for mici.integrators

 
     References:
 
-    Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14).
-    Cambridge University Press.
+      1. Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14).
+         Cambridge University Press.
     """
 
     def __init__(
diff --git a/_modules/mici/samplers.html b/_modules/mici/samplers.html
index f057fe6..e04f7a1 100644
--- a/_modules/mici/samplers.html
+++ b/_modules/mici/samplers.html
@@ -877,8 +877,18 @@ 

Source code for mici.samplers

                 DeprecationWarning,
             )
             rng = np.random.Generator(rng._bit_generator)
-        self.rng = rng
-        self.transitions = transitions
+        self._rng = rng
+        self._transitions = transitions
+
+    @property
+    def transitions(self) -> dict[str, Transition]:
+        """Dictionary of transition kernels sampled from in each chain iteration."""
+        return self._transitions
+
+    @property
+    def rng(self) -> Generator:
+        """NumPy random number generator object."""
+        return self._rng
 
 
[docs] def sample_chains( self, @@ -1164,21 +1174,22 @@

Source code for mici.samplers

     ):
         """
         Args:
-            system Hamiltonian system to be simulated.
+            system Hamiltonian system to be simulated, corresponding to joint
+                distribution on augmented space.
             rng: Numpy random number generator.
-            integration_transition: Markov transition kernel which leaves canonical
+            integration_transition: Markov transition kernel which leaves joint
                 distribution invariant and jointly updates the position and momentum
                 components of the chain state by integrating the Hamiltonian dynamics of
                 the system to propose new values for the state.
             momentum_transition: Markov transition kernel which leaves the conditional
-                distribution on the momentum under the canonical distribution invariant,
+                distribution on the momentum under the join distribution invariant,
                 updating only the momentum component of the chain state. If set to
-                `None` the momentum transition operator
-                `mici.transitions.IndependentMomentumTransition` will be used, which
-                independently samples the momentum from its conditional distribution.
+                :py:const:`None` the momentum transition operator
+                :py:class:`mici.transitions.IndependentMomentumTransition` will be used,
+                which independently samples the momentum from its conditional
+                distribution.
         """
-        self.system = system
-        self.rng = rng
+        self._system = system
         if momentum_transition is None:
             momentum_transition = IndependentMomentumTransition(system)
         super().__init__(
@@ -1189,6 +1200,11 @@ 

Source code for mici.samplers

             },
         )
 
+    @property
+    def system(self) -> System:
+        """Hamiltonian system corresponding to joint distribution on augmented space."""
+        return self._system
+
     def _preprocess_init_state(
         self, init_state: Union[NDArray, ChainState, dict]
     ) -> ChainState:
diff --git a/_modules/mici/stagers.html b/_modules/mici/stagers.html
index 0e444e4..00b4df8 100644
--- a/_modules/mici/stagers.html
+++ b/_modules/mici/stagers.html
@@ -70,7 +70,7 @@
            

Source code for mici.stagers

-"""Classes for controlling sampling of Markov chains split into stages."""
+"""Classes for staging sampling of Markov chains."""
 
 from __future__ import annotations
 
@@ -78,26 +78,24 @@ 

Source code for mici.stagers

 from typing import NamedTuple, TYPE_CHECKING
 
 if TYPE_CHECKING:
-    from typing import Callable, Iterable
-    from numpy.typing import ArrayLike
+    from typing import Iterable, Optional
     from mici.adapters import Adapter
-    from mici.states import ChainState
     from mici.types import TraceFunction
 
 
 
[docs]class ChainStage(NamedTuple): """Parameters of chain stage. - + Parameters: n_iter: Number of iterations in chain stage. adapters: Dictionary of adapters to apply to each transition in chain stage. trace_funcs: Functions defining chain variables to trace during chain stage. - record_stats: Whether to record statistics and traces during chain stage. + record_stats: Whether to record statistics during chain stage. """ n_iter: int adapters: dict[str, Iterable[Adapter]] - trace_funcs: tuple[TraceFunction] + trace_funcs: Optional[tuple[TraceFunction]] record_stats: bool
@@ -115,10 +113,10 @@

Source code for mici.stagers

     ) -> dict[str, ChainStage]:
         """Create dictionary specifying labels and parameters of chain sampling stages.
 
-        Constructs a (ordered) dictionary with entries corresponding to the sequence of
+        Constructs an ordered dictionary with entries corresponding to the sequence of
         sampling stages when running chains with one or more initial adaptation stages.
         The keys of each entry are a string label for the sampling stage and the value a
-        `ChainStage` named tuple specifying the parameters of the stage.
+        :py:class:`ChainStage` named tuple specifying the parameters of the stage.
 
         Args:
             n_warm_up_iter: Number of adaptive warm up iterations per chain. Depending
@@ -136,16 +134,19 @@ 

Source code for mici.stagers

                 stored. By default chains are only traced in the iterations of the final
                 non-adaptive stage - this behaviour can be altered using the
                 `trace_warm_up` argument.
-            adapters: Dictionary of iterables of `Adapter` instances keyed by strings
-                corresponding to the key of the transition in the sampler `transitions`
+            adapters: Dictionary of iterables of :py:class:`mici.adapters.Adapter`
+                instances keyed by strings corresponding to the key of the transition in
+                the sampler
+                :py:attr:`mici.samplers.MarkovChainMonteCarloMethod.transitions`
                 dictionary to apply the adapters to, to use to adaptatively set
                 parameters of the transitions during the adaptive stages of the chains.
                 Note that the adapter updates are applied in the order the adapters
                 appear in the iterables and so if multiple adapters change the same
                 parameter(s) the order will matter.
             trace_warm_up: Whether to record chain traces and statistics during warm-up
-                stage iterations (`True`) or only record traces and statistics in the
-                iterations of the final non-adaptive stage (`False`, the default).
+                stage iterations (:code:`True`) or only record traces and statistics in
+                the iterations of the final non-adaptive stage (:code:`False`, the
+                default).
 
         Returns:
             Dictionary specifying chain stages, keyed by labels for stages.
@@ -169,17 +170,18 @@ 

Source code for mici.stagers

         n_warm_up_iter: int,
         n_main_iter: int,
         adapters: dict[str, Iterable[Adapter]],
-        trace_funcs: Iterable[Callable[[ChainState], dict[str, ArrayLike]]],
+        trace_funcs: Iterable[TraceFunction],
         trace_warm_up: bool = False,
     ) -> dict[str, ChainStage]:
         sampling_stages = dict()
+        trace_funcs = tuple(trace_funcs) if trace_funcs is not None else trace_funcs
         # adaptive warm up stage
         if n_warm_up_iter > 0:
             warm_up_trace_funcs = trace_funcs if trace_warm_up else None
             sampling_stages["Adaptive warm up"] = ChainStage(
                 n_iter=n_warm_up_iter,
                 adapters=adapters,
-                trace_funcs=tuple(warm_up_trace_funcs),
+                trace_funcs=warm_up_trace_funcs,
                 record_stats=trace_warm_up,
             )
         # main non-adaptive stage
@@ -187,7 +189,7 @@ 

Source code for mici.stagers

             sampling_stages["Main non-adaptive"] = ChainStage(
                 n_iter=n_main_iter,
                 adapters=None,
-                trace_funcs=tuple(trace_funcs),
+                trace_funcs=trace_funcs,
                 record_stats=True,
             )
         return sampling_stages
@@ -203,7 +205,8 @@

Source code for mici.stagers

     information. The adapters to be used in both the fast and slow adaptation stages
     will be referred to as the *fast adapters* and the adapters to use in only the slow
     adaptation stages the *slow adapters*. Each adapter self identifies if it is a fast
-    adapter by whether the `is_fast` attribute is set to `True`.
+    adapter by whether the :py:attr:`mici.adapters.Adapter.is_fast` attribute is set to
+    :code:`True`.
 
     The adaptive warm up iterations are split into three stages:
 
@@ -267,6 +270,7 @@ 

Source code for mici.stagers

         trace_funcs: Iterable[TraceFunction],
         trace_warm_up: bool = False,
     ) -> dict[str, ChainStage]:
+        trace_funcs = tuple(trace_funcs) if trace_funcs is not None else trace_funcs
         fast_adapters = {
             trans_key: [adapter for adapter in adapter_list if adapter.is_fast]
             for trans_key, adapter_list in adapters.items()
@@ -294,7 +298,7 @@ 

Source code for mici.stagers

             sampling_stages["Initial fast adaptive"] = ChainStage(
                 n_iter=n_init_fast_stage_iter,
                 adapters=fast_adapters,
-                trace_funcs=tuple(warm_up_trace_funcs),
+                trace_funcs=warm_up_trace_funcs,
                 record_stats=record_stats,
             )
             # growing size slow adaptation windows
@@ -323,14 +327,14 @@ 

Source code for mici.stagers

                 ] = ChainStage(
                     n_iter=n_iter,
                     adapters=adapters,
-                    trace_funcs=tuple(warm_up_trace_funcs),
+                    trace_funcs=warm_up_trace_funcs,
                     record_stats=record_stats,
                 )
             # final fast adaptation stage
             sampling_stages["Final fast adaptive"] = ChainStage(
                 n_iter=n_final_fast_stage_iter,
                 adapters=fast_adapters,
-                trace_funcs=tuple(warm_up_trace_funcs),
+                trace_funcs=warm_up_trace_funcs,
                 record_stats=record_stats,
             )
         # main non-adaptive stage
@@ -338,7 +342,7 @@ 

Source code for mici.stagers

             sampling_stages["Main non-adaptive"] = ChainStage(
                 n_iter=n_main_iter,
                 adapters=None,
-                trace_funcs=tuple(trace_funcs),
+                trace_funcs=trace_funcs,
                 record_stats=True,
             )
         return sampling_stages
diff --git a/_modules/mici/systems.html b/_modules/mici/systems.html index b27219f..b6a3bc7 100644 --- a/_modules/mici/systems.html +++ b/_modules/mici/systems.html @@ -120,7 +120,7 @@

Source code for mici.systems

     the corresponding exact Hamiltonian flow may or may not be simulable.
 
     By default :math:`h_1` is assumed to correspond to the negative logarithm of an
-    unnormalized density on the position variables with respect to the Lebesgue measure,
+    unnormalized density on the position variables with respect to a reference measure,
     with the corresponding distribution on the position space being the target
     distribution it is wished to draw approximate samples from.
     """
@@ -134,7 +134,7 @@ 

Source code for mici.systems

         Args:
             neg_log_dens: Function which given a position array returns the negative
                 logarithm of an unnormalized probability density on the position space
-                with respect to the Lebesgue measure, with the corresponding
+                with respect to a reference measure, with the corresponding
                 distribution on the position space being the target distribution it is
                 wished to draw approximate samples from.
             grad_neg_log_dens: Function which given a position array returns the
@@ -288,7 +288,55 @@ 

Source code for mici.systems

         """
-
[docs]class EuclideanMetricSystem(System): +
[docs]class TractableFlowSystem(System): + r"""Base class for Hamiltonian systems with tractable component flows. + + The Hamiltonian function :math:`h` is assumed to have the general form + + .. math:: + + h(q, p) = h_1(q) + h_2(q, p) + + where :math:`q` and :math:`p` are the position and momentum variables respectively, + and :math:`h_1` and :math:`h_2` Hamiltonian component functions. The exact + Hamiltonian flows for both the :math:`h_1` and :math:`h_2` components are assumed to + be tractable for subclasses of this class. + + By default :math:`h_1` is assumed to correspond to the negative logarithm of an + unnormalized density on the position variables with respect to a reference measure, + with the corresponding distribution on the position space being the target + distribution it is wished to draw approximate samples from. + """ + +
[docs] @abstractmethod + def h2_flow(self, state: ChainState, dt: ScalarLike): + """Apply exact flow map corresponding to `h2` Hamiltonian component. + + `state` argument is modified in place. + + Args: + state: State to start flow at. + dt: Time interval to simulate flow for. + """
+ +
[docs] @abstractmethod + def dh2_flow_dmom(self, dt: ScalarLike) -> tuple[matrices.Matrix, matrices.Matrix]: + """Derivatives of `h2_flow` flow map with respect to momentum argument. + + Args: + dt: Time interval flow simulated for. + + Returns: + Tuple `(dpos_dmom, dmom_dmom)` with :code:`dpos_dmom` a matrix representing + derivative (Jacobian) of position output of :py:meth:`h2_flow` with respect + to the value of the momentum component of the initial input state and + :code:`dmom_dmom` a matrix representing derivative (Jacobian) of momentum + output of :py:meth:`h2_flow` with respect to the value of the momentum + component of the initial input state. + """
+ + +
[docs]class EuclideanMetricSystem(TractableFlowSystem): r"""Hamiltonian system with a Euclidean metric on the position space. Here Euclidean metric is defined to mean a metric with a fixed positive definite @@ -375,30 +423,9 @@

Source code for mici.systems

         return self.dh1_dpos(state)
[docs] def h2_flow(self, state: ChainState, dt: ScalarLike): - """Apply exact flow map corresponding to `h2` Hamiltonian component. - - `state` argument is modified in place. - - Args: - state: State to start flow at. - dt: Time interval to simulate flow for. - """ state.pos += dt * self.dh2_dmom(state)
[docs] def dh2_flow_dmom(self, dt: ScalarLike) -> tuple[matrices.Matrix, matrices.Matrix]: - """Derivatives of `h2_flow` flow map with respect to input momentum. - - Args: - dt: Time interval flow simulated for. - - Returns: - dpos_dmom: Matrix representing derivative (Jacobian) of position output of - `h2_flow` with respect to the value of the momentum component of the - initial input state. - dmom_dmom: Matrix representing derivative (Jacobian) of momentum output of - `h2_flow` with respect to the value of the momentum component of the - initial input state. - """ return (dt * self.metric.inv, matrices.IdentityMatrix(self.metric.shape[0]))
[docs] def sample_momentum(self, state: ChainState, rng: Generator) -> ArrayLike: @@ -532,7 +559,7 @@

Source code for mici.systems

         h_2(q, p) = \frac{1}{2} p^T M^{-1} p.
 
     The time-derivative of the constraint equation implies a further set of constraints
-    on the momentum :math:`q` with :math:` \partial c(q) M^{-1} p = 0` at all time
+    on the momentum :math:`q` with :math:`\partial c(q) M^{-1} p = 0` at all time
     points, corresponding to the momentum (velocity) being in the co-tangent space
     (tangent space) to the manifold.
 
@@ -563,7 +590,7 @@ 

Source code for mici.systems

     Due to the requirement to enforce the constraints on the position and momentum, a
     constraint-preserving numerical integrator needs to be used when simulating the
     Hamiltonian dynamic associated with the system, e.g.
-    `mici.integrators.ConstrainedLeapfrogIntegrator`.
+    :py:class:`mici.integrators.ConstrainedLeapfrogIntegrator`.
 
     References:
 
@@ -584,80 +611,75 @@ 

Source code for mici.systems

         grad_neg_log_dens: Optional[GradientFunction] = None,
         jacob_constr: Optional[JacobianFunction] = None,
     ):
-        """
+        r"""
         Args:
             neg_log_dens: Function which given a position array returns the negative
                 logarithm of an unnormalized probability density on the constrained
                 position space with respect to the Hausdorff measure on the constraint
-                manifold (if `dens_wrt_hausdorff == True`) or alternatively the negative
-                logarithm of an unnormalized probability density on the unconstrained
-                (ambient) position space with respect to the Lebesgue measure. In the
-                former case the target distribution it is wished to draw approximate
-                samples from is assumed to be directly specified by the density function
-                on the manifold. In the latter case the density function is instead
-                taken to specify a prior distribution on the ambient space with the
-                target distribution then corresponding to the posterior distribution
-                when conditioning on the (zero Lebesgue measure) event `constr(pos) ==
-                0`. This target posterior distribution has support on the differentiable
-                manifold implicitly defined by the constraint equation, with density
-                with respect to the Hausdorff measure on the manifold corresponding to
-                the ratio of the prior density (specified by `neg_log_dens`) and the
+                manifold (if :code:`dens_wrt_hausdorff == True`) or alternatively the
+                negative logarithm of an unnormalized probability density on the
+                unconstrained (ambient) position space with respect to the Lebesgue
+                measure. In the former case the target distribution it is wished to draw
+                approximate samples from is assumed to be directly specified by the
+                density function on the manifold. In the latter case the density
+                function is instead taken to specify a prior distribution on the ambient
+                space with the target distribution then corresponding to the posterior
+                distribution when conditioning on the (zero Lebesgue measure) event
+                :code:`constr(q) == 0` where :code:`q` is the position array. This
+                target posterior distribution has support on the differentiable manifold
+                implicitly defined by the constraint equation, with density with respect
+                to the Hausdorff measure on the manifold corresponding to the ratio of
+                the prior density (specified by :code:`neg_log_dens`) and the
                 square-root of the determinant of the Gram matrix defined by
-
-                .. code-block::
-
-                    gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
-
-                where `jacob_constr` is the Jacobian of the constraint function `constr`
-                and `metric` is the matrix representation of the metric on the ambient
-                space.
+                :code:`gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T`
+                where :code:`jacob_constr` is the Jacobian of the constraint function
+                :code:`constr` and :code:`metric` is the matrix representation of the
+                metric on the ambient space.
             constr: Function which given a position rray return as a 1D array the value
                 of the (vector-valued) constraint function, the zero level-set of which
                 implicitly defines the manifold the dynamic is simulated on.
             metric: Matrix object corresponding to matrix representation of metric on
                 *unconstrained* position space and covariance of Gaussian marginal
-                distribution on *unconstrained* momentum vector. If `None` is passed
-                (the default), the identity matrix will be used. If a 1D array is passed
-                then this is assumed to specify a metric with positive diagonal matrix
-                representation and the array the matrix diagonal. If a 2D array is
-                passed then this is assumed to specify a metric with a dense positive
+                distribution on *unconstrained* momentum vector. If :code:`None` is
+                passed (the default), the identity matrix will be used. If a 1D array is
+                passed then this is assumed to specify a metric with positive diagonal
+                matrix representation and the array the matrix diagonal. If a 2D array
+                is passed then this is assumed to specify a metric with a dense positive
                 definite matrix representation specified by the array. Otherwise if the
-                value is a `mici.matrices.PositiveDefiniteMatrix` subclass it is assumed
-                to directly specify the metric matrix representation.
-            dens_wrt_hausdorff: Whether the `neg_log_dens` function specifies the
+                value is a :py:class:`mici.matrices.PositiveDefiniteMatrix` subclass it
+                is assumed to directly specify the metric matrix representation.
+            dens_wrt_hausdorff: Whether the :code:`neg_log_dens` function specifies the
                 (negative logarithm) of the density of the target distribution with
-                respect to the Hausdorff measure on the manifold directly (True) or
-                alternatively the negative logarithm of a density of a prior
+                respect to the Hausdorff measure on the manifold directly (:code:`True`)
+                or alternatively the negative logarithm of a density of a prior
                 distriubtion on the unconstrained (ambient) position space with respect
                 to the Lebesgue measure, with the target distribution then corresponding
-                to the posterior distribution when conditioning on the event `const(pos)
-                == 0` (False). Note that in the former case the base Hausdorff measure
-                on the manifold depends on the metric defined on the ambient space, with
-                the Hausdorff measure being defined with respect to the metric induced
-                on the manifold from this ambient metric.
+                to the posterior distribution when conditioning on the event
+                :code:`constr(pos) == 0` (:code:`False`). Note that in the former case
+                the base Hausdorff measure on the manifold depends on the metric defined
+                on the ambient space, with the Hausdorff measure being defined with
+                respect to the metric induced on the manifold from this ambient metric.
             grad_neg_log_dens: Function which given a position array returns the
-                derivative of `neg_log_dens` with respect to the position array
+                derivative of :code:`neg_log_dens` with respect to the position array
                 argument. Optionally the function may instead return a 2-tuple of values
                 with the first being the array corresponding to the derivative and the
-                second being the value of the `neg_log_dens` evaluated at the passed
-                position array. If `None` is passed (the default) an automatic
-                differentiation fallback will be used to attempt to construct a function
-                to compute the derivative (and value) of `neg_log_dens` automatically.
+                second being the value of the :code:`neg_log_dens` evaluated at the
+                passed position array. If :code:`None` is passed (the default) an
+                automatic differentiation fallback will be used to attempt to construct
+                a function to compute the derivative (and value) of :code:`neg_log_dens`
+                automatically.
             jacob_constr: Function which given a position array computes the Jacobian
                 (matrix / 2D array of partial derivatives) of the output of the
-                constraint function `c = constr(q)` with respect to the position array
-                argument `q`, returning the computed Jacobian as a 2D array `jacob` with
-
-               .. code-block::
-
-                    jacob[i, j] = ∂c[i] / ∂q[j]
-
-                Optionally the function may instead return a 2-tuple of values with the
-                first being the array corresponding to the Jacobian and the second being
-                the value of `constr` evaluated at the passed position array. If `None`
+                constraint function :code:`c = constr(q)` with respect to the position
+                array argument :code:`q`, returning the computed Jacobian as a 2D array
+                :code:`jacob` with :code:`jacob[i, j] = ∂c[i] / ∂q[j]`. Optionally the
+                function may instead return a 2-tuple of values with the first being the
+                array corresponding to the Jacobian and the second being the value of
+                :code:`constr` evaluated at the passed position array. If :code:`None`
                 is passed (the default) an automatic differentiation fallback will be
                 used to attempt to construct a function to compute the Jacobian (and
-                value) of `constr` automatically.
+                value) of :code:`constr`
+                automatically.
         """
         super().__init__(
             neg_log_dens=neg_log_dens,
@@ -678,7 +700,7 @@ 

Source code for mici.systems

             state: State to compute value at.
 
         Returns:
-            Value of `constr(state.pos)` as 1D array.
+            Value of :code:`constr(state.pos)` as 1D array.
         """
         return self._constr(state.pos)
@@ -690,7 +712,7 @@

Source code for mici.systems

             state: State to compute value at.
 
         Returns:
-            Value of Jacobian of `constr(state.pos)` as 2D array.
+            Value of Jacobian of :code:`constr(state.pos)` as 2D array.
         """
         return self._jacob_constr(state.pos)
@@ -703,16 +725,16 @@

Source code for mici.systems

     ) -> MatrixLike:
         """Compute inner product of rows of constraint Jacobian matrices.
 
-        Computes `jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T` potentially
-        exploiting any structure / sparsity in `jacob_constr_1`, `jacob_constr_2` and
-        `inner_product_matrix`.
+        Computes :code:`jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T`
+        potentially exploiting any structure / sparsity in :code:`jacob_constr_1`,
+        :code:`jacob_constr_2` and :code:`inner_product_matrix`.
 
         Args:
             jacob_constr_1: First constraint Jacobian in product.
             inner_product_matrix: Positive-definite matrix defining inner-product
                 between rows of two constraint Jacobians.
             jacob_constr_2: Second constraint Jacobian in product. Defaults to
-                `jacob_constr_1` if set to `None`.
+                :code:`jacob_constr_1` if set to :code:`None`.
 
         Returns
             Object corresponding to computed inner products of the constraint Jacobian
@@ -725,12 +747,13 @@ 

Source code for mici.systems

 
         The Gram matrix as a position `q` is defined as
 
-        .. code-block::
+        .. code::
 
             gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
 
-        where `jacob_constr` is the Jacobian of the constraint function `constr` and
-        `metric` is the matrix representation of the metric on the ambient space.
+        where :code:`jacob_constr` is the Jacobian of the constraint function
+        :code:`constr` and :code:`metric` is the matrix representation of the metric on
+        the ambient space.
 
         Args:
             state: State to compute value at.
@@ -759,13 +782,14 @@ 

Source code for mici.systems

 
 
[docs] @abstractmethod def grad_log_det_sqrt_gram(self, state: ChainState) -> ArrayLike: - """Derivative of (half of) log-determinant of Gram matrix wrt position. + """Derivative of half of log-determinant of Gram matrix with respect to position Args: state: State to compute value at. Returns: - Value of `log_det_sqrt_gram(state)` derivative with respect to `state.pos`. + Value of :code:`log_det_sqrt_gram(state)` derivative with respect to + :code:`state.pos`. """
[docs] def h1(self, state: ChainState) -> ScalarLike: @@ -791,7 +815,7 @@

Source code for mici.systems

                 co-tangent space of.
 
         Returns:
-            Projected momentum in the co-tangent space at `state.pos`.
+            Projected momentum in the co-tangent space at :code:`state.pos`.
         """
         # Use parenthesis to force right-to-left evaluation to avoid
         # matrix-matrix products
@@ -809,7 +833,8 @@ 

Source code for mici.systems

 
[docs]class DenseConstrainedEuclideanMetricSystem(ConstrainedEuclideanMetricSystem): r"""Euclidean Hamiltonian system subject to a dense set of constraints. - See `ConstrainedEuclideanMetricSystem` for more details about constrained systems. + See :py:class:`ConstrainedEuclideanMetricSystem` for more details about constrained + systems. """ def __init__( @@ -827,100 +852,88 @@

Source code for mici.systems

             neg_log_dens: Function which given a position array returns the negative
                 logarithm of an unnormalized probability density on the constrained
                 position space with respect to the Hausdorff measure on the constraint
-                manifold (if `dens_wrt_hausdorff == True`) or alternatively the negative
-                logarithm of an unnormalized probability density on the unconstrained
-                (ambient) position space with respect to the Lebesgue measure. In the
-                former case the target distribution it is wished to draw approximate
-                samples from is assumed to be directly specified by the density function
-                on the manifold. In the latter case the density function is instead
-                taken to specify a prior distribution on the ambient space with the
-                target distribution then corresponding to the posterior distribution
-                when conditioning on the (zero Lebesgue measure) event `constr(pos) ==
-                0`. This target posterior distribution has support on the differentiable
-                manifold implicitly defined by the constraint equation, with density
-                with respect to the Hausdorff measure on the manifold corresponding to
-                the ratio of the prior density (specified by `neg_log_dens`) and the
+                manifold (if :code:`dens_wrt_hausdorff == True`) or alternatively the
+                negative logarithm of an unnormalized probability density on the
+                unconstrained (ambient) position space with respect to the Lebesgue
+                measure. In the former case the target distribution it is wished to draw
+                approximate samples from is assumed to be directly specified by the
+                density function on the manifold. In the latter case the density
+                function is instead taken to specify a prior distribution on the ambient
+                space with the target distribution then corresponding to the posterior
+                distribution when conditioning on the (zero Lebesgue measure) event
+                :code:`constr(q) == 0` where :code:`q` is the position array. This
+                target posterior distribution has support on the differentiable manifold
+                implicitly defined by the constraint equation, with density with respect
+                to the Hausdorff measure on the manifold corresponding to the ratio of
+                the prior density (specified by :code:`neg_log_dens`) and the
                 square-root of the determinant of the Gram matrix defined by
-                
-               .. code-block::
-
-                    gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
-
-                where `jacob_constr` is the Jacobian of the constraint function `constr`
-                and `metric` is the matrix representation of the metric on the ambient
-                space.
-            constr: Function which given a position array return as a 1D array the value
+                :code:`gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T`
+                where :code:`jacob_constr` is the Jacobian of the constraint function
+                :code:`constr` and :code:`metric` is the matrix representation of the
+                metric on the ambient space.
+            constr: Function which given a position rray return as a 1D array the value
                 of the (vector-valued) constraint function, the zero level-set of which
                 implicitly defines the manifold the dynamic is simulated on.
             metric: Matrix object corresponding to matrix representation of metric on
                 *unconstrained* position space and covariance of Gaussian marginal
-                distribution on *unconstrained* momentum vector. If `None` is passed
-                (the default), the identity matrix will be used. If a 1D array is passed
-                then this is assumed to specify a metric with positive diagonal matrix
-                representation and the array the matrix diagonal. If a 2D array is
-                passed then this is assumed to specify a metric with a dense positive
+                distribution on *unconstrained* momentum vector. If :code:`None` is
+                passed (the default), the identity matrix will be used. If a 1D array is
+                passed then this is assumed to specify a metric with positive diagonal
+                matrix representation and the array the matrix diagonal. If a 2D array
+                is passed then this is assumed to specify a metric with a dense positive
                 definite matrix representation specified by the array. Otherwise if the
-                value is a `mici.matrices.PositiveDefiniteMatrix` subclass it is assumed
-                to directly specify the metric matrix representation.
-            dens_wrt_hausdorff: Whether the `neg_log_dens` function specifies the
+                value is a :py:class:`mici.matrices.PositiveDefiniteMatrix` subclass it
+                is assumed to directly specify the metric matrix representation.
+            dens_wrt_hausdorff: Whether the :code:`neg_log_dens` function specifies the
                 (negative logarithm) of the density of the target distribution with
-                respect to the Hausdorff measure on the manifold directly (True) or
-                alternatively the negative logarithm of a density of a prior
+                respect to the Hausdorff measure on the manifold directly (:code:`True`)
+                or alternatively the negative logarithm of a density of a prior
                 distriubtion on the unconstrained (ambient) position space with respect
                 to the Lebesgue measure, with the target distribution then corresponding
-                to the posterior distribution when conditioning on the event `const(pos)
-                == 0` (False). Note that in the former case the base Hausdorff measure
-                on the manifold depends on the metric defined on the ambient space, with
-                the Hausdorff measure being defined with respect to the metric induced
-                on the manifold from this ambient metric.
+                to the posterior distribution when conditioning on the event
+                :code:`constr(pos) == 0` (:code:`False`). Note that in the former case
+                the base Hausdorff measure on the manifold depends on the metric defined
+                on the ambient space, with the Hausdorff measure being defined with
+                respect to the metric induced on the manifold from this ambient metric.
             grad_neg_log_dens: Function which given a position array returns the
-                derivative of `neg_log_dens` with respect to the position array
+                derivative of :code:`neg_log_dens` with respect to the position array
                 argument. Optionally the function may instead return a 2-tuple of values
                 with the first being the array corresponding to the derivative and the
-                second being the value of the `neg_log_dens` evaluated at the passed
-                position array. If `None` is passed (the default) an automatic
-                differentiation fallback will be used to attempt to construct a function
-                to compute the derivative (and value) of `neg_log_dens` automatically.
+                second being the value of the :code:`neg_log_dens` evaluated at the
+                passed position array. If :code:`None` is passed (the default) an
+                automatic differentiation fallback will be used to attempt to construct
+                a function to compute the derivative (and value) of :code:`neg_log_dens`
+                automatically.
             jacob_constr: Function which given a position array computes the Jacobian
                 (matrix / 2D array of partial derivatives) of the output of the
-                constraint function `c = constr(q)` with respect to the position array
-                argument `q`, returning the computed Jacobian as a 2D array `jacob` with
-                
-               .. code-block::
-
-                    jacob[i, j] = ∂c[i] / ∂q[j]
-
-                Optionally the function may instead return a 2-tuple of values with the
-                first being the array corresponding to the Jacobian and the second being
-                the value of `constr` evaluated at the passed position array. If `None`
+                constraint function :code:`c = constr(q)` with respect to the position
+                array argument :code:`q`, returning the computed Jacobian as a 2D array
+                :code:`jacob` with :code:`jacob[i, j] = ∂c[i] / ∂q[j]`. Optionally the
+                function may instead return a 2-tuple of values with the first being the
+                array corresponding to the Jacobian and the second being the value of
+                :code:`constr` evaluated at the passed position array. If :code:`None`
                 is passed (the default) an automatic differentiation fallback will be
                 used to attempt to construct a function to compute the Jacobian (and
-                value) of `neg_log_dens` automatically.
+                value) of :code:`constr`
+                automatically.
             mhp_constr: Function which given a position array returns another function
                 which takes a 2D array as an argument and returns the
-                *matrix-Hessian-product* (MHP) of the constraint function `constr` with
-                respect to the position array argument. The MHP is here defined as a
-                function of a `(dim_constr, dim_pos)` shaped 2D array `m`
-                
-               .. code-block::
-
-                    mhp(m) = sum(m[:, :, None] * hess[:, :, :], axis=(0, 1))
-
-                where `hess` is the `(dim_constr, dim_pos, dim_pos)` shaped
-                vector-Hessian of `c = constr(q)` with respect to `q` i.e. the array of
-                second-order partial derivatives of such that
-                
-               .. code-block::
-
-                    hess[i, j, k] = ∂²c[i] / (∂q[j] ∂q[k])
-
-                Optionally the function may instead return a 3-tuple of values with the
-                first a function to compute a MHP of `constr`, the second a 2D array
-                corresponding to the Jacobian of `constr`, and the third the value of
-                `constr`, all evaluated at the passed position array. If `None` is
-                passed (the default) an automatic differentiation fallback will be used
-                to attempt to construct a function which calculates the MHP (and
-                Jacobian and value) of `constr` automatically.
+                *matrix-Hessian-product* (MHP) of the constraint function :code:`constr`
+                with respect to the position array argument. The MHP is here defined as
+                a function of a :code:`(dim_constr, dim_pos)` shaped 2D array :code:`m`
+                as :code:`mhp(m) = sum(m[:, :, None] * hess[:, :, :], axis=(0, 1))`
+                where :code:`hess` is the :code:`(dim_constr, dim_pos, dim_pos)` shaped
+                vector-Hessian of :code:`c = constr(q)` with respect to :code:`q` i.e.
+                the array of second-order partial derivatives of such that
+                :code:`hess[i, j, k] = ∂²c[i] / (∂q[j] ∂q[k])`. Optionally the function
+                may instead return a 3-tuple of values with the first a function to
+                compute a MHP of :code:`constr`, the second a 2D array corresponding to
+                the Jacobian of :code:`constr`, and the third the value of
+                :code:`constr`, all evaluated at the passed position array. If
+                :code:`None` is passed (the default) an automatic differentiation
+                fallback will be used to attempt to construct a function which
+                calculates the MHP (and Jacobian and value) of :code:`constr`
+                automatically.
         """
         super().__init__(
             neg_log_dens=neg_log_dens,
diff --git a/genindex.html b/genindex.html
index 8200f10..9c5dd33 100644
--- a/genindex.html
+++ b/genindex.html
@@ -373,6 +373,8 @@ 

D

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • dh2_dmom() (mici.systems.CholeskyFactoredRiemannianMetricSystem method) @@ -399,6 +401,8 @@

    D

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • dh2_dpos() (mici.systems.CholeskyFactoredRiemannianMetricSystem method) @@ -425,6 +429,8 @@

    D

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • dh2_flow_dmom() (mici.systems.ConstrainedEuclideanMetricSystem method) @@ -437,6 +443,8 @@

    D

  • (mici.systems.GaussianDenseConstrainedEuclideanMetricSystem method)
  • (mici.systems.GaussianEuclideanMetricSystem method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • dh_dmom() (mici.systems.CholeskyFactoredRiemannianMetricSystem method) @@ -463,6 +471,8 @@

    D

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • @@ -491,6 +501,8 @@

    D

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • diagonal (mici.matrices.BlockColumnMatrix property) @@ -821,6 +833,8 @@

    G

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • @@ -893,6 +907,8 @@

    H

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • h1() (mici.systems.CholeskyFactoredRiemannianMetricSystem method) @@ -919,6 +935,8 @@

    H

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • h1_flow() (mici.systems.CholeskyFactoredRiemannianMetricSystem method) @@ -945,6 +963,8 @@

    H

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • @@ -973,6 +993,8 @@

    H

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • h2_flow() (mici.systems.ConstrainedEuclideanMetricSystem method) @@ -985,6 +1007,8 @@

    H

  • (mici.systems.GaussianDenseConstrainedEuclideanMetricSystem method)
  • (mici.systems.GaussianEuclideanMetricSystem method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • HamiltonianDivergenceError @@ -1553,6 +1577,8 @@

    N

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • @@ -1645,8 +1671,6 @@

    R

  • (mici.progressbars.SequenceProgressBar method)
  • - - + @@ -1725,6 +1765,8 @@

    S

  • (mici.systems.SoftAbsRiemannianMetricSystem method)
  • (mici.systems.System method) +
  • +
  • (mici.systems.TractableFlowSystem method)
  • sample_pymc3_model() (in module mici.interop) @@ -2001,6 +2043,18 @@

    S

  • System (class in mici.systems)
  • +
  • system (mici.samplers.DynamicMultinomialHMC property) + +
  • @@ -2092,9 +2146,25 @@

    T

  • TractableFlowIntegrator (class in mici.integrators) +
  • +
  • TractableFlowSystem (class in mici.systems)
  • Transition (class in mici.transitions)
  • +
  • transitions (mici.samplers.DynamicMultinomialHMC property) + +
    • transpose (mici.matrices.BlockColumnMatrix property) diff --git a/mici.adapters.html b/mici.adapters.html index a8363d0..8a033f9 100644 --- a/mici.adapters.html +++ b/mici.adapters.html @@ -175,7 +175,7 @@

      An adapter which requires only local information to adapt the transition parameters should be classified as fast while one which requires more global information and so more chain iterations should be classified as slow i.e. -is_fast == False.

      +is_fast == False.

      diff --git a/mici.html b/mici.html index a5c2557..f11e3f8 100644 --- a/mici.html +++ b/mici.html @@ -254,6 +254,7 @@

      SubmodulesScalarRiemannianMetricSystem

    • SoftAbsRiemannianMetricSystem
    • System
    • +
    • TractableFlowSystem
  • mici.transitions module
      diff --git a/mici.integrators.html b/mici.integrators.html index 8af50af..c51eb74 100644 --- a/mici.integrators.html +++ b/mici.integrators.html @@ -16,6 +16,7 @@ + @@ -115,17 +116,20 @@

      Bases: SymmetricCompositionIntegrator

      Four-stage symmetric composition integrator due to Blanes, Casas & Sanz-Serna.

      Described in equation (6.8) in Blanes, Casas, Sanz-Serna (2014).

      -

      References:

      -

      Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014). +

      References

      +
        +
      1. Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014). Numerical integrators for the Hybrid Monte Carlo method. -SIAM Journal on Scientific Computing, 36(4), A1556-A1580.

        +SIAM Journal on Scientific Computing, 36(4), A1556-A1580.

      2. +
      Parameters:
        -
      • system (System) – Hamiltonian system to integrate the dynamics of.

      • -
      • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a step -size adapter will be used to set the step size before calling the step -method.

      • +
      • system (TractableFlowSystem) – Hamiltonian system to integrate the dynamics of with tractable +Hamiltonian component flows.

      • +
      • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that +a step size adapter will be used to set the step size before calling the +step() method.

      @@ -154,17 +158,20 @@

      Bases: SymmetricCompositionIntegrator

      Three-stage symmetric composition integrator due to Blanes, Casas & Sanz-Serna.

      Described in equation (6.7) in Blanes, Casas, Sanz-Serna (2014).

      -

      References:

      -

      Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014). +

      References

      +
        +
      1. Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014). Numerical integrators for the Hybrid Monte Carlo method. -SIAM Journal on Scientific Computing, 36(4), A1556-A1580.

        +SIAM Journal on Scientific Computing, 36(4), A1556-A1580.

      2. +
      Parameters:
        -
      • system (System) – Hamiltonian system to integrate the dynamics of.

      • -
      • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a step -size adapter will be used to set the step size before calling the step -method.

      • +
      • system (TractableFlowSystem) – Hamiltonian system to integrate the dynamics of with tractable +Hamiltonian component flows.

      • +
      • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a +step size adapter will be used to set the step size before calling the +step() method.

      @@ -193,17 +200,20 @@

      Bases: SymmetricCompositionIntegrator

      Two-stage symmetric composition integrator due to Blanes, Casas & Sanz-Serna.

      Described in equation (6.4) in Blanes, Casas, Sanz-Serna (2014).

      -

      References:

      -

      Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014). +

      References

      +
        +
      1. Blanes, S., Casas, F., & Sanz-Serna, J. M. (2014). Numerical integrators for the Hybrid Monte Carlo method. -SIAM Journal on Scientific Computing, 36(4), A1556-A1580.

        +SIAM Journal on Scientific Computing, 36(4), A1556-A1580.

      2. +
      Parameters:
        -
      • system (System) – Hamiltonian system to integrate the dynamics of.

      • -
      • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a step -size adapter will be used to set the step size before calling the step -method.

      • +
      • system (TractableFlowSystem) – Hamiltonian system to integrate the dynamics of with tractable +Hamiltonian component flows.

      • +
      • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a +step size adapter will be used to set the step size before calling the +step() method.

      @@ -405,24 +415,25 @@

      Bases: Integrator

      Implicit leapfrog integrator for Hamiltonians with a non-separable component.

      Also known as the generalised leapfrog method.

      -

      The Hamiltonian function h is assumed to take the form

      -
      -

      h(q, p) = h₁(q) + h₂(q, p)

      -
      -

      where q and p are the position and momentum variables respectively, h₁ is a -Hamiltonian component function for which the exact flow can be computed and h₂ is -a Hamiltonian component function of the position and momentum variables, which may -be non-separable and for which exact simulation of the correspond Hamiltonian flow -may not be possible.

      +

      The Hamiltonian function \(h\) is assumed to take the form

      +
      +\[h(q, p) = h_1(q) + h_2(q, p)\]
      +

      where \(q\) and \(p\) are the position and momentum variables respectively, +\(h_1\) is a Hamiltonian component function for which the exact flow can be +computed and \(h_2\) is a Hamiltonian component function of the position and +momentum variables, which may be non-separable and for which exact simulation of the +correspond Hamiltonian flow may not be possible.

      A pair of implicit component updates are used to approximate the flow due to the -h₂ Hamiltonian component, with a fixed-point iteration used to solve the +\(h_2\) Hamiltonian component, with a fixed-point iteration used to solve the non-linear system of equations.

      The resulting implicit integrator is a symmetric second-order method corresponding to a symplectic partitioned Runge-Kutta method. See Section 6.3.2 in Leimkuhler and Reich (2004) for more details.

      -

      References:

      -

      Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). -Cambridge University Press.

      +

      References

      +
        +
      1. Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). +Cambridge University Press.

      2. +
      Parameters:
        @@ -541,19 +552,17 @@ class mici.integrators.Integrator(system, step_size=None)[source]

        Bases: ABC

        Base class for integrators for simulating Hamiltonian dynamics.

        -

        For a Hamiltonian function h with position variables q and momentum variables -p, the canonical Hamiltonian dynamic is defined by the ordinary differential -equation system

        -
        -

        q̇ = ∇₂h(q, p) -ṗ = -∇₁h(q, p)

        -
        +

        For a Hamiltonian function \(h\) with position variables \(q\) and momentum +variables \(p\), the canonical Hamiltonian dynamic is defined by the ordinary +differential equation system

        +
        +\[\dot{q} = \nabla_2 h(q, p), \qquad \dot{p} = -\nabla_1 h(q, p)\]

        with the flow map corresponding to the solution of the corresponding initial value problem a time-reversible and symplectic (and by consequence volume-preserving) map.

        -

        Derived classes implement a step method which approximates the flow-map over some -small time interval, while conserving the properties of being time-reversible and -symplectic, with composition of this integrator step method allowing simulation of -time-discretised trajectories of the Hamiltonian dynamics.

        +

        Derived classes implement a step() method which approximates the flow-map +over some small time interval, while conserving the properties of being +time-reversible and symplectic, with composition of this integrator step method +allowing simulation of time-discretised trajectories of the Hamiltonian dynamics.

        Parameters:
          @@ -588,29 +597,29 @@ class mici.integrators.LeapfrogIntegrator(system, step_size=None)[source]

          Bases: TractableFlowIntegrator

          Leapfrog integrator for Hamiltonian systems with tractable component flows.

          -

          For separable Hamiltonians of the form

          -
          -

          h(q, p) = h₁(q) + h₂(p)

          -
          -

          where h₁ is the potential energy and h₂ is the kinetic energy, this integrator -corresponds to the classic (position) Störmer-Verlet method.

          +

          For separable Hamiltonians of the

          +
          +\[h(q, p) = h_1(q) + h_2(p)\]
          +

          where \(h_1\) is the potential energy and \(h_2\) is the kinetic energy, +this integrator corresponds to the classic (position) Störmer-Verlet method.

          The integrator can also be applied to the more general Hamiltonian splitting

          -
          -

          h(q, p) = h₁(q) + h₂(q, p)

          -
          -

          providing the flows for h₁ and h₂ are both tractable.

          +
          +\[h(q, p) = h_1(q) + h_2(q, p)\]
          +

          providing the flows for \(h_1\) and \(h_2\) are both tractable.

          For more details see Sections 2.6 and 4.2.2 in Leimkuhler and Reich (2004).

          -

          References:

          -

          Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). -Cambridge University Press.

          +

          References

          +
            +
          1. Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). +Cambridge University Press.

          2. +
          Parameters:
            -
          • system (System) – Hamiltonian system to integrate the dynamics of. Must define both -h1_flow and h2_flow methods.

          • -
          • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a step -size adapter will be used to set the step size before calling the step -method.

          • +
          • system (TractableFlowSystem) – Hamiltonian system to integrate the dynamics of with tractable +Hamiltonian component flows.

          • +
          • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a +step size adapter will be used to set the step size before calling the +step() method.

          @@ -637,57 +646,65 @@
          class mici.integrators.SymmetricCompositionIntegrator(system, free_coefficients, step_size=None, initial_h1_flow_step=True)[source]

          Bases: TractableFlowIntegrator

          -

          Symmetric composition integrator for Hamiltonians with tractable component flows.

          +

          Symmetric composition integrator for Hamiltonians with tractable component flows

          The Hamiltonian function is assumed to be expressible as the sum of two analytically tractable components for which the corresponding Hamiltonian flows can be exactly -simulated. Specifically it is assumed that the Hamiltonian function h takes the form

          -
          -

          h(q, p) = h₁(q) + h₂(q, p)

          -
          -

          where q and p are the position and momentum variables respectively, and h₁ and -h₂ are Hamiltonian component functions for which the exact flows, respectively -Φ₁ and Φ₂, can be computed. An alternating composition can then be formed as

          -
          -

          Ψ(t) = A(aₛt) ∘ B(bₛt) ∘ ⋯ ∘ A(a₁t) ∘ B(b₁t) ∘ A(a₀t)

          -
          -

          where A = Φ₁ and B = Φ₂ or A = Φ₂ and B = Φ₁, and (a₀, ⋯, aₛ) and -(b₁, ⋯, bₛ) are a set of coefficients to be determined and s is the number of -stages in the composition.

          +simulated. Specifically it is assumed that the Hamiltonian function \(h\) takes +the form

          +
          +\[h(q, p) = h_1(q) + h_2(q, p)\]
          +

          where \(q\) and \(p\) are the position and momentum variables respectively, +and \(h_1\) and \(h_2\) are Hamiltonian component functions for which the +exact flows, respectively \(\Phi_1\) and \(\Phi_2\), can be computed. An +alternating composition can then be formed as

          +
          +\[\Psi(t) = +A(a_S t) \circ B(b_S t) \circ \dots \circ A(a_1 t) \circ B(b_1 t) \circ A(a_0 t)\]
          +

          where \(A = \Phi_1\) and \(B = \Phi_2\) or \(A = \Phi_2\) and \(B = +\Phi_1\), and \((a_0,\dots, a_S)\) and \((b_1, \dots, b_S)\) are a set of +coefficients to be determined and \(S\) is the number of stages in the +composition.

          To ensure a consistency (i.e. the integrator is at least order one) we require that

          -
          -

          sum(a₀, ⋯, aₛ) = sum(b₁, ⋯, bₛ) = 1

          -
          +
          +\[\sum_{s=0}^S a_s = \sum_{s=1}^S b_s = 1.\]

          For symmetric compositions we restrict that

          -
          -

          aₛ₋ₘ = aₘ and bₛ₊₁₋ₘ = bₛ

          -
          +
          +\[a_{S-m} = a_m, \quad b_{S+1-m} = b_s\]

          with symmetric consistent methods of at least order two.

          -

          The combination of the symmetry and consistency requirements mean that a s-stage -symmetric composition method can be described by (s - 1) ‘free’ coefficients

          -
          -

          (a₀, b₁, a₁, ⋯, aₖ, bₖ) with k = (s - 1) / 2 if s is odd or -(a₀, b₁, a₁, ⋯, aₖ) with k = (s - 2) / 2 if s is even

          -
          +

          The combination of the symmetry and consistency requirements mean that a +\(S\)-stage symmetric composition method can be described by \(S - 1\) +‘free’ coefficients

          +
          +\[(a_0, b_1, a_1, \dots, a_K, b_K)\]
          +

          with \(K = (S - 1) / 2\) if \(S\) is odd or

          +
          +\[(a_0, b_1, a_1, \dots, a_K)\]
          +

          with \(K = (S - 2) / 2\) if \(S\) is even.

          The Störmer-Verlet ‘leapfrog’ integrator is a special case corresponding to the unique (symmetric and consistent) 1-stage integrator.

          For more details see Section 6.2 in Leimkuhler and Reich (2004).

          -

          References:

          -

          Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). -Cambridge University Press.

          +

          References

          +
            +
          1. Leimkuhler, B., & Reich, S. (2004). Simulating Hamiltonian Dynamics (No. 14). +Cambridge University Press.

          2. +
          Parameters:
            -
          • system (System) – Hamiltonian system to integrate the dynamics of.

          • -
          • free_coefficients (Sequence[float]) – Sequence of s - 1 scalar values, where s is the -number of stages in the symmetric composition, specifying the free -coefficients (a₀, b₁, a₁, ⋯, aₖ, bₖ) with k = (s - 1) / 2 if s is -odd or (a₀, b₁, a₁, ⋯, aₖ) with k = (s - 2) / 2 if s is even.

          • -
          • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a step -size adapter will be used to set the step size before calling the step -method.

          • -
          • initial_h1_flow_step (bool) – Whether the initial ‘A’ flow in the composition should -correspond to the flow of the h₁ Hamiltonian component (True) or to -the flow of the h₂ component (False).

          • +
          • system (TractableFlowSystem) – Hamiltonian system to integrate the dynamics of with tractable +Hamiltonian component flows.

          • +
          • free_coefficients (Sequence[float]) – Sequence of \(S - 1\) scalar values, where \(S\) +is the number of stages in the symmetric composition, specifying the +free coefficients \((a_0, b_1, a_1, \dots, a_K, b_K)\) with \(K += (S - 1) / 2\) if \(S\) is odd or \((a_0, b_1, a_1, \dots, +a_K)\) with \(k = (S - 2) / 2\) if S is even.

          • +
          • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a +step size adapter will be used to set the step size before calling the +step() method.

          • +
          • initial_h1_flow_step (bool) – Whether the initial \(A\) flow in the composition +should correspond to the flow of the h_1 Hamiltonian component +(True) or to the flow of the \(h_2\) component +(False).

          @@ -717,21 +734,21 @@

          Base class for integrators for Hamiltonian systems with tractable component flows

          The Hamiltonian function is assumed to be expressible as the sum of two analytically tractable components for which the corresponding Hamiltonian flows can be exactly -simulated. Specifically it is assumed that the Hamiltonian function h takes the -form

          -
          -

          h(q, p) = h₁(q) + h₂(q, p)

          -
          -

          where q and p are the position and momentum variables respectively, and h₁ and -h₂ are Hamiltonian component functions for which the exact flows can be computed.

          +simulated. Specifically it is assumed that the Hamiltonian function \(h\) takes +the form

          +
          +\[h(q, p) = h_1(q) + h_2(q, p)\]
          +

          where \(q\) and \(p\) are the position and momentum variables respectively, +and \(h_1\) and \(h_2\) are Hamiltonian component functions for which the +exact flows can be computed.

          Parameters:
            -
          • system (System) – Hamiltonian system to integrate the dynamics of. Must define both -h1_flow and h2_flow methods.

          • -
          • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a step -size adapter will be used to set the step size before calling the step -method.

          • +
          • system (TractableFlowSystem) – Hamiltonian system to integrate the dynamics of with tractable +Hamiltonian component flows.

          • +
          • step_size (Optional[float]) – Integrator time step. If set to None it is assumed that a +step size adapter will be used to set the step size before calling the +step() method.

          diff --git a/mici.samplers.html b/mici.samplers.html index 29a203f..cea524e 100644 --- a/mici.samplers.html +++ b/mici.samplers.html @@ -186,6 +186,12 @@

          Maximum depth to expand trajectory binary tree to.

        +
        +
        +property rng: Generator
        +

        NumPy random number generator object.

        +
        +
        sample_chains(n_warm_up_iter, n_main_iter, init_states, **kwargs)
        @@ -298,6 +304,18 @@
      +
      +
      +property system: System
      +

      Hamiltonian system corresponding to joint distribution on augmented space.

      +
      + +
      +
      +property transitions: dict[str, Transition]
      +

      Dictionary of transition kernels sampled from in each chain iteration.

      +
      +
      @@ -376,6 +394,12 @@

      Maximum depth to expand trajectory binary tree to.

      +
      +
      +property rng: Generator
      +

      NumPy random number generator object.

      +
      +
      sample_chains(n_warm_up_iter, n_main_iter, init_states, **kwargs)
      @@ -488,6 +512,18 @@
      +
      +
      +property system: System
      +

      Hamiltonian system corresponding to joint distribution on augmented space.

      +
      + +
      +
      +property transitions: dict[str, Transition]
      +

      Dictionary of transition kernels sampled from in each chain iteration.

      +
      +
      @@ -551,22 +587,30 @@
      Parameters:
        -
      • simulated. (system Hamiltonian system to be) –

      • +
      • simulated (system Hamiltonian system to be) – distribution on augmented space.

      • +
      • joint (corresponding to) – distribution on augmented space.

      • rng (Generator) – Numpy random number generator.

      • -
      • integration_transition (IntegrationTransition) – Markov transition kernel which leaves canonical +

      • integration_transition (IntegrationTransition) – Markov transition kernel which leaves joint distribution invariant and jointly updates the position and momentum components of the chain state by integrating the Hamiltonian dynamics of the system to propose new values for the state.

      • momentum_transition (Optional[MomentumTransition]) – Markov transition kernel which leaves the conditional -distribution on the momentum under the canonical distribution invariant, +distribution on the momentum under the join distribution invariant, updating only the momentum component of the chain state. If set to -None the momentum transition operator -mici.transitions.IndependentMomentumTransition will be used, which -independently samples the momentum from its conditional distribution.

      • +None the momentum transition operator +mici.transitions.IndependentMomentumTransition will be used, +which independently samples the momentum from its conditional +distribution.

      • system (System) –

      +
      +
      +property rng: Generator
      +

      NumPy random number generator object.

      +
      +
      sample_chains(n_warm_up_iter, n_main_iter, init_states, **kwargs)[source]
      @@ -679,6 +723,18 @@
      +
      +
      +property system: System
      +

      Hamiltonian system corresponding to joint distribution on augmented space.

      +
      + +
      +
      +property transitions: dict[str, Transition]
      +

      Dictionary of transition kernels sampled from in each chain iteration.

      +
      +
      @@ -730,6 +786,12 @@
    +
    +
    +property rng: Generator
    +

    NumPy random number generator object.

    +
    +
    sample_chains(n_warm_up_iter, n_main_iter, init_states, *, trace_funcs=None, adapters=None, stager=None, n_process=1, trace_warm_up=False, max_threads_per_process=None, force_memmap=False, memmap_path=None, monitor_stats=None, display_progress=True, progress_bar_class=None)[source]
    @@ -836,6 +898,12 @@
    +
    +
    +property transitions: dict[str, Transition]
    +

    Dictionary of transition kernels sampled from in each chain iteration.

    +
    +
    @@ -890,6 +958,12 @@

    Interval to uniformly draw number of integrator steps from.

    +
    +
    +property rng: Generator
    +

    NumPy random number generator object.

    +
    +
    sample_chains(n_warm_up_iter, n_main_iter, init_states, **kwargs)
    @@ -1002,6 +1076,18 @@
    +
    +
    +property system: System
    +

    Hamiltonian system corresponding to joint distribution on augmented space.

    +
    + +
    +
    +property transitions: dict[str, Transition]
    +

    Dictionary of transition kernels sampled from in each chain iteration.

    +
    +
    @@ -1051,6 +1137,12 @@

    Number of integrator steps per integrator transition.

    +
    +
    +property rng: Generator
    +

    NumPy random number generator object.

    +
    +
    sample_chains(n_warm_up_iter, n_main_iter, init_states, **kwargs)
    @@ -1163,6 +1255,18 @@
    +
    +
    +property system: System
    +

    Hamiltonian system corresponding to joint distribution on augmented space.

    +
    + +
    +
    +property transitions: dict[str, Transition]
    +

    Dictionary of transition kernels sampled from in each chain iteration.

    +
    + diff --git a/mici.stagers.html b/mici.stagers.html index 4daf9d9..2b9049c 100644 --- a/mici.stagers.html +++ b/mici.stagers.html @@ -102,7 +102,7 @@

    mici.stagers module

    -

    Classes for controlling sampling of Markov chains split into stages.

    +

    Classes for staging sampling of Markov chains.

    class mici.stagers.ChainStage(n_iter, adapters, trace_funcs, record_stats)[source]
    @@ -113,8 +113,8 @@
    • n_iter (int) – Number of iterations in chain stage.

    • adapters (dict[str, Iterable[Adapter]]) – Dictionary of adapters to apply to each transition in chain stage.

    • -
    • trace_funcs (tuple[TraceFunction]) – Functions defining chain variables to trace during chain stage.

    • -
    • record_stats (bool) – Whether to record statistics and traces during chain stage.

    • +
    • trace_funcs (Optional[tuple[TraceFunction]]) – Functions defining chain variables to trace during chain stage.

    • +
    • record_stats (bool) – Whether to record statistics during chain stage.

    @@ -129,10 +129,10 @@
    abstract stages(n_warm_up_iter, n_main_iter, adapters, trace_funcs, trace_warm_up=False)[source]

    Create dictionary specifying labels and parameters of chain sampling stages.

    -

    Constructs a (ordered) dictionary with entries corresponding to the sequence of +

    Constructs an ordered dictionary with entries corresponding to the sequence of sampling stages when running chains with one or more initial adaptation stages. The keys of each entry are a string label for the sampling stage and the value a -ChainStage named tuple specifying the parameters of the stage.

    +ChainStage named tuple specifying the parameters of the stage.

    Parameters:
      @@ -151,16 +151,19 @@ stored. By default chains are only traced in the iterations of the final non-adaptive stage - this behaviour can be altered using the trace_warm_up argument.

      -
    • adapters (dict[str, Iterable[Adapter]]) – Dictionary of iterables of Adapter instances keyed by strings -corresponding to the key of the transition in the sampler transitions +

    • adapters (dict[str, Iterable[Adapter]]) – Dictionary of iterables of mici.adapters.Adapter +instances keyed by strings corresponding to the key of the transition in +the sampler +mici.samplers.MarkovChainMonteCarloMethod.transitions dictionary to apply the adapters to, to use to adaptatively set parameters of the transitions during the adaptive stages of the chains. Note that the adapter updates are applied in the order the adapters appear in the iterables and so if multiple adapters change the same parameter(s) the order will matter.

    • trace_warm_up (bool) – Whether to record chain traces and statistics during warm-up -stage iterations (True) or only record traces and statistics in the -iterations of the final non-adaptive stage (False, the default).

    • +stage iterations (True) or only record traces and statistics in +the iterations of the final non-adaptive stage (False, the +default).

    Returns:
    @@ -192,10 +195,10 @@
    stages(n_warm_up_iter, n_main_iter, adapters, trace_funcs, trace_warm_up=False)[source]

    Create dictionary specifying labels and parameters of chain sampling stages.

    -

    Constructs a (ordered) dictionary with entries corresponding to the sequence of +

    Constructs an ordered dictionary with entries corresponding to the sequence of sampling stages when running chains with one or more initial adaptation stages. The keys of each entry are a string label for the sampling stage and the value a -ChainStage named tuple specifying the parameters of the stage.

    +ChainStage named tuple specifying the parameters of the stage.

    Parameters:
      @@ -204,7 +207,7 @@ iterations may be split between one or more adaptive stages.

    • n_main_iter (int) – Number of iterations (samples to draw) per chain during main (non-adaptive) sampling stage.

    • -
    • trace_funcs (Iterable[Callable[[ChainState], dict[str, ArrayLike]]]) – Iterable of functions which compute the variables to be +

    • trace_funcs (Iterable[TraceFunction]) – Iterable of functions which compute the variables to be recorded at each chain iteration, with each trace function being passed the current state and returning a dictionary of scalar or array values corresponding to the variable(s) to be stored. The keys in the returned @@ -214,16 +217,19 @@ stored. By default chains are only traced in the iterations of the final non-adaptive stage - this behaviour can be altered using the trace_warm_up argument.

    • -
    • adapters (dict[str, Iterable[Adapter]]) – Dictionary of iterables of Adapter instances keyed by strings -corresponding to the key of the transition in the sampler transitions +

    • adapters (dict[str, Iterable[Adapter]]) – Dictionary of iterables of mici.adapters.Adapter +instances keyed by strings corresponding to the key of the transition in +the sampler +mici.samplers.MarkovChainMonteCarloMethod.transitions dictionary to apply the adapters to, to use to adaptatively set parameters of the transitions during the adaptive stages of the chains. Note that the adapter updates are applied in the order the adapters appear in the iterables and so if multiple adapters change the same parameter(s) the order will matter.

    • trace_warm_up (bool) – Whether to record chain traces and statistics during warm-up -stage iterations (True) or only record traces and statistics in the -iterations of the final non-adaptive stage (False, the default).

    • +stage iterations (True) or only record traces and statistics in +the iterations of the final non-adaptive stage (False, the +default).

    Returns:
    @@ -249,7 +255,8 @@ information. The adapters to be used in both the fast and slow adaptation stages will be referred to as the fast adapters and the adapters to use in only the slow adaptation stages the slow adapters. Each adapter self identifies if it is a fast -adapter by whether the is_fast attribute is set to True.

    +adapter by whether the mici.adapters.Adapter.is_fast attribute is set to +True.

    The adaptive warm up iterations are split into three stages:

      @@ -298,10 +305,10 @@
      stages(n_warm_up_iter, n_main_iter, adapters, trace_funcs, trace_warm_up=False)[source]

      Create dictionary specifying labels and parameters of chain sampling stages.

      -

      Constructs a (ordered) dictionary with entries corresponding to the sequence of +

      Constructs an ordered dictionary with entries corresponding to the sequence of sampling stages when running chains with one or more initial adaptation stages. The keys of each entry are a string label for the sampling stage and the value a -ChainStage named tuple specifying the parameters of the stage.

      +ChainStage named tuple specifying the parameters of the stage.

      Parameters:
        @@ -320,16 +327,19 @@ stored. By default chains are only traced in the iterations of the final non-adaptive stage - this behaviour can be altered using the trace_warm_up argument.

        -
      • adapters (dict[str, Iterable[Adapter]]) – Dictionary of iterables of Adapter instances keyed by strings -corresponding to the key of the transition in the sampler transitions +

      • adapters (dict[str, Iterable[Adapter]]) – Dictionary of iterables of mici.adapters.Adapter +instances keyed by strings corresponding to the key of the transition in +the sampler +mici.samplers.MarkovChainMonteCarloMethod.transitions dictionary to apply the adapters to, to use to adaptatively set parameters of the transitions during the adaptive stages of the chains. Note that the adapter updates are applied in the order the adapters appear in the iterables and so if multiple adapters change the same parameter(s) the order will matter.

      • trace_warm_up (bool) – Whether to record chain traces and statistics during warm-up -stage iterations (True) or only record traces and statistics in the -iterations of the final non-adaptive stage (False, the default).

      • +stage iterations (True) or only record traces and statistics in +the iterations of the final non-adaptive stage (False, the +default).

      Returns:
      diff --git a/mici.systems.html b/mici.systems.html index f539dab..28061fc 100644 --- a/mici.systems.html +++ b/mici.systems.html @@ -73,6 +73,7 @@
    1. ScalarRiemannianMetricSystem
    2. SoftAbsRiemannianMetricSystem
    3. System
    4. +
    5. TractableFlowSystem
    6. mici.transitions module
    7. @@ -456,7 +457,7 @@
      \[h_2(q, p) = \frac{1}{2} p^T M^{-1} p.\]

      The time-derivative of the constraint equation implies a further set of constraints -on the momentum \(q\) with :math:` partial c(q) M^{-1} p = 0` at all time +on the momentum \(q\) with \(\partial c(q) M^{-1} p = 0\) at all time points, corresponding to the momentum (velocity) being in the co-tangent space (tangent space) to the manifold.

      The target distribution is either assumed to be directly specified with unnormalized @@ -479,7 +480,7 @@

      Due to the requirement to enforce the constraints on the position and momentum, a constraint-preserving numerical integrator needs to be used when simulating the Hamiltonian dynamic associated with the system, e.g. -mici.integrators.ConstrainedLeapfrogIntegrator.

      +mici.integrators.ConstrainedLeapfrogIntegrator.

      References

      1. Lelièvre, T., Rousset, M. and Stoltz, G., 2019. Hybrid Monte Carlo methods for @@ -492,79 +493,73 @@

        Parameters:
          -
        • neg_log_dens (ScalarFunction) –

          Function which given a position array returns the negative +

        • neg_log_dens (ScalarFunction) – Function which given a position array returns the negative logarithm of an unnormalized probability density on the constrained position space with respect to the Hausdorff measure on the constraint -manifold (if dens_wrt_hausdorff == True) or alternatively the negative -logarithm of an unnormalized probability density on the unconstrained -(ambient) position space with respect to the Lebesgue measure. In the -former case the target distribution it is wished to draw approximate -samples from is assumed to be directly specified by the density function -on the manifold. In the latter case the density function is instead -taken to specify a prior distribution on the ambient space with the -target distribution then corresponding to the posterior distribution -when conditioning on the (zero Lebesgue measure) event constr(pos) == -0. This target posterior distribution has support on the differentiable -manifold implicitly defined by the constraint equation, with density -with respect to the Hausdorff measure on the manifold corresponding to -the ratio of the prior density (specified by neg_log_dens) and the -square-root of the determinant of the Gram matrix defined by

          -
          gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
          -
          -
          -

          where jacob_constr is the Jacobian of the constraint function constr -and metric is the matrix representation of the metric on the ambient -space.

          -

        • +manifold (if dens_wrt_hausdorff == True) or alternatively the +negative logarithm of an unnormalized probability density on the +unconstrained (ambient) position space with respect to the Lebesgue +measure. In the former case the target distribution it is wished to draw +approximate samples from is assumed to be directly specified by the +density function on the manifold. In the latter case the density +function is instead taken to specify a prior distribution on the ambient +space with the target distribution then corresponding to the posterior +distribution when conditioning on the (zero Lebesgue measure) event +constr(q) == 0 where q is the position array. This +target posterior distribution has support on the differentiable manifold +implicitly defined by the constraint equation, with density with respect +to the Hausdorff measure on the manifold corresponding to the ratio of +the prior density (specified by neg_log_dens) and the +square-root of the determinant of the Gram matrix defined by +gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T +where jacob_constr is the Jacobian of the constraint function +constr and metric is the matrix representation of the +metric on the ambient space.

        • constr (ArrayFunction) – Function which given a position rray return as a 1D array the value of the (vector-valued) constraint function, the zero level-set of which implicitly defines the manifold the dynamic is simulated on.

        • metric (Optional[MetricLike]) – Matrix object corresponding to matrix representation of metric on unconstrained position space and covariance of Gaussian marginal -distribution on unconstrained momentum vector. If None is passed -(the default), the identity matrix will be used. If a 1D array is passed -then this is assumed to specify a metric with positive diagonal matrix -representation and the array the matrix diagonal. If a 2D array is -passed then this is assumed to specify a metric with a dense positive +distribution on unconstrained momentum vector. If None is +passed (the default), the identity matrix will be used. If a 1D array is +passed then this is assumed to specify a metric with positive diagonal +matrix representation and the array the matrix diagonal. If a 2D array +is passed then this is assumed to specify a metric with a dense positive definite matrix representation specified by the array. Otherwise if the -value is a mici.matrices.PositiveDefiniteMatrix subclass it is assumed -to directly specify the metric matrix representation.

        • -
        • dens_wrt_hausdorff (bool) – Whether the neg_log_dens function specifies the +value is a mici.matrices.PositiveDefiniteMatrix subclass it +is assumed to directly specify the metric matrix representation.

        • +
        • dens_wrt_hausdorff (bool) – Whether the neg_log_dens function specifies the (negative logarithm) of the density of the target distribution with -respect to the Hausdorff measure on the manifold directly (True) or -alternatively the negative logarithm of a density of a prior +respect to the Hausdorff measure on the manifold directly (True) +or alternatively the negative logarithm of a density of a prior distriubtion on the unconstrained (ambient) position space with respect to the Lebesgue measure, with the target distribution then corresponding -to the posterior distribution when conditioning on the event const(pos) -== 0 (False). Note that in the former case the base Hausdorff measure -on the manifold depends on the metric defined on the ambient space, with -the Hausdorff measure being defined with respect to the metric induced -on the manifold from this ambient metric.

        • +to the posterior distribution when conditioning on the event +constr(pos) == 0 (False). Note that in the former case +the base Hausdorff measure on the manifold depends on the metric defined +on the ambient space, with the Hausdorff measure being defined with +respect to the metric induced on the manifold from this ambient metric.

        • grad_neg_log_dens (Optional[GradientFunction]) – Function which given a position array returns the -derivative of neg_log_dens with respect to the position array +derivative of neg_log_dens with respect to the position array argument. Optionally the function may instead return a 2-tuple of values with the first being the array corresponding to the derivative and the -second being the value of the neg_log_dens evaluated at the passed -position array. If None is passed (the default) an automatic -differentiation fallback will be used to attempt to construct a function -to compute the derivative (and value) of neg_log_dens automatically.

        • -
        • jacob_constr (Optional[JacobianFunction]) –

          -
          Function which given a position array computes the Jacobian

          (matrix / 2D array of partial derivatives) of the output of the -constraint function c = constr(q) with respect to the position array -argument q, returning the computed Jacobian as a 2D array jacob with

          -
          -
          -
              jacob[i, j] = ∂c[i] / ∂q[j]
          -
          -Optionally the function may instead return a 2-tuple of values with the
          -first being the array corresponding to the Jacobian and the second being
          -the value of `constr` evaluated at the passed position array. If `None`
          +second being the value of the neg_log_dens evaluated at the
          +passed position array. If None is passed (the default) an
          +automatic differentiation fallback will be used to attempt to construct
          +a function to compute the derivative (and value) of neg_log_dens
          +automatically.

        • +
        • jacob_constr (Optional[JacobianFunction]) – Function which given a position array computes the Jacobian +(matrix / 2D array of partial derivatives) of the output of the +constraint function c = constr(q) with respect to the position +array argument q, returning the computed Jacobian as a 2D array +jacob with jacob[i, j] = ∂c[i] / ∂q[j]. Optionally the +function may instead return a 2-tuple of values with the first being the +array corresponding to the Jacobian and the second being the value of +constr evaluated at the passed position array. If None is passed (the default) an automatic differentiation fallback will be used to attempt to construct a function to compute the Jacobian (and -value) of `constr` automatically. -

  • -
    -

    +value) of constr +automatically.

    @@ -577,7 +572,7 @@

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of constr(state.pos) as 1D array.

    +

    Value of constr(state.pos) as 1D array.

    Return type:

    ArrayLike

    @@ -639,24 +634,21 @@
    dh2_flow_dmom(dt)
    -

    Derivatives of h2_flow flow map with respect to input momentum.

    +

    Derivatives of h2_flow flow map with respect to momentum argument.

    Parameters:

    dt (ScalarLike) – Time interval flow simulated for.

    Returns:
    -

    -
    Matrix representing derivative (Jacobian) of position output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    dmom_dmom: Matrix representing derivative (Jacobian) of momentum output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    -

    +

    Tuple (dpos_dmom, dmom_dmom) with dpos_dmom a matrix representing +derivative (Jacobian) of position output of h2_flow() with respect +to the value of the momentum component of the initial input state and +dmom_dmom a matrix representing derivative (Jacobian) of momentum +output of h2_flow() with respect to the value of the momentum +component of the initial input state.

    Return type:
    -

    dpos_dmom

    +

    tuple[Matrix, Matrix]

    @@ -698,13 +690,14 @@
    abstract grad_log_det_sqrt_gram(state)[source]
    -

    Derivative of (half of) log-determinant of Gram matrix wrt position.

    +

    Derivative of half of log-determinant of Gram matrix with respect to position

    Parameters:

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of log_det_sqrt_gram(state) derivative with respect to state.pos.

    +

    Value of log_det_sqrt_gram(state) derivative with respect to +state.pos.

    Return type:

    ArrayLike

    @@ -737,8 +730,9 @@
    gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
     
    -

    where jacob_constr is the Jacobian of the constraint function constr and -metric is the matrix representation of the metric on the ambient space.

    +

    where jacob_constr is the Jacobian of the constraint function +constr and metric is the matrix representation of the metric on +the ambient space.

    Parameters:

    state (ChainState) – State to compute value at.

    @@ -859,7 +853,7 @@

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of Jacobian of constr(state.pos) as 2D array.

    +

    Value of Jacobian of constr(state.pos) as 2D array.

    Return type:

    ArrayLike

    @@ -871,9 +865,9 @@
    abstract jacob_constr_inner_product(jacob_constr_1, inner_product_matrix, jacob_constr_2=None)[source]

    Compute inner product of rows of constraint Jacobian matrices.

    -

    Computes jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T potentially -exploiting any structure / sparsity in jacob_constr_1, jacob_constr_2 and -inner_product_matrix.

    +

    Computes jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T +potentially exploiting any structure / sparsity in jacob_constr_1, +jacob_constr_2 and inner_product_matrix.

    Parameters:
      @@ -881,7 +875,7 @@
    • inner_product_matrix (PositiveDefiniteMatrix) – Positive-definite matrix defining inner-product between rows of two constraint Jacobians.

    • jacob_constr_2 (Optional[MatrixLike]) – Second constraint Jacobian in product. Defaults to -jacob_constr_1 if set to None.

    • +jacob_constr_1 if set to None.

    Return type:
    @@ -939,7 +933,7 @@
    Returns:
    -

    Projected momentum in the co-tangent space at state.pos.

    +

    Projected momentum in the co-tangent space at state.pos.

    Return type:

    ArrayLike

    @@ -974,112 +968,96 @@ class mici.systems.DenseConstrainedEuclideanMetricSystem(neg_log_dens, constr, metric=None, dens_wrt_hausdorff=True, grad_neg_log_dens=None, jacob_constr=None, mhp_constr=None)[source]

    Bases: ConstrainedEuclideanMetricSystem

    Euclidean Hamiltonian system subject to a dense set of constraints.

    -

    See ConstrainedEuclideanMetricSystem for more details about constrained systems.

    +

    See ConstrainedEuclideanMetricSystem for more details about constrained +systems.

    Parameters:
      -
    • neg_log_dens (ScalarFunction) –

      -
      Function which given a position array returns the negative

      logarithm of an unnormalized probability density on the constrained +

    • neg_log_dens (ScalarFunction) – Function which given a position array returns the negative +logarithm of an unnormalized probability density on the constrained position space with respect to the Hausdorff measure on the constraint -manifold (if dens_wrt_hausdorff == True) or alternatively the negative -logarithm of an unnormalized probability density on the unconstrained -(ambient) position space with respect to the Lebesgue measure. In the -former case the target distribution it is wished to draw approximate -samples from is assumed to be directly specified by the density function -on the manifold. In the latter case the density function is instead -taken to specify a prior distribution on the ambient space with the -target distribution then corresponding to the posterior distribution -when conditioning on the (zero Lebesgue measure) event constr(pos) == -0. This target posterior distribution has support on the differentiable -manifold implicitly defined by the constraint equation, with density -with respect to the Hausdorff measure on the manifold corresponding to -the ratio of the prior density (specified by neg_log_dens) and the -square-root of the determinant of the Gram matrix defined by

      -
    • -
      -
          gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
      -
      -where `jacob_constr` is the Jacobian of the constraint function `constr`
      -and `metric` is the matrix representation of the metric on the ambient
      -space.
      -
      -
      -

    • -
    • constr (ArrayFunction) – Function which given a position array return as a 1D array the value +manifold (if dens_wrt_hausdorff == True) or alternatively the +negative logarithm of an unnormalized probability density on the +unconstrained (ambient) position space with respect to the Lebesgue +measure. In the former case the target distribution it is wished to draw +approximate samples from is assumed to be directly specified by the +density function on the manifold. In the latter case the density +function is instead taken to specify a prior distribution on the ambient +space with the target distribution then corresponding to the posterior +distribution when conditioning on the (zero Lebesgue measure) event +constr(q) == 0 where q is the position array. This +target posterior distribution has support on the differentiable manifold +implicitly defined by the constraint equation, with density with respect +to the Hausdorff measure on the manifold corresponding to the ratio of +the prior density (specified by neg_log_dens) and the +square-root of the determinant of the Gram matrix defined by +gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T +where jacob_constr is the Jacobian of the constraint function +constr and metric is the matrix representation of the +metric on the ambient space.

    • +
    • constr (ArrayFunction) – Function which given a position rray return as a 1D array the value of the (vector-valued) constraint function, the zero level-set of which implicitly defines the manifold the dynamic is simulated on.

    • metric (Optional[MetricLike]) – Matrix object corresponding to matrix representation of metric on unconstrained position space and covariance of Gaussian marginal -distribution on unconstrained momentum vector. If None is passed -(the default), the identity matrix will be used. If a 1D array is passed -then this is assumed to specify a metric with positive diagonal matrix -representation and the array the matrix diagonal. If a 2D array is -passed then this is assumed to specify a metric with a dense positive +distribution on unconstrained momentum vector. If None is +passed (the default), the identity matrix will be used. If a 1D array is +passed then this is assumed to specify a metric with positive diagonal +matrix representation and the array the matrix diagonal. If a 2D array +is passed then this is assumed to specify a metric with a dense positive definite matrix representation specified by the array. Otherwise if the -value is a mici.matrices.PositiveDefiniteMatrix subclass it is assumed -to directly specify the metric matrix representation.

    • -
    • dens_wrt_hausdorff (bool) – Whether the neg_log_dens function specifies the +value is a mici.matrices.PositiveDefiniteMatrix subclass it +is assumed to directly specify the metric matrix representation.

    • +
    • dens_wrt_hausdorff (bool) – Whether the neg_log_dens function specifies the (negative logarithm) of the density of the target distribution with -respect to the Hausdorff measure on the manifold directly (True) or -alternatively the negative logarithm of a density of a prior +respect to the Hausdorff measure on the manifold directly (True) +or alternatively the negative logarithm of a density of a prior distriubtion on the unconstrained (ambient) position space with respect to the Lebesgue measure, with the target distribution then corresponding -to the posterior distribution when conditioning on the event const(pos) -== 0 (False). Note that in the former case the base Hausdorff measure -on the manifold depends on the metric defined on the ambient space, with -the Hausdorff measure being defined with respect to the metric induced -on the manifold from this ambient metric.

    • +to the posterior distribution when conditioning on the event +constr(pos) == 0 (False). Note that in the former case +the base Hausdorff measure on the manifold depends on the metric defined +on the ambient space, with the Hausdorff measure being defined with +respect to the metric induced on the manifold from this ambient metric.

    • grad_neg_log_dens (Optional[GradientFunction]) – Function which given a position array returns the -derivative of neg_log_dens with respect to the position array +derivative of neg_log_dens with respect to the position array argument. Optionally the function may instead return a 2-tuple of values with the first being the array corresponding to the derivative and the -second being the value of the neg_log_dens evaluated at the passed -position array. If None is passed (the default) an automatic -differentiation fallback will be used to attempt to construct a function -to compute the derivative (and value) of neg_log_dens automatically.

    • -
    • jacob_constr (Optional[JacobianFunction]) –

      -
      Function which given a position array computes the Jacobian

      (matrix / 2D array of partial derivatives) of the output of the -constraint function c = constr(q) with respect to the position array -argument q, returning the computed Jacobian as a 2D array jacob with

      -
      -
      -
          jacob[i, j] = ∂c[i] / ∂q[j]
      -
      -Optionally the function may instead return a 2-tuple of values with the
      -first being the array corresponding to the Jacobian and the second being
      -the value of `constr` evaluated at the passed position array. If `None`
      +second being the value of the neg_log_dens evaluated at the
      +passed position array. If None is passed (the default) an
      +automatic differentiation fallback will be used to attempt to construct
      +a function to compute the derivative (and value) of neg_log_dens
      +automatically.

    • +
    • jacob_constr (Optional[JacobianFunction]) – Function which given a position array computes the Jacobian +(matrix / 2D array of partial derivatives) of the output of the +constraint function c = constr(q) with respect to the position +array argument q, returning the computed Jacobian as a 2D array +jacob with jacob[i, j] = ∂c[i] / ∂q[j]. Optionally the +function may instead return a 2-tuple of values with the first being the +array corresponding to the Jacobian and the second being the value of +constr evaluated at the passed position array. If None is passed (the default) an automatic differentiation fallback will be used to attempt to construct a function to compute the Jacobian (and -value) of `neg_log_dens` automatically. -

    -
    -

    -
  • mhp_constr (Optional[MatrixHessianProductFunction]) –

    -
    Function which given a position array returns another function

    which takes a 2D array as an argument and returns the -matrix-Hessian-product (MHP) of the constraint function constr with -respect to the position array argument. The MHP is here defined as a -function of a (dim_constr, dim_pos) shaped 2D array m

    -
    -
    -
        mhp(m) = sum(m[:, :, None] * hess[:, :, :], axis=(0, 1))
    -
    -where `hess` is the `(dim_constr, dim_pos, dim_pos)` shaped
    -vector-Hessian of `c = constr(q)` with respect to `q` i.e. the array of
    -second-order partial derivatives of such that
    -
    -
    -
        hess[i, j, k] = ∂²c[i] / (∂q[j] ∂q[k])
    -
    -Optionally the function may instead return a 3-tuple of values with the
    -first a function to compute a MHP of `constr`, the second a 2D array
    -corresponding to the Jacobian of `constr`, and the third the value of
    -`constr`, all evaluated at the passed position array. If `None` is
    -passed (the default) an automatic differentiation fallback will be used
    -to attempt to construct a function which calculates the MHP (and
    -Jacobian and value) of `constr` automatically.
    -
    -
    -

  • +value) of constr +automatically.

    +
  • mhp_constr (Optional[MatrixHessianProductFunction]) – Function which given a position array returns another function +which takes a 2D array as an argument and returns the +matrix-Hessian-product (MHP) of the constraint function constr +with respect to the position array argument. The MHP is here defined as +a function of a (dim_constr, dim_pos) shaped 2D array m +as mhp(m) = sum(m[:, :, None] * hess[:, :, :], axis=(0, 1)) +where hess is the (dim_constr, dim_pos, dim_pos) shaped +vector-Hessian of c = constr(q) with respect to q i.e. +the array of second-order partial derivatives of such that +hess[i, j, k] = ∂²c[i] / (∂q[j] ∂q[k]). Optionally the function +may instead return a 3-tuple of values with the first a function to +compute a MHP of constr, the second a 2D array corresponding to +the Jacobian of constr, and the third the value of +constr, all evaluated at the passed position array. If +None is passed (the default) an automatic differentiation +fallback will be used to attempt to construct a function which +calculates the MHP (and Jacobian and value) of constr +automatically.

  • @@ -1092,7 +1070,7 @@

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of constr(state.pos) as 1D array.

    +

    Value of constr(state.pos) as 1D array.

    Return type:

    ArrayLike

    @@ -1154,24 +1132,21 @@
    dh2_flow_dmom(dt)
    -

    Derivatives of h2_flow flow map with respect to input momentum.

    +

    Derivatives of h2_flow flow map with respect to momentum argument.

    Parameters:

    dt (ScalarLike) – Time interval flow simulated for.

    Returns:
    -

    -
    Matrix representing derivative (Jacobian) of position output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    dmom_dmom: Matrix representing derivative (Jacobian) of momentum output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    -

    +

    Tuple (dpos_dmom, dmom_dmom) with dpos_dmom a matrix representing +derivative (Jacobian) of position output of h2_flow() with respect +to the value of the momentum component of the initial input state and +dmom_dmom a matrix representing derivative (Jacobian) of momentum +output of h2_flow() with respect to the value of the momentum +component of the initial input state.

    Return type:
    -

    dpos_dmom

    +

    tuple[Matrix, Matrix]

    @@ -1213,13 +1188,14 @@
    grad_log_det_sqrt_gram(state)[source]
    -

    Derivative of (half of) log-determinant of Gram matrix wrt position.

    +

    Derivative of half of log-determinant of Gram matrix with respect to position

    Parameters:

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of log_det_sqrt_gram(state) derivative with respect to state.pos.

    +

    Value of log_det_sqrt_gram(state) derivative with respect to +state.pos.

    Return type:

    ArrayLike

    @@ -1252,8 +1228,9 @@
    gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
     
    -

    where jacob_constr is the Jacobian of the constraint function constr and -metric is the matrix representation of the metric on the ambient space.

    +

    where jacob_constr is the Jacobian of the constraint function +constr and metric is the matrix representation of the metric on +the ambient space.

    Parameters:

    state (ChainState) – State to compute value at.

    @@ -1374,7 +1351,7 @@

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of Jacobian of constr(state.pos) as 2D array.

    +

    Value of Jacobian of constr(state.pos) as 2D array.

    Return type:

    ArrayLike

    @@ -1386,9 +1363,9 @@
    jacob_constr_inner_product(jacob_constr_1, inner_product_matrix, jacob_constr_2=None)[source]

    Compute inner product of rows of constraint Jacobian matrices.

    -

    Computes jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T potentially -exploiting any structure / sparsity in jacob_constr_1, jacob_constr_2 and -inner_product_matrix.

    +

    Computes jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T +potentially exploiting any structure / sparsity in jacob_constr_1, +jacob_constr_2 and inner_product_matrix.

    Parameters:
      @@ -1396,7 +1373,7 @@
    • inner_product_matrix (PositiveDefiniteMatrix) – Positive-definite matrix defining inner-product between rows of two constraint Jacobians.

    • jacob_constr_2 (Optional[MatrixLike]) – Second constraint Jacobian in product. Defaults to -jacob_constr_1 if set to None.

    • +jacob_constr_1 if set to None.

    Return type:
    @@ -1467,7 +1444,7 @@
    Returns:
    -

    Projected momentum in the co-tangent space at state.pos.

    +

    Projected momentum in the co-tangent space at state.pos.

    Return type:

    ArrayLike

    @@ -2152,7 +2129,7 @@
    class mici.systems.EuclideanMetricSystem(neg_log_dens, metric=None, grad_neg_log_dens=None)[source]
    -

    Bases: System

    +

    Bases: TractableFlowSystem

    Hamiltonian system with a Euclidean metric on the position space.

    Here Euclidean metric is defined to mean a metric with a fixed positive definite matrix representation \(M\). The momentum variables are taken to be independent @@ -2249,24 +2226,21 @@

    dh2_flow_dmom(dt)[source]
    -

    Derivatives of h2_flow flow map with respect to input momentum.

    +

    Derivatives of h2_flow flow map with respect to momentum argument.

    Parameters:

    dt (ScalarLike) – Time interval flow simulated for.

    Returns:
    -

    -
    Matrix representing derivative (Jacobian) of position output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    dmom_dmom: Matrix representing derivative (Jacobian) of momentum output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    -

    +

    Tuple (dpos_dmom, dmom_dmom) with dpos_dmom a matrix representing +derivative (Jacobian) of position output of h2_flow() with respect +to the value of the momentum component of the initial input state and +dmom_dmom a matrix representing derivative (Jacobian) of momentum +output of h2_flow() with respect to the value of the momentum +component of the initial input state.

    Return type:
    -

    dpos_dmom

    +

    tuple[Matrix, Matrix]

    @@ -2541,7 +2515,7 @@

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of constr(state.pos) as 1D array.

    +

    Value of constr(state.pos) as 1D array.

    Return type:

    ArrayLike

    @@ -2603,24 +2577,21 @@
    dh2_flow_dmom(dt)
    -

    Derivatives of h2_flow flow map with respect to input momentum.

    +

    Derivatives of h2_flow flow map with respect to momentum argument.

    Parameters:

    dt (ScalarLike) – Time interval flow simulated for.

    Returns:
    -

    -
    Matrix representing derivative (Jacobian) of position output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    dmom_dmom: Matrix representing derivative (Jacobian) of momentum output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    -

    +

    Tuple (dpos_dmom, dmom_dmom) with dpos_dmom a matrix representing +derivative (Jacobian) of position output of h2_flow() with respect +to the value of the momentum component of the initial input state and +dmom_dmom a matrix representing derivative (Jacobian) of momentum +output of h2_flow() with respect to the value of the momentum +component of the initial input state.

    Return type:
    -

    dpos_dmom

    +

    tuple[Matrix, Matrix]

    @@ -2662,13 +2633,14 @@
    grad_log_det_sqrt_gram(state)
    -

    Derivative of (half of) log-determinant of Gram matrix wrt position.

    +

    Derivative of half of log-determinant of Gram matrix with respect to position

    Parameters:

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of log_det_sqrt_gram(state) derivative with respect to state.pos.

    +

    Value of log_det_sqrt_gram(state) derivative with respect to +state.pos.

    Return type:

    ArrayLike

    @@ -2701,8 +2673,9 @@
    gram(q) = jacob_constr(q) @ inv(metric) @ jacob_constr(q).T
     
    -

    where jacob_constr is the Jacobian of the constraint function constr and -metric is the matrix representation of the metric on the ambient space.

    +

    where jacob_constr is the Jacobian of the constraint function +constr and metric is the matrix representation of the metric on +the ambient space.

    Parameters:

    state (ChainState) – State to compute value at.

    @@ -2823,7 +2796,7 @@

    state (ChainState) – State to compute value at.

    Returns:
    -

    Value of Jacobian of constr(state.pos) as 2D array.

    +

    Value of Jacobian of constr(state.pos) as 2D array.

    Return type:

    ArrayLike

    @@ -2835,9 +2808,9 @@
    jacob_constr_inner_product(jacob_constr_1, inner_product_matrix, jacob_constr_2=None)[source]

    Compute inner product of rows of constraint Jacobian matrices.

    -

    Computes jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T potentially -exploiting any structure / sparsity in jacob_constr_1, jacob_constr_2 and -inner_product_matrix.

    +

    Computes jacob_constr_1 @ inner_product_matrix @ jacob_constr_2.T +potentially exploiting any structure / sparsity in jacob_constr_1, +jacob_constr_2 and inner_product_matrix.

    Parameters:
      @@ -2845,7 +2818,7 @@
    • inner_product_matrix (PositiveDefiniteMatrix) – Positive-definite matrix defining inner-product between rows of two constraint Jacobians.

    • jacob_constr_2 (Optional[MatrixLike]) – Second constraint Jacobian in product. Defaults to -jacob_constr_1 if set to None.

    • +jacob_constr_1 if set to None.

    Return type:
    @@ -2916,7 +2889,7 @@
    Returns:
    -

    Projected momentum in the co-tangent space at state.pos.

    +

    Projected momentum in the co-tangent space at state.pos.

    Return type:

    ArrayLike

    @@ -3059,24 +3032,21 @@
    dh2_flow_dmom(dt)[source]
    -

    Derivatives of h2_flow flow map with respect to input momentum.

    +

    Derivatives of h2_flow flow map with respect to momentum argument.

    Parameters:

    dt (ScalarLike) – Time interval flow simulated for.

    Returns:
    -

    -
    Matrix representing derivative (Jacobian) of position output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    dmom_dmom: Matrix representing derivative (Jacobian) of momentum output of

    h2_flow with respect to the value of the momentum component of the -initial input state.

    -
    -
    -

    +

    Tuple (dpos_dmom, dmom_dmom) with dpos_dmom a matrix representing +derivative (Jacobian) of position output of h2_flow() with respect +to the value of the momentum component of the initial input state and +dmom_dmom a matrix representing derivative (Jacobian) of momentum +output of h2_flow() with respect to the value of the momentum +component of the initial input state.

    Return type:
    -

    dpos_dmom

    +

    tuple[Matrix, Matrix]

    @@ -4371,7 +4341,7 @@ depends only on the position variable however depending on the form of \(h_2\) the corresponding exact Hamiltonian flow may or may not be simulable.

    By default \(h_1\) is assumed to correspond to the negative logarithm of an -unnormalized density on the position variables with respect to the Lebesgue measure, +unnormalized density on the position variables with respect to a reference measure, with the corresponding distribution on the position space being the target distribution it is wished to draw approximate samples from.

    @@ -4379,7 +4349,7 @@
    • neg_log_dens (ScalarFunction) – Function which given a position array returns the negative logarithm of an unnormalized probability density on the position space -with respect to the Lebesgue measure, with the corresponding +with respect to a reference measure, with the corresponding distribution on the position space being the target distribution it is wished to draw approximate samples from.

    • grad_neg_log_dens (Optional[GradientFunction]) – Function which given a position array returns the @@ -4600,6 +4570,285 @@

    +
    +
    +class mici.systems.TractableFlowSystem(neg_log_dens, grad_neg_log_dens=None)[source]
    +

    Bases: System

    +

    Base class for Hamiltonian systems with tractable component flows.

    +

    The Hamiltonian function \(h\) is assumed to have the general form

    +
    +\[h(q, p) = h_1(q) + h_2(q, p)\]
    +

    where \(q\) and \(p\) are the position and momentum variables respectively, +and \(h_1\) and \(h_2\) Hamiltonian component functions. The exact +Hamiltonian flows for both the \(h_1\) and \(h_2\) components are assumed to +be tractable for subclasses of this class.

    +

    By default \(h_1\) is assumed to correspond to the negative logarithm of an +unnormalized density on the position variables with respect to a reference measure, +with the corresponding distribution on the position space being the target +distribution it is wished to draw approximate samples from.

    +
    +
    Parameters:
    +
      +
    • neg_log_dens (ScalarFunction) – Function which given a position array returns the negative +logarithm of an unnormalized probability density on the position space +with respect to a reference measure, with the corresponding +distribution on the position space being the target distribution it is +wished to draw approximate samples from.

    • +
    • grad_neg_log_dens (Optional[GradientFunction]) – Function which given a position array returns the +derivative of neg_log_dens with respect to the position array +argument. Optionally the function may instead return a 2-tuple of values +with the first being the array corresponding to the derivative and the +second being the value of the neg_log_dens evaluated at the passed +position array. If None is passed (the default) an automatic +differentiation fallback will be used to attempt to construct the +derivative of neg_log_dens automatically.

    • +
    +
    +
    +
    +
    +dh1_dpos(state)
    +

    Derivative of h1 Hamiltonian component with respect to position.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of computed h1 derivative.

    +
    +
    Return type:
    +

    ScalarLike

    +
    +
    +
    + +
    +
    +abstract dh2_dmom(state)
    +

    Derivative of h2 Hamiltonian component with respect to momentum.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of h2(state) derivative with respect to state.mom.

    +
    +
    Return type:
    +

    ArrayLike

    +
    +
    +
    + +
    +
    +abstract dh2_dpos(state)
    +

    Derivative of h2 Hamiltonian component with respect to position.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of h2(state) derivative with respect to state.pos.

    +
    +
    Return type:
    +

    ArrayLike

    +
    +
    +
    + +
    +
    +abstract dh2_flow_dmom(dt)[source]
    +

    Derivatives of h2_flow flow map with respect to momentum argument.

    +
    +
    Parameters:
    +

    dt (ScalarLike) – Time interval flow simulated for.

    +
    +
    Returns:
    +

    Tuple (dpos_dmom, dmom_dmom) with dpos_dmom a matrix representing +derivative (Jacobian) of position output of h2_flow() with respect +to the value of the momentum component of the initial input state and +dmom_dmom a matrix representing derivative (Jacobian) of momentum +output of h2_flow() with respect to the value of the momentum +component of the initial input state.

    +
    +
    Return type:
    +

    tuple[Matrix, Matrix]

    +
    +
    +
    + +
    +
    +dh_dmom(state)
    +

    Derivative of Hamiltonian with respect to momentum.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of h(state) derivative with respect to state.mom.

    +
    +
    Return type:
    +

    ArrayLike

    +
    +
    +
    + +
    +
    +dh_dpos(state)
    +

    Derivative of Hamiltonian with respect to position.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of h(state) derivative with respect to state.pos.

    +
    +
    Return type:
    +

    ArrayLike

    +
    +
    +
    + +
    +
    +grad_neg_log_dens(state)
    +

    Derivative of negative log density with respect to position.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of neg_log_dens(state) derivative with respect to state.pos.

    +
    +
    Return type:
    +

    ArrayLike

    +
    +
    +
    + +
    +
    +h(state)
    +

    Hamiltonian function for system.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of Hamiltonian.

    +
    +
    Return type:
    +

    ScalarLike

    +
    +
    +
    + +
    +
    +h1(state)
    +

    Hamiltonian component depending only on position.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of h1 Hamiltonian component.

    +
    +
    Return type:
    +

    ScalarLike

    +
    +
    +
    + +
    +
    +h1_flow(state, dt)
    +

    Apply exact flow map corresponding to h1 Hamiltonian component.

    +

    state argument is modified in place.

    +
    +
    Parameters:
    +
      +
    • state (ChainState) – State to start flow at.

    • +
    • dt (ScalarLike) – Time interval to simulate flow for.

    • +
    +
    +
    +
    + +
    +
    +abstract h2(state)
    +

    Hamiltonian component depending on momentum and optionally position.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of h2 Hamiltonian component.

    +
    +
    Return type:
    +

    ScalarLike

    +
    +
    +
    + +
    +
    +abstract h2_flow(state, dt)[source]
    +

    Apply exact flow map corresponding to h2 Hamiltonian component.

    +

    state argument is modified in place.

    +
    +
    Parameters:
    +
      +
    • state (ChainState) – State to start flow at.

    • +
    • dt (ScalarLike) – Time interval to simulate flow for.

    • +
    +
    +
    +
    + +
    +
    +neg_log_dens(state)
    +

    Negative logarithm of unnormalized density of target distribution.

    +
    +
    Parameters:
    +

    state (ChainState) – State to compute value at.

    +
    +
    Returns:
    +

    Value of computed negative log density.

    +
    +
    Return type:
    +

    ScalarLike

    +
    +
    +
    + +
    +
    +abstract sample_momentum(state, rng)
    +

    Sample a momentum from its conditional distribution given a position.

    +
    +
    Parameters:
    +
      +
    • state (ChainState) – State defining position to condition on.

    • +
    • rng (Generator) –

    • +
    +
    +
    Returns:
    +

    Sampled momentum.

    +
    +
    Return type:
    +

    ArrayLike

    +
    +
    +
    + +
    + diff --git a/objects.inv b/objects.inv index 0cd810d..1ee99b8 100644 Binary files a/objects.inv and b/objects.inv differ diff --git a/searchindex.js b/searchindex.js index c7cec5f..d941fdb 100644 --- a/searchindex.js +++ b/searchindex.js @@ -1 +1 @@ -Search.setIndex({"docnames": ["index", "mici", "mici.adapters", "mici.autodiff", "mici.autograd_wrapper", "mici.errors", "mici.integrators", "mici.interop", "mici.matrices", "mici.progressbars", "mici.samplers", "mici.solvers", "mici.stagers", "mici.states", "mici.systems", "mici.transitions", "mici.types", "mici.utils"], "filenames": ["index.rst", "mici.rst", "mici.adapters.rst", "mici.autodiff.rst", "mici.autograd_wrapper.rst", "mici.errors.rst", "mici.integrators.rst", "mici.interop.rst", "mici.matrices.rst", "mici.progressbars.rst", "mici.samplers.rst", "mici.solvers.rst", "mici.stagers.rst", "mici.states.rst", "mici.systems.rst", "mici.transitions.rst", "mici.types.rst", "mici.utils.rst"], "titles": ["Welcome to Mici\u2019s documentation!", "mici package", "mici.adapters module", "mici.autodiff module", "mici.autograd_wrapper module", "mici.errors module", "mici.integrators module", "mici.interop module", "mici.matrices module", "mici.progressbars module", "mici.samplers module", "mici.solvers module", "mici.stagers module", "mici.states module", "mici.systems module", "mici.transitions module", "mici.types module", "mici.utils module"], "terms": {"i": [0, 2, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "python": [0, 7, 10], "packag": 0, "provid": [0, 3, 6, 7, 13, 14], "implement": [0, 2, 3, 6, 8, 9, 10, 17], "markov": [0, 2, 7, 10, 12, 13, 15], "chain": [0, 2, 5, 7, 9, 10, 11, 12, 13, 15], "mont": [0, 2, 6, 10, 14, 15], "carlo": [0, 2, 6, 10, 14, 15], "mcmc": [0, 1, 10, 15], "method": [0, 2, 6, 7, 8, 9, 10, 11, 13, 14, 15], "approxim": [0, 6, 7, 8, 10, 11, 12, 14, 15], "infer": [0, 7, 10, 14], "probabilist": [0, 2, 7], "model": [0, 7, 10, 14, 15], "particular": 0, "focu": 0, "base": [0, 1, 2, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "simul": [0, 1, 6, 10, 11, 14, 15], "hamiltonian": [0, 1, 2, 5, 6, 7, 10, 11, 14, 15], "dynam": [0, 1, 5, 6, 7, 10, 11, 14, 15], "manifold": [0, 1, 6, 11, 14, 15], "submodul": 0, "adapt": [0, 1, 5, 6, 7, 10, 12, 15], "modul": [0, 1], "autodiff": [0, 1], "autograd_wrapp": [0, 1], "error": [0, 1, 2, 3, 6, 11, 13], "integr": [0, 1, 2, 5, 7, 10, 11, 14, 15], "interop": [0, 1], "matric": [0, 1, 14], "progressbar": [0, 1, 7, 10], "sampler": [0, 1, 2, 7, 12, 15], "solver": [0, 1, 5, 6], "stager": [0, 1, 10], "state": [0, 1, 2, 5, 6, 9, 10, 11, 12, 14, 15], "system": [0, 1, 6, 7, 8, 10, 11, 13, 15], "transit": [0, 1, 2, 5, 7, 10, 12], "type": [0, 1, 2, 3, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15, 17], "util": [0, 1, 7], "dualaveragingstepsizeadapt": [1, 2, 10], "onlinecovariancemetricadapt": [1, 2], "onlinevariancemetricadapt": [1, 2], "arithmetic_mean_log_step_size_reduc": [1, 2], "default_adapt_stat_func": [1, 2], "geometric_mean_log_step_size_reduc": [1, 2], "min_log_step_size_reduc": [1, 2], "autodiff_fallback": [1, 3], "grad_and_valu": [1, 4], "hessian_grad_and_valu": [1, 4], "jacobian_and_valu": [1, 4], "mhp_jacobian_and_valu": [1, 4], "mtp_hessian_grad_and_valu": [1, 4], "adaptationerror": [1, 2, 5], "convergenceerror": [1, 5, 6, 11], "hamiltoniandivergenceerror": [1, 5], "integratorerror": [1, 5], "linalgerror": [1, 5, 8, 14], "nonreversiblesteperror": [1, 5, 6], "readonlystateerror": [1, 5, 13], "bcssfourstageintegr": [1, 6], "bcssthreestageintegr": [1, 6], "bcsstwostageintegr": [1, 6], "constrainedleapfrogintegr": [1, 6, 14], "implicitleapfrogintegr": [1, 6, 14], "implicitmidpointintegr": [1, 6], "leapfrogintegr": [1, 6], "symmetriccompositionintegr": [1, 6], "tractableflowintegr": [1, 6], "convert_to_inference_data": [1, 7], "sample_pymc3_model": [1, 7], "sample_stan_model": [1, 7], "blockcolumnmatrix": [1, 8], "blockmatrix": [1, 8], "blockrowmatrix": [1, 8], "densedefinitematrix": [1, 8], "densepositivedefinitematrix": [1, 8], "densepositivedefiniteproductmatrix": [1, 8], "denserectangularmatrix": [1, 8], "densesquarematrix": [1, 8], "densesymmetricmatrix": [1, 8], "diagonalmatrix": [1, 8, 14], "differentiablematrix": [1, 8, 14], "eigendecomposedpositivedefinitematrix": [1, 8], "eigendecomposedsymmetricmatrix": [1, 8], "explicitarraymatrix": [1, 8], "identitymatrix": [1, 8], "implicitarraymatrix": [1, 8], "inverselufactoredsquarematrix": [1, 8], "inversetriangularmatrix": [1, 8], "invertiblematrix": [1, 8], "invertiblematrixproduct": [1, 8], "matrix": [1, 2, 4, 5, 7, 8, 10, 11, 14, 15], "matrixproduct": [1, 8], "orthogonalmatrix": [1, 8], "positivedefiniteblockdiagonalmatrix": [1, 8], "positivedefinitelowrankupdatematrix": [1, 8], "positivedefinitematrix": [1, 8, 14], "positivediagonalmatrix": [1, 8], "positivescaledidentitymatrix": [1, 8], "scaledidentitymatrix": [1, 8], "scaledorthogonalmatrix": [1, 8], "softabsregularizedpositivedefinitematrix": [1, 8], "squareblockdiagonalmatrix": [1, 8], "squarelowrankupdatematrix": [1, 8], "squarematrix": [1, 8], "squarematrixproduct": [1, 8], "symmetricblockdiagonalmatrix": [1, 8], "symmetriclowrankupdatematrix": [1, 8], "symmetricmatrix": [1, 8], "triangularfactoreddefinitematrix": [1, 8], "triangularfactoredpositivedefinitematrix": [1, 8], "triangularmatrix": [1, 8], "dummyprogressbar": [1, 9], "filedisplai": [1, 9], "labelledsequenceprogressbar": [1, 9], "sequenceprogressbar": [1, 9, 10], "dynamicmultinomialhmc": [1, 10], "dynamicslicehmc": [1, 10], "hmcsamplechainsoutput": [1, 10], "hamiltonianmontecarlo": [1, 10], "mcmcsamplechainsoutput": [1, 10], "markovchainmontecarlomethod": [1, 7, 10], "randommetropolishmc": [1, 10], "staticmetropolishmc": [1, 10], "fixedpointsolv": [1, 6, 11], "projectionsolv": [1, 6, 11], "euclidean_norm": [1, 11], "maximum_norm": [1, 6, 11], "solve_fixed_point_direct": [1, 6, 11], "solve_fixed_point_steffensen": [1, 11], "solve_projection_onto_manifold_newton": [1, 11], "solve_projection_onto_manifold_newton_with_line_search": [1, 11], "solve_projection_onto_manifold_quasi_newton": [1, 6, 11], "chainstag": [1, 12], "warmupstag": [1, 10, 12], "windowedwarmupstag": [1, 10, 12], "chainstat": [1, 2, 6, 10, 11, 12, 13, 14, 15], "cache_in_st": [1, 13], "cache_in_state_with_aux": [1, 13], "choleskyfactoredriemannianmetricsystem": [1, 14], "constrainedeuclideanmetricsystem": [1, 14], "denseconstrainedeuclideanmetricsystem": [1, 14], "denseriemannianmetricsystem": [1, 14], "diagonalriemannianmetricsystem": [1, 14], "euclideanmetricsystem": [1, 14], "gaussiandenseconstrainedeuclideanmetricsystem": [1, 14], "gaussianeuclideanmetricsystem": [1, 14], "riemannianmetricsystem": [1, 14], "scalarriemannianmetricsystem": [1, 14], "softabsriemannianmetricsystem": [1, 14], "correlatedmomentumtransit": [1, 15], "dynamicintegrationtransit": [1, 15], "independentmomentumtransit": [1, 10, 15], "integrationtransit": [1, 10, 15], "metropolisintegrationtransit": [1, 15], "metropolisrandomintegrationtransit": [1, 15], "metropolisstaticintegrationtransit": [1, 15], "momentumtransit": [1, 10, 15], "multinomialdynamicintegrationtransit": [1, 15], "slicedynamicintegrationtransit": [1, 15], "euclidean_no_u_turn_criterion": [1, 10, 15], "riemannian_no_u_turn_criterion": [1, 10, 15], "logrepfloat": [1, 17], "hash_arrai": [1, 17], "log1m_exp": [1, 17], "log1p_exp": [1, 17], "log_diff_exp": [1, 17], "log_sum_exp": [1, 17], "set": [2, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15], "algorithm": [2, 7, 10, 15], "paramet": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "class": [2, 5, 6, 8, 9, 10, 11, 12, 13, 14, 15, 17], "sourc": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "abc": [2, 6, 8, 9, 12, 14, 15], "abstract": [2, 8, 9, 12, 14, 15], "scheme": [2, 7, 10, 15], "ar": [2, 6, 7, 8, 10, 11, 12, 13, 14, 15], "assum": [2, 4, 6, 8, 14, 15], "updat": [2, 6, 8, 9, 10, 11, 12, 13, 15], "collect": [2, 9], "variabl": [2, 6, 7, 10, 12, 13, 14, 15], "term": [2, 6, 8, 10, 14, 15], "here": [2, 4, 8, 10, 14], "after": [2, 6, 10, 11, 12, 13], "each": [2, 6, 7, 8, 9, 10, 11, 12, 13, 15], "sampl": [2, 7, 10, 12, 13, 14, 15], "statist": [2, 7, 9, 10, 12, 14, 15], "an": [2, 3, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "accept": [2, 6, 7, 10, 14, 15], "probabl": [2, 7, 10, 14, 15], "complet": [2, 9, 10], "one": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "more": [2, 6, 8, 10, 12, 13, 14, 15, 17], "final": [2, 6, 7, 10, 12], "mai": [2, 6, 7, 8, 10, 11, 12, 13, 14], "us": [2, 3, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "perform": [2, 6, 8, 10, 11, 12, 15], "adapt_st": 2, "chain_stat": 2, "rng": [2, 10, 14, 15], "option": [2, 3, 6, 7, 8, 9, 10, 13, 14, 15, 17], "multipl": [2, 7, 8, 10, 12], "avail": [2, 8, 10, 13], "e": [2, 4, 6, 8, 10, 11, 13, 14, 15], "g": [2, 6, 10, 13, 14, 15], "from": [2, 3, 6, 7, 10, 14, 15], "independ": [2, 7, 10, 13, 14, 15], "inform": [2, 12, 14], "all": [2, 6, 7, 8, 10, 12, 13, 14, 15], "combin": [2, 6], "": [2, 6, 8, 9, 10, 11, 12, 13, 14, 15], "union": [2, 7, 8, 10], "adapterst": 2, "iter": [2, 5, 6, 7, 8, 9, 10, 11, 12, 13], "list": [2, 7, 8, 9, 10], "per": [2, 7, 9, 10, 11, 12], "arrai": [2, 4, 6, 7, 8, 10, 12, 14, 15, 17], "buffer": 2, "associ": [2, 7, 8, 10, 13, 14], "entri": [2, 7, 8, 9, 10, 12, 13, 15], "recycl": 2, "reduc": [2, 6, 10, 15], "memori": [2, 8, 10], "usag": [2, 10], "so": [2, 8, 10, 11, 12, 13, 14, 15], "correspond": [2, 3, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "remov": 2, "dictionari": [2, 6, 7, 9, 10, 12, 13, 14, 15], "current": [2, 9, 10, 11, 12, 14, 15], "stage": [2, 6, 9, 10, 12], "place": [2, 14], "alter": [2, 12], "requir": [2, 3, 6, 8, 11, 12, 14], "ani": [2, 6, 7, 8, 9, 10, 11, 13, 14, 15], "compon": [2, 6, 10, 11, 14, 15], "being": [2, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "dapt": 2, "attribut": [2, 5, 10, 12, 13], "child": 2, "object": [2, 6, 7, 8, 9, 10, 11, 13, 14, 15, 17], "gener": [2, 3, 6, 7, 8, 10, 14, 15], "random": [2, 7, 10, 15], "number": [2, 6, 7, 8, 9, 10, 11, 12, 13, 15], "resampl": [2, 10, 15], "need": [2, 6, 13, 14], "due": [2, 6, 10, 14, 15], "initi": [2, 6, 7, 10, 11, 12, 13, 14, 15], "prior": [2, 7, 14], "start": [2, 7, 13, 14], "calcul": [2, 11, 13, 14], "should": [2, 6, 8, 10, 13, 14, 15], "mutat": 2, "return": [2, 3, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15, 17], "properti": [2, 6, 8, 9, 10, 14, 15, 17], "is_fast": [2, 10, 12], "bool": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "whether": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "fast": [2, 7, 10, 12], "slow": [2, 7, 12], "which": [2, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "onli": [2, 5, 6, 8, 10, 11, 12, 13, 14, 15], "local": [2, 12], "classifi": 2, "while": [2, 6, 7, 13, 15], "global": [2, 12], "fals": [2, 6, 7, 8, 10, 12, 13, 14], "trans_stat": [2, 15], "follow": [2, 6, 7, 10, 12], "transitionstatist": 2, "adapt_stat_target": 2, "0": [2, 4, 6, 7, 9, 10, 11, 12, 14, 15], "8": [2, 6, 7], "adapt_stat_func": 2, "none": [2, 3, 4, 6, 7, 8, 9, 10, 13, 14, 15, 17], "log_step_size_reg_target": 2, "log_step_size_reg_coeffici": 2, "05": [2, 7], "iter_decay_coeff": 2, "75": [2, 7, 12], "iter_offset": 2, "10": [2, 7, 9, 10, 11, 12, 15], "max_init_step_size_it": 2, "100": [2, 11], "log_step_size_reduc": 2, "dual": [2, 10], "averag": [2, 10], "step": [2, 5, 6, 7, 10, 11, 14, 15], "size": [2, 6, 7, 8, 10, 11, 12, 15], "describ": [2, 6, 7, 9, 15], "1": [2, 4, 6, 7, 8, 9, 10, 11, 14, 15, 17], "modifi": [2, 14], "version": [2, 10], "stochast": 2, "optimis": 2, "2": [2, 4, 6, 7, 8, 10, 11, 12, 14, 15], "By": [2, 8, 12, 13, 14], "default": [2, 6, 7, 9, 10, 12, 13, 14, 15], "control": [2, 6, 7, 10, 12, 14], "accept_prob": 2, "close": [2, 6, 8, 10, 14, 15], "target": [2, 7, 10, 14, 15], "valu": [2, 3, 4, 6, 7, 8, 9, 10, 12, 13, 14, 15, 17], "can": [2, 4, 6, 7, 8, 10, 12, 13, 14], "chang": [2, 10, 11, 12, 13, 15], "refer": [2, 6, 10, 12, 14, 15], "hoffman": [2, 10, 15], "m": [2, 4, 6, 10, 14, 15], "d": [2, 10, 14, 15], "gelman": [2, 10, 15], "A": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "2014": [2, 6, 10, 14, 15], "The": [2, 6, 7, 8, 10, 11, 12, 13, 14, 15], "No": [2, 6, 10, 15], "u": [2, 10, 15], "turn": [2, 10, 15], "path": [2, 10, 15], "length": [2, 9, 10, 15], "journal": [2, 6, 10, 14, 15], "machin": [2, 10, 15], "learn": [2, 10, 15], "research": [2, 10, 15], "15": [2, 10, 12, 15], "pp": [2, 10, 14, 15], "1593": [2, 10, 15], "1623": [2, 10, 15], "nesterov": 2, "y": 2, "2009": 2, "primal": [2, 13], "subgradi": 2, "convex": 2, "problem": [2, 6], "mathemat": 2, "program": [2, 7], "120": 2, "221": 2, "259": 2, "float": [2, 6, 7, 8, 9, 10, 11, 12, 14, 15, 17], "dure": [2, 6, 7, 10, 11, 12, 15], "adaptationstatisticfunct": 2, "function": [2, 3, 4, 6, 7, 8, 10, 11, 12, 13, 14, 15, 17], "given": [2, 6, 10, 14, 15], "output": [2, 4, 6, 7, 8, 9, 10, 12, 13, 14], "thi": [2, 6, 7, 8, 10, 12, 13, 14, 15], "simpli": [2, 14], "select": [2, 10], "accept_stat": [2, 10], "regular": [2, 7, 8, 14], "logarithm": [2, 8, 14, 17], "toward": [2, 10, 15], "If": [2, 6, 7, 8, 10, 11, 12, 13, 14, 15], "log": [2, 7, 8, 14, 17], "init_step_s": 2, "where": [2, 4, 6, 8, 11, 14, 15, 17], "reason": 2, "found": 2, "coars": 2, "search": [2, 11], "recommend": 2, "ha": [2, 3, 7, 8, 10, 14, 15], "effect": [2, 6, 10, 15], "give": [2, 6, 8, 14], "tendenc": 2, "test": [2, 7, 11], "larger": [2, 6, 7], "than": [2, 8, 12, 14, 15], "typic": [2, 6, 8], "have": [2, 6, 8, 9, 10, 13, 14, 15], "lower": [2, 8, 10, 14, 15], "comput": [2, 4, 6, 8, 10, 11, 12, 13, 14, 15, 17], "cost": [2, 8, 10, 11, 15], "coeffici": [2, 6, 8, 14, 15], "amount": 2, "regularis": [2, 8, 14], "expon": [2, 7], "decai": 2, "schedul": 2, "weight": [2, 15], "smooth": [2, 8, 14], "estim": [2, 7, 9], "interv": [2, 6, 7, 10, 14, 15], "5": [2, 6, 11], "ensur": [2, 6, 8, 10, 14, 15], "asymptot": [2, 14], "converg": [2, 5, 6, 7, 11], "equal": [2, 6, 7, 8, 10, 15], "whole": 2, "histori": 2, "smaller": 2, "increasingli": [2, 8, 14], "highli": 2, "recent": 2, "forget": 2, "earli": 2, "int": [2, 6, 7, 8, 9, 10, 11, 12, 13, 15, 17], "offset": [2, 7], "non": [2, 6, 7, 8, 10, 11, 12, 14], "neg": [2, 6, 7, 8, 14, 15], "stabilis": 2, "maximum": [2, 7, 10, 11, 15], "except": [2, 5, 6, 8, 11, 13, 14], "rais": [2, 5, 6, 11, 13, 14], "suitabl": 2, "within": [2, 5, 6, 7, 9, 10, 11], "mani": 2, "reducerfunct": 2, "reduct": 2, "appli": [2, 3, 6, 7, 10, 12, 14], "produc": [2, 15], "overal": [2, 6, 8], "main": [2, 10, 12], "specifi": [2, 3, 6, 7, 8, 9, 10, 12, 13, 14, 15], "sequenc": [2, 6, 8, 9, 10, 12, 17], "arithmet": [2, 17], "mean": [2, 6, 7, 8, 9, 10, 14, 15], "true": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "reg_iter_offset": 2, "reg_scal": 2, "001": 2, "dens": [2, 7, 8, 14], "metric": [2, 7, 8, 10, 14, 15], "onlin": 2, "covari": [2, 7, 14], "welford": 2, "stabli": 2, "posit": [2, 6, 7, 8, 9, 10, 11, 14, 15, 17], "variant": [2, 13, 15], "schubert": 2, "gertz": 2, "parallel": [2, 7, 10], "batch": [2, 4], "increment": 2, "varianc": [2, 7], "chan": 2, "et": 2, "al": 2, "3": [2, 4, 6, 8, 10, 14, 15], "scale": [2, 7, 11, 14], "ident": [2, 6, 7, 8, 10, 14, 15], "increas": [2, 12], "small": [2, 6, 11], "decreas": [2, 11], "noisi": 2, "approach": [2, 6, 12, 15], "stan": [2, 7, 10, 12, 15], "4": [2, 6, 7, 10, 14, 15], "represent": [2, 7, 8, 9, 10, 14, 15, 17], "definit": [2, 8, 14], "invers": [2, 8, 14], "b": [2, 6, 9, 10, 14, 15], "p": [2, 6, 10, 11, 14, 15], "1962": 2, "note": [2, 6, 8, 10, 12, 14], "correct": [2, 14], "sum": [2, 4, 6, 10, 12, 14, 15], "squar": [2, 8, 14], "product": [2, 4, 8, 14, 15], "technometr": 2, "419": 2, "420": 2, "2018": 2, "numer": [2, 6, 10, 14, 17], "stabl": [2, 17], "co": [2, 6, 11, 14], "acm": 2, "doi": 2, "1145": 2, "3221269": 2, "3223036": 2, "t": [2, 4, 6, 8, 13, 14], "f": [2, 4, 6, 8, 14], "golub": 2, "h": [2, 4, 6, 14], "levequ": 2, "r": [2, 10, 11, 14, 15], "j": [2, 4, 6, 8, 10, 14, 15], "1979": 2, "formula": 2, "pairwis": 2, "technic": 2, "report": 2, "c": [2, 6, 11, 14], "79": 2, "773": 2, "depart": 2, "scienc": [2, 14], "stanford": 2, "univers": [2, 6], "carpent": 2, "lee": 2, "goodrich": 2, "betancourt": [2, 10, 14, 15], "brubak": 2, "guo": 2, "li": 2, "riddel": 2, "2017": [2, 10, 14, 15], "languag": 2, "softwar": 2, "76": 2, "depend": [2, 8, 10, 12, 13, 14], "between": [2, 9, 10, 12, 13, 14, 15], "higher": 2, "caus": 2, "stronger": 2, "scalar": [2, 4, 6, 8, 10, 12, 14, 15], "defin": [2, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "diagon": [2, 7, 8, 14], "common": [2, 8, 13], "element": [2, 8, 14], "reciproc": [2, 9], "zero": [2, 8, 9, 10, 11, 14, 15], "guarante": [2, 14], "log_step_s": 2, "stat": [2, 7, 9], "extract": 2, "geometr": [2, 14], "minimum": [2, 9, 14], "automat": [3, 13, 14], "different": 3, "fallback": [3, 14], "construct": [3, 8, 12, 13, 14], "deriv": [3, 4, 6, 8, 13, 14], "diff_func": 3, "func": [3, 6, 11], "diff_op_nam": 3, "name": [3, 7, 10, 12, 13, 15], "differenti": [3, 4, 6, 13, 14], "oper": [3, 4, 5, 7, 8, 10, 17], "altern": [3, 6, 14], "been": [3, 8, 13], "callabl": [3, 12, 13], "either": [3, 7, 8, 10, 13, 14, 15], "wa": [3, 15], "str": [3, 6, 7, 9, 10, 12, 13, 14, 15], "string": [3, 7, 9, 10, 12, 13, 15], "framework": 3, "wrapper": [3, 10], "messag": 3, "otherwis": [3, 6, 8, 10, 14], "addit": [4, 7, 10, 13, 14, 15], "autograd": 4, "fun": 4, "x": [4, 6, 8, 11, 14], "make": 4, "both": [4, 6, 8, 9, 10, 11, 12, 14, 15], "gradient": [4, 8, 14], "scalarfunct": [4, 11, 14], "arraylik": [4, 7, 11, 12, 13, 14, 15], "tupl": [4, 8, 9, 10, 12, 13, 14, 15], "scalarlik": [4, 8, 14, 15], "hessian": [4, 14], "broadcast": 4, "along": [4, 8, 11, 15], "first": [4, 6, 7, 8, 9, 10, 13, 14, 15], "dimens": [4, 6, 7, 8, 10], "input": [4, 6, 8, 14], "respect": [4, 6, 7, 8, 10, 11, 13, 14, 15], "concurr": 4, "arrayfunct": [4, 11, 14], "jacobian": [4, 11, 14], "mhp": [4, 14], "For": [4, 6, 8, 10, 15], "vector": [4, 6, 8, 11, 14, 15], "axi": [4, 14], "wrt": [4, 14], "rank": [4, 8], "tensor": 4, "second": [4, 6, 7, 8, 9, 11, 14, 15], "order": [4, 6, 8, 9, 10, 12, 13, 14], "partial": [4, 7, 9, 14, 15], "k": [4, 6, 14], "\u00b2f": 4, "matrixhessianproduct": [4, 14], "mtp": [4, 14], "tressian": [4, 14], "3d": [4, 14], "third": [4, 14], "\u00b3f": [4, 14], "matrixtressianproduct": [4, 14], "when": [5, 7, 8, 10, 11, 12, 13, 14, 15], "fail": [5, 10, 14, 15], "arg": [5, 11], "with_traceback": 5, "tb": 5, "self": [5, 8, 12], "__traceback__": 5, "allow": [5, 6, 7, 8, 9, 11, 13, 14], "runtimeerror": 5, "diverg": [5, 6, 10, 11, 15], "linear": [5, 6, 8, 11, 14], "algebra": [5, 6, 8], "revers": [5, 6, 10, 13, 15], "check": [5, 6, 8, 10, 15], "write": [5, 9, 10], "read": [5, 13], "symplect": [6, 10, 15], "step_siz": 6, "four": 6, "symmetr": [6, 8, 11, 14], "composit": 6, "blane": 6, "casa": 6, "sanz": 6, "serna": 6, "equat": [6, 11, 14], "6": 6, "hybrid": [6, 10, 14, 15], "siam": 6, "scientif": 6, "36": 6, "a1556": 6, "a1580": 6, "time": [6, 9, 10, 11, 13, 14, 15], "befor": [6, 10, 11, 13, 15], "call": [6, 7, 10, 13], "singl": [6, 9, 10, 12, 14], "suppli": 6, "new": [6, 9, 10, 13, 15], "three": [6, 12], "7": 6, "two": [6, 10, 11, 12, 14, 15], "n_inner_step": 6, "reverse_check_tol": 6, "2e": 6, "08": [6, 11], "reverse_check_norm": 6, "projection_solv": 6, "projection_solver_kwarg": 6, "leapfrog": 6, "constrain": [6, 11, 14], "express": 6, "unconstrain": [6, 11, 14], "flow": [6, 11, 14], "exactli": [6, 10, 15], "specif": [6, 14], "take": [6, 10, 14, 15], "form": [6, 8, 11, 14], "q": [6, 11, 14], "h\u2081": 6, "h\u2082": [6, 11], "momentum": [6, 10, 11, 14, 15], "exact": [6, 14], "\u03c6\u2081": 6, "\u03c6\u2082": [6, 11], "addition": [6, 13, 14], "subject": [6, 14], "holonom": 6, "constraint": [6, 11, 14], "valid": [6, 9, 10, 13], "must": [6, 8, 9, 13], "satisfi": [6, 8, 11, 15], "some": [6, 7, 10, 15], "surject": 6, "implicitli": [6, 8, 14], "remain": [6, 7, 9, 15], "confin": 6, "enforc": [6, 14], "introduc": 6, "lagrang": [6, 11], "multipli": [6, 8, 11, 12], "\u03bb": [6, 11], "\u1d40\u03bb": [6, 11], "\u2082h": 6, "\u2081h": 6, "abov": [6, 8, 13, 14], "cotang": 6, "space": [6, 8, 10, 11, 14, 15], "pair": [6, 8, 9, 10, 15], "bundl": [6, 11], "To": 6, "up": [6, 7, 9, 10, 12, 15], "point": [6, 7, 8, 11, 14, 15], "preserv": [6, 10, 14], "map": [6, 7, 10, 11, 14], "we": 6, "reich": 6, "1996": 6, "\u03c0": 6, "parametris": [6, 8], "\u03c8\u2081": 6, "tangent": [6, 11, 14], "trivial": 6, "therefor": 6, "project": [6, 11, 14], "result": [6, 8, 10, 13, 14, 15], "back": 6, "usual": [6, 7, 13], "case": [6, 8, 10, 12, 14, 15], "includ": [6, 10], "quadrat": [6, 8, 11, 14], "analyt": [6, 14], "solv": [6, 8, 11, 14], "also": [6, 7, 13, 14], "\u03c8\u2082": 6, "decompos": 6, "\u2081": [6, 11], "newton": [6, 11], "solut": [6, 11], "\u03c8": 6, "n": [6, 14], "\u1d3a": 6, "integ": [6, 7, 10, 15, 17], "inner": [6, 8, 10, 11, 14], "detail": [6, 10, 13, 14, 15], "see": [6, 10, 12, 13, 14, 15], "section": 6, "leimkuhl": 6, "2004": 6, "analysi": 6, "33": 6, "475": 6, "491": 6, "14": 6, "cambridg": 6, "press": 6, "h2_flow": [6, 11, 14], "As": [6, 8, 13, 14], "dh1_dpo": [6, 14], "evalu": [6, 8, 11, 14], "rel": [6, 10, 15], "expens": 6, "compar": [6, 13], "computation": 6, "effici": [6, 10, 15], "thu": 6, "forward": [6, 10, 13, 15], "still": 6, "involv": 6, "retract": 6, "too": 6, "larg": [6, 10], "toler": [6, 10, 11, 15], "implicit": [6, 8, 11, 14], "sub": [6, 10, 15], "sequenti": [6, 10], "adjoint": 6, "distanc": [6, 15], "argument": [6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "origin": [6, 8, 10, 13, 15], "condit": [6, 10, 14, 15], "met": [6, 10, 15], "normfunct": 6, "norm": [6, 11], "dimension": [6, 14], "state_prev": [6, 11], "time_step": [6, 11], "constr": [6, 11, 14], "po": [6, 10, 11, 13, 14], "dh2_flow_pos_dmom": 6, "jacob_constr": [6, 11, 14], "dh2_flow_dmom": [6, 14], "action": 6, "dict": [6, 7, 8, 9, 10, 12, 13, 14, 15], "keyword": [6, 8, 10, 12, 13, 14], "fixed_point_solv": 6, "fixed_point_solver_kwarg": 6, "separ": [6, 14], "known": [6, 8, 15], "generalis": 6, "possibl": [6, 8, 13, 17], "fix": [6, 7, 10, 11, 14, 15], "partit": 6, "rung": 6, "kutta": 6, "guess": 6, "x0": [6, 11], "initialis": [6, 8, 11], "midpoint": 6, "euler": 6, "half": [6, 10, 14, 15], "explicit": [6, 8], "canon": [6, 10, 15], "ordinari": 6, "consequ": 6, "volum": [6, 10], "over": [6, 7, 9, 10, 15], "conserv": [6, 10, 15], "discretis": 6, "trajectori": [6, 7, 10, 15], "tractabl": [6, 14], "potenti": [6, 10, 13, 14, 15], "energi": [6, 7, 14], "kinet": 6, "classic": [6, 10], "st\u00f6rmer": 6, "verlet": 6, "split": [6, 10, 12, 14], "h1_flow": [6, 14], "free_coeffici": 6, "initial_h1_flow_step": 6, "a\u209bt": 6, "b\u209bt": 6, "a\u2081t": 6, "b\u2081t": 6, "a\u2080t": 6, "a\u2080": 6, "a\u209b": 6, "b\u2081": 6, "b\u209b": 6, "determin": [6, 8, 10, 14, 15], "consist": [6, 10], "least": 6, "restrict": [6, 8], "\u2098": 6, "a\u2098": 6, "symmetri": 6, "free": 6, "a\u2081": 6, "a\u2096": 6, "b\u2096": 6, "odd": 6, "even": [6, 13], "special": [6, 8, 14], "uniqu": [6, 8, 13], "interfac": [7, 9, 15], "extern": 7, "librari": [7, 10], "trace": [7, 10, 12], "energy_kei": 7, "lp_kei": 7, "lp": 7, "convert": 7, "sample_chain": [7, 10], "arviz": 7, "inferencedata": 7, "kei": [7, 8, 9, 10, 12, 13, 15], "draw": [7, 10, 12, 14, 15], "index": [7, 9, 10, 12], "propos": [7, 10, 15], "constant": [7, 14], "present": 7, "ad": [7, 13], "sample_stat": 7, "group": 7, "joint": [7, 10], "posterior": [7, 14], "densiti": [7, 8, 10, 14, 15], "data": [7, 10, 17], "store": [7, 8, 10, 12, 13, 15, 17], "1000": [7, 10, 15], "tune": [7, 10], "core": 7, "random_se": 7, "init": 7, "auto": 7, "jitter_max_retri": 7, "return_inferencedata": 7, "target_accept": 7, "max_treedepth": 7, "pymc3": 7, "multinomi": [7, 10, 15], "hmc": [7, 10, 15], "warm": [7, 10, 12], "phase": 7, "replic": 7, "drop": 7, "replac": 7, "adjust": [7, 12], "similar": 7, "drawn": 7, "discard": 7, "run": [7, 10, 12], "import": 7, "reveal": 7, "mode": [7, 13], "code": 7, "whichev": 7, "cpu": 7, "most": [7, 14], "seed": 7, "numpi": [7, 10, 15, 17], "entropi": 7, "displai": [7, 9, 10], "progress": [7, 9, 10, 15], "bar": [7, 9, 10], "liter": [7, 8], "adapt_diag": 7, "jitter": 7, "adapt_ful": 7, "One": [7, 8, 10, 13], "mass": 7, "same": [7, 8, 10, 12, 14, 15], "add": 7, "uniform": [7, 10, 15], "chosen": [7, 10, 15], "repeat": 7, "attempt": [7, 8, 13, 14], "creat": [7, 9, 10, 12, 13], "yield": 7, "finit": 7, "track": [7, 9, 10], "unobserved_rv": 7, "distribut": [7, 10, 14, 15], "context": 7, "manag": 7, "depth": [7, 10, 15], "expand": [7, 10, 15], "binari": [7, 8, 10, 15], "tree": [7, 10, 15], "contain": [7, 8, 10, 14, 15], "across": [7, 10, 15], "instead": [7, 8, 10, 11, 14, 15], "model_cod": 7, "num_sampl": 7, "num_warmup": 7, "num_chain": 7, "save_warmup": 7, "diag_": 7, "stepsiz": 7, "adapt_engag": 7, "delta": 7, "gamma": 7, "kappa": 7, "t0": 7, "init_buff": 7, "term_buff": 7, "50": [7, 11, 12], "window": [7, 12], "25": [7, 9, 12], "max_depth": 7, "pystan": 7, "itself": [7, 8, 13], "cmdstan": 7, "save": [7, 13], "unit_": 7, "dense_": 7, "indic": [7, 8, 13], "margin": [7, 14], "engag": 7, "relax": 7, "width": 7, "flatten": 7, "structur": [8, 14], "basic": 8, "block": [8, 9, 13], "compos": 8, "vertic": 8, "concaten": 8, "seri": [8, 14], "column": [8, 9, 14], "top": 8, "bottom": 8, "transpos": 8, "ndarrai": [8, 10, 17], "full": [8, 11], "2d": [8, 14], "access": [8, 13, 15], "avoid": [8, 10, 13, 15], "wherev": 8, "lot": 8, "abl": 8, "exploit": [8, 14], "1d": [8, 14], "shape": [8, 14], "num_row": 8, "num_column": 8, "kwarg": [8, 10, 11], "submatrix": 8, "instanc": [8, 10, 12, 13, 14], "horizont": 8, "row": [8, 14], "left": [8, 10, 14], "right": [8, 14], "factor": [8, 14], "is_posdef": 8, "_basetriangularfactoreddefinitematrix": 8, "triangular": [8, 14], "factoris": 8, "pre": [8, 15], "later": 8, "made": 8, "eigval": [8, 14], "eigenvalu": [8, 14], "eigvec": [8, 14], "eigenvector": [8, 14], "stack": 8, "sign": 8, "grad_log_abs_det": [8, 14], "absolut": [8, 14], "grad_quadratic_form_inv": [8, 14], "inv": [8, 14], "repres": [8, 9, 14], "necessarili": 8, "log_abs_det": [8, 14], "proport": [8, 9], "riemannian": [8, 14, 15], "measur": [8, 14], "lebesgu": [8, 14], "sqrt": 8, "root": [8, 14], "rect_matrix": 8, "pos_def_matrix": 8, "rectangular": 8, "dim_0": 8, "dim_1": 8, "under": [8, 10, 14, 15], "assumpt": 8, "its": [8, 10, 14, 15], "leftmost": 8, "righmost": 8, "dim_inn": 8, "lu_and_piv": 8, "lu_transpos": 8, "singular": 8, "pivot": 8, "lu": 8, "upper": [8, 10, 15], "unit": [8, 9], "scipi": 8, "linalg": 8, "lu_factor": 8, "lu_solv": 8, "orthonorm": 8, "parameter": 8, "convent": 8, "__init__": [8, 10], "subclass": [8, 14], "wrap": [8, 13], "exampl": [8, 9, 13], "param": 8, "ab": [8, 14], "det": 8, "In": [8, 10, 14, 15], "relev": [8, 13], "parametr": 8, "eigendecomposit": 8, "parameteris": 8, "diag": [8, 14], "orthogon": [8, 14], "strictli": [8, 14], "ones": 8, "elsewher": 8, "subset": 8, "inv_arrai": 8, "inv_lu_and_piv": 8, "inv_lu_transpos": 8, "inverse_arrai": 8, "make_triangular": 8, "below": [8, 12], "ignor": [8, 14], "explicitli": 8, "triangl": 8, "check_shap": 8, "invert": 8, "success": 8, "he": 8, "compat": 8, "like": 8, "overload": [8, 17], "well": [8, 10, 13, 15], "standard": [8, 10, 14, 15], "divis": 8, "quantiti": [8, 13], "adjac": 8, "specialis": 8, "factor_matrix": 8, "inner_pos_def_matrix": 8, "capacitance_matrix": 8, "low": 8, "dim_out": 8, "downdat": 8, "peform": [8, 10], "woodburi": 8, "lemma": 8, "o": [8, 10, 14], "plu": 8, "square_root": 8, "exist": 8, "cheaper": [8, 11], "directli": [8, 14], "pass": [8, 9, 10, 12, 13, 14], "alreadi": 8, "previou": [8, 10, 11, 15], "do": 8, "reli": 8, "reprsent": 8, "orth_arrai": 8, "paramteris": 8, "real": [8, 14], "symmetric_arrai": 8, "softabs_coeff": [8, 14], "transform": [8, 14], "eigh": [8, 14], "softab": [8, 14], "tend": [8, 14], "infin": [8, 11, 14], "becom": [8, 14], "grad_softab": 8, "left_factor_matrix": 8, "right_factor_matrix": 8, "square_matrix": 8, "inner_square_matrix": 8, "resp": 8, "rightmost": 8, "symmetric_matrix": 8, "inner_symmetric_matrix": 8, "factor_is_low": 8, "trinagular": 8, "boolean": 8, "choleski": [8, 14], "descript": [9, 10, 12, 13], "placehold": 9, "doe": [9, 11], "_and_": 9, "len": 9, "task": 9, "prefix": 9, "total": 9, "n_iter": [9, 12], "iter_count": 9, "iter_dict": 9, "refresh": [9, 15], "counter": [9, 13], "postfix": [9, 10], "file": [9, 10], "support": [9, 10, 14], "ansi": 9, "escap": 9, "line": [9, 11, 15], "textio": 9, "x1b": 9, "cursor": 9, "down": 9, "manipul": 9, "sy": 9, "stdout": 9, "cursor_down": 9, "move": [9, 10, 15], "cursor_up": 9, "obj": 9, "labelled_sequ": 9, "label": [9, 12], "visual": 9, "much": 9, "completed_label": 9, "count": [9, 13], "current_label": 9, "text": 9, "progress_bar": 9, "statu": 9, "reset": [9, 12], "comma": 9, "delimit": 9, "unstarted_label": 9, "unstart": 9, "expect": [9, 14, 15], "n_col": 9, "min_refresh_tim": 9, "html": 9, "richer": 9, "jupyt": 9, "notebook": 9, "interact": 9, "termin": [9, 10, 11, 15], "charact": 9, "min_referesh_tim": 9, "glyph": 9, "bar_color": 9, "css": 9, "color": 9, "elapsed_tim": 9, "elaps": 9, "format": 9, "empty_block": 9, "empti": [9, 10], "est_remaining_tim": 9, "filled_block": 9, "fill": 9, "iter_r": 9, "rate": 9, "n_block_empti": 9, "n_block_fil": 9, "partial_block": 9, "perc_complet": 9, "percentag": 9, "prop_complet": 9, "prop_partial_block": 9, "max_tree_depth": [10, 15], "max_delta_h": [10, 15], "termination_criterion": [10, 15], "do_extra_subtree_check": [10, 15], "momentum_transit": 10, "recurs": [10, 15], "randomli": [10, 15], "backward": [10, 15], "until": [10, 11, 15], "criteria": [10, 15], "leav": [10, 15], "next": [10, 15], "candid": [10, 15], "differ": [10, 15], "bias": [10, 15], "further": [10, 12, 14, 15], "criterion": [10, 15], "extra": 10, "subtre": [10, 15], "enabl": 10, "equival": [10, 15], "nut": 10, "minu": 10, "http": [10, 11, 12], "mc": [10, 12], "org": [10, 11, 12], "v2": 10, "23": 10, "conceptu": [10, 15], "introduct": [10, 15], "arxiv": [10, 15], "preprint": [10, 15], "1701": [10, 15], "02434": [10, 15], "signal": [10, 15], "terminationcriterion": [10, 15], "expans": [10, 15], "edg": [10, 15], "node": [10, 15], "overlap": [10, 15], "improv": [10, 15], "robust": [10, 15], "simpl": [10, 15], "harmon": [10, 15], "oscil": [10, 15], "normal": [10, 15], "certain": [10, 15], "reson": [10, 15], "behaviour": [10, 12, 14, 15], "seen": [10, 15], "detect": [10, 15], "past": [10, 15], "period": [10, 15], "continu": [10, 11, 15], "limit": [10, 15], "hit": [10, 15], "discours": [10, 15], "discuss": [10, 15], "kutt": [10, 15], "yaki": [10, 15], "help": [10, 15], "correl": [10, 15], "overhead": [10, 15], "kernel": [10, 15], "invari": [10, 15], "trigger": 10, "n_warm_up_it": [10, 12], "n_main_it": [10, 12], "init_st": 10, "process": 10, "mom": [10, 13, 14], "trace_func": [10, 12], "record": [10, 12, 13], "trace_warm_up": [10, 12], "appear": [10, 12], "last": [10, 12], "matter": [10, 12], "activ": [10, 12], "docstr": 10, "n_process": 10, "multiprocess": 10, "pool": 10, "assign": [10, 15], "cpu_count": 10, "max_threads_per_process": 10, "threadpoolctl": 10, "thread": 10, "bla": 10, "openmp": 10, "instal": 10, "environ": 10, "force_memmap": 10, "forc": 10, "disk": 10, "excess": 10, "long": 10, "written": 10, "npy": 10, "directori": 10, "memmap_path": 10, "temporari": 10, "alwai": [10, 14], "delet": 10, "onc": 10, "them": 10, "monitor_stat": 10, "monitor": [10, 13], "far": 10, "print": 10, "display_progress": 10, "progress_bar_class": 10, "factori": [10, 14], "show": 10, "final_st": 10, "interatino": 10, "slice": [10, 15], "disabl": 10, "namedtupl": [10, 12], "hamiltonianmcmc": 10, "resum": 10, "lead": [10, 13], "integration_transit": 10, "augment": 10, "henceforth": 10, "user": 10, "appropri": [10, 15], "There": 10, "variou": 10, "duan": [10, 15], "kennedi": [10, 15], "pendleton": [10, 15], "roweth": [10, 15], "1987": [10, 15], "physic": [10, 15], "letter": [10, 15], "195": [10, 15], "216": [10, 15], "222": [10, 15], "neal": [10, 14, 15], "2011": [10, 14, 15], "handbook": [10, 15], "11": [10, 14, 15], "jointli": [10, 15], "outer": 10, "tracefunct": [10, 12], "sueqenc": 10, "statistics_typ": 10, "n_step_rang": [10, 15], "metropoli": [10, 15], "direct": [10, 11, 15], "end": [10, 15], "negat": [10, 15], "involut": [10, 15], "determinist": [10, 15], "again": [10, 15], "irrespect": [10, 15], "decis": [10, 15], "reject": [10, 15], "randomis": [10, 15], "mix": [10, 15], "poorli": [10, 15], "mackenzi": [10, 15], "1989": [10, 15], "226": [10, 15], "369": [10, 15], "371": [10, 15], "bound": [10, 15], "inclus": [10, 15], "uniformli": [10, 15], "n_step": [10, 15], "static": [10, 15], "often": [10, 15], "now": [10, 15], "protocol": 11, "__call__": 11, "level": [11, 14, 15], "vct": 11, "euclidean": [11, 14, 15], "l": [11, 14], "convergence_tol": 11, "1e": 11, "09": 11, "divergence_tol": 11, "10000000000": 11, "max_it": 11, "find": 11, "successfulli": 11, "abort": 11, "assess": 11, "encount": 11, "valueerror": 11, "steffensen": 11, "steffennsen": 11, "achiev": 11, "en": 11, "wikipedia": 11, "wiki": 11, "27s_method": 11, "constraint_tol": 11, "position_tol": 11, "re": 11, "loop": 11, "decomposit": [11, 14], "residu": 11, "\u2082\u03c6\u2082": 11, "\u1d40": 11, "\u00b9": 11, "post": [11, 15], "delt_po": 11, "delta_po": 11, "max_line_search_it": 11, "backtrack": [11, 15], "\u03bb_": 11, "\u03b1": 11, "try": 11, "quasi": 11, "recomput": [11, 13], "previous": 11, "record_stat": 12, "n_init_slow_window_it": 12, "n_init_fast_stage_it": 12, "n_final_fast_stage_it": 12, "slow_window_multipli": 12, "hierarchi": 12, "quickli": 12, "addtion": 12, "identifi": [12, 13], "grow": 12, "memoryless": 12, "begin": [12, 13], "doubl": 12, "subsequ": [12, 13, 15], "smallest": 12, "cach": 13, "_call_count": 13, "_read_onli": 13, "_depend": 13, "_cach": 13, "recalcul": 13, "reus": 13, "memoiz": 13, "those": 13, "decor": 13, "everi": 13, "isn": 13, "constructor": 13, "underscor": 13, "pos_val": 13, "mom_val": 13, "dir": 13, "dir_val": 13, "reserv": 13, "copi": 13, "persist": 13, "intend": 13, "intern": 13, "read_onli": 13, "deep": 13, "depends_on": 13, "prevent": 13, "futur": 13, "correctli": 13, "clear": 13, "auxiliary_output": 13, "auxiliari": 13, "intermedi": [13, 15], "primari": 13, "anoth": [13, 14], "thei": 13, "pattern": 13, "alongsid": 13, "part": 13, "retriev": 13, "encapsul": 14, "neg_log_den": 14, "metric_chol_func": 14, "vjp_metric_chol_func": 14, "grad_neg_log_den": 14, "taken": 14, "document": 14, "about": 14, "unnorm": 14, "wish": 14, "vectorjacobianproductfunct": 14, "vjp": 14, "v": 14, "jacob": 14, "dim_po": 14, "gradientfunct": 14, "h1": 14, "dh2_dmom": 14, "h2": 14, "dh2_dpo": 14, "dh_dmom": 14, "dh_dpo": 14, "dt": 14, "metric_matrix_class": 14, "metric_func": 14, "sample_momentum": 14, "vjp_metric_func": 14, "rang": 14, "ndim": 14, "vectorjacobianproduct": 14, "dens_wrt_hausdorff": 14, "embed": 14, "ambient": 14, "mathcal": 14, "lbrace": 14, "mathbb": 14, "rbrace": 14, "equip": 14, "gaussian": [14, 15], "h_2": 14, "frac": 14, "impli": 14, "math": 14, "veloc": [14, 15], "exp": [14, 17], "ell": 14, "hausdorff": 14, "induc": 14, "h_1": 14, "event": 14, "gram": 14, "leli\u00e8vr": 14, "rousset": 14, "stoltz": 14, "2019": 14, "submanifold": 14, "numerisch": 14, "mathematik": 14, "143": 14, "379": 14, "421": 14, "graham": 14, "storkei": 14, "electron": 14, "5105": 14, "5164": 14, "former": 14, "latter": 14, "ratio": 14, "rrai": 14, "metriclik": 14, "distriubt": 14, "const": 14, "jacobianfunct": 14, "dmom_dmom": 14, "dpos_dmom": 14, "grad_log_det_sqrt_gram": 14, "log_det_sqrt_gram": 14, "inv_gram": 14, "jacob_constr_inner_product": 14, "jacob_constr_1": 14, "inner_product_matrix": 14, "jacob_constr_2": 14, "sparsiti": 14, "matrixlik": 14, "project_onto_cotangent_spac": 14, "definin": 14, "mhp_constr": 14, "matrixhessianproductfunct": 14, "dim_constr": 14, "hess": 14, "\u00b2c": 14, "almost": 14, "everywher": 14, "metric_diagonal_func": 14, "vjp_metric_diagonal_func": 14, "st": 14, "rather": [14, 15], "shahbaba": 14, "lan": 14, "johnson": 14, "w": 14, "24": 14, "339": 14, "349": 14, "metric_kwarg": 14, "simpler": 14, "constructng": 14, "sim": 14, "coupl": [14, 15], "girolami": 14, "calderhead": 14, "riemann": 14, "langevin": 14, "varlo": 14, "royal": 14, "societi": 14, "methodologi": 14, "73": 14, "123": 14, "214": 14, "fulli": 14, "togeth": 14, "__matmul__": 14, "__rmatmul__": 14, "metric_scalar_func": 14, "vjp_metric_scalar_func": 14, "metric_scalar_funct": 14, "grad": 14, "hess_neg_log_den": 14, "mtp_neg_log_den": 14, "riemmanian": 14, "tanh": 14, "elementwis": 14, "act": 14, "piecewis": 14, "2013": [14, 15], "327": 14, "334": 14, "hessianfunct": 14, "containt": 14, "matrixtressianproductfunct": 14, "tress": 14, "fourth": 14, "hesisan": 14, "howev": [14, 15], "mom_resample_coeff": 15, "pertub": 15, "crank": 15, "nicolson": 15, "It": 15, "momenta": 15, "sometim": 15, "succes": 15, "applic": 15, "evolv": 15, "walk": 15, "without": 15, "tractori": 15, "vari": 15, "horowitz": 15, "1991": 15, "guid": 15, "phy": 15, "lett": 15, "268": 15, "cern": 15, "th": 15, "6172": 15, "91": 15, "247": 15, "252": 15, "state_vari": 15, "statistic_typ": 15, "dtypelik": 15, "dtype": 15, "transtion": 15, "through": 15, "state_1": 15, "state_2": 15, "sum_mom": 15, "dot": 15, "evolut": 15, "intrins": 15, "curvatur": 15, "geodes": 15, "longer": 15, "straight": 15, "1304": 15, "1920": 15, "alias": 16, "val": 17, "log_val": 17, "hash": 17, "byte": 17, "val1": 17, "val2": 17}, "objects": {"": [[1, 0, 0, "-", "mici"]], "mici": [[2, 0, 0, "-", "adapters"], [3, 0, 0, "-", "autodiff"], [4, 0, 0, "-", "autograd_wrapper"], [5, 0, 0, "-", "errors"], [6, 0, 0, "-", "integrators"], [7, 0, 0, "-", "interop"], [8, 0, 0, "-", "matrices"], [9, 0, 0, "-", "progressbars"], [10, 0, 0, "-", "samplers"], [11, 0, 0, "-", "solvers"], [12, 0, 0, "-", "stagers"], [13, 0, 0, "-", "states"], [14, 0, 0, "-", "systems"], [15, 0, 0, "-", "transitions"], [16, 0, 0, "-", "types"], [17, 0, 0, "-", "utils"]], "mici.adapters": [[2, 1, 1, "", "Adapter"], [2, 1, 1, "", "DualAveragingStepSizeAdapter"], [2, 1, 1, "", "OnlineCovarianceMetricAdapter"], [2, 1, 1, "", "OnlineVarianceMetricAdapter"], [2, 5, 1, "", "arithmetic_mean_log_step_size_reducer"], [2, 5, 1, "", "default_adapt_stat_func"], [2, 5, 1, "", "geometric_mean_log_step_size_reducer"], [2, 5, 1, "", "min_log_step_size_reducer"]], "mici.adapters.Adapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 3, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.adapters.DualAveragingStepSizeAdapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 4, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.adapters.OnlineCovarianceMetricAdapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 4, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.adapters.OnlineVarianceMetricAdapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 4, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.autodiff": [[3, 5, 1, "", "autodiff_fallback"]], "mici.autograd_wrapper": [[4, 5, 1, "", "grad_and_value"], [4, 5, 1, "", "hessian_grad_and_value"], [4, 5, 1, "", "jacobian_and_value"], [4, 5, 1, "", "mhp_jacobian_and_value"], [4, 5, 1, "", "mtp_hessian_grad_and_value"]], "mici.errors": [[5, 6, 1, "", "AdaptationError"], [5, 6, 1, "", "ConvergenceError"], [5, 6, 1, "", "Error"], [5, 6, 1, "", "HamiltonianDivergenceError"], [5, 6, 1, "", "IntegratorError"], [5, 6, 1, "", "LinAlgError"], [5, 6, 1, "", "NonReversibleStepError"], [5, 6, 1, "", "ReadOnlyStateError"]], "mici.errors.AdaptationError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.ConvergenceError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.Error": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.HamiltonianDivergenceError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.IntegratorError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.LinAlgError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.NonReversibleStepError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.ReadOnlyStateError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.integrators": [[6, 1, 1, "", "BCSSFourStageIntegrator"], [6, 1, 1, "", "BCSSThreeStageIntegrator"], [6, 1, 1, "", "BCSSTwoStageIntegrator"], [6, 1, 1, "", "ConstrainedLeapfrogIntegrator"], [6, 1, 1, "", "ImplicitLeapfrogIntegrator"], [6, 1, 1, "", "ImplicitMidpointIntegrator"], [6, 1, 1, "", "Integrator"], [6, 1, 1, "", "LeapfrogIntegrator"], [6, 1, 1, "", "SymmetricCompositionIntegrator"], [6, 1, 1, "", "TractableFlowIntegrator"]], "mici.integrators.BCSSFourStageIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.BCSSThreeStageIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.BCSSTwoStageIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.ConstrainedLeapfrogIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.ImplicitLeapfrogIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.ImplicitMidpointIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.Integrator": [[6, 2, 1, "", "step"]], "mici.integrators.LeapfrogIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.SymmetricCompositionIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.TractableFlowIntegrator": [[6, 2, 1, "", "step"]], "mici.interop": [[7, 5, 1, "", "convert_to_inference_data"], [7, 5, 1, "", "sample_pymc3_model"], [7, 5, 1, "", "sample_stan_model"]], "mici.matrices": [[8, 1, 1, "", "BlockColumnMatrix"], [8, 1, 1, "", "BlockMatrix"], [8, 1, 1, "", "BlockRowMatrix"], [8, 1, 1, "", "DenseDefiniteMatrix"], [8, 1, 1, "", "DensePositiveDefiniteMatrix"], [8, 1, 1, "", "DensePositiveDefiniteProductMatrix"], [8, 1, 1, "", "DenseRectangularMatrix"], [8, 1, 1, "", "DenseSquareMatrix"], [8, 1, 1, "", "DenseSymmetricMatrix"], [8, 1, 1, "", "DiagonalMatrix"], [8, 1, 1, "", "DifferentiableMatrix"], [8, 1, 1, "", "EigendecomposedPositiveDefiniteMatrix"], [8, 1, 1, "", "EigendecomposedSymmetricMatrix"], [8, 1, 1, "", "ExplicitArrayMatrix"], [8, 1, 1, "", "IdentityMatrix"], [8, 1, 1, "", "ImplicitArrayMatrix"], [8, 1, 1, "", "InverseLUFactoredSquareMatrix"], [8, 1, 1, "", "InverseTriangularMatrix"], [8, 1, 1, "", "InvertibleMatrix"], [8, 1, 1, "", "InvertibleMatrixProduct"], [8, 1, 1, "", "Matrix"], [8, 1, 1, "", "MatrixProduct"], [8, 1, 1, "", "OrthogonalMatrix"], [8, 1, 1, "", "PositiveDefiniteBlockDiagonalMatrix"], [8, 1, 1, "", "PositiveDefiniteLowRankUpdateMatrix"], [8, 1, 1, "", "PositiveDefiniteMatrix"], [8, 1, 1, "", "PositiveDiagonalMatrix"], [8, 1, 1, "", "PositiveScaledIdentityMatrix"], [8, 1, 1, "", "ScaledIdentityMatrix"], [8, 1, 1, "", "ScaledOrthogonalMatrix"], [8, 1, 1, "", "SoftAbsRegularizedPositiveDefiniteMatrix"], [8, 1, 1, "", "SquareBlockDiagonalMatrix"], [8, 1, 1, "", "SquareLowRankUpdateMatrix"], [8, 1, 1, "", "SquareMatrix"], [8, 1, 1, "", "SquareMatrixProduct"], [8, 1, 1, "", "SymmetricBlockDiagonalMatrix"], [8, 1, 1, "", "SymmetricLowRankUpdateMatrix"], [8, 1, 1, "", "SymmetricMatrix"], [8, 1, 1, "", "TriangularFactoredDefiniteMatrix"], [8, 1, 1, "", "TriangularFactoredPositiveDefiniteMatrix"], [8, 1, 1, "", "TriangularMatrix"]], "mici.matrices.BlockColumnMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.BlockMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.BlockRowMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "transpose"]], "mici.matrices.DensePositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.DensePositiveDefiniteProductMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseRectangularMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseSquareMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "lu_and_piv"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseSymmetricMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DifferentiableMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.EigendecomposedPositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.EigendecomposedSymmetricMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.ExplicitArrayMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.IdentityMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.ImplicitArrayMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InverseLUFactoredSquareMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InverseTriangularMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "lower"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InvertibleMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InvertibleMatrixProduct": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "matrices"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.Matrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.MatrixProduct": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "matrices"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.OrthogonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDefiniteBlockDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDefiniteLowRankUpdateMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "capacitance_matrix"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveScaledIdentityMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "scalar"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.ScaledIdentityMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "scalar"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.ScaledOrthogonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 2, 1, "", "grad_softabs"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 2, 1, "", "softabs"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareBlockDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareLowRankUpdateMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "capacitance_matrix"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareMatrixProduct": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "matrices"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SymmetricBlockDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SymmetricLowRankUpdateMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "capacitance_matrix"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SymmetricMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.TriangularFactoredDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "transpose"]], "mici.matrices.TriangularFactoredPositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.TriangularMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "lower"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.progressbars": [[9, 1, 1, "", "DummyProgressBar"], [9, 1, 1, "", "FileDisplay"], [9, 1, 1, "", "LabelledSequenceProgressBar"], [9, 1, 1, "", "ProgressBar"], [9, 1, 1, "", "SequenceProgressBar"]], "mici.progressbars.DummyProgressBar": [[9, 3, 1, "", "n_iter"], [9, 3, 1, "", "sequence"], [9, 2, 1, "", "update"]], "mici.progressbars.FileDisplay": [[9, 4, 1, "", "CURSOR_DOWN"], [9, 4, 1, "", "CURSOR_UP"], [9, 2, 1, "", "update"]], "mici.progressbars.LabelledSequenceProgressBar": [[9, 3, 1, "", "completed_labels"], [9, 3, 1, "", "counter"], [9, 3, 1, "", "current_label"], [9, 3, 1, "", "description"], [9, 3, 1, "", "n_iter"], [9, 3, 1, "", "postfix"], [9, 3, 1, "", "prefix"], [9, 3, 1, "", "progress_bar"], [9, 2, 1, "", "refresh"], [9, 2, 1, "", "reset"], [9, 3, 1, "", "sequence"], [9, 3, 1, "", "stats"], [9, 3, 1, "", "unstarted_labels"], [9, 2, 1, "", "update"]], "mici.progressbars.ProgressBar": [[9, 3, 1, "", "n_iter"], [9, 3, 1, "", "sequence"], [9, 2, 1, "", "update"]], "mici.progressbars.SequenceProgressBar": [[9, 4, 1, "", "GLYPHS"], [9, 3, 1, "", "bar_color"], [9, 3, 1, "", "counter"], [9, 3, 1, "", "description"], [9, 3, 1, "", "elapsed_time"], [9, 3, 1, "", "empty_blocks"], [9, 3, 1, "", "est_remaining_time"], [9, 3, 1, "", "filled_blocks"], [9, 3, 1, "", "iter_rate"], [9, 3, 1, "", "n_block_empty"], [9, 3, 1, "", "n_block_filled"], [9, 3, 1, "", "n_iter"], [9, 3, 1, "", "partial_block"], [9, 3, 1, "", "perc_complete"], [9, 3, 1, "", "postfix"], [9, 3, 1, "", "prefix"], [9, 3, 1, "", "progress_bar"], [9, 3, 1, "", "prop_complete"], [9, 3, 1, "", "prop_partial_block"], [9, 2, 1, "", "refresh"], [9, 2, 1, "", "reset"], [9, 3, 1, "", "sequence"], [9, 3, 1, "", "stats"], [9, 2, 1, "", "update"]], "mici.samplers": [[10, 1, 1, "", "DynamicMultinomialHMC"], [10, 1, 1, "", "DynamicSliceHMC"], [10, 1, 1, "", "HMCSampleChainsOutputs"], [10, 1, 1, "", "HamiltonianMonteCarlo"], [10, 1, 1, "", "MCMCSampleChainsOutputs"], [10, 1, 1, "", "MarkovChainMonteCarloMethod"], [10, 1, 1, "", "RandomMetropolisHMC"], [10, 1, 1, "", "StaticMetropolisHMC"]], "mici.samplers.DynamicMultinomialHMC": [[10, 3, 1, "", "max_delta_h"], [10, 3, 1, "", "max_tree_depth"], [10, 2, 1, "", "sample_chains"]], "mici.samplers.DynamicSliceHMC": [[10, 3, 1, "", "max_delta_h"], [10, 3, 1, "", "max_tree_depth"], [10, 2, 1, "", "sample_chains"]], "mici.samplers.HamiltonianMonteCarlo": [[10, 2, 1, "", "sample_chains"]], "mici.samplers.MarkovChainMonteCarloMethod": [[10, 2, 1, "", "sample_chains"]], "mici.samplers.RandomMetropolisHMC": [[10, 3, 1, "", "n_step_range"], [10, 2, 1, "", "sample_chains"]], "mici.samplers.StaticMetropolisHMC": [[10, 3, 1, "", "n_step"], [10, 2, 1, "", "sample_chains"]], "mici.solvers": [[11, 1, 1, "", "FixedPointSolver"], [11, 1, 1, "", "ProjectionSolver"], [11, 5, 1, "", "euclidean_norm"], [11, 5, 1, "", "maximum_norm"], [11, 5, 1, "", "solve_fixed_point_direct"], [11, 5, 1, "", "solve_fixed_point_steffensen"], [11, 5, 1, "", "solve_projection_onto_manifold_newton"], [11, 5, 1, "", "solve_projection_onto_manifold_newton_with_line_search"], [11, 5, 1, "", "solve_projection_onto_manifold_quasi_newton"]], "mici.solvers.FixedPointSolver": [[11, 2, 1, "", "__call__"]], "mici.solvers.ProjectionSolver": [[11, 2, 1, "", "__call__"]], "mici.stagers": [[12, 1, 1, "", "ChainStage"], [12, 1, 1, "", "Stager"], [12, 1, 1, "", "WarmUpStager"], [12, 1, 1, "", "WindowedWarmUpStager"]], "mici.stagers.Stager": [[12, 2, 1, "", "stages"]], "mici.stagers.WarmUpStager": [[12, 2, 1, "", "stages"]], "mici.stagers.WindowedWarmUpStager": [[12, 2, 1, "", "stages"]], "mici.states": [[13, 1, 1, "", "ChainState"], [13, 5, 1, "", "cache_in_state"], [13, 5, 1, "", "cache_in_state_with_aux"]], "mici.states.ChainState": [[13, 2, 1, "", "copy"]], "mici.systems": [[14, 1, 1, "", "CholeskyFactoredRiemannianMetricSystem"], [14, 1, 1, "", "ConstrainedEuclideanMetricSystem"], [14, 1, 1, "", "DenseConstrainedEuclideanMetricSystem"], [14, 1, 1, "", "DenseRiemannianMetricSystem"], [14, 1, 1, "", "DiagonalRiemannianMetricSystem"], [14, 1, 1, "", "EuclideanMetricSystem"], [14, 1, 1, "", "GaussianDenseConstrainedEuclideanMetricSystem"], [14, 1, 1, "", "GaussianEuclideanMetricSystem"], [14, 1, 1, "", "RiemannianMetricSystem"], [14, 1, 1, "", "ScalarRiemannianMetricSystem"], [14, 1, 1, "", "SoftAbsRiemannianMetricSystem"], [14, 1, 1, "", "System"]], "mici.systems.CholeskyFactoredRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.ConstrainedEuclideanMetricSystem": [[14, 2, 1, "", "constr"], [14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_log_det_sqrt_gram"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "gram"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "inv_gram"], [14, 2, 1, "", "jacob_constr"], [14, 2, 1, "", "jacob_constr_inner_product"], [14, 2, 1, "", "log_det_sqrt_gram"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "project_onto_cotangent_space"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.DenseConstrainedEuclideanMetricSystem": [[14, 2, 1, "", "constr"], [14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_log_det_sqrt_gram"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "gram"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "inv_gram"], [14, 2, 1, "", "jacob_constr"], [14, 2, 1, "", "jacob_constr_inner_product"], [14, 2, 1, "", "log_det_sqrt_gram"], [14, 2, 1, "", "mhp_constr"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "project_onto_cotangent_space"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.DenseRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.DiagonalRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.EuclideanMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem": [[14, 2, 1, "", "constr"], [14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_log_det_sqrt_gram"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "gram"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "inv_gram"], [14, 2, 1, "", "jacob_constr"], [14, 2, 1, "", "jacob_constr_inner_product"], [14, 2, 1, "", "log_det_sqrt_gram"], [14, 2, 1, "", "mhp_constr"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "project_onto_cotangent_space"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.GaussianEuclideanMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.RiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.ScalarRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.SoftAbsRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "hess_neg_log_dens"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "mtp_neg_log_dens"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.System": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.transitions": [[15, 1, 1, "", "CorrelatedMomentumTransition"], [15, 1, 1, "", "DynamicIntegrationTransition"], [15, 1, 1, "", "IndependentMomentumTransition"], [15, 1, 1, "", "IntegrationTransition"], [15, 1, 1, "", "MetropolisIntegrationTransition"], [15, 1, 1, "", "MetropolisRandomIntegrationTransition"], [15, 1, 1, "", "MetropolisStaticIntegrationTransition"], [15, 1, 1, "", "MomentumTransition"], [15, 1, 1, "", "MultinomialDynamicIntegrationTransition"], [15, 1, 1, "", "SliceDynamicIntegrationTransition"], [15, 1, 1, "", "Transition"], [15, 5, 1, "", "euclidean_no_u_turn_criterion"], [15, 5, 1, "", "riemannian_no_u_turn_criterion"]], "mici.transitions.CorrelatedMomentumTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.DynamicIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.IndependentMomentumTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.IntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MetropolisIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MetropolisRandomIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MetropolisStaticIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MomentumTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MultinomialDynamicIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.SliceDynamicIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.Transition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.utils": [[17, 1, 1, "", "LogRepFloat"], [17, 5, 1, "", "hash_array"], [17, 5, 1, "", "log1m_exp"], [17, 5, 1, "", "log1p_exp"], [17, 5, 1, "", "log_diff_exp"], [17, 5, 1, "", "log_sum_exp"]], "mici.utils.LogRepFloat": [[17, 3, 1, "", "val"]]}, "objtypes": {"0": "py:module", "1": "py:class", "2": "py:method", "3": "py:property", "4": "py:attribute", "5": "py:function", "6": "py:exception"}, "objnames": {"0": ["py", "module", "Python module"], "1": ["py", "class", "Python class"], "2": ["py", "method", "Python method"], "3": ["py", "property", "Python property"], "4": ["py", "attribute", "Python attribute"], "5": ["py", "function", "Python function"], "6": ["py", "exception", "Python exception"]}, "titleterms": {"welcom": 0, "mici": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17], "": 0, "document": 0, "content": 0, "packag": 1, "submodul": 1, "adapt": 2, "modul": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17], "autodiff": 3, "autograd_wrapp": 4, "error": 5, "integr": 6, "interop": 7, "matric": 8, "progressbar": 9, "sampler": 10, "solver": 11, "stager": 12, "state": 13, "system": 14, "transit": 15, "type": 16, "util": 17}, "envversion": {"sphinx.domains.c": 2, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 8, "sphinx.domains.index": 1, "sphinx.domains.javascript": 2, "sphinx.domains.math": 2, "sphinx.domains.python": 3, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.viewcode": 1, "sphinx.ext.intersphinx": 1, "sphinx": 57}, "alltitles": {"Welcome to Mici\u2019s documentation!": [[0, "welcome-to-mici-s-documentation"]], "Contents:": [[0, null]], "mici package": [[1, "module-mici"]], "Submodules": [[1, "submodules"]], "mici.adapters module": [[2, "module-mici.adapters"]], "mici.autodiff module": [[3, "module-mici.autodiff"]], "mici.autograd_wrapper module": [[4, "module-mici.autograd_wrapper"]], "mici.errors module": [[5, "module-mici.errors"]], "mici.integrators module": [[6, "module-mici.integrators"]], "mici.interop module": [[7, "module-mici.interop"]], "mici.matrices module": [[8, "module-mici.matrices"]], "mici.progressbars module": [[9, "module-mici.progressbars"]], "mici.samplers module": [[10, "module-mici.samplers"]], "mici.solvers module": [[11, "module-mici.solvers"]], "mici.stagers module": [[12, "module-mici.stagers"]], "mici.states module": [[13, "module-mici.states"]], "mici.systems module": [[14, "module-mici.systems"]], "mici.transitions module": [[15, "module-mici.transitions"]], "mici.types module": [[16, "module-mici.types"]], "mici.utils module": [[17, "module-mici.utils"]]}, "indexentries": {"mici": [[1, "module-mici"]], "module": [[1, "module-mici"], [2, "module-mici.adapters"], [3, "module-mici.autodiff"], [4, "module-mici.autograd_wrapper"], [5, "module-mici.errors"], [6, "module-mici.integrators"], [7, "module-mici.interop"], [8, "module-mici.matrices"], [9, "module-mici.progressbars"], [10, "module-mici.samplers"], [11, "module-mici.solvers"], [12, "module-mici.stagers"], [13, "module-mici.states"], [14, "module-mici.systems"], [15, "module-mici.transitions"], [16, "module-mici.types"], [17, "module-mici.utils"]], "adapter (class in mici.adapters)": [[2, "mici.adapters.Adapter"]], "dualaveragingstepsizeadapter (class in mici.adapters)": [[2, "mici.adapters.DualAveragingStepSizeAdapter"]], "onlinecovariancemetricadapter (class in mici.adapters)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter"]], "onlinevariancemetricadapter (class in mici.adapters)": [[2, "mici.adapters.OnlineVarianceMetricAdapter"]], "arithmetic_mean_log_step_size_reducer() (in module mici.adapters)": [[2, "mici.adapters.arithmetic_mean_log_step_size_reducer"]], "default_adapt_stat_func() (in module mici.adapters)": [[2, "mici.adapters.default_adapt_stat_func"]], "finalize() (mici.adapters.adapter method)": [[2, "mici.adapters.Adapter.finalize"]], "finalize() (mici.adapters.dualaveragingstepsizeadapter method)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.finalize"]], "finalize() (mici.adapters.onlinecovariancemetricadapter method)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.finalize"]], "finalize() (mici.adapters.onlinevariancemetricadapter method)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.finalize"]], "geometric_mean_log_step_size_reducer() (in module mici.adapters)": [[2, "mici.adapters.geometric_mean_log_step_size_reducer"]], "initialize() (mici.adapters.adapter method)": [[2, "mici.adapters.Adapter.initialize"]], "initialize() (mici.adapters.dualaveragingstepsizeadapter method)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.initialize"]], "initialize() (mici.adapters.onlinecovariancemetricadapter method)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.initialize"]], "initialize() (mici.adapters.onlinevariancemetricadapter method)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.initialize"]], "is_fast (mici.adapters.adapter property)": [[2, "mici.adapters.Adapter.is_fast"]], "is_fast (mici.adapters.dualaveragingstepsizeadapter attribute)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.is_fast"]], "is_fast (mici.adapters.onlinecovariancemetricadapter attribute)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.is_fast"]], "is_fast (mici.adapters.onlinevariancemetricadapter attribute)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.is_fast"]], "mici.adapters": [[2, "module-mici.adapters"]], "min_log_step_size_reducer() (in module mici.adapters)": [[2, "mici.adapters.min_log_step_size_reducer"]], "update() (mici.adapters.adapter method)": [[2, "mici.adapters.Adapter.update"]], "update() (mici.adapters.dualaveragingstepsizeadapter method)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.update"]], "update() (mici.adapters.onlinecovariancemetricadapter method)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.update"]], "update() (mici.adapters.onlinevariancemetricadapter method)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.update"]], "autodiff_fallback() (in module mici.autodiff)": [[3, "mici.autodiff.autodiff_fallback"]], "mici.autodiff": [[3, "module-mici.autodiff"]], "grad_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.grad_and_value"]], "hessian_grad_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.hessian_grad_and_value"]], "jacobian_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.jacobian_and_value"]], "mhp_jacobian_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.mhp_jacobian_and_value"]], "mici.autograd_wrapper": [[4, "module-mici.autograd_wrapper"]], "mtp_hessian_grad_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.mtp_hessian_grad_and_value"]], "adaptationerror": [[5, "mici.errors.AdaptationError"]], "convergenceerror": [[5, "mici.errors.ConvergenceError"]], "error": [[5, "mici.errors.Error"]], "hamiltoniandivergenceerror": [[5, "mici.errors.HamiltonianDivergenceError"]], "integratorerror": [[5, "mici.errors.IntegratorError"]], "linalgerror": [[5, "mici.errors.LinAlgError"]], "nonreversiblesteperror": [[5, "mici.errors.NonReversibleStepError"]], "readonlystateerror": [[5, "mici.errors.ReadOnlyStateError"]], "args (mici.errors.adaptationerror attribute)": [[5, "mici.errors.AdaptationError.args"]], "args (mici.errors.convergenceerror attribute)": [[5, "mici.errors.ConvergenceError.args"]], "args (mici.errors.error attribute)": [[5, "mici.errors.Error.args"]], "args (mici.errors.hamiltoniandivergenceerror attribute)": [[5, "mici.errors.HamiltonianDivergenceError.args"]], "args (mici.errors.integratorerror attribute)": [[5, "mici.errors.IntegratorError.args"]], "args (mici.errors.linalgerror attribute)": [[5, "mici.errors.LinAlgError.args"]], "args (mici.errors.nonreversiblesteperror attribute)": [[5, "mici.errors.NonReversibleStepError.args"]], "args (mici.errors.readonlystateerror attribute)": [[5, "mici.errors.ReadOnlyStateError.args"]], "mici.errors": [[5, "module-mici.errors"]], "with_traceback() (mici.errors.adaptationerror method)": [[5, "mici.errors.AdaptationError.with_traceback"]], "with_traceback() (mici.errors.convergenceerror method)": [[5, "mici.errors.ConvergenceError.with_traceback"]], "with_traceback() (mici.errors.error method)": [[5, "mici.errors.Error.with_traceback"]], "with_traceback() (mici.errors.hamiltoniandivergenceerror method)": [[5, "mici.errors.HamiltonianDivergenceError.with_traceback"]], "with_traceback() (mici.errors.integratorerror method)": [[5, "mici.errors.IntegratorError.with_traceback"]], "with_traceback() (mici.errors.linalgerror method)": [[5, "mici.errors.LinAlgError.with_traceback"]], "with_traceback() (mici.errors.nonreversiblesteperror method)": [[5, "mici.errors.NonReversibleStepError.with_traceback"]], "with_traceback() (mici.errors.readonlystateerror method)": [[5, "mici.errors.ReadOnlyStateError.with_traceback"]], "bcssfourstageintegrator (class in mici.integrators)": [[6, "mici.integrators.BCSSFourStageIntegrator"]], "bcssthreestageintegrator (class in mici.integrators)": [[6, "mici.integrators.BCSSThreeStageIntegrator"]], "bcsstwostageintegrator (class in mici.integrators)": [[6, "mici.integrators.BCSSTwoStageIntegrator"]], "constrainedleapfrogintegrator (class in mici.integrators)": [[6, "mici.integrators.ConstrainedLeapfrogIntegrator"]], "implicitleapfrogintegrator (class in mici.integrators)": [[6, "mici.integrators.ImplicitLeapfrogIntegrator"]], "implicitmidpointintegrator (class in mici.integrators)": [[6, "mici.integrators.ImplicitMidpointIntegrator"]], "integrator (class in mici.integrators)": [[6, "mici.integrators.Integrator"]], "leapfrogintegrator (class in mici.integrators)": [[6, "mici.integrators.LeapfrogIntegrator"]], "symmetriccompositionintegrator (class in mici.integrators)": [[6, "mici.integrators.SymmetricCompositionIntegrator"]], "tractableflowintegrator (class in mici.integrators)": [[6, "mici.integrators.TractableFlowIntegrator"]], "mici.integrators": [[6, "module-mici.integrators"]], "step() (mici.integrators.bcssfourstageintegrator method)": [[6, "mici.integrators.BCSSFourStageIntegrator.step"]], "step() (mici.integrators.bcssthreestageintegrator method)": [[6, "mici.integrators.BCSSThreeStageIntegrator.step"]], "step() (mici.integrators.bcsstwostageintegrator method)": [[6, "mici.integrators.BCSSTwoStageIntegrator.step"]], "step() (mici.integrators.constrainedleapfrogintegrator method)": [[6, "mici.integrators.ConstrainedLeapfrogIntegrator.step"]], "step() (mici.integrators.implicitleapfrogintegrator method)": [[6, "mici.integrators.ImplicitLeapfrogIntegrator.step"]], "step() (mici.integrators.implicitmidpointintegrator method)": [[6, "mici.integrators.ImplicitMidpointIntegrator.step"]], "step() (mici.integrators.integrator method)": [[6, "mici.integrators.Integrator.step"]], "step() (mici.integrators.leapfrogintegrator method)": [[6, "mici.integrators.LeapfrogIntegrator.step"]], "step() (mici.integrators.symmetriccompositionintegrator method)": [[6, "mici.integrators.SymmetricCompositionIntegrator.step"]], "step() (mici.integrators.tractableflowintegrator method)": [[6, "mici.integrators.TractableFlowIntegrator.step"]], "convert_to_inference_data() (in module mici.interop)": [[7, "mici.interop.convert_to_inference_data"]], "mici.interop": [[7, "module-mici.interop"]], "sample_pymc3_model() (in module mici.interop)": [[7, "mici.interop.sample_pymc3_model"]], "sample_stan_model() (in module mici.interop)": [[7, "mici.interop.sample_stan_model"]], "blockcolumnmatrix (class in mici.matrices)": [[8, "mici.matrices.BlockColumnMatrix"]], "blockmatrix (class in mici.matrices)": [[8, "mici.matrices.BlockMatrix"]], "blockrowmatrix (class in mici.matrices)": [[8, "mici.matrices.BlockRowMatrix"]], "densedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.DenseDefiniteMatrix"]], "densepositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.DensePositiveDefiniteMatrix"]], "densepositivedefiniteproductmatrix (class in mici.matrices)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix"]], "denserectangularmatrix (class in mici.matrices)": [[8, "mici.matrices.DenseRectangularMatrix"]], "densesquarematrix (class in mici.matrices)": [[8, "mici.matrices.DenseSquareMatrix"]], "densesymmetricmatrix (class in mici.matrices)": [[8, "mici.matrices.DenseSymmetricMatrix"]], "diagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.DiagonalMatrix"]], "differentiablematrix (class in mici.matrices)": [[8, "mici.matrices.DifferentiableMatrix"]], "eigendecomposedpositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix"]], "eigendecomposedsymmetricmatrix (class in mici.matrices)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix"]], "explicitarraymatrix (class in mici.matrices)": [[8, "mici.matrices.ExplicitArrayMatrix"]], "identitymatrix (class in mici.matrices)": [[8, "mici.matrices.IdentityMatrix"]], "implicitarraymatrix (class in mici.matrices)": [[8, "mici.matrices.ImplicitArrayMatrix"]], "inverselufactoredsquarematrix (class in mici.matrices)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix"]], "inversetriangularmatrix (class in mici.matrices)": [[8, "mici.matrices.InverseTriangularMatrix"]], "invertiblematrix (class in mici.matrices)": [[8, "mici.matrices.InvertibleMatrix"]], "invertiblematrixproduct (class in mici.matrices)": [[8, "mici.matrices.InvertibleMatrixProduct"]], "matrix (class in mici.matrices)": [[8, "mici.matrices.Matrix"]], "matrixproduct (class in mici.matrices)": [[8, "mici.matrices.MatrixProduct"]], "orthogonalmatrix (class in mici.matrices)": [[8, "mici.matrices.OrthogonalMatrix"]], "positivedefiniteblockdiagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix"]], "positivedefinitelowrankupdatematrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix"]], "positivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDefiniteMatrix"]], "positivediagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDiagonalMatrix"]], "positivescaledidentitymatrix (class in mici.matrices)": [[8, "mici.matrices.PositiveScaledIdentityMatrix"]], "scaledidentitymatrix (class in mici.matrices)": [[8, "mici.matrices.ScaledIdentityMatrix"]], "scaledorthogonalmatrix (class in mici.matrices)": [[8, "mici.matrices.ScaledOrthogonalMatrix"]], "softabsregularizedpositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix"]], "squareblockdiagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.SquareBlockDiagonalMatrix"]], "squarelowrankupdatematrix (class in mici.matrices)": [[8, "mici.matrices.SquareLowRankUpdateMatrix"]], "squarematrix (class in mici.matrices)": [[8, "mici.matrices.SquareMatrix"]], "squarematrixproduct (class in mici.matrices)": [[8, "mici.matrices.SquareMatrixProduct"]], "symmetricblockdiagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix"]], "symmetriclowrankupdatematrix (class in mici.matrices)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix"]], "symmetricmatrix (class in mici.matrices)": [[8, "mici.matrices.SymmetricMatrix"]], "t (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.T"]], "t (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.T"]], "t (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.T"]], "t (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.T"]], "t (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.T"]], "t (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.T"]], "t (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.T"]], "t (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.T"]], "t (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.T"]], "t (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.T"]], "t (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.T"]], "t (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.T"]], "t (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.T"]], "t (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.T"]], "t (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.T"]], "t (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.T"]], "t (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.T"]], "t (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.T"]], "t (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.T"]], "t (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.T"]], "t (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.T"]], "t (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.T"]], "t (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.T"]], "t (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.T"]], "t (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.T"]], "t (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.T"]], "t (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.T"]], "t (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.T"]], "t (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.T"]], "t (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.T"]], "t (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.T"]], "t (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.T"]], "t (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.T"]], "t (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.T"]], "t (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.T"]], "t (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.T"]], "t (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.T"]], "t (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.T"]], "t (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.T"]], "t (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.T"]], "t (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.T"]], "triangularfactoreddefinitematrix (class in mici.matrices)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix"]], "triangularfactoredpositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix"]], "triangularmatrix (class in mici.matrices)": [[8, "mici.matrices.TriangularMatrix"]], "array (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.array"]], "array (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.array"]], "array (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.array"]], "array (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.array"]], "array (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.array"]], "array (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.array"]], "array (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.array"]], "array (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.array"]], "array (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.array"]], "array (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.array"]], "array (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.array"]], "array (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.array"]], "array (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.array"]], "array (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.array"]], "array (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.array"]], "array (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.array"]], "array (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.array"]], "array (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.array"]], "array (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.array"]], "array (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.array"]], "array (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.array"]], "array (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.array"]], "array (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.array"]], "array (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.array"]], "array (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.array"]], "array (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.array"]], "array (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.array"]], "array (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.array"]], "array (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.array"]], "array (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.array"]], "array (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.array"]], "array (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.array"]], "array (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.array"]], "array (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.array"]], "array (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.array"]], "array (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.array"]], "array (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.array"]], "array (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.array"]], "array (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.array"]], "array (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.array"]], "array (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.array"]], "blocks (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.blocks"]], "blocks (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.blocks"]], "blocks (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.blocks"]], "blocks (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.blocks"]], "blocks (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.blocks"]], "blocks (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.blocks"]], "capacitance_matrix (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.capacitance_matrix"]], "capacitance_matrix (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.capacitance_matrix"]], "capacitance_matrix (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.capacitance_matrix"]], "diagonal (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.diagonal"]], "diagonal (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.diagonal"]], "diagonal (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.diagonal"]], "diagonal (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.diagonal"]], "diagonal (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.diagonal"]], "diagonal (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.diagonal"]], "diagonal (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.diagonal"]], "diagonal (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.diagonal"]], "diagonal (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.diagonal"]], "diagonal (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.diagonal"]], "diagonal (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.diagonal"]], "diagonal (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.diagonal"]], "diagonal (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.diagonal"]], "diagonal (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.diagonal"]], "diagonal (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.diagonal"]], "diagonal (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.diagonal"]], "diagonal (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.diagonal"]], "diagonal (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.diagonal"]], "diagonal (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.diagonal"]], "diagonal (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.diagonal"]], "diagonal (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.diagonal"]], "diagonal (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.diagonal"]], "diagonal (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.diagonal"]], "diagonal (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.diagonal"]], "diagonal (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.diagonal"]], "diagonal (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.diagonal"]], "diagonal (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.diagonal"]], "diagonal (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.diagonal"]], "diagonal (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.diagonal"]], "diagonal (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.diagonal"]], "eigval (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.eigval"]], "eigval (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.eigval"]], "eigval (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.eigval"]], "eigval (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.eigval"]], "eigval (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.eigval"]], "eigval (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.eigval"]], "eigval (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.eigval"]], "eigval (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.eigval"]], "eigval (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.eigval"]], "eigval (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.eigval"]], "eigval (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.eigval"]], "eigval (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.eigval"]], "eigval (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.eigval"]], "eigval (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.eigval"]], "eigval (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.eigval"]], "eigval (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.eigval"]], "eigval (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.eigval"]], "eigvec (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.eigvec"]], "eigvec (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.eigvec"]], "eigvec (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.eigvec"]], "eigvec (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.eigvec"]], "eigvec (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.eigvec"]], "eigvec (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.eigvec"]], "eigvec (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.eigvec"]], "eigvec (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.eigvec"]], "eigvec (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.eigvec"]], "eigvec (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.eigvec"]], "eigvec (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.eigvec"]], "factor (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.factor"]], "factor (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.factor"]], "factor (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.factor"]], "factor (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.factor"]], "factor (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.factor"]], "grad_log_abs_det (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.grad_log_abs_det"]], "grad_quadratic_form_inv() (mici.matrices.densedefinitematrix method)": [[8, "mici.matrices.DenseDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.densepositivedefinitematrix method)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.densepositivedefiniteproductmatrix method)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.diagonalmatrix method)": [[8, "mici.matrices.DiagonalMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.differentiablematrix method)": [[8, "mici.matrices.DifferentiableMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivedefiniteblockdiagonalmatrix method)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivedefinitelowrankupdatematrix method)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivediagonalmatrix method)": [[8, "mici.matrices.PositiveDiagonalMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivescaledidentitymatrix method)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.scaledidentitymatrix method)": [[8, "mici.matrices.ScaledIdentityMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.softabsregularizedpositivedefinitematrix method)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.triangularfactoreddefinitematrix method)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.triangularfactoredpositivedefinitematrix method)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.grad_quadratic_form_inv"]], "grad_softabs() (mici.matrices.softabsregularizedpositivedefinitematrix method)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.grad_softabs"]], "inv (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.inv"]], "inv (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.inv"]], "inv (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.inv"]], "inv (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.inv"]], "inv (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.inv"]], "inv (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.inv"]], "inv (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.inv"]], "inv (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.inv"]], "inv (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.inv"]], "inv (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.inv"]], "inv (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.inv"]], "inv (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.inv"]], "inv (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.inv"]], "inv (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.inv"]], "inv (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.inv"]], "inv (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.inv"]], "inv (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.inv"]], "inv (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.inv"]], "inv (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.inv"]], "inv (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.inv"]], "inv (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.inv"]], "inv (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.inv"]], "inv (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.inv"]], "inv (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.inv"]], "inv (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.inv"]], "inv (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.inv"]], "inv (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.inv"]], "inv (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.inv"]], "inv (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.inv"]], "inv (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.inv"]], "log_abs_det (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.log_abs_det"]], "log_abs_det (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.log_abs_det"]], "log_abs_det (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.log_abs_det"]], "log_abs_det (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.log_abs_det"]], "log_abs_det (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.log_abs_det"]], "log_abs_det (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.log_abs_det"]], "log_abs_det (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.log_abs_det"]], "log_abs_det (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.log_abs_det"]], "log_abs_det (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.log_abs_det"]], "log_abs_det (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.log_abs_det"]], "log_abs_det (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.log_abs_det"]], "log_abs_det (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.log_abs_det"]], "log_abs_det (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.log_abs_det"]], "log_abs_det (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.log_abs_det"]], "lower (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.lower"]], "lower (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.lower"]], "lu_and_piv (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.lu_and_piv"]], "matrices (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.matrices"]], "matrices (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.matrices"]], "matrices (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.matrices"]], "mici.matrices": [[8, "module-mici.matrices"]], "scalar (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.scalar"]], "scalar (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.scalar"]], "shape (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.shape"]], "shape (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.shape"]], "shape (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.shape"]], "shape (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.shape"]], "shape (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.shape"]], "shape (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.shape"]], "shape (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.shape"]], "shape (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.shape"]], "shape (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.shape"]], "shape (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.shape"]], "shape (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.shape"]], "shape (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.shape"]], "shape (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.shape"]], "shape (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.shape"]], "shape (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.shape"]], "shape (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.shape"]], "shape (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.shape"]], "shape (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.shape"]], "shape (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.shape"]], "shape (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.shape"]], "shape (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.shape"]], "shape (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.shape"]], "shape (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.shape"]], "shape (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.shape"]], "shape (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.shape"]], "shape (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.shape"]], "shape (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.shape"]], "shape (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.shape"]], "shape (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.shape"]], "shape (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.shape"]], "shape (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.shape"]], "shape (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.shape"]], "shape (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.shape"]], "shape (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.shape"]], "shape (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.shape"]], "shape (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.shape"]], "shape (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.shape"]], "shape (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.shape"]], "shape (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.shape"]], "shape (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.shape"]], "shape (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.shape"]], "sign (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.sign"]], "sign (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.sign"]], "sign (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.sign"]], "sign (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.sign"]], "sign (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.sign"]], "softabs() (mici.matrices.softabsregularizedpositivedefinitematrix method)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.softabs"]], "sqrt (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.sqrt"]], "sqrt (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.sqrt"]], "sqrt (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.sqrt"]], "sqrt (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.sqrt"]], "sqrt (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.sqrt"]], "sqrt (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.sqrt"]], "sqrt (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.sqrt"]], "transpose (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.transpose"]], "transpose (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.transpose"]], "transpose (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.transpose"]], "transpose (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.transpose"]], "transpose (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.transpose"]], "transpose (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.transpose"]], "transpose (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.transpose"]], "transpose (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.transpose"]], "transpose (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.transpose"]], "transpose (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.transpose"]], "transpose (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.transpose"]], "transpose (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.transpose"]], "transpose (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.transpose"]], "transpose (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.transpose"]], "transpose (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.transpose"]], "transpose (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.transpose"]], "transpose (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.transpose"]], "transpose (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.transpose"]], "transpose (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.transpose"]], "transpose (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.transpose"]], "transpose (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.transpose"]], "transpose (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.transpose"]], "transpose (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.transpose"]], "transpose (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.transpose"]], "transpose (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.transpose"]], "transpose (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.transpose"]], "transpose (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.transpose"]], "transpose (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.transpose"]], "transpose (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.transpose"]], "transpose (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.transpose"]], "transpose (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.transpose"]], "transpose (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.transpose"]], "transpose (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.transpose"]], "transpose (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.transpose"]], "transpose (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.transpose"]], "transpose (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.transpose"]], "cursor_down (mici.progressbars.filedisplay attribute)": [[9, "mici.progressbars.FileDisplay.CURSOR_DOWN"]], "cursor_up (mici.progressbars.filedisplay attribute)": [[9, "mici.progressbars.FileDisplay.CURSOR_UP"]], "dummyprogressbar (class in mici.progressbars)": [[9, "mici.progressbars.DummyProgressBar"]], "filedisplay (class in mici.progressbars)": [[9, "mici.progressbars.FileDisplay"]], "glyphs (mici.progressbars.sequenceprogressbar attribute)": [[9, "mici.progressbars.SequenceProgressBar.GLYPHS"]], "labelledsequenceprogressbar (class in mici.progressbars)": [[9, "mici.progressbars.LabelledSequenceProgressBar"]], "progressbar (class in mici.progressbars)": [[9, "mici.progressbars.ProgressBar"]], "sequenceprogressbar (class in mici.progressbars)": [[9, "mici.progressbars.SequenceProgressBar"]], "bar_color (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.bar_color"]], "completed_labels (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.completed_labels"]], "counter (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.counter"]], "counter (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.counter"]], "current_label (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.current_label"]], "description (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.description"]], "description (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.description"]], "elapsed_time (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.elapsed_time"]], "empty_blocks (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.empty_blocks"]], "est_remaining_time (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.est_remaining_time"]], "filled_blocks (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.filled_blocks"]], "iter_rate (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.iter_rate"]], "mici.progressbars": [[9, "module-mici.progressbars"]], "n_block_empty (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.n_block_empty"]], "n_block_filled (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.n_block_filled"]], "n_iter (mici.progressbars.dummyprogressbar property)": [[9, "mici.progressbars.DummyProgressBar.n_iter"]], "n_iter (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.n_iter"]], "n_iter (mici.progressbars.progressbar property)": [[9, "mici.progressbars.ProgressBar.n_iter"]], "n_iter (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.n_iter"]], "partial_block (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.partial_block"]], "perc_complete (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.perc_complete"]], "postfix (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.postfix"]], "postfix (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.postfix"]], "prefix (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.prefix"]], "prefix (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.prefix"]], "progress_bar (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.progress_bar"]], "progress_bar (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.progress_bar"]], "prop_complete (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.prop_complete"]], "prop_partial_block (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.prop_partial_block"]], "refresh() (mici.progressbars.labelledsequenceprogressbar method)": [[9, "mici.progressbars.LabelledSequenceProgressBar.refresh"]], "refresh() (mici.progressbars.sequenceprogressbar method)": [[9, "mici.progressbars.SequenceProgressBar.refresh"]], "reset() (mici.progressbars.labelledsequenceprogressbar method)": [[9, "mici.progressbars.LabelledSequenceProgressBar.reset"]], "reset() (mici.progressbars.sequenceprogressbar method)": [[9, "mici.progressbars.SequenceProgressBar.reset"]], "sequence (mici.progressbars.dummyprogressbar property)": [[9, "mici.progressbars.DummyProgressBar.sequence"]], "sequence (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.sequence"]], "sequence (mici.progressbars.progressbar property)": [[9, "mici.progressbars.ProgressBar.sequence"]], "sequence (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.sequence"]], "stats (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.stats"]], "stats (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.stats"]], "unstarted_labels (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.unstarted_labels"]], "update() (mici.progressbars.dummyprogressbar method)": [[9, "mici.progressbars.DummyProgressBar.update"]], "update() (mici.progressbars.filedisplay method)": [[9, "mici.progressbars.FileDisplay.update"]], "update() (mici.progressbars.labelledsequenceprogressbar method)": [[9, "mici.progressbars.LabelledSequenceProgressBar.update"]], "update() (mici.progressbars.progressbar method)": [[9, "mici.progressbars.ProgressBar.update"]], "update() (mici.progressbars.sequenceprogressbar method)": [[9, "mici.progressbars.SequenceProgressBar.update"]], "dynamicmultinomialhmc (class in mici.samplers)": [[10, "mici.samplers.DynamicMultinomialHMC"]], "dynamicslicehmc (class in mici.samplers)": [[10, "mici.samplers.DynamicSliceHMC"]], "hmcsamplechainsoutputs (class in mici.samplers)": [[10, "mici.samplers.HMCSampleChainsOutputs"]], "hamiltonianmontecarlo (class in mici.samplers)": [[10, "mici.samplers.HamiltonianMonteCarlo"]], "mcmcsamplechainsoutputs (class in mici.samplers)": [[10, "mici.samplers.MCMCSampleChainsOutputs"]], "markovchainmontecarlomethod (class in mici.samplers)": [[10, "mici.samplers.MarkovChainMonteCarloMethod"]], "randommetropolishmc (class in mici.samplers)": [[10, "mici.samplers.RandomMetropolisHMC"]], "staticmetropolishmc (class in mici.samplers)": [[10, "mici.samplers.StaticMetropolisHMC"]], "max_delta_h (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.max_delta_h"]], "max_delta_h (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.max_delta_h"]], "max_tree_depth (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.max_tree_depth"]], "max_tree_depth (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.max_tree_depth"]], "mici.samplers": [[10, "module-mici.samplers"]], "n_step (mici.samplers.staticmetropolishmc property)": [[10, "mici.samplers.StaticMetropolisHMC.n_step"]], "n_step_range (mici.samplers.randommetropolishmc property)": [[10, "mici.samplers.RandomMetropolisHMC.n_step_range"]], "sample_chains() (mici.samplers.dynamicmultinomialhmc method)": [[10, "mici.samplers.DynamicMultinomialHMC.sample_chains"]], "sample_chains() (mici.samplers.dynamicslicehmc method)": [[10, "mici.samplers.DynamicSliceHMC.sample_chains"]], "sample_chains() (mici.samplers.hamiltonianmontecarlo method)": [[10, "mici.samplers.HamiltonianMonteCarlo.sample_chains"]], "sample_chains() (mici.samplers.markovchainmontecarlomethod method)": [[10, "mici.samplers.MarkovChainMonteCarloMethod.sample_chains"]], "sample_chains() (mici.samplers.randommetropolishmc method)": [[10, "mici.samplers.RandomMetropolisHMC.sample_chains"]], "sample_chains() (mici.samplers.staticmetropolishmc method)": [[10, "mici.samplers.StaticMetropolisHMC.sample_chains"]], "fixedpointsolver (class in mici.solvers)": [[11, "mici.solvers.FixedPointSolver"]], "projectionsolver (class in mici.solvers)": [[11, "mici.solvers.ProjectionSolver"]], "__call__() (mici.solvers.fixedpointsolver method)": [[11, "mici.solvers.FixedPointSolver.__call__"]], "__call__() (mici.solvers.projectionsolver method)": [[11, "mici.solvers.ProjectionSolver.__call__"]], "euclidean_norm() (in module mici.solvers)": [[11, "mici.solvers.euclidean_norm"]], "maximum_norm() (in module mici.solvers)": [[11, "mici.solvers.maximum_norm"]], "mici.solvers": [[11, "module-mici.solvers"]], "solve_fixed_point_direct() (in module mici.solvers)": [[11, "mici.solvers.solve_fixed_point_direct"]], "solve_fixed_point_steffensen() (in module mici.solvers)": [[11, "mici.solvers.solve_fixed_point_steffensen"]], "solve_projection_onto_manifold_newton() (in module mici.solvers)": [[11, "mici.solvers.solve_projection_onto_manifold_newton"]], "solve_projection_onto_manifold_newton_with_line_search() (in module mici.solvers)": [[11, "mici.solvers.solve_projection_onto_manifold_newton_with_line_search"]], "solve_projection_onto_manifold_quasi_newton() (in module mici.solvers)": [[11, "mici.solvers.solve_projection_onto_manifold_quasi_newton"]], "chainstage (class in mici.stagers)": [[12, "mici.stagers.ChainStage"]], "stager (class in mici.stagers)": [[12, "mici.stagers.Stager"]], "warmupstager (class in mici.stagers)": [[12, "mici.stagers.WarmUpStager"]], "windowedwarmupstager (class in mici.stagers)": [[12, "mici.stagers.WindowedWarmUpStager"]], "mici.stagers": [[12, "module-mici.stagers"]], "stages() (mici.stagers.stager method)": [[12, "mici.stagers.Stager.stages"]], "stages() (mici.stagers.warmupstager method)": [[12, "mici.stagers.WarmUpStager.stages"]], "stages() (mici.stagers.windowedwarmupstager method)": [[12, "mici.stagers.WindowedWarmUpStager.stages"]], "chainstate (class in mici.states)": [[13, "mici.states.ChainState"]], "cache_in_state() (in module mici.states)": [[13, "mici.states.cache_in_state"]], "cache_in_state_with_aux() (in module mici.states)": [[13, "mici.states.cache_in_state_with_aux"]], "copy() (mici.states.chainstate method)": [[13, "mici.states.ChainState.copy"]], "mici.states": [[13, "module-mici.states"]], "choleskyfactoredriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem"]], "constrainedeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem"]], "denseconstrainedeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem"]], "denseriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.DenseRiemannianMetricSystem"]], "diagonalriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.DiagonalRiemannianMetricSystem"]], "euclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.EuclideanMetricSystem"]], "gaussiandenseconstrainedeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem"]], "gaussianeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.GaussianEuclideanMetricSystem"]], "riemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.RiemannianMetricSystem"]], "scalarriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.ScalarRiemannianMetricSystem"]], "softabsriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem"]], "system (class in mici.systems)": [[14, "mici.systems.System"]], "constr() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.constr"]], "constr() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.constr"]], "constr() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.constr"]], "dh1_dpos() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.system method)": [[14, "mici.systems.System.dh1_dpos"]], "dh2_dmom() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.system method)": [[14, "mici.systems.System.dh2_dmom"]], "dh2_dpos() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.system method)": [[14, "mici.systems.System.dh2_dpos"]], "dh2_flow_dmom() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh2_flow_dmom"]], "dh_dmom() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.system method)": [[14, "mici.systems.System.dh_dmom"]], "dh_dpos() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.system method)": [[14, "mici.systems.System.dh_dpos"]], "grad_log_det_sqrt_gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.grad_log_det_sqrt_gram"]], "grad_log_det_sqrt_gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.grad_log_det_sqrt_gram"]], "grad_log_det_sqrt_gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.grad_log_det_sqrt_gram"]], "grad_neg_log_dens() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.system method)": [[14, "mici.systems.System.grad_neg_log_dens"]], "gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.gram"]], "gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.gram"]], "gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.gram"]], "h() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h"]], "h() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h"]], "h() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h"]], "h() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h"]], "h() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h"]], "h() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h"]], "h() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h"]], "h() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h"]], "h() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h"]], "h() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h"]], "h() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h"]], "h() (mici.systems.system method)": [[14, "mici.systems.System.h"]], "h1() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h1"]], "h1() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h1"]], "h1() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h1"]], "h1() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h1"]], "h1() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h1"]], "h1() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h1"]], "h1() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h1"]], "h1() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h1"]], "h1() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h1"]], "h1() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h1"]], "h1() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h1"]], "h1() (mici.systems.system method)": [[14, "mici.systems.System.h1"]], "h1_flow() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.system method)": [[14, "mici.systems.System.h1_flow"]], "h2() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h2"]], "h2() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h2"]], "h2() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h2"]], "h2() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h2"]], "h2() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h2"]], "h2() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h2"]], "h2() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h2"]], "h2() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h2"]], "h2() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h2"]], "h2() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h2"]], "h2() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h2"]], "h2() (mici.systems.system method)": [[14, "mici.systems.System.h2"]], "h2_flow() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h2_flow"]], "hess_neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.hess_neg_log_dens"]], "inv_gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.inv_gram"]], "inv_gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.inv_gram"]], "inv_gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.inv_gram"]], "jacob_constr() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.jacob_constr"]], "jacob_constr() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.jacob_constr"]], "jacob_constr() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.jacob_constr"]], "jacob_constr_inner_product() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.jacob_constr_inner_product"]], "jacob_constr_inner_product() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.jacob_constr_inner_product"]], "jacob_constr_inner_product() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.jacob_constr_inner_product"]], "log_det_sqrt_gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.log_det_sqrt_gram"]], "log_det_sqrt_gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.log_det_sqrt_gram"]], "log_det_sqrt_gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.log_det_sqrt_gram"]], "metric() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.metric"]], "metric() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.metric"]], "metric() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.metric"]], "metric() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.metric"]], "metric() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.metric"]], "metric() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.metric"]], "metric_func() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.metric_func"]], "mhp_constr() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.mhp_constr"]], "mhp_constr() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.mhp_constr"]], "mici.systems": [[14, "module-mici.systems"]], "mtp_neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.mtp_neg_log_dens"]], "neg_log_dens() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.system method)": [[14, "mici.systems.System.neg_log_dens"]], "project_onto_cotangent_space() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.project_onto_cotangent_space"]], "project_onto_cotangent_space() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.project_onto_cotangent_space"]], "project_onto_cotangent_space() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.project_onto_cotangent_space"]], "sample_momentum() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.system method)": [[14, "mici.systems.System.sample_momentum"]], "vjp_metric_func() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.vjp_metric_func"]], "correlatedmomentumtransition (class in mici.transitions)": [[15, "mici.transitions.CorrelatedMomentumTransition"]], "dynamicintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.DynamicIntegrationTransition"]], "independentmomentumtransition (class in mici.transitions)": [[15, "mici.transitions.IndependentMomentumTransition"]], "integrationtransition (class in mici.transitions)": [[15, "mici.transitions.IntegrationTransition"]], "metropolisintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MetropolisIntegrationTransition"]], "metropolisrandomintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition"]], "metropolisstaticintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition"]], "momentumtransition (class in mici.transitions)": [[15, "mici.transitions.MomentumTransition"]], "multinomialdynamicintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition"]], "slicedynamicintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.SliceDynamicIntegrationTransition"]], "transition (class in mici.transitions)": [[15, "mici.transitions.Transition"]], "euclidean_no_u_turn_criterion() (in module mici.transitions)": [[15, "mici.transitions.euclidean_no_u_turn_criterion"]], "mici.transitions": [[15, "module-mici.transitions"]], "riemannian_no_u_turn_criterion() (in module mici.transitions)": [[15, "mici.transitions.riemannian_no_u_turn_criterion"]], "sample() (mici.transitions.correlatedmomentumtransition method)": [[15, "mici.transitions.CorrelatedMomentumTransition.sample"]], "sample() (mici.transitions.dynamicintegrationtransition method)": [[15, "mici.transitions.DynamicIntegrationTransition.sample"]], "sample() (mici.transitions.independentmomentumtransition method)": [[15, "mici.transitions.IndependentMomentumTransition.sample"]], "sample() (mici.transitions.integrationtransition method)": [[15, "mici.transitions.IntegrationTransition.sample"]], "sample() (mici.transitions.metropolisintegrationtransition method)": [[15, "mici.transitions.MetropolisIntegrationTransition.sample"]], "sample() (mici.transitions.metropolisrandomintegrationtransition method)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition.sample"]], "sample() (mici.transitions.metropolisstaticintegrationtransition method)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition.sample"]], "sample() (mici.transitions.momentumtransition method)": [[15, "mici.transitions.MomentumTransition.sample"]], "sample() (mici.transitions.multinomialdynamicintegrationtransition method)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition.sample"]], "sample() (mici.transitions.slicedynamicintegrationtransition method)": [[15, "mici.transitions.SliceDynamicIntegrationTransition.sample"]], "sample() (mici.transitions.transition method)": [[15, "mici.transitions.Transition.sample"]], "state_variables (mici.transitions.correlatedmomentumtransition property)": [[15, "mici.transitions.CorrelatedMomentumTransition.state_variables"]], "state_variables (mici.transitions.dynamicintegrationtransition property)": [[15, "mici.transitions.DynamicIntegrationTransition.state_variables"]], "state_variables (mici.transitions.independentmomentumtransition property)": [[15, "mici.transitions.IndependentMomentumTransition.state_variables"]], "state_variables (mici.transitions.integrationtransition property)": [[15, "mici.transitions.IntegrationTransition.state_variables"]], "state_variables (mici.transitions.metropolisintegrationtransition property)": [[15, "mici.transitions.MetropolisIntegrationTransition.state_variables"]], "state_variables (mici.transitions.metropolisrandomintegrationtransition property)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition.state_variables"]], "state_variables (mici.transitions.metropolisstaticintegrationtransition property)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition.state_variables"]], "state_variables (mici.transitions.momentumtransition property)": [[15, "mici.transitions.MomentumTransition.state_variables"]], "state_variables (mici.transitions.multinomialdynamicintegrationtransition property)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition.state_variables"]], "state_variables (mici.transitions.slicedynamicintegrationtransition property)": [[15, "mici.transitions.SliceDynamicIntegrationTransition.state_variables"]], "state_variables (mici.transitions.transition property)": [[15, "mici.transitions.Transition.state_variables"]], "statistic_types (mici.transitions.correlatedmomentumtransition property)": [[15, "mici.transitions.CorrelatedMomentumTransition.statistic_types"]], "statistic_types (mici.transitions.dynamicintegrationtransition property)": [[15, "mici.transitions.DynamicIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.independentmomentumtransition property)": [[15, "mici.transitions.IndependentMomentumTransition.statistic_types"]], "statistic_types (mici.transitions.integrationtransition property)": [[15, "mici.transitions.IntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.metropolisintegrationtransition property)": [[15, "mici.transitions.MetropolisIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.metropolisrandomintegrationtransition property)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.metropolisstaticintegrationtransition property)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.momentumtransition property)": [[15, "mici.transitions.MomentumTransition.statistic_types"]], "statistic_types (mici.transitions.multinomialdynamicintegrationtransition property)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.slicedynamicintegrationtransition property)": [[15, "mici.transitions.SliceDynamicIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.transition property)": [[15, "mici.transitions.Transition.statistic_types"]], "mici.types": [[16, "module-mici.types"]], "logrepfloat (class in mici.utils)": [[17, "mici.utils.LogRepFloat"]], "hash_array() (in module mici.utils)": [[17, "mici.utils.hash_array"]], "log1m_exp() (in module mici.utils)": [[17, "mici.utils.log1m_exp"]], "log1p_exp() (in module mici.utils)": [[17, "mici.utils.log1p_exp"]], "log_diff_exp() (in module mici.utils)": [[17, "mici.utils.log_diff_exp"]], "log_sum_exp() (in module mici.utils)": [[17, "mici.utils.log_sum_exp"]], "mici.utils": [[17, "module-mici.utils"]], "val (mici.utils.logrepfloat property)": [[17, "mici.utils.LogRepFloat.val"]]}}) \ No newline at end of file +Search.setIndex({"docnames": ["index", "mici", "mici.adapters", "mici.autodiff", "mici.autograd_wrapper", "mici.errors", "mici.integrators", "mici.interop", "mici.matrices", "mici.progressbars", "mici.samplers", "mici.solvers", "mici.stagers", "mici.states", "mici.systems", "mici.transitions", "mici.types", "mici.utils"], "filenames": ["index.rst", "mici.rst", "mici.adapters.rst", "mici.autodiff.rst", "mici.autograd_wrapper.rst", "mici.errors.rst", "mici.integrators.rst", "mici.interop.rst", "mici.matrices.rst", "mici.progressbars.rst", "mici.samplers.rst", "mici.solvers.rst", "mici.stagers.rst", "mici.states.rst", "mici.systems.rst", "mici.transitions.rst", "mici.types.rst", "mici.utils.rst"], "titles": ["Welcome to Mici\u2019s documentation!", "mici package", "mici.adapters module", "mici.autodiff module", "mici.autograd_wrapper module", "mici.errors module", "mici.integrators module", "mici.interop module", "mici.matrices module", "mici.progressbars module", "mici.samplers module", "mici.solvers module", "mici.stagers module", "mici.states module", "mici.systems module", "mici.transitions module", "mici.types module", "mici.utils module"], "terms": {"i": [0, 2, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "python": [0, 7, 10], "packag": 0, "provid": [0, 3, 6, 7, 13, 14], "implement": [0, 2, 3, 6, 8, 9, 10, 17], "markov": [0, 2, 7, 10, 12, 13, 15], "chain": [0, 2, 5, 7, 9, 10, 11, 12, 13, 15], "mont": [0, 2, 6, 10, 14, 15], "carlo": [0, 2, 6, 10, 14, 15], "mcmc": [0, 1, 10, 15], "method": [0, 2, 6, 7, 8, 9, 10, 11, 13, 14, 15], "approxim": [0, 6, 7, 8, 10, 11, 12, 14, 15], "infer": [0, 7, 10, 14], "probabilist": [0, 2, 7], "model": [0, 7, 10, 14, 15], "particular": 0, "focu": 0, "base": [0, 1, 2, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "simul": [0, 1, 6, 10, 11, 14, 15], "hamiltonian": [0, 1, 2, 5, 6, 7, 10, 11, 14, 15], "dynam": [0, 1, 5, 6, 7, 10, 11, 14, 15], "manifold": [0, 1, 6, 11, 14, 15], "submodul": 0, "adapt": [0, 1, 5, 6, 7, 10, 12, 15], "modul": [0, 1], "autodiff": [0, 1], "autograd_wrapp": [0, 1], "error": [0, 1, 2, 3, 6, 11, 13], "integr": [0, 1, 2, 5, 7, 10, 11, 14, 15], "interop": [0, 1], "matric": [0, 1, 14], "progressbar": [0, 1, 7, 10], "sampler": [0, 1, 2, 7, 12, 15], "solver": [0, 1, 5, 6], "stager": [0, 1, 10], "state": [0, 1, 2, 5, 6, 9, 10, 11, 12, 14, 15], "system": [0, 1, 6, 7, 8, 10, 11, 13, 15], "transit": [0, 1, 2, 5, 7, 10, 12], "type": [0, 1, 2, 3, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15, 17], "util": [0, 1, 7], "dualaveragingstepsizeadapt": [1, 2, 10], "onlinecovariancemetricadapt": [1, 2], "onlinevariancemetricadapt": [1, 2], "arithmetic_mean_log_step_size_reduc": [1, 2], "default_adapt_stat_func": [1, 2], "geometric_mean_log_step_size_reduc": [1, 2], "min_log_step_size_reduc": [1, 2], "autodiff_fallback": [1, 3], "grad_and_valu": [1, 4], "hessian_grad_and_valu": [1, 4], "jacobian_and_valu": [1, 4], "mhp_jacobian_and_valu": [1, 4], "mtp_hessian_grad_and_valu": [1, 4], "adaptationerror": [1, 2, 5], "convergenceerror": [1, 5, 6, 11], "hamiltoniandivergenceerror": [1, 5], "integratorerror": [1, 5], "linalgerror": [1, 5, 8, 14], "nonreversiblesteperror": [1, 5, 6], "readonlystateerror": [1, 5, 13], "bcssfourstageintegr": [1, 6], "bcssthreestageintegr": [1, 6], "bcsstwostageintegr": [1, 6], "constrainedleapfrogintegr": [1, 6, 14], "implicitleapfrogintegr": [1, 6, 14], "implicitmidpointintegr": [1, 6], "leapfrogintegr": [1, 6], "symmetriccompositionintegr": [1, 6], "tractableflowintegr": [1, 6], "convert_to_inference_data": [1, 7], "sample_pymc3_model": [1, 7], "sample_stan_model": [1, 7], "blockcolumnmatrix": [1, 8], "blockmatrix": [1, 8], "blockrowmatrix": [1, 8], "densedefinitematrix": [1, 8], "densepositivedefinitematrix": [1, 8], "densepositivedefiniteproductmatrix": [1, 8], "denserectangularmatrix": [1, 8], "densesquarematrix": [1, 8], "densesymmetricmatrix": [1, 8], "diagonalmatrix": [1, 8, 14], "differentiablematrix": [1, 8, 14], "eigendecomposedpositivedefinitematrix": [1, 8], "eigendecomposedsymmetricmatrix": [1, 8], "explicitarraymatrix": [1, 8], "identitymatrix": [1, 8], "implicitarraymatrix": [1, 8], "inverselufactoredsquarematrix": [1, 8], "inversetriangularmatrix": [1, 8], "invertiblematrix": [1, 8], "invertiblematrixproduct": [1, 8], "matrix": [1, 2, 4, 5, 7, 8, 10, 11, 14, 15], "matrixproduct": [1, 8], "orthogonalmatrix": [1, 8], "positivedefiniteblockdiagonalmatrix": [1, 8], "positivedefinitelowrankupdatematrix": [1, 8], "positivedefinitematrix": [1, 8, 14], "positivediagonalmatrix": [1, 8], "positivescaledidentitymatrix": [1, 8], "scaledidentitymatrix": [1, 8], "scaledorthogonalmatrix": [1, 8], "softabsregularizedpositivedefinitematrix": [1, 8], "squareblockdiagonalmatrix": [1, 8], "squarelowrankupdatematrix": [1, 8], "squarematrix": [1, 8], "squarematrixproduct": [1, 8], "symmetricblockdiagonalmatrix": [1, 8], "symmetriclowrankupdatematrix": [1, 8], "symmetricmatrix": [1, 8], "triangularfactoreddefinitematrix": [1, 8], "triangularfactoredpositivedefinitematrix": [1, 8], "triangularmatrix": [1, 8], "dummyprogressbar": [1, 9], "filedisplai": [1, 9], "labelledsequenceprogressbar": [1, 9], "sequenceprogressbar": [1, 9, 10], "dynamicmultinomialhmc": [1, 10], "dynamicslicehmc": [1, 10], "hmcsamplechainsoutput": [1, 10], "hamiltonianmontecarlo": [1, 10], "mcmcsamplechainsoutput": [1, 10], "markovchainmontecarlomethod": [1, 7, 10, 12], "randommetropolishmc": [1, 10], "staticmetropolishmc": [1, 10], "fixedpointsolv": [1, 6, 11], "projectionsolv": [1, 6, 11], "euclidean_norm": [1, 11], "maximum_norm": [1, 6, 11], "solve_fixed_point_direct": [1, 6, 11], "solve_fixed_point_steffensen": [1, 11], "solve_projection_onto_manifold_newton": [1, 11], "solve_projection_onto_manifold_newton_with_line_search": [1, 11], "solve_projection_onto_manifold_quasi_newton": [1, 6, 11], "chainstag": [1, 12], "warmupstag": [1, 10, 12], "windowedwarmupstag": [1, 10, 12], "chainstat": [1, 2, 6, 10, 11, 13, 14, 15], "cache_in_st": [1, 13], "cache_in_state_with_aux": [1, 13], "choleskyfactoredriemannianmetricsystem": [1, 14], "constrainedeuclideanmetricsystem": [1, 14], "denseconstrainedeuclideanmetricsystem": [1, 14], "denseriemannianmetricsystem": [1, 14], "diagonalriemannianmetricsystem": [1, 14], "euclideanmetricsystem": [1, 14], "gaussiandenseconstrainedeuclideanmetricsystem": [1, 14], "gaussianeuclideanmetricsystem": [1, 14], "riemannianmetricsystem": [1, 14], "scalarriemannianmetricsystem": [1, 14], "softabsriemannianmetricsystem": [1, 14], "tractableflowsystem": [1, 6, 14], "correlatedmomentumtransit": [1, 15], "dynamicintegrationtransit": [1, 15], "independentmomentumtransit": [1, 10, 15], "integrationtransit": [1, 10, 15], "metropolisintegrationtransit": [1, 15], "metropolisrandomintegrationtransit": [1, 15], "metropolisstaticintegrationtransit": [1, 15], "momentumtransit": [1, 10, 15], "multinomialdynamicintegrationtransit": [1, 15], "slicedynamicintegrationtransit": [1, 15], "euclidean_no_u_turn_criterion": [1, 10, 15], "riemannian_no_u_turn_criterion": [1, 10, 15], "logrepfloat": [1, 17], "hash_arrai": [1, 17], "log1m_exp": [1, 17], "log1p_exp": [1, 17], "log_diff_exp": [1, 17], "log_sum_exp": [1, 17], "set": [2, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15], "algorithm": [2, 7, 10, 15], "paramet": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "class": [2, 5, 6, 8, 9, 10, 11, 12, 13, 14, 15, 17], "sourc": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "abc": [2, 6, 8, 9, 12, 14, 15], "abstract": [2, 8, 9, 12, 14, 15], "scheme": [2, 7, 10, 15], "ar": [2, 6, 7, 8, 10, 11, 12, 13, 14, 15], "assum": [2, 4, 6, 8, 14, 15], "updat": [2, 6, 8, 9, 10, 11, 12, 13, 15], "collect": [2, 9], "variabl": [2, 6, 7, 10, 12, 13, 14, 15], "term": [2, 6, 8, 10, 14, 15], "here": [2, 4, 8, 10, 14], "after": [2, 6, 10, 11, 12, 13], "each": [2, 6, 7, 8, 9, 10, 11, 12, 13, 15], "sampl": [2, 7, 10, 12, 13, 14, 15], "statist": [2, 7, 9, 10, 12, 14, 15], "an": [2, 3, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "accept": [2, 6, 7, 10, 14, 15], "probabl": [2, 7, 10, 14, 15], "complet": [2, 9, 10], "one": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "more": [2, 6, 8, 10, 12, 13, 14, 15, 17], "final": [2, 6, 7, 10, 12], "mai": [2, 6, 7, 8, 10, 11, 12, 13, 14], "us": [2, 3, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17], "perform": [2, 6, 8, 10, 11, 12, 15], "adapt_st": 2, "chain_stat": 2, "rng": [2, 10, 14, 15], "option": [2, 3, 6, 7, 8, 9, 10, 12, 13, 14, 15, 17], "multipl": [2, 7, 8, 10, 12], "avail": [2, 8, 10, 13], "e": [2, 4, 6, 8, 10, 11, 13, 14, 15], "g": [2, 6, 10, 13, 14, 15], "from": [2, 3, 6, 7, 10, 14, 15], "independ": [2, 7, 10, 13, 14, 15], "inform": [2, 12, 14], "all": [2, 6, 7, 8, 10, 12, 13, 14, 15], "combin": [2, 6], "": [2, 6, 8, 9, 10, 11, 12, 13, 14, 15], "union": [2, 7, 8, 10], "adapterst": 2, "iter": [2, 5, 6, 7, 8, 9, 10, 11, 12, 13], "list": [2, 7, 8, 9, 10], "per": [2, 7, 9, 10, 11, 12], "arrai": [2, 4, 6, 7, 8, 10, 12, 14, 15, 17], "buffer": 2, "associ": [2, 7, 8, 10, 13, 14], "entri": [2, 7, 8, 9, 10, 12, 13, 15], "recycl": 2, "reduc": [2, 6, 10, 15], "memori": [2, 8, 10], "usag": [2, 10], "so": [2, 8, 10, 11, 12, 13, 14, 15], "correspond": [2, 3, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "remov": 2, "dictionari": [2, 6, 7, 9, 10, 12, 13, 14, 15], "current": [2, 9, 10, 11, 12, 14, 15], "stage": [2, 6, 9, 10, 12], "place": [2, 14], "alter": [2, 12], "requir": [2, 3, 6, 8, 11, 12, 14], "ani": [2, 6, 7, 8, 9, 10, 11, 13, 14, 15], "compon": [2, 6, 10, 11, 14, 15], "being": [2, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "dapt": 2, "attribut": [2, 5, 10, 12, 13], "child": 2, "object": [2, 6, 7, 8, 9, 10, 11, 13, 14, 15, 17], "gener": [2, 3, 6, 7, 8, 10, 14, 15], "random": [2, 7, 10, 15], "number": [2, 6, 7, 8, 9, 10, 11, 12, 13, 15], "resampl": [2, 10, 15], "need": [2, 6, 13, 14], "due": [2, 6, 10, 14, 15], "initi": [2, 6, 7, 10, 11, 12, 13, 14, 15], "prior": [2, 7, 14], "start": [2, 7, 13, 14], "calcul": [2, 11, 13, 14], "should": [2, 6, 8, 10, 13, 14, 15], "mutat": 2, "return": [2, 3, 4, 5, 6, 7, 8, 10, 11, 12, 13, 14, 15, 17], "properti": [2, 6, 8, 9, 10, 14, 15, 17], "is_fast": [2, 10, 12], "bool": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "whether": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "fast": [2, 7, 10, 12], "slow": [2, 7, 12], "which": [2, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "onli": [2, 5, 6, 8, 10, 11, 12, 13, 14, 15], "local": [2, 12], "classifi": 2, "while": [2, 6, 7, 13, 15], "global": [2, 12], "fals": [2, 6, 7, 8, 10, 12, 13, 14], "trans_stat": [2, 15], "follow": [2, 6, 7, 10, 12], "transitionstatist": 2, "adapt_stat_target": 2, "0": [2, 4, 6, 7, 9, 10, 11, 12, 14, 15], "8": [2, 6, 7], "adapt_stat_func": 2, "none": [2, 3, 4, 6, 7, 8, 9, 10, 13, 14, 15, 17], "log_step_size_reg_target": 2, "log_step_size_reg_coeffici": 2, "05": [2, 7], "iter_decay_coeff": 2, "75": [2, 7, 12], "iter_offset": 2, "10": [2, 7, 9, 10, 11, 12, 15], "max_init_step_size_it": 2, "100": [2, 11], "log_step_size_reduc": 2, "dual": [2, 10], "averag": [2, 10], "step": [2, 5, 6, 7, 10, 11, 14, 15], "size": [2, 6, 7, 8, 10, 11, 12, 15], "describ": [2, 6, 7, 9, 15], "1": [2, 4, 6, 7, 8, 9, 10, 11, 14, 15, 17], "modifi": [2, 14], "version": [2, 10], "stochast": 2, "optimis": 2, "2": [2, 4, 6, 7, 8, 10, 11, 12, 14, 15], "By": [2, 8, 12, 13, 14], "default": [2, 6, 7, 9, 10, 12, 13, 14, 15], "control": [2, 6, 7, 10, 12, 14], "accept_prob": 2, "close": [2, 6, 8, 10, 14, 15], "target": [2, 7, 10, 14, 15], "valu": [2, 3, 4, 6, 7, 8, 9, 10, 12, 13, 14, 15, 17], "can": [2, 4, 6, 7, 8, 10, 12, 13, 14], "chang": [2, 10, 11, 12, 13, 15], "refer": [2, 6, 10, 12, 14, 15], "hoffman": [2, 10, 15], "m": [2, 4, 6, 10, 14, 15], "d": [2, 10, 14, 15], "gelman": [2, 10, 15], "A": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "2014": [2, 6, 10, 14, 15], "The": [2, 6, 7, 8, 10, 11, 12, 13, 14, 15], "No": [2, 6, 10, 15], "u": [2, 10, 15], "turn": [2, 10, 15], "path": [2, 10, 15], "length": [2, 9, 10, 15], "journal": [2, 6, 10, 14, 15], "machin": [2, 10, 15], "learn": [2, 10, 15], "research": [2, 10, 15], "15": [2, 10, 12, 15], "pp": [2, 10, 14, 15], "1593": [2, 10, 15], "1623": [2, 10, 15], "nesterov": 2, "y": 2, "2009": 2, "primal": [2, 13], "subgradi": 2, "convex": 2, "problem": [2, 6], "mathemat": 2, "program": [2, 7], "120": 2, "221": 2, "259": 2, "float": [2, 6, 7, 8, 9, 10, 11, 12, 14, 15, 17], "dure": [2, 6, 7, 10, 11, 12, 15], "adaptationstatisticfunct": 2, "function": [2, 3, 4, 6, 7, 8, 10, 11, 12, 13, 14, 15, 17], "given": [2, 6, 10, 14, 15], "output": [2, 4, 6, 7, 8, 9, 10, 12, 13, 14], "thi": [2, 6, 7, 8, 10, 12, 13, 14, 15], "simpli": [2, 14], "select": [2, 10], "accept_stat": [2, 10], "regular": [2, 7, 8, 14], "logarithm": [2, 8, 14, 17], "toward": [2, 10, 15], "If": [2, 6, 7, 8, 10, 11, 12, 13, 14, 15], "log": [2, 7, 8, 14, 17], "init_step_s": 2, "where": [2, 4, 6, 8, 11, 14, 15, 17], "reason": 2, "found": 2, "coars": 2, "search": [2, 11], "recommend": 2, "ha": [2, 3, 7, 8, 10, 14, 15], "effect": [2, 6, 10, 15], "give": [2, 6, 8, 14], "tendenc": 2, "test": [2, 7, 11], "larger": [2, 6, 7], "than": [2, 8, 12, 14, 15], "typic": [2, 6, 8], "have": [2, 6, 8, 9, 10, 13, 14, 15], "lower": [2, 8, 10, 14, 15], "comput": [2, 4, 6, 8, 10, 11, 12, 13, 14, 15, 17], "cost": [2, 8, 10, 11, 15], "coeffici": [2, 6, 8, 14, 15], "amount": 2, "regularis": [2, 8, 14], "expon": [2, 7], "decai": 2, "schedul": 2, "weight": [2, 15], "smooth": [2, 8, 14], "estim": [2, 7, 9], "interv": [2, 6, 7, 10, 14, 15], "5": [2, 6, 11], "ensur": [2, 6, 8, 10, 14, 15], "asymptot": [2, 14], "converg": [2, 5, 6, 7, 11], "equal": [2, 6, 7, 8, 10, 15], "whole": 2, "histori": 2, "smaller": 2, "increasingli": [2, 8, 14], "highli": 2, "recent": 2, "forget": 2, "earli": 2, "int": [2, 6, 7, 8, 9, 10, 11, 12, 13, 15, 17], "offset": [2, 7], "non": [2, 6, 7, 8, 10, 11, 12, 14], "neg": [2, 6, 7, 8, 14, 15], "stabilis": 2, "maximum": [2, 7, 10, 11, 15], "except": [2, 5, 6, 8, 11, 13, 14], "rais": [2, 5, 6, 11, 13, 14], "suitabl": 2, "within": [2, 5, 6, 7, 9, 10, 11], "mani": 2, "reducerfunct": 2, "reduct": 2, "appli": [2, 3, 6, 7, 10, 12, 14], "produc": [2, 15], "overal": [2, 6, 8], "main": [2, 10, 12], "specifi": [2, 3, 6, 7, 8, 9, 10, 12, 13, 14, 15], "sequenc": [2, 6, 8, 9, 10, 12, 17], "arithmet": [2, 17], "mean": [2, 6, 7, 8, 9, 10, 14, 15], "true": [2, 6, 7, 8, 9, 10, 12, 13, 14, 15], "reg_iter_offset": 2, "reg_scal": 2, "001": 2, "dens": [2, 7, 8, 14], "metric": [2, 7, 8, 10, 14, 15], "onlin": 2, "covari": [2, 7, 14], "welford": 2, "stabli": 2, "posit": [2, 6, 7, 8, 9, 10, 11, 14, 15, 17], "variant": [2, 13, 15], "schubert": 2, "gertz": 2, "parallel": [2, 7, 10], "batch": [2, 4], "increment": 2, "varianc": [2, 7], "chan": 2, "et": 2, "al": 2, "3": [2, 4, 6, 8, 10, 14, 15], "scale": [2, 7, 11, 14], "ident": [2, 6, 7, 8, 10, 14, 15], "increas": [2, 12], "small": [2, 6, 11], "decreas": [2, 11], "noisi": 2, "approach": [2, 6, 12, 15], "stan": [2, 7, 10, 12, 15], "4": [2, 6, 7, 10, 14, 15], "represent": [2, 7, 8, 9, 10, 14, 15, 17], "definit": [2, 8, 14], "invers": [2, 8, 14], "b": [2, 6, 9, 10, 14, 15], "p": [2, 6, 10, 11, 14, 15], "1962": 2, "note": [2, 6, 8, 10, 12, 14], "correct": [2, 14], "sum": [2, 4, 6, 10, 12, 14, 15], "squar": [2, 8, 14], "product": [2, 4, 8, 14, 15], "technometr": 2, "419": 2, "420": 2, "2018": 2, "numer": [2, 6, 10, 14, 17], "stabl": [2, 17], "co": [2, 6, 11, 14], "acm": 2, "doi": 2, "1145": 2, "3221269": 2, "3223036": 2, "t": [2, 4, 6, 8, 13, 14], "f": [2, 4, 6, 8, 14], "golub": 2, "h": [2, 4, 6, 14], "levequ": 2, "r": [2, 10, 11, 14, 15], "j": [2, 4, 6, 8, 10, 14, 15], "1979": 2, "formula": 2, "pairwis": 2, "technic": 2, "report": 2, "c": [2, 6, 11, 14], "79": 2, "773": 2, "depart": 2, "scienc": [2, 14], "stanford": 2, "univers": [2, 6], "carpent": 2, "lee": 2, "goodrich": 2, "betancourt": [2, 10, 14, 15], "brubak": 2, "guo": 2, "li": 2, "riddel": 2, "2017": [2, 10, 14, 15], "languag": 2, "softwar": 2, "76": 2, "depend": [2, 8, 10, 12, 13, 14], "between": [2, 9, 10, 12, 13, 14, 15], "higher": 2, "caus": 2, "stronger": 2, "scalar": [2, 4, 6, 8, 10, 12, 14, 15], "defin": [2, 4, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "diagon": [2, 7, 8, 14], "common": [2, 8, 13], "element": [2, 8, 14], "reciproc": [2, 9], "zero": [2, 8, 9, 10, 11, 14, 15], "guarante": [2, 14], "log_step_s": 2, "stat": [2, 7, 9], "extract": 2, "geometr": [2, 14], "minimum": [2, 9, 14], "automat": [3, 13, 14], "different": 3, "fallback": [3, 14], "construct": [3, 8, 12, 13, 14], "deriv": [3, 4, 6, 8, 13, 14], "diff_func": 3, "func": [3, 6, 11], "diff_op_nam": 3, "name": [3, 7, 10, 12, 13, 15], "differenti": [3, 4, 6, 13, 14], "oper": [3, 4, 5, 7, 8, 10, 17], "altern": [3, 6, 14], "been": [3, 8, 13], "callabl": [3, 13], "either": [3, 7, 8, 10, 13, 14, 15], "wa": [3, 15], "str": [3, 6, 7, 9, 10, 12, 13, 14, 15], "string": [3, 7, 9, 10, 12, 13, 15], "framework": 3, "wrapper": [3, 10], "messag": 3, "otherwis": [3, 6, 8, 10, 14], "addit": [4, 7, 10, 13, 14, 15], "autograd": 4, "fun": 4, "x": [4, 6, 8, 11, 14], "make": 4, "both": [4, 6, 8, 9, 10, 11, 12, 14, 15], "gradient": [4, 8, 14], "scalarfunct": [4, 11, 14], "arraylik": [4, 7, 11, 13, 14, 15], "tupl": [4, 8, 9, 10, 12, 13, 14, 15], "scalarlik": [4, 8, 14, 15], "hessian": [4, 14], "broadcast": 4, "along": [4, 8, 11, 15], "first": [4, 6, 7, 8, 9, 10, 13, 14, 15], "dimens": [4, 6, 7, 8, 10], "input": [4, 6, 8, 14], "respect": [4, 6, 7, 8, 10, 11, 13, 14, 15], "concurr": 4, "arrayfunct": [4, 11, 14], "jacobian": [4, 11, 14], "mhp": [4, 14], "For": [4, 6, 8, 10, 15], "vector": [4, 6, 8, 11, 14, 15], "axi": [4, 14], "wrt": [4, 14], "rank": [4, 8], "tensor": 4, "second": [4, 6, 7, 8, 9, 11, 14, 15], "order": [4, 6, 8, 9, 10, 12, 13, 14], "partial": [4, 7, 9, 14, 15], "k": [4, 6, 14], "\u00b2f": 4, "matrixhessianproduct": [4, 14], "mtp": [4, 14], "tressian": [4, 14], "3d": [4, 14], "third": [4, 14], "\u00b3f": [4, 14], "matrixtressianproduct": [4, 14], "when": [5, 7, 8, 10, 11, 12, 13, 14, 15], "fail": [5, 10, 14, 15], "arg": [5, 11], "with_traceback": 5, "tb": 5, "self": [5, 8, 12], "__traceback__": 5, "allow": [5, 6, 7, 8, 9, 11, 13, 14], "runtimeerror": 5, "diverg": [5, 6, 10, 11, 15], "linear": [5, 6, 8, 11, 14], "algebra": [5, 6, 8], "revers": [5, 6, 10, 13, 15], "check": [5, 6, 8, 10, 15], "write": [5, 9, 10], "read": [5, 13], "symplect": [6, 10, 15], "step_siz": 6, "four": 6, "symmetr": [6, 8, 11, 14], "composit": 6, "blane": 6, "casa": 6, "sanz": 6, "serna": 6, "equat": [6, 11, 14], "6": 6, "hybrid": [6, 10, 14, 15], "siam": 6, "scientif": 6, "36": 6, "a1556": 6, "a1580": 6, "tractabl": [6, 14], "flow": [6, 11, 14], "time": [6, 9, 10, 11, 13, 14, 15], "befor": [6, 10, 11, 13, 15], "call": [6, 7, 10, 13], "singl": [6, 9, 10, 12, 14], "suppli": 6, "new": [6, 9, 10, 13, 15], "three": [6, 12], "7": 6, "two": [6, 10, 11, 12, 14, 15], "n_inner_step": 6, "reverse_check_tol": 6, "2e": 6, "08": [6, 11], "reverse_check_norm": 6, "projection_solv": 6, "projection_solver_kwarg": 6, "leapfrog": 6, "constrain": [6, 11, 14], "express": 6, "unconstrain": [6, 11, 14], "exactli": [6, 10, 15], "specif": [6, 14], "take": [6, 10, 14, 15], "form": [6, 8, 11, 14], "q": [6, 11, 14], "h\u2081": 6, "h\u2082": [6, 11], "momentum": [6, 10, 11, 14, 15], "exact": [6, 14], "\u03c6\u2081": 6, "\u03c6\u2082": [6, 11], "addition": [6, 13, 14], "subject": [6, 14], "holonom": 6, "constraint": [6, 11, 14], "valid": [6, 9, 10, 13], "must": [6, 8, 9, 13], "satisfi": [6, 8, 11, 15], "some": [6, 7, 10, 15], "surject": 6, "implicitli": [6, 8, 14], "remain": [6, 7, 9, 15], "confin": 6, "enforc": [6, 14], "introduc": 6, "lagrang": [6, 11], "multipli": [6, 8, 11, 12], "\u03bb": [6, 11], "\u1d40\u03bb": [6, 11], "\u2082h": 6, "\u2081h": 6, "abov": [6, 8, 13, 14], "cotang": 6, "space": [6, 8, 10, 11, 14, 15], "pair": [6, 8, 9, 10, 15], "bundl": [6, 11], "To": 6, "up": [6, 7, 9, 10, 12, 15], "point": [6, 7, 8, 11, 14, 15], "preserv": [6, 10, 14], "map": [6, 7, 10, 11, 14], "we": 6, "reich": 6, "1996": 6, "\u03c0": 6, "parametris": [6, 8], "\u03c8\u2081": 6, "tangent": [6, 11, 14], "trivial": 6, "therefor": 6, "project": [6, 11, 14], "result": [6, 8, 10, 13, 14, 15], "back": 6, "usual": [6, 7, 13], "case": [6, 8, 10, 12, 14, 15], "includ": [6, 10], "quadrat": [6, 8, 11, 14], "analyt": [6, 14], "solv": [6, 8, 11, 14], "also": [6, 7, 13, 14], "\u03c8\u2082": 6, "decompos": 6, "\u2081": [6, 11], "newton": [6, 11], "solut": [6, 11], "\u03c8": 6, "n": [6, 14], "\u1d3a": 6, "integ": [6, 7, 10, 15, 17], "inner": [6, 8, 10, 11, 14], "detail": [6, 10, 13, 14, 15], "see": [6, 10, 12, 13, 14, 15], "section": 6, "leimkuhl": 6, "2004": 6, "analysi": 6, "33": 6, "475": 6, "491": 6, "14": 6, "cambridg": 6, "press": 6, "h2_flow": [6, 11, 14], "As": [6, 8, 13, 14], "dh1_dpo": [6, 14], "evalu": [6, 8, 11, 14], "rel": [6, 10, 15], "expens": 6, "compar": [6, 13], "computation": 6, "effici": [6, 10, 15], "thu": 6, "forward": [6, 10, 13, 15], "still": 6, "involv": 6, "retract": 6, "too": 6, "larg": [6, 10], "toler": [6, 10, 11, 15], "implicit": [6, 8, 11, 14], "sub": [6, 10, 15], "sequenti": [6, 10], "adjoint": 6, "distanc": [6, 15], "argument": [6, 7, 8, 9, 10, 11, 12, 13, 14, 15], "origin": [6, 8, 10, 13, 15], "condit": [6, 10, 14, 15], "met": [6, 10, 15], "normfunct": 6, "norm": [6, 11], "dimension": [6, 14], "state_prev": [6, 11], "time_step": [6, 11], "constr": [6, 11, 14], "po": [6, 10, 11, 13, 14], "dh2_flow_pos_dmom": 6, "jacob_constr": [6, 11, 14], "dh2_flow_dmom": [6, 14], "action": 6, "dict": [6, 7, 8, 9, 10, 12, 13, 14, 15], "keyword": [6, 8, 10, 12, 13, 14], "fixed_point_solv": 6, "fixed_point_solver_kwarg": 6, "separ": [6, 14], "known": [6, 8, 15], "generalis": 6, "h_1": [6, 14], "h_2": [6, 14], "possibl": [6, 8, 13, 17], "fix": [6, 7, 10, 11, 14, 15], "partit": 6, "rung": 6, "kutta": 6, "guess": 6, "x0": [6, 11], "initialis": [6, 8, 11], "midpoint": 6, "euler": 6, "half": [6, 10, 14, 15], "explicit": [6, 8], "canon": [6, 10, 15], "ordinari": 6, "dot": [6, 15], "nabla_2": 6, "qquad": 6, "nabla_1": 6, "consequ": 6, "volum": [6, 10], "over": [6, 7, 9, 10, 15], "conserv": [6, 10, 15], "discretis": 6, "trajectori": [6, 7, 10, 15], "potenti": [6, 10, 13, 14, 15], "energi": [6, 7, 14], "kinet": 6, "classic": [6, 10], "st\u00f6rmer": 6, "verlet": 6, "split": [6, 10, 12, 14], "free_coeffici": 6, "initial_h1_flow_step": 6, "phi_1": 6, "phi_2": 6, "psi": 6, "a_": 6, "circ": 6, "b_": 6, "a_1": 6, "b_1": 6, "a_0": 6, "determin": [6, 8, 10, 14, 15], "consist": [6, 10], "least": 6, "sum_": 6, "restrict": [6, 8], "a_m": 6, "quad": 6, "symmetri": 6, "free": 6, "a_k": 6, "b_k": 6, "odd": 6, "even": [6, 13], "special": [6, 8, 14], "uniqu": [6, 8, 13], "interfac": [7, 9, 15], "extern": 7, "librari": [7, 10], "trace": [7, 10, 12], "energy_kei": 7, "lp_kei": 7, "lp": 7, "convert": 7, "sample_chain": [7, 10], "arviz": 7, "inferencedata": 7, "kei": [7, 8, 9, 10, 12, 13, 15], "draw": [7, 10, 12, 14, 15], "index": [7, 9, 10, 12], "propos": [7, 10, 15], "constant": [7, 14], "present": 7, "ad": [7, 13], "sample_stat": 7, "group": 7, "joint": [7, 10], "posterior": [7, 14], "densiti": [7, 8, 10, 14, 15], "data": [7, 10, 17], "store": [7, 8, 10, 12, 13, 15, 17], "1000": [7, 10, 15], "tune": [7, 10], "core": 7, "random_se": 7, "init": 7, "auto": 7, "jitter_max_retri": 7, "return_inferencedata": 7, "target_accept": 7, "max_treedepth": 7, "pymc3": 7, "multinomi": [7, 10, 15], "hmc": [7, 10, 15], "warm": [7, 10, 12], "phase": 7, "replic": 7, "drop": 7, "replac": 7, "adjust": [7, 12], "similar": 7, "drawn": 7, "discard": 7, "run": [7, 10, 12], "import": 7, "reveal": 7, "mode": [7, 13], "code": 7, "whichev": 7, "cpu": 7, "most": [7, 14], "seed": 7, "numpi": [7, 10, 15, 17], "entropi": 7, "displai": [7, 9, 10], "progress": [7, 9, 10, 15], "bar": [7, 9, 10], "liter": [7, 8], "adapt_diag": 7, "jitter": 7, "adapt_ful": 7, "One": [7, 8, 10, 13], "mass": 7, "same": [7, 8, 10, 12, 14, 15], "add": 7, "uniform": [7, 10, 15], "chosen": [7, 10, 15], "repeat": 7, "attempt": [7, 8, 13, 14], "creat": [7, 9, 10, 12, 13], "yield": 7, "finit": 7, "track": [7, 9, 10], "unobserved_rv": 7, "distribut": [7, 10, 14, 15], "context": 7, "manag": 7, "depth": [7, 10, 15], "expand": [7, 10, 15], "binari": [7, 8, 10, 15], "tree": [7, 10, 15], "contain": [7, 8, 10, 14, 15], "across": [7, 10, 15], "instead": [7, 8, 10, 11, 14, 15], "model_cod": 7, "num_sampl": 7, "num_warmup": 7, "num_chain": 7, "save_warmup": 7, "diag_": 7, "stepsiz": 7, "adapt_engag": 7, "delta": 7, "gamma": 7, "kappa": 7, "t0": 7, "init_buff": 7, "term_buff": 7, "50": [7, 11, 12], "window": [7, 12], "25": [7, 9, 12], "max_depth": 7, "pystan": 7, "itself": [7, 8, 13], "cmdstan": 7, "save": [7, 13], "unit_": 7, "dense_": 7, "indic": [7, 8, 13], "margin": [7, 14], "engag": 7, "relax": 7, "width": 7, "flatten": 7, "structur": [8, 14], "basic": 8, "block": [8, 9, 13], "compos": 8, "vertic": 8, "concaten": 8, "seri": [8, 14], "column": [8, 9, 14], "top": 8, "bottom": 8, "transpos": 8, "ndarrai": [8, 10, 17], "full": [8, 11], "2d": [8, 14], "access": [8, 13, 15], "avoid": [8, 10, 13, 15], "wherev": 8, "lot": 8, "abl": 8, "exploit": [8, 14], "1d": [8, 14], "shape": [8, 14], "num_row": 8, "num_column": 8, "kwarg": [8, 10, 11], "submatrix": 8, "instanc": [8, 10, 12, 13, 14], "horizont": 8, "row": [8, 14], "left": [8, 10, 14], "right": [8, 14], "factor": [8, 14], "is_posdef": 8, "_basetriangularfactoreddefinitematrix": 8, "triangular": [8, 14], "factoris": 8, "pre": [8, 15], "later": 8, "made": 8, "eigval": [8, 14], "eigenvalu": [8, 14], "eigvec": [8, 14], "eigenvector": [8, 14], "stack": 8, "sign": 8, "grad_log_abs_det": [8, 14], "absolut": [8, 14], "grad_quadratic_form_inv": [8, 14], "inv": [8, 14], "repres": [8, 9, 14], "necessarili": 8, "log_abs_det": [8, 14], "proport": [8, 9], "riemannian": [8, 14, 15], "measur": [8, 14], "lebesgu": [8, 14], "sqrt": 8, "root": [8, 14], "rect_matrix": 8, "pos_def_matrix": 8, "rectangular": 8, "dim_0": 8, "dim_1": 8, "under": [8, 10, 14, 15], "assumpt": 8, "its": [8, 10, 14, 15], "leftmost": 8, "righmost": 8, "dim_inn": 8, "lu_and_piv": 8, "lu_transpos": 8, "singular": 8, "pivot": 8, "lu": 8, "upper": [8, 10, 15], "unit": [8, 9], "scipi": 8, "linalg": 8, "lu_factor": 8, "lu_solv": 8, "orthonorm": 8, "parameter": 8, "convent": 8, "__init__": [8, 10], "subclass": [8, 14], "wrap": [8, 13], "exampl": [8, 9, 13], "param": 8, "ab": [8, 14], "det": 8, "In": [8, 10, 14, 15], "relev": [8, 13], "parametr": 8, "eigendecomposit": 8, "parameteris": 8, "diag": [8, 14], "orthogon": [8, 14], "strictli": [8, 14], "ones": 8, "elsewher": 8, "subset": 8, "inv_arrai": 8, "inv_lu_and_piv": 8, "inv_lu_transpos": 8, "inverse_arrai": 8, "make_triangular": 8, "below": [8, 12], "ignor": [8, 14], "explicitli": 8, "triangl": 8, "check_shap": 8, "invert": 8, "success": 8, "he": 8, "compat": 8, "like": 8, "overload": [8, 17], "well": [8, 10, 13, 15], "standard": [8, 10, 14, 15], "divis": 8, "quantiti": [8, 13], "adjac": 8, "specialis": 8, "factor_matrix": 8, "inner_pos_def_matrix": 8, "capacitance_matrix": 8, "low": 8, "dim_out": 8, "downdat": 8, "peform": [8, 10], "woodburi": 8, "lemma": 8, "o": [8, 10, 14], "plu": 8, "square_root": 8, "exist": 8, "cheaper": [8, 11], "directli": [8, 14], "pass": [8, 9, 10, 12, 13, 14], "alreadi": 8, "previou": [8, 10, 11, 15], "do": 8, "reli": 8, "reprsent": 8, "orth_arrai": 8, "paramteris": 8, "real": [8, 14], "symmetric_arrai": 8, "softabs_coeff": [8, 14], "transform": [8, 14], "eigh": [8, 14], "softab": [8, 14], "tend": [8, 14], "infin": [8, 11, 14], "becom": [8, 14], "grad_softab": 8, "left_factor_matrix": 8, "right_factor_matrix": 8, "square_matrix": 8, "inner_square_matrix": 8, "resp": 8, "rightmost": 8, "symmetric_matrix": 8, "inner_symmetric_matrix": 8, "factor_is_low": 8, "trinagular": 8, "boolean": 8, "choleski": [8, 14], "descript": [9, 10, 12, 13], "placehold": 9, "doe": [9, 11], "_and_": 9, "len": 9, "task": 9, "prefix": 9, "total": 9, "n_iter": [9, 12], "iter_count": 9, "iter_dict": 9, "refresh": [9, 15], "counter": [9, 13], "postfix": [9, 10], "file": [9, 10], "support": [9, 10, 14], "ansi": 9, "escap": 9, "line": [9, 11, 15], "textio": 9, "x1b": 9, "cursor": 9, "down": 9, "manipul": 9, "sy": 9, "stdout": 9, "cursor_down": 9, "move": [9, 10, 15], "cursor_up": 9, "obj": 9, "labelled_sequ": 9, "label": [9, 12], "visual": 9, "much": 9, "completed_label": 9, "count": [9, 13], "current_label": 9, "text": 9, "progress_bar": 9, "statu": 9, "reset": [9, 12], "comma": 9, "delimit": 9, "unstarted_label": 9, "unstart": 9, "expect": [9, 14, 15], "n_col": 9, "min_refresh_tim": 9, "html": 9, "richer": 9, "jupyt": 9, "notebook": 9, "interact": 9, "termin": [9, 10, 11, 15], "charact": 9, "min_referesh_tim": 9, "glyph": 9, "bar_color": 9, "css": 9, "color": 9, "elapsed_tim": 9, "elaps": 9, "format": 9, "empty_block": 9, "empti": [9, 10], "est_remaining_tim": 9, "filled_block": 9, "fill": 9, "iter_r": 9, "rate": 9, "n_block_empti": 9, "n_block_fil": 9, "partial_block": 9, "perc_complet": 9, "percentag": 9, "prop_complet": 9, "prop_partial_block": 9, "max_tree_depth": [10, 15], "max_delta_h": [10, 15], "termination_criterion": [10, 15], "do_extra_subtree_check": [10, 15], "momentum_transit": 10, "recurs": [10, 15], "randomli": [10, 15], "backward": [10, 15], "until": [10, 11, 15], "criteria": [10, 15], "leav": [10, 15], "next": [10, 15], "candid": [10, 15], "differ": [10, 15], "bias": [10, 15], "further": [10, 12, 14, 15], "criterion": [10, 15], "extra": 10, "subtre": [10, 15], "enabl": 10, "equival": [10, 15], "nut": 10, "minu": 10, "http": [10, 11, 12], "mc": [10, 12], "org": [10, 11, 12], "v2": 10, "23": 10, "conceptu": [10, 15], "introduct": [10, 15], "arxiv": [10, 15], "preprint": [10, 15], "1701": [10, 15], "02434": [10, 15], "signal": [10, 15], "terminationcriterion": [10, 15], "expans": [10, 15], "edg": [10, 15], "node": [10, 15], "overlap": [10, 15], "improv": [10, 15], "robust": [10, 15], "simpl": [10, 15], "harmon": [10, 15], "oscil": [10, 15], "normal": [10, 15], "certain": [10, 15], "reson": [10, 15], "behaviour": [10, 12, 14, 15], "seen": [10, 15], "detect": [10, 15], "past": [10, 15], "period": [10, 15], "continu": [10, 11, 15], "limit": [10, 15], "hit": [10, 15], "discours": [10, 15], "discuss": [10, 15], "kutt": [10, 15], "yaki": [10, 15], "help": [10, 15], "correl": [10, 15], "overhead": [10, 15], "kernel": [10, 15], "invari": [10, 15], "trigger": 10, "n_warm_up_it": [10, 12], "n_main_it": [10, 12], "init_st": 10, "process": 10, "mom": [10, 13, 14], "trace_func": [10, 12], "record": [10, 12, 13], "trace_warm_up": [10, 12], "appear": [10, 12], "last": [10, 12], "matter": [10, 12], "activ": [10, 12], "docstr": 10, "n_process": 10, "multiprocess": 10, "pool": 10, "assign": [10, 15], "cpu_count": 10, "max_threads_per_process": 10, "threadpoolctl": 10, "thread": 10, "bla": 10, "openmp": 10, "instal": 10, "environ": 10, "force_memmap": 10, "forc": 10, "disk": 10, "excess": 10, "long": 10, "written": 10, "npy": 10, "directori": 10, "memmap_path": 10, "temporari": 10, "alwai": [10, 14], "delet": 10, "onc": 10, "them": 10, "monitor_stat": 10, "monitor": [10, 13], "far": 10, "print": 10, "display_progress": 10, "progress_bar_class": 10, "factori": [10, 14], "show": 10, "final_st": 10, "interatino": 10, "augment": 10, "slice": [10, 15], "disabl": 10, "namedtupl": [10, 12], "hamiltonianmcmc": 10, "resum": 10, "lead": [10, 13], "integration_transit": 10, "henceforth": 10, "user": 10, "appropri": [10, 15], "There": 10, "variou": 10, "duan": [10, 15], "kennedi": [10, 15], "pendleton": [10, 15], "roweth": [10, 15], "1987": [10, 15], "physic": [10, 15], "letter": [10, 15], "195": [10, 15], "216": [10, 15], "222": [10, 15], "neal": [10, 14, 15], "2011": [10, 14, 15], "handbook": [10, 15], "11": [10, 14, 15], "jointli": [10, 15], "join": 10, "outer": 10, "tracefunct": [10, 12], "sueqenc": 10, "statistics_typ": 10, "n_step_rang": [10, 15], "metropoli": [10, 15], "direct": [10, 11, 15], "end": [10, 15], "negat": [10, 15], "involut": [10, 15], "determinist": [10, 15], "again": [10, 15], "irrespect": [10, 15], "decis": [10, 15], "reject": [10, 15], "randomis": [10, 15], "mix": [10, 15], "poorli": [10, 15], "mackenzi": [10, 15], "1989": [10, 15], "226": [10, 15], "369": [10, 15], "371": [10, 15], "bound": [10, 15], "inclus": [10, 15], "uniformli": [10, 15], "n_step": [10, 15], "static": [10, 15], "often": [10, 15], "now": [10, 15], "protocol": 11, "__call__": 11, "level": [11, 14, 15], "vct": 11, "euclidean": [11, 14, 15], "l": [11, 14], "convergence_tol": 11, "1e": 11, "09": 11, "divergence_tol": 11, "10000000000": 11, "max_it": 11, "find": 11, "successfulli": 11, "abort": 11, "assess": 11, "encount": 11, "valueerror": 11, "steffensen": 11, "steffennsen": 11, "achiev": 11, "en": 11, "wikipedia": 11, "wiki": 11, "27s_method": 11, "constraint_tol": 11, "position_tol": 11, "re": 11, "loop": 11, "decomposit": [11, 14], "residu": 11, "\u2082\u03c6\u2082": 11, "\u1d40": 11, "\u00b9": 11, "post": [11, 15], "delt_po": 11, "delta_po": 11, "max_line_search_it": 11, "backtrack": [11, 15], "\u03bb_": 11, "\u03b1": 11, "try": 11, "quasi": 11, "recomput": [11, 13], "previous": 11, "record_stat": 12, "n_init_slow_window_it": 12, "n_init_fast_stage_it": 12, "n_final_fast_stage_it": 12, "slow_window_multipli": 12, "hierarchi": 12, "quickli": 12, "addtion": 12, "identifi": [12, 13], "grow": 12, "memoryless": 12, "begin": [12, 13], "doubl": 12, "subsequ": [12, 13, 15], "smallest": 12, "cach": 13, "_call_count": 13, "_read_onli": 13, "_depend": 13, "_cach": 13, "recalcul": 13, "reus": 13, "memoiz": 13, "those": 13, "decor": 13, "everi": 13, "isn": 13, "constructor": 13, "underscor": 13, "pos_val": 13, "mom_val": 13, "dir": 13, "dir_val": 13, "reserv": 13, "copi": 13, "persist": 13, "intend": 13, "intern": 13, "read_onli": 13, "deep": 13, "depends_on": 13, "prevent": 13, "futur": 13, "correctli": 13, "clear": 13, "auxiliary_output": 13, "auxiliari": 13, "intermedi": [13, 15], "primari": 13, "anoth": [13, 14], "thei": 13, "pattern": 13, "alongsid": 13, "part": 13, "retriev": 13, "encapsul": 14, "neg_log_den": 14, "metric_chol_func": 14, "vjp_metric_chol_func": 14, "grad_neg_log_den": 14, "taken": 14, "document": 14, "about": 14, "unnorm": 14, "wish": 14, "vectorjacobianproductfunct": 14, "vjp": 14, "v": 14, "jacob": 14, "dim_po": 14, "gradientfunct": 14, "h1": 14, "dh2_dmom": 14, "h2": 14, "dh2_dpo": 14, "dh_dmom": 14, "dh_dpo": 14, "h1_flow": 14, "dt": 14, "metric_matrix_class": 14, "metric_func": 14, "sample_momentum": 14, "vjp_metric_func": 14, "rang": 14, "ndim": 14, "vectorjacobianproduct": 14, "dens_wrt_hausdorff": 14, "embed": 14, "ambient": 14, "mathcal": 14, "lbrace": 14, "mathbb": 14, "rbrace": 14, "equip": 14, "gaussian": [14, 15], "frac": 14, "impli": 14, "veloc": [14, 15], "exp": [14, 17], "ell": 14, "hausdorff": 14, "induc": 14, "event": 14, "gram": 14, "leli\u00e8vr": 14, "rousset": 14, "stoltz": 14, "2019": 14, "submanifold": 14, "numerisch": 14, "mathematik": 14, "143": 14, "379": 14, "421": 14, "graham": 14, "storkei": 14, "electron": 14, "5105": 14, "5164": 14, "former": 14, "latter": 14, "ratio": 14, "rrai": 14, "metriclik": 14, "distriubt": 14, "jacobianfunct": 14, "dpos_dmom": 14, "dmom_dmom": 14, "grad_log_det_sqrt_gram": 14, "log_det_sqrt_gram": 14, "inv_gram": 14, "jacob_constr_inner_product": 14, "jacob_constr_1": 14, "inner_product_matrix": 14, "jacob_constr_2": 14, "sparsiti": 14, "matrixlik": 14, "project_onto_cotangent_spac": 14, "definin": 14, "mhp_constr": 14, "matrixhessianproductfunct": 14, "dim_constr": 14, "hess": 14, "\u00b2c": 14, "almost": 14, "everywher": 14, "metric_diagonal_func": 14, "vjp_metric_diagonal_func": 14, "st": 14, "rather": [14, 15], "shahbaba": 14, "lan": 14, "johnson": 14, "w": 14, "24": 14, "339": 14, "349": 14, "metric_kwarg": 14, "simpler": 14, "constructng": 14, "sim": 14, "coupl": [14, 15], "girolami": 14, "calderhead": 14, "riemann": 14, "langevin": 14, "varlo": 14, "royal": 14, "societi": 14, "methodologi": 14, "73": 14, "123": 14, "214": 14, "fulli": 14, "togeth": 14, "__matmul__": 14, "__rmatmul__": 14, "metric_scalar_func": 14, "vjp_metric_scalar_func": 14, "metric_scalar_funct": 14, "grad": 14, "hess_neg_log_den": 14, "mtp_neg_log_den": 14, "riemmanian": 14, "tanh": 14, "elementwis": 14, "act": 14, "piecewis": 14, "2013": [14, 15], "327": 14, "334": 14, "hessianfunct": 14, "containt": 14, "matrixtressianproductfunct": 14, "tress": 14, "fourth": 14, "hesisan": 14, "howev": [14, 15], "mom_resample_coeff": 15, "pertub": 15, "crank": 15, "nicolson": 15, "It": 15, "momenta": 15, "sometim": 15, "succes": 15, "applic": 15, "evolv": 15, "walk": 15, "without": 15, "tractori": 15, "vari": 15, "horowitz": 15, "1991": 15, "guid": 15, "phy": 15, "lett": 15, "268": 15, "cern": 15, "th": 15, "6172": 15, "91": 15, "247": 15, "252": 15, "state_vari": 15, "statistic_typ": 15, "dtypelik": 15, "dtype": 15, "transtion": 15, "through": 15, "state_1": 15, "state_2": 15, "sum_mom": 15, "evolut": 15, "intrins": 15, "curvatur": 15, "geodes": 15, "longer": 15, "straight": 15, "1304": 15, "1920": 15, "alias": 16, "val": 17, "log_val": 17, "hash": 17, "byte": 17, "val1": 17, "val2": 17}, "objects": {"": [[1, 0, 0, "-", "mici"]], "mici": [[2, 0, 0, "-", "adapters"], [3, 0, 0, "-", "autodiff"], [4, 0, 0, "-", "autograd_wrapper"], [5, 0, 0, "-", "errors"], [6, 0, 0, "-", "integrators"], [7, 0, 0, "-", "interop"], [8, 0, 0, "-", "matrices"], [9, 0, 0, "-", "progressbars"], [10, 0, 0, "-", "samplers"], [11, 0, 0, "-", "solvers"], [12, 0, 0, "-", "stagers"], [13, 0, 0, "-", "states"], [14, 0, 0, "-", "systems"], [15, 0, 0, "-", "transitions"], [16, 0, 0, "-", "types"], [17, 0, 0, "-", "utils"]], "mici.adapters": [[2, 1, 1, "", "Adapter"], [2, 1, 1, "", "DualAveragingStepSizeAdapter"], [2, 1, 1, "", "OnlineCovarianceMetricAdapter"], [2, 1, 1, "", "OnlineVarianceMetricAdapter"], [2, 5, 1, "", "arithmetic_mean_log_step_size_reducer"], [2, 5, 1, "", "default_adapt_stat_func"], [2, 5, 1, "", "geometric_mean_log_step_size_reducer"], [2, 5, 1, "", "min_log_step_size_reducer"]], "mici.adapters.Adapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 3, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.adapters.DualAveragingStepSizeAdapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 4, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.adapters.OnlineCovarianceMetricAdapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 4, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.adapters.OnlineVarianceMetricAdapter": [[2, 2, 1, "", "finalize"], [2, 2, 1, "", "initialize"], [2, 4, 1, "", "is_fast"], [2, 2, 1, "", "update"]], "mici.autodiff": [[3, 5, 1, "", "autodiff_fallback"]], "mici.autograd_wrapper": [[4, 5, 1, "", "grad_and_value"], [4, 5, 1, "", "hessian_grad_and_value"], [4, 5, 1, "", "jacobian_and_value"], [4, 5, 1, "", "mhp_jacobian_and_value"], [4, 5, 1, "", "mtp_hessian_grad_and_value"]], "mici.errors": [[5, 6, 1, "", "AdaptationError"], [5, 6, 1, "", "ConvergenceError"], [5, 6, 1, "", "Error"], [5, 6, 1, "", "HamiltonianDivergenceError"], [5, 6, 1, "", "IntegratorError"], [5, 6, 1, "", "LinAlgError"], [5, 6, 1, "", "NonReversibleStepError"], [5, 6, 1, "", "ReadOnlyStateError"]], "mici.errors.AdaptationError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.ConvergenceError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.Error": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.HamiltonianDivergenceError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.IntegratorError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.LinAlgError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.NonReversibleStepError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.errors.ReadOnlyStateError": [[5, 4, 1, "", "args"], [5, 2, 1, "", "with_traceback"]], "mici.integrators": [[6, 1, 1, "", "BCSSFourStageIntegrator"], [6, 1, 1, "", "BCSSThreeStageIntegrator"], [6, 1, 1, "", "BCSSTwoStageIntegrator"], [6, 1, 1, "", "ConstrainedLeapfrogIntegrator"], [6, 1, 1, "", "ImplicitLeapfrogIntegrator"], [6, 1, 1, "", "ImplicitMidpointIntegrator"], [6, 1, 1, "", "Integrator"], [6, 1, 1, "", "LeapfrogIntegrator"], [6, 1, 1, "", "SymmetricCompositionIntegrator"], [6, 1, 1, "", "TractableFlowIntegrator"]], "mici.integrators.BCSSFourStageIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.BCSSThreeStageIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.BCSSTwoStageIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.ConstrainedLeapfrogIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.ImplicitLeapfrogIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.ImplicitMidpointIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.Integrator": [[6, 2, 1, "", "step"]], "mici.integrators.LeapfrogIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.SymmetricCompositionIntegrator": [[6, 2, 1, "", "step"]], "mici.integrators.TractableFlowIntegrator": [[6, 2, 1, "", "step"]], "mici.interop": [[7, 5, 1, "", "convert_to_inference_data"], [7, 5, 1, "", "sample_pymc3_model"], [7, 5, 1, "", "sample_stan_model"]], "mici.matrices": [[8, 1, 1, "", "BlockColumnMatrix"], [8, 1, 1, "", "BlockMatrix"], [8, 1, 1, "", "BlockRowMatrix"], [8, 1, 1, "", "DenseDefiniteMatrix"], [8, 1, 1, "", "DensePositiveDefiniteMatrix"], [8, 1, 1, "", "DensePositiveDefiniteProductMatrix"], [8, 1, 1, "", "DenseRectangularMatrix"], [8, 1, 1, "", "DenseSquareMatrix"], [8, 1, 1, "", "DenseSymmetricMatrix"], [8, 1, 1, "", "DiagonalMatrix"], [8, 1, 1, "", "DifferentiableMatrix"], [8, 1, 1, "", "EigendecomposedPositiveDefiniteMatrix"], [8, 1, 1, "", "EigendecomposedSymmetricMatrix"], [8, 1, 1, "", "ExplicitArrayMatrix"], [8, 1, 1, "", "IdentityMatrix"], [8, 1, 1, "", "ImplicitArrayMatrix"], [8, 1, 1, "", "InverseLUFactoredSquareMatrix"], [8, 1, 1, "", "InverseTriangularMatrix"], [8, 1, 1, "", "InvertibleMatrix"], [8, 1, 1, "", "InvertibleMatrixProduct"], [8, 1, 1, "", "Matrix"], [8, 1, 1, "", "MatrixProduct"], [8, 1, 1, "", "OrthogonalMatrix"], [8, 1, 1, "", "PositiveDefiniteBlockDiagonalMatrix"], [8, 1, 1, "", "PositiveDefiniteLowRankUpdateMatrix"], [8, 1, 1, "", "PositiveDefiniteMatrix"], [8, 1, 1, "", "PositiveDiagonalMatrix"], [8, 1, 1, "", "PositiveScaledIdentityMatrix"], [8, 1, 1, "", "ScaledIdentityMatrix"], [8, 1, 1, "", "ScaledOrthogonalMatrix"], [8, 1, 1, "", "SoftAbsRegularizedPositiveDefiniteMatrix"], [8, 1, 1, "", "SquareBlockDiagonalMatrix"], [8, 1, 1, "", "SquareLowRankUpdateMatrix"], [8, 1, 1, "", "SquareMatrix"], [8, 1, 1, "", "SquareMatrixProduct"], [8, 1, 1, "", "SymmetricBlockDiagonalMatrix"], [8, 1, 1, "", "SymmetricLowRankUpdateMatrix"], [8, 1, 1, "", "SymmetricMatrix"], [8, 1, 1, "", "TriangularFactoredDefiniteMatrix"], [8, 1, 1, "", "TriangularFactoredPositiveDefiniteMatrix"], [8, 1, 1, "", "TriangularMatrix"]], "mici.matrices.BlockColumnMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.BlockMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.BlockRowMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "transpose"]], "mici.matrices.DensePositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.DensePositiveDefiniteProductMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseRectangularMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseSquareMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "lu_and_piv"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DenseSymmetricMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.DifferentiableMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.EigendecomposedPositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.EigendecomposedSymmetricMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.ExplicitArrayMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.IdentityMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.ImplicitArrayMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InverseLUFactoredSquareMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InverseTriangularMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "lower"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InvertibleMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.InvertibleMatrixProduct": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "matrices"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.Matrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.MatrixProduct": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "matrices"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.OrthogonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDefiniteBlockDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDefiniteLowRankUpdateMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "capacitance_matrix"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.PositiveScaledIdentityMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "scalar"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.ScaledIdentityMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "scalar"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.ScaledOrthogonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 2, 1, "", "grad_softabs"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 2, 1, "", "softabs"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareBlockDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareLowRankUpdateMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "capacitance_matrix"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SquareMatrixProduct": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "matrices"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SymmetricBlockDiagonalMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "blocks"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SymmetricLowRankUpdateMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "capacitance_matrix"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.SymmetricMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.matrices.TriangularFactoredDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "transpose"]], "mici.matrices.TriangularFactoredPositiveDefiniteMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "eigval"], [8, 3, 1, "", "eigvec"], [8, 3, 1, "", "factor"], [8, 3, 1, "", "grad_log_abs_det"], [8, 2, 1, "", "grad_quadratic_form_inv"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "sign"], [8, 3, 1, "", "sqrt"], [8, 3, 1, "", "transpose"]], "mici.matrices.TriangularMatrix": [[8, 3, 1, "", "T"], [8, 3, 1, "", "array"], [8, 3, 1, "", "diagonal"], [8, 3, 1, "", "inv"], [8, 3, 1, "", "log_abs_det"], [8, 3, 1, "", "lower"], [8, 3, 1, "", "shape"], [8, 3, 1, "", "transpose"]], "mici.progressbars": [[9, 1, 1, "", "DummyProgressBar"], [9, 1, 1, "", "FileDisplay"], [9, 1, 1, "", "LabelledSequenceProgressBar"], [9, 1, 1, "", "ProgressBar"], [9, 1, 1, "", "SequenceProgressBar"]], "mici.progressbars.DummyProgressBar": [[9, 3, 1, "", "n_iter"], [9, 3, 1, "", "sequence"], [9, 2, 1, "", "update"]], "mici.progressbars.FileDisplay": [[9, 4, 1, "", "CURSOR_DOWN"], [9, 4, 1, "", "CURSOR_UP"], [9, 2, 1, "", "update"]], "mici.progressbars.LabelledSequenceProgressBar": [[9, 3, 1, "", "completed_labels"], [9, 3, 1, "", "counter"], [9, 3, 1, "", "current_label"], [9, 3, 1, "", "description"], [9, 3, 1, "", "n_iter"], [9, 3, 1, "", "postfix"], [9, 3, 1, "", "prefix"], [9, 3, 1, "", "progress_bar"], [9, 2, 1, "", "refresh"], [9, 2, 1, "", "reset"], [9, 3, 1, "", "sequence"], [9, 3, 1, "", "stats"], [9, 3, 1, "", "unstarted_labels"], [9, 2, 1, "", "update"]], "mici.progressbars.ProgressBar": [[9, 3, 1, "", "n_iter"], [9, 3, 1, "", "sequence"], [9, 2, 1, "", "update"]], "mici.progressbars.SequenceProgressBar": [[9, 4, 1, "", "GLYPHS"], [9, 3, 1, "", "bar_color"], [9, 3, 1, "", "counter"], [9, 3, 1, "", "description"], [9, 3, 1, "", "elapsed_time"], [9, 3, 1, "", "empty_blocks"], [9, 3, 1, "", "est_remaining_time"], [9, 3, 1, "", "filled_blocks"], [9, 3, 1, "", "iter_rate"], [9, 3, 1, "", "n_block_empty"], [9, 3, 1, "", "n_block_filled"], [9, 3, 1, "", "n_iter"], [9, 3, 1, "", "partial_block"], [9, 3, 1, "", "perc_complete"], [9, 3, 1, "", "postfix"], [9, 3, 1, "", "prefix"], [9, 3, 1, "", "progress_bar"], [9, 3, 1, "", "prop_complete"], [9, 3, 1, "", "prop_partial_block"], [9, 2, 1, "", "refresh"], [9, 2, 1, "", "reset"], [9, 3, 1, "", "sequence"], [9, 3, 1, "", "stats"], [9, 2, 1, "", "update"]], "mici.samplers": [[10, 1, 1, "", "DynamicMultinomialHMC"], [10, 1, 1, "", "DynamicSliceHMC"], [10, 1, 1, "", "HMCSampleChainsOutputs"], [10, 1, 1, "", "HamiltonianMonteCarlo"], [10, 1, 1, "", "MCMCSampleChainsOutputs"], [10, 1, 1, "", "MarkovChainMonteCarloMethod"], [10, 1, 1, "", "RandomMetropolisHMC"], [10, 1, 1, "", "StaticMetropolisHMC"]], "mici.samplers.DynamicMultinomialHMC": [[10, 3, 1, "", "max_delta_h"], [10, 3, 1, "", "max_tree_depth"], [10, 3, 1, "", "rng"], [10, 2, 1, "", "sample_chains"], [10, 3, 1, "", "system"], [10, 3, 1, "", "transitions"]], "mici.samplers.DynamicSliceHMC": [[10, 3, 1, "", "max_delta_h"], [10, 3, 1, "", "max_tree_depth"], [10, 3, 1, "", "rng"], [10, 2, 1, "", "sample_chains"], [10, 3, 1, "", "system"], [10, 3, 1, "", "transitions"]], "mici.samplers.HamiltonianMonteCarlo": [[10, 3, 1, "", "rng"], [10, 2, 1, "", "sample_chains"], [10, 3, 1, "", "system"], [10, 3, 1, "", "transitions"]], "mici.samplers.MarkovChainMonteCarloMethod": [[10, 3, 1, "", "rng"], [10, 2, 1, "", "sample_chains"], [10, 3, 1, "", "transitions"]], "mici.samplers.RandomMetropolisHMC": [[10, 3, 1, "", "n_step_range"], [10, 3, 1, "", "rng"], [10, 2, 1, "", "sample_chains"], [10, 3, 1, "", "system"], [10, 3, 1, "", "transitions"]], "mici.samplers.StaticMetropolisHMC": [[10, 3, 1, "", "n_step"], [10, 3, 1, "", "rng"], [10, 2, 1, "", "sample_chains"], [10, 3, 1, "", "system"], [10, 3, 1, "", "transitions"]], "mici.solvers": [[11, 1, 1, "", "FixedPointSolver"], [11, 1, 1, "", "ProjectionSolver"], [11, 5, 1, "", "euclidean_norm"], [11, 5, 1, "", "maximum_norm"], [11, 5, 1, "", "solve_fixed_point_direct"], [11, 5, 1, "", "solve_fixed_point_steffensen"], [11, 5, 1, "", "solve_projection_onto_manifold_newton"], [11, 5, 1, "", "solve_projection_onto_manifold_newton_with_line_search"], [11, 5, 1, "", "solve_projection_onto_manifold_quasi_newton"]], "mici.solvers.FixedPointSolver": [[11, 2, 1, "", "__call__"]], "mici.solvers.ProjectionSolver": [[11, 2, 1, "", "__call__"]], "mici.stagers": [[12, 1, 1, "", "ChainStage"], [12, 1, 1, "", "Stager"], [12, 1, 1, "", "WarmUpStager"], [12, 1, 1, "", "WindowedWarmUpStager"]], "mici.stagers.Stager": [[12, 2, 1, "", "stages"]], "mici.stagers.WarmUpStager": [[12, 2, 1, "", "stages"]], "mici.stagers.WindowedWarmUpStager": [[12, 2, 1, "", "stages"]], "mici.states": [[13, 1, 1, "", "ChainState"], [13, 5, 1, "", "cache_in_state"], [13, 5, 1, "", "cache_in_state_with_aux"]], "mici.states.ChainState": [[13, 2, 1, "", "copy"]], "mici.systems": [[14, 1, 1, "", "CholeskyFactoredRiemannianMetricSystem"], [14, 1, 1, "", "ConstrainedEuclideanMetricSystem"], [14, 1, 1, "", "DenseConstrainedEuclideanMetricSystem"], [14, 1, 1, "", "DenseRiemannianMetricSystem"], [14, 1, 1, "", "DiagonalRiemannianMetricSystem"], [14, 1, 1, "", "EuclideanMetricSystem"], [14, 1, 1, "", "GaussianDenseConstrainedEuclideanMetricSystem"], [14, 1, 1, "", "GaussianEuclideanMetricSystem"], [14, 1, 1, "", "RiemannianMetricSystem"], [14, 1, 1, "", "ScalarRiemannianMetricSystem"], [14, 1, 1, "", "SoftAbsRiemannianMetricSystem"], [14, 1, 1, "", "System"], [14, 1, 1, "", "TractableFlowSystem"]], "mici.systems.CholeskyFactoredRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.ConstrainedEuclideanMetricSystem": [[14, 2, 1, "", "constr"], [14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_log_det_sqrt_gram"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "gram"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "inv_gram"], [14, 2, 1, "", "jacob_constr"], [14, 2, 1, "", "jacob_constr_inner_product"], [14, 2, 1, "", "log_det_sqrt_gram"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "project_onto_cotangent_space"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.DenseConstrainedEuclideanMetricSystem": [[14, 2, 1, "", "constr"], [14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_log_det_sqrt_gram"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "gram"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "inv_gram"], [14, 2, 1, "", "jacob_constr"], [14, 2, 1, "", "jacob_constr_inner_product"], [14, 2, 1, "", "log_det_sqrt_gram"], [14, 2, 1, "", "mhp_constr"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "project_onto_cotangent_space"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.DenseRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.DiagonalRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.EuclideanMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem": [[14, 2, 1, "", "constr"], [14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_log_det_sqrt_gram"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "gram"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "inv_gram"], [14, 2, 1, "", "jacob_constr"], [14, 2, 1, "", "jacob_constr_inner_product"], [14, 2, 1, "", "log_det_sqrt_gram"], [14, 2, 1, "", "mhp_constr"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "project_onto_cotangent_space"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.GaussianEuclideanMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.RiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.ScalarRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.SoftAbsRiemannianMetricSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "hess_neg_log_dens"], [14, 2, 1, "", "metric"], [14, 2, 1, "", "metric_func"], [14, 2, 1, "", "mtp_neg_log_dens"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"], [14, 2, 1, "", "vjp_metric_func"]], "mici.systems.System": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.systems.TractableFlowSystem": [[14, 2, 1, "", "dh1_dpos"], [14, 2, 1, "", "dh2_dmom"], [14, 2, 1, "", "dh2_dpos"], [14, 2, 1, "", "dh2_flow_dmom"], [14, 2, 1, "", "dh_dmom"], [14, 2, 1, "", "dh_dpos"], [14, 2, 1, "", "grad_neg_log_dens"], [14, 2, 1, "", "h"], [14, 2, 1, "", "h1"], [14, 2, 1, "", "h1_flow"], [14, 2, 1, "", "h2"], [14, 2, 1, "", "h2_flow"], [14, 2, 1, "", "neg_log_dens"], [14, 2, 1, "", "sample_momentum"]], "mici.transitions": [[15, 1, 1, "", "CorrelatedMomentumTransition"], [15, 1, 1, "", "DynamicIntegrationTransition"], [15, 1, 1, "", "IndependentMomentumTransition"], [15, 1, 1, "", "IntegrationTransition"], [15, 1, 1, "", "MetropolisIntegrationTransition"], [15, 1, 1, "", "MetropolisRandomIntegrationTransition"], [15, 1, 1, "", "MetropolisStaticIntegrationTransition"], [15, 1, 1, "", "MomentumTransition"], [15, 1, 1, "", "MultinomialDynamicIntegrationTransition"], [15, 1, 1, "", "SliceDynamicIntegrationTransition"], [15, 1, 1, "", "Transition"], [15, 5, 1, "", "euclidean_no_u_turn_criterion"], [15, 5, 1, "", "riemannian_no_u_turn_criterion"]], "mici.transitions.CorrelatedMomentumTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.DynamicIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.IndependentMomentumTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.IntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MetropolisIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MetropolisRandomIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MetropolisStaticIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MomentumTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.MultinomialDynamicIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.SliceDynamicIntegrationTransition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.transitions.Transition": [[15, 2, 1, "", "sample"], [15, 3, 1, "", "state_variables"], [15, 3, 1, "", "statistic_types"]], "mici.utils": [[17, 1, 1, "", "LogRepFloat"], [17, 5, 1, "", "hash_array"], [17, 5, 1, "", "log1m_exp"], [17, 5, 1, "", "log1p_exp"], [17, 5, 1, "", "log_diff_exp"], [17, 5, 1, "", "log_sum_exp"]], "mici.utils.LogRepFloat": [[17, 3, 1, "", "val"]]}, "objtypes": {"0": "py:module", "1": "py:class", "2": "py:method", "3": "py:property", "4": "py:attribute", "5": "py:function", "6": "py:exception"}, "objnames": {"0": ["py", "module", "Python module"], "1": ["py", "class", "Python class"], "2": ["py", "method", "Python method"], "3": ["py", "property", "Python property"], "4": ["py", "attribute", "Python attribute"], "5": ["py", "function", "Python function"], "6": ["py", "exception", "Python exception"]}, "titleterms": {"welcom": 0, "mici": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17], "": 0, "document": 0, "content": 0, "packag": 1, "submodul": 1, "adapt": 2, "modul": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17], "autodiff": 3, "autograd_wrapp": 4, "error": 5, "integr": 6, "interop": 7, "matric": 8, "progressbar": 9, "sampler": 10, "solver": 11, "stager": 12, "state": 13, "system": 14, "transit": 15, "type": 16, "util": 17}, "envversion": {"sphinx.domains.c": 2, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 8, "sphinx.domains.index": 1, "sphinx.domains.javascript": 2, "sphinx.domains.math": 2, "sphinx.domains.python": 3, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.viewcode": 1, "sphinx.ext.intersphinx": 1, "sphinx": 57}, "alltitles": {"Welcome to Mici\u2019s documentation!": [[0, "welcome-to-mici-s-documentation"]], "Contents:": [[0, null]], "mici package": [[1, "module-mici"]], "Submodules": [[1, "submodules"]], "mici.adapters module": [[2, "module-mici.adapters"]], "mici.autodiff module": [[3, "module-mici.autodiff"]], "mici.autograd_wrapper module": [[4, "module-mici.autograd_wrapper"]], "mici.errors module": [[5, "module-mici.errors"]], "mici.integrators module": [[6, "module-mici.integrators"]], "mici.interop module": [[7, "module-mici.interop"]], "mici.matrices module": [[8, "module-mici.matrices"]], "mici.progressbars module": [[9, "module-mici.progressbars"]], "mici.samplers module": [[10, "module-mici.samplers"]], "mici.solvers module": [[11, "module-mici.solvers"]], "mici.stagers module": [[12, "module-mici.stagers"]], "mici.states module": [[13, "module-mici.states"]], "mici.systems module": [[14, "module-mici.systems"]], "mici.transitions module": [[15, "module-mici.transitions"]], "mici.types module": [[16, "module-mici.types"]], "mici.utils module": [[17, "module-mici.utils"]]}, "indexentries": {"mici": [[1, "module-mici"]], "module": [[1, "module-mici"], [2, "module-mici.adapters"], [3, "module-mici.autodiff"], [4, "module-mici.autograd_wrapper"], [5, "module-mici.errors"], [6, "module-mici.integrators"], [7, "module-mici.interop"], [8, "module-mici.matrices"], [9, "module-mici.progressbars"], [10, "module-mici.samplers"], [11, "module-mici.solvers"], [12, "module-mici.stagers"], [13, "module-mici.states"], [14, "module-mici.systems"], [15, "module-mici.transitions"], [16, "module-mici.types"], [17, "module-mici.utils"]], "adapter (class in mici.adapters)": [[2, "mici.adapters.Adapter"]], "dualaveragingstepsizeadapter (class in mici.adapters)": [[2, "mici.adapters.DualAveragingStepSizeAdapter"]], "onlinecovariancemetricadapter (class in mici.adapters)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter"]], "onlinevariancemetricadapter (class in mici.adapters)": [[2, "mici.adapters.OnlineVarianceMetricAdapter"]], "arithmetic_mean_log_step_size_reducer() (in module mici.adapters)": [[2, "mici.adapters.arithmetic_mean_log_step_size_reducer"]], "default_adapt_stat_func() (in module mici.adapters)": [[2, "mici.adapters.default_adapt_stat_func"]], "finalize() (mici.adapters.adapter method)": [[2, "mici.adapters.Adapter.finalize"]], "finalize() (mici.adapters.dualaveragingstepsizeadapter method)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.finalize"]], "finalize() (mici.adapters.onlinecovariancemetricadapter method)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.finalize"]], "finalize() (mici.adapters.onlinevariancemetricadapter method)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.finalize"]], "geometric_mean_log_step_size_reducer() (in module mici.adapters)": [[2, "mici.adapters.geometric_mean_log_step_size_reducer"]], "initialize() (mici.adapters.adapter method)": [[2, "mici.adapters.Adapter.initialize"]], "initialize() (mici.adapters.dualaveragingstepsizeadapter method)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.initialize"]], "initialize() (mici.adapters.onlinecovariancemetricadapter method)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.initialize"]], "initialize() (mici.adapters.onlinevariancemetricadapter method)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.initialize"]], "is_fast (mici.adapters.adapter property)": [[2, "mici.adapters.Adapter.is_fast"]], "is_fast (mici.adapters.dualaveragingstepsizeadapter attribute)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.is_fast"]], "is_fast (mici.adapters.onlinecovariancemetricadapter attribute)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.is_fast"]], "is_fast (mici.adapters.onlinevariancemetricadapter attribute)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.is_fast"]], "mici.adapters": [[2, "module-mici.adapters"]], "min_log_step_size_reducer() (in module mici.adapters)": [[2, "mici.adapters.min_log_step_size_reducer"]], "update() (mici.adapters.adapter method)": [[2, "mici.adapters.Adapter.update"]], "update() (mici.adapters.dualaveragingstepsizeadapter method)": [[2, "mici.adapters.DualAveragingStepSizeAdapter.update"]], "update() (mici.adapters.onlinecovariancemetricadapter method)": [[2, "mici.adapters.OnlineCovarianceMetricAdapter.update"]], "update() (mici.adapters.onlinevariancemetricadapter method)": [[2, "mici.adapters.OnlineVarianceMetricAdapter.update"]], "autodiff_fallback() (in module mici.autodiff)": [[3, "mici.autodiff.autodiff_fallback"]], "mici.autodiff": [[3, "module-mici.autodiff"]], "grad_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.grad_and_value"]], "hessian_grad_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.hessian_grad_and_value"]], "jacobian_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.jacobian_and_value"]], "mhp_jacobian_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.mhp_jacobian_and_value"]], "mici.autograd_wrapper": [[4, "module-mici.autograd_wrapper"]], "mtp_hessian_grad_and_value() (in module mici.autograd_wrapper)": [[4, "mici.autograd_wrapper.mtp_hessian_grad_and_value"]], "adaptationerror": [[5, "mici.errors.AdaptationError"]], "convergenceerror": [[5, "mici.errors.ConvergenceError"]], "error": [[5, "mici.errors.Error"]], "hamiltoniandivergenceerror": [[5, "mici.errors.HamiltonianDivergenceError"]], "integratorerror": [[5, "mici.errors.IntegratorError"]], "linalgerror": [[5, "mici.errors.LinAlgError"]], "nonreversiblesteperror": [[5, "mici.errors.NonReversibleStepError"]], "readonlystateerror": [[5, "mici.errors.ReadOnlyStateError"]], "args (mici.errors.adaptationerror attribute)": [[5, "mici.errors.AdaptationError.args"]], "args (mici.errors.convergenceerror attribute)": [[5, "mici.errors.ConvergenceError.args"]], "args (mici.errors.error attribute)": [[5, "mici.errors.Error.args"]], "args (mici.errors.hamiltoniandivergenceerror attribute)": [[5, "mici.errors.HamiltonianDivergenceError.args"]], "args (mici.errors.integratorerror attribute)": [[5, "mici.errors.IntegratorError.args"]], "args (mici.errors.linalgerror attribute)": [[5, "mici.errors.LinAlgError.args"]], "args (mici.errors.nonreversiblesteperror attribute)": [[5, "mici.errors.NonReversibleStepError.args"]], "args (mici.errors.readonlystateerror attribute)": [[5, "mici.errors.ReadOnlyStateError.args"]], "mici.errors": [[5, "module-mici.errors"]], "with_traceback() (mici.errors.adaptationerror method)": [[5, "mici.errors.AdaptationError.with_traceback"]], "with_traceback() (mici.errors.convergenceerror method)": [[5, "mici.errors.ConvergenceError.with_traceback"]], "with_traceback() (mici.errors.error method)": [[5, "mici.errors.Error.with_traceback"]], "with_traceback() (mici.errors.hamiltoniandivergenceerror method)": [[5, "mici.errors.HamiltonianDivergenceError.with_traceback"]], "with_traceback() (mici.errors.integratorerror method)": [[5, "mici.errors.IntegratorError.with_traceback"]], "with_traceback() (mici.errors.linalgerror method)": [[5, "mici.errors.LinAlgError.with_traceback"]], "with_traceback() (mici.errors.nonreversiblesteperror method)": [[5, "mici.errors.NonReversibleStepError.with_traceback"]], "with_traceback() (mici.errors.readonlystateerror method)": [[5, "mici.errors.ReadOnlyStateError.with_traceback"]], "bcssfourstageintegrator (class in mici.integrators)": [[6, "mici.integrators.BCSSFourStageIntegrator"]], "bcssthreestageintegrator (class in mici.integrators)": [[6, "mici.integrators.BCSSThreeStageIntegrator"]], "bcsstwostageintegrator (class in mici.integrators)": [[6, "mici.integrators.BCSSTwoStageIntegrator"]], "constrainedleapfrogintegrator (class in mici.integrators)": [[6, "mici.integrators.ConstrainedLeapfrogIntegrator"]], "implicitleapfrogintegrator (class in mici.integrators)": [[6, "mici.integrators.ImplicitLeapfrogIntegrator"]], "implicitmidpointintegrator (class in mici.integrators)": [[6, "mici.integrators.ImplicitMidpointIntegrator"]], "integrator (class in mici.integrators)": [[6, "mici.integrators.Integrator"]], "leapfrogintegrator (class in mici.integrators)": [[6, "mici.integrators.LeapfrogIntegrator"]], "symmetriccompositionintegrator (class in mici.integrators)": [[6, "mici.integrators.SymmetricCompositionIntegrator"]], "tractableflowintegrator (class in mici.integrators)": [[6, "mici.integrators.TractableFlowIntegrator"]], "mici.integrators": [[6, "module-mici.integrators"]], "step() (mici.integrators.bcssfourstageintegrator method)": [[6, "mici.integrators.BCSSFourStageIntegrator.step"]], "step() (mici.integrators.bcssthreestageintegrator method)": [[6, "mici.integrators.BCSSThreeStageIntegrator.step"]], "step() (mici.integrators.bcsstwostageintegrator method)": [[6, "mici.integrators.BCSSTwoStageIntegrator.step"]], "step() (mici.integrators.constrainedleapfrogintegrator method)": [[6, "mici.integrators.ConstrainedLeapfrogIntegrator.step"]], "step() (mici.integrators.implicitleapfrogintegrator method)": [[6, "mici.integrators.ImplicitLeapfrogIntegrator.step"]], "step() (mici.integrators.implicitmidpointintegrator method)": [[6, "mici.integrators.ImplicitMidpointIntegrator.step"]], "step() (mici.integrators.integrator method)": [[6, "mici.integrators.Integrator.step"]], "step() (mici.integrators.leapfrogintegrator method)": [[6, "mici.integrators.LeapfrogIntegrator.step"]], "step() (mici.integrators.symmetriccompositionintegrator method)": [[6, "mici.integrators.SymmetricCompositionIntegrator.step"]], "step() (mici.integrators.tractableflowintegrator method)": [[6, "mici.integrators.TractableFlowIntegrator.step"]], "convert_to_inference_data() (in module mici.interop)": [[7, "mici.interop.convert_to_inference_data"]], "mici.interop": [[7, "module-mici.interop"]], "sample_pymc3_model() (in module mici.interop)": [[7, "mici.interop.sample_pymc3_model"]], "sample_stan_model() (in module mici.interop)": [[7, "mici.interop.sample_stan_model"]], "blockcolumnmatrix (class in mici.matrices)": [[8, "mici.matrices.BlockColumnMatrix"]], "blockmatrix (class in mici.matrices)": [[8, "mici.matrices.BlockMatrix"]], "blockrowmatrix (class in mici.matrices)": [[8, "mici.matrices.BlockRowMatrix"]], "densedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.DenseDefiniteMatrix"]], "densepositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.DensePositiveDefiniteMatrix"]], "densepositivedefiniteproductmatrix (class in mici.matrices)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix"]], "denserectangularmatrix (class in mici.matrices)": [[8, "mici.matrices.DenseRectangularMatrix"]], "densesquarematrix (class in mici.matrices)": [[8, "mici.matrices.DenseSquareMatrix"]], "densesymmetricmatrix (class in mici.matrices)": [[8, "mici.matrices.DenseSymmetricMatrix"]], "diagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.DiagonalMatrix"]], "differentiablematrix (class in mici.matrices)": [[8, "mici.matrices.DifferentiableMatrix"]], "eigendecomposedpositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix"]], "eigendecomposedsymmetricmatrix (class in mici.matrices)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix"]], "explicitarraymatrix (class in mici.matrices)": [[8, "mici.matrices.ExplicitArrayMatrix"]], "identitymatrix (class in mici.matrices)": [[8, "mici.matrices.IdentityMatrix"]], "implicitarraymatrix (class in mici.matrices)": [[8, "mici.matrices.ImplicitArrayMatrix"]], "inverselufactoredsquarematrix (class in mici.matrices)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix"]], "inversetriangularmatrix (class in mici.matrices)": [[8, "mici.matrices.InverseTriangularMatrix"]], "invertiblematrix (class in mici.matrices)": [[8, "mici.matrices.InvertibleMatrix"]], "invertiblematrixproduct (class in mici.matrices)": [[8, "mici.matrices.InvertibleMatrixProduct"]], "matrix (class in mici.matrices)": [[8, "mici.matrices.Matrix"]], "matrixproduct (class in mici.matrices)": [[8, "mici.matrices.MatrixProduct"]], "orthogonalmatrix (class in mici.matrices)": [[8, "mici.matrices.OrthogonalMatrix"]], "positivedefiniteblockdiagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix"]], "positivedefinitelowrankupdatematrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix"]], "positivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDefiniteMatrix"]], "positivediagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.PositiveDiagonalMatrix"]], "positivescaledidentitymatrix (class in mici.matrices)": [[8, "mici.matrices.PositiveScaledIdentityMatrix"]], "scaledidentitymatrix (class in mici.matrices)": [[8, "mici.matrices.ScaledIdentityMatrix"]], "scaledorthogonalmatrix (class in mici.matrices)": [[8, "mici.matrices.ScaledOrthogonalMatrix"]], "softabsregularizedpositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix"]], "squareblockdiagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.SquareBlockDiagonalMatrix"]], "squarelowrankupdatematrix (class in mici.matrices)": [[8, "mici.matrices.SquareLowRankUpdateMatrix"]], "squarematrix (class in mici.matrices)": [[8, "mici.matrices.SquareMatrix"]], "squarematrixproduct (class in mici.matrices)": [[8, "mici.matrices.SquareMatrixProduct"]], "symmetricblockdiagonalmatrix (class in mici.matrices)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix"]], "symmetriclowrankupdatematrix (class in mici.matrices)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix"]], "symmetricmatrix (class in mici.matrices)": [[8, "mici.matrices.SymmetricMatrix"]], "t (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.T"]], "t (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.T"]], "t (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.T"]], "t (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.T"]], "t (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.T"]], "t (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.T"]], "t (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.T"]], "t (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.T"]], "t (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.T"]], "t (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.T"]], "t (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.T"]], "t (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.T"]], "t (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.T"]], "t (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.T"]], "t (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.T"]], "t (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.T"]], "t (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.T"]], "t (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.T"]], "t (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.T"]], "t (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.T"]], "t (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.T"]], "t (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.T"]], "t (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.T"]], "t (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.T"]], "t (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.T"]], "t (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.T"]], "t (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.T"]], "t (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.T"]], "t (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.T"]], "t (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.T"]], "t (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.T"]], "t (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.T"]], "t (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.T"]], "t (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.T"]], "t (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.T"]], "t (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.T"]], "t (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.T"]], "t (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.T"]], "t (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.T"]], "t (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.T"]], "t (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.T"]], "triangularfactoreddefinitematrix (class in mici.matrices)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix"]], "triangularfactoredpositivedefinitematrix (class in mici.matrices)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix"]], "triangularmatrix (class in mici.matrices)": [[8, "mici.matrices.TriangularMatrix"]], "array (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.array"]], "array (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.array"]], "array (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.array"]], "array (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.array"]], "array (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.array"]], "array (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.array"]], "array (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.array"]], "array (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.array"]], "array (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.array"]], "array (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.array"]], "array (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.array"]], "array (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.array"]], "array (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.array"]], "array (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.array"]], "array (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.array"]], "array (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.array"]], "array (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.array"]], "array (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.array"]], "array (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.array"]], "array (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.array"]], "array (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.array"]], "array (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.array"]], "array (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.array"]], "array (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.array"]], "array (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.array"]], "array (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.array"]], "array (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.array"]], "array (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.array"]], "array (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.array"]], "array (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.array"]], "array (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.array"]], "array (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.array"]], "array (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.array"]], "array (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.array"]], "array (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.array"]], "array (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.array"]], "array (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.array"]], "array (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.array"]], "array (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.array"]], "array (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.array"]], "array (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.array"]], "blocks (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.blocks"]], "blocks (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.blocks"]], "blocks (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.blocks"]], "blocks (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.blocks"]], "blocks (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.blocks"]], "blocks (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.blocks"]], "capacitance_matrix (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.capacitance_matrix"]], "capacitance_matrix (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.capacitance_matrix"]], "capacitance_matrix (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.capacitance_matrix"]], "diagonal (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.diagonal"]], "diagonal (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.diagonal"]], "diagonal (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.diagonal"]], "diagonal (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.diagonal"]], "diagonal (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.diagonal"]], "diagonal (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.diagonal"]], "diagonal (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.diagonal"]], "diagonal (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.diagonal"]], "diagonal (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.diagonal"]], "diagonal (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.diagonal"]], "diagonal (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.diagonal"]], "diagonal (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.diagonal"]], "diagonal (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.diagonal"]], "diagonal (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.diagonal"]], "diagonal (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.diagonal"]], "diagonal (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.diagonal"]], "diagonal (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.diagonal"]], "diagonal (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.diagonal"]], "diagonal (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.diagonal"]], "diagonal (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.diagonal"]], "diagonal (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.diagonal"]], "diagonal (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.diagonal"]], "diagonal (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.diagonal"]], "diagonal (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.diagonal"]], "diagonal (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.diagonal"]], "diagonal (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.diagonal"]], "diagonal (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.diagonal"]], "diagonal (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.diagonal"]], "diagonal (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.diagonal"]], "diagonal (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.diagonal"]], "diagonal (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.diagonal"]], "diagonal (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.diagonal"]], "eigval (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.eigval"]], "eigval (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.eigval"]], "eigval (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.eigval"]], "eigval (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.eigval"]], "eigval (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.eigval"]], "eigval (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.eigval"]], "eigval (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.eigval"]], "eigval (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.eigval"]], "eigval (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.eigval"]], "eigval (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.eigval"]], "eigval (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.eigval"]], "eigval (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.eigval"]], "eigval (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.eigval"]], "eigval (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.eigval"]], "eigval (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.eigval"]], "eigval (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.eigval"]], "eigval (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.eigval"]], "eigval (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.eigval"]], "eigvec (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.eigvec"]], "eigvec (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.eigvec"]], "eigvec (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.eigvec"]], "eigvec (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.eigvec"]], "eigvec (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.eigvec"]], "eigvec (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.eigvec"]], "eigvec (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.eigvec"]], "eigvec (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.eigvec"]], "eigvec (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.eigvec"]], "eigvec (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.eigvec"]], "eigvec (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.eigvec"]], "eigvec (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.eigvec"]], "eigvec (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.eigvec"]], "factor (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.factor"]], "factor (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.factor"]], "factor (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.factor"]], "factor (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.factor"]], "factor (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.factor"]], "grad_log_abs_det (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.grad_log_abs_det"]], "grad_log_abs_det (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.grad_log_abs_det"]], "grad_quadratic_form_inv() (mici.matrices.densedefinitematrix method)": [[8, "mici.matrices.DenseDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.densepositivedefinitematrix method)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.densepositivedefiniteproductmatrix method)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.diagonalmatrix method)": [[8, "mici.matrices.DiagonalMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.differentiablematrix method)": [[8, "mici.matrices.DifferentiableMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivedefiniteblockdiagonalmatrix method)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivedefinitelowrankupdatematrix method)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivediagonalmatrix method)": [[8, "mici.matrices.PositiveDiagonalMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.positivescaledidentitymatrix method)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.scaledidentitymatrix method)": [[8, "mici.matrices.ScaledIdentityMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.softabsregularizedpositivedefinitematrix method)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.triangularfactoreddefinitematrix method)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.grad_quadratic_form_inv"]], "grad_quadratic_form_inv() (mici.matrices.triangularfactoredpositivedefinitematrix method)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.grad_quadratic_form_inv"]], "grad_softabs() (mici.matrices.softabsregularizedpositivedefinitematrix method)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.grad_softabs"]], "inv (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.inv"]], "inv (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.inv"]], "inv (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.inv"]], "inv (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.inv"]], "inv (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.inv"]], "inv (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.inv"]], "inv (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.inv"]], "inv (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.inv"]], "inv (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.inv"]], "inv (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.inv"]], "inv (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.inv"]], "inv (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.inv"]], "inv (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.inv"]], "inv (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.inv"]], "inv (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.inv"]], "inv (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.inv"]], "inv (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.inv"]], "inv (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.inv"]], "inv (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.inv"]], "inv (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.inv"]], "inv (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.inv"]], "inv (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.inv"]], "inv (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.inv"]], "inv (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.inv"]], "inv (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.inv"]], "inv (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.inv"]], "inv (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.inv"]], "inv (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.inv"]], "inv (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.inv"]], "inv (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.inv"]], "log_abs_det (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.log_abs_det"]], "log_abs_det (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.log_abs_det"]], "log_abs_det (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.log_abs_det"]], "log_abs_det (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.log_abs_det"]], "log_abs_det (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.log_abs_det"]], "log_abs_det (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.log_abs_det"]], "log_abs_det (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.log_abs_det"]], "log_abs_det (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.log_abs_det"]], "log_abs_det (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.log_abs_det"]], "log_abs_det (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.log_abs_det"]], "log_abs_det (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.log_abs_det"]], "log_abs_det (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.log_abs_det"]], "log_abs_det (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.log_abs_det"]], "log_abs_det (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.log_abs_det"]], "log_abs_det (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.log_abs_det"]], "log_abs_det (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.log_abs_det"]], "log_abs_det (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.log_abs_det"]], "log_abs_det (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.log_abs_det"]], "lower (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.lower"]], "lower (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.lower"]], "lu_and_piv (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.lu_and_piv"]], "matrices (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.matrices"]], "matrices (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.matrices"]], "matrices (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.matrices"]], "mici.matrices": [[8, "module-mici.matrices"]], "scalar (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.scalar"]], "scalar (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.scalar"]], "shape (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.shape"]], "shape (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.shape"]], "shape (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.shape"]], "shape (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.shape"]], "shape (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.shape"]], "shape (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.shape"]], "shape (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.shape"]], "shape (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.shape"]], "shape (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.shape"]], "shape (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.shape"]], "shape (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.shape"]], "shape (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.shape"]], "shape (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.shape"]], "shape (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.shape"]], "shape (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.shape"]], "shape (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.shape"]], "shape (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.shape"]], "shape (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.shape"]], "shape (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.shape"]], "shape (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.shape"]], "shape (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.shape"]], "shape (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.shape"]], "shape (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.shape"]], "shape (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.shape"]], "shape (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.shape"]], "shape (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.shape"]], "shape (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.shape"]], "shape (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.shape"]], "shape (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.shape"]], "shape (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.shape"]], "shape (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.shape"]], "shape (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.shape"]], "shape (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.shape"]], "shape (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.shape"]], "shape (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.shape"]], "shape (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.shape"]], "shape (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.shape"]], "shape (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.shape"]], "shape (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.shape"]], "shape (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.shape"]], "shape (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.shape"]], "sign (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.sign"]], "sign (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.sign"]], "sign (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.sign"]], "sign (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.sign"]], "sign (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.sign"]], "softabs() (mici.matrices.softabsregularizedpositivedefinitematrix method)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.softabs"]], "sqrt (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.sqrt"]], "sqrt (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.sqrt"]], "sqrt (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.sqrt"]], "sqrt (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.sqrt"]], "sqrt (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.sqrt"]], "sqrt (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.sqrt"]], "sqrt (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.sqrt"]], "sqrt (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.sqrt"]], "transpose (mici.matrices.blockcolumnmatrix property)": [[8, "mici.matrices.BlockColumnMatrix.transpose"]], "transpose (mici.matrices.blockmatrix property)": [[8, "mici.matrices.BlockMatrix.transpose"]], "transpose (mici.matrices.blockrowmatrix property)": [[8, "mici.matrices.BlockRowMatrix.transpose"]], "transpose (mici.matrices.densedefinitematrix property)": [[8, "mici.matrices.DenseDefiniteMatrix.transpose"]], "transpose (mici.matrices.densepositivedefinitematrix property)": [[8, "mici.matrices.DensePositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.densepositivedefiniteproductmatrix property)": [[8, "mici.matrices.DensePositiveDefiniteProductMatrix.transpose"]], "transpose (mici.matrices.denserectangularmatrix property)": [[8, "mici.matrices.DenseRectangularMatrix.transpose"]], "transpose (mici.matrices.densesquarematrix property)": [[8, "mici.matrices.DenseSquareMatrix.transpose"]], "transpose (mici.matrices.densesymmetricmatrix property)": [[8, "mici.matrices.DenseSymmetricMatrix.transpose"]], "transpose (mici.matrices.diagonalmatrix property)": [[8, "mici.matrices.DiagonalMatrix.transpose"]], "transpose (mici.matrices.differentiablematrix property)": [[8, "mici.matrices.DifferentiableMatrix.transpose"]], "transpose (mici.matrices.eigendecomposedpositivedefinitematrix property)": [[8, "mici.matrices.EigendecomposedPositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.eigendecomposedsymmetricmatrix property)": [[8, "mici.matrices.EigendecomposedSymmetricMatrix.transpose"]], "transpose (mici.matrices.explicitarraymatrix property)": [[8, "mici.matrices.ExplicitArrayMatrix.transpose"]], "transpose (mici.matrices.identitymatrix property)": [[8, "mici.matrices.IdentityMatrix.transpose"]], "transpose (mici.matrices.implicitarraymatrix property)": [[8, "mici.matrices.ImplicitArrayMatrix.transpose"]], "transpose (mici.matrices.inverselufactoredsquarematrix property)": [[8, "mici.matrices.InverseLUFactoredSquareMatrix.transpose"]], "transpose (mici.matrices.inversetriangularmatrix property)": [[8, "mici.matrices.InverseTriangularMatrix.transpose"]], "transpose (mici.matrices.invertiblematrix property)": [[8, "mici.matrices.InvertibleMatrix.transpose"]], "transpose (mici.matrices.invertiblematrixproduct property)": [[8, "mici.matrices.InvertibleMatrixProduct.transpose"]], "transpose (mici.matrices.matrix property)": [[8, "mici.matrices.Matrix.transpose"]], "transpose (mici.matrices.matrixproduct property)": [[8, "mici.matrices.MatrixProduct.transpose"]], "transpose (mici.matrices.orthogonalmatrix property)": [[8, "mici.matrices.OrthogonalMatrix.transpose"]], "transpose (mici.matrices.positivedefiniteblockdiagonalmatrix property)": [[8, "mici.matrices.PositiveDefiniteBlockDiagonalMatrix.transpose"]], "transpose (mici.matrices.positivedefinitelowrankupdatematrix property)": [[8, "mici.matrices.PositiveDefiniteLowRankUpdateMatrix.transpose"]], "transpose (mici.matrices.positivedefinitematrix property)": [[8, "mici.matrices.PositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.positivediagonalmatrix property)": [[8, "mici.matrices.PositiveDiagonalMatrix.transpose"]], "transpose (mici.matrices.positivescaledidentitymatrix property)": [[8, "mici.matrices.PositiveScaledIdentityMatrix.transpose"]], "transpose (mici.matrices.scaledidentitymatrix property)": [[8, "mici.matrices.ScaledIdentityMatrix.transpose"]], "transpose (mici.matrices.scaledorthogonalmatrix property)": [[8, "mici.matrices.ScaledOrthogonalMatrix.transpose"]], "transpose (mici.matrices.softabsregularizedpositivedefinitematrix property)": [[8, "mici.matrices.SoftAbsRegularizedPositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.squareblockdiagonalmatrix property)": [[8, "mici.matrices.SquareBlockDiagonalMatrix.transpose"]], "transpose (mici.matrices.squarelowrankupdatematrix property)": [[8, "mici.matrices.SquareLowRankUpdateMatrix.transpose"]], "transpose (mici.matrices.squarematrix property)": [[8, "mici.matrices.SquareMatrix.transpose"]], "transpose (mici.matrices.squarematrixproduct property)": [[8, "mici.matrices.SquareMatrixProduct.transpose"]], "transpose (mici.matrices.symmetricblockdiagonalmatrix property)": [[8, "mici.matrices.SymmetricBlockDiagonalMatrix.transpose"]], "transpose (mici.matrices.symmetriclowrankupdatematrix property)": [[8, "mici.matrices.SymmetricLowRankUpdateMatrix.transpose"]], "transpose (mici.matrices.symmetricmatrix property)": [[8, "mici.matrices.SymmetricMatrix.transpose"]], "transpose (mici.matrices.triangularfactoreddefinitematrix property)": [[8, "mici.matrices.TriangularFactoredDefiniteMatrix.transpose"]], "transpose (mici.matrices.triangularfactoredpositivedefinitematrix property)": [[8, "mici.matrices.TriangularFactoredPositiveDefiniteMatrix.transpose"]], "transpose (mici.matrices.triangularmatrix property)": [[8, "mici.matrices.TriangularMatrix.transpose"]], "cursor_down (mici.progressbars.filedisplay attribute)": [[9, "mici.progressbars.FileDisplay.CURSOR_DOWN"]], "cursor_up (mici.progressbars.filedisplay attribute)": [[9, "mici.progressbars.FileDisplay.CURSOR_UP"]], "dummyprogressbar (class in mici.progressbars)": [[9, "mici.progressbars.DummyProgressBar"]], "filedisplay (class in mici.progressbars)": [[9, "mici.progressbars.FileDisplay"]], "glyphs (mici.progressbars.sequenceprogressbar attribute)": [[9, "mici.progressbars.SequenceProgressBar.GLYPHS"]], "labelledsequenceprogressbar (class in mici.progressbars)": [[9, "mici.progressbars.LabelledSequenceProgressBar"]], "progressbar (class in mici.progressbars)": [[9, "mici.progressbars.ProgressBar"]], "sequenceprogressbar (class in mici.progressbars)": [[9, "mici.progressbars.SequenceProgressBar"]], "bar_color (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.bar_color"]], "completed_labels (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.completed_labels"]], "counter (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.counter"]], "counter (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.counter"]], "current_label (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.current_label"]], "description (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.description"]], "description (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.description"]], "elapsed_time (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.elapsed_time"]], "empty_blocks (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.empty_blocks"]], "est_remaining_time (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.est_remaining_time"]], "filled_blocks (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.filled_blocks"]], "iter_rate (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.iter_rate"]], "mici.progressbars": [[9, "module-mici.progressbars"]], "n_block_empty (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.n_block_empty"]], "n_block_filled (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.n_block_filled"]], "n_iter (mici.progressbars.dummyprogressbar property)": [[9, "mici.progressbars.DummyProgressBar.n_iter"]], "n_iter (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.n_iter"]], "n_iter (mici.progressbars.progressbar property)": [[9, "mici.progressbars.ProgressBar.n_iter"]], "n_iter (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.n_iter"]], "partial_block (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.partial_block"]], "perc_complete (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.perc_complete"]], "postfix (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.postfix"]], "postfix (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.postfix"]], "prefix (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.prefix"]], "prefix (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.prefix"]], "progress_bar (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.progress_bar"]], "progress_bar (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.progress_bar"]], "prop_complete (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.prop_complete"]], "prop_partial_block (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.prop_partial_block"]], "refresh() (mici.progressbars.labelledsequenceprogressbar method)": [[9, "mici.progressbars.LabelledSequenceProgressBar.refresh"]], "refresh() (mici.progressbars.sequenceprogressbar method)": [[9, "mici.progressbars.SequenceProgressBar.refresh"]], "reset() (mici.progressbars.labelledsequenceprogressbar method)": [[9, "mici.progressbars.LabelledSequenceProgressBar.reset"]], "reset() (mici.progressbars.sequenceprogressbar method)": [[9, "mici.progressbars.SequenceProgressBar.reset"]], "sequence (mici.progressbars.dummyprogressbar property)": [[9, "mici.progressbars.DummyProgressBar.sequence"]], "sequence (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.sequence"]], "sequence (mici.progressbars.progressbar property)": [[9, "mici.progressbars.ProgressBar.sequence"]], "sequence (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.sequence"]], "stats (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.stats"]], "stats (mici.progressbars.sequenceprogressbar property)": [[9, "mici.progressbars.SequenceProgressBar.stats"]], "unstarted_labels (mici.progressbars.labelledsequenceprogressbar property)": [[9, "mici.progressbars.LabelledSequenceProgressBar.unstarted_labels"]], "update() (mici.progressbars.dummyprogressbar method)": [[9, "mici.progressbars.DummyProgressBar.update"]], "update() (mici.progressbars.filedisplay method)": [[9, "mici.progressbars.FileDisplay.update"]], "update() (mici.progressbars.labelledsequenceprogressbar method)": [[9, "mici.progressbars.LabelledSequenceProgressBar.update"]], "update() (mici.progressbars.progressbar method)": [[9, "mici.progressbars.ProgressBar.update"]], "update() (mici.progressbars.sequenceprogressbar method)": [[9, "mici.progressbars.SequenceProgressBar.update"]], "dynamicmultinomialhmc (class in mici.samplers)": [[10, "mici.samplers.DynamicMultinomialHMC"]], "dynamicslicehmc (class in mici.samplers)": [[10, "mici.samplers.DynamicSliceHMC"]], "hmcsamplechainsoutputs (class in mici.samplers)": [[10, "mici.samplers.HMCSampleChainsOutputs"]], "hamiltonianmontecarlo (class in mici.samplers)": [[10, "mici.samplers.HamiltonianMonteCarlo"]], "mcmcsamplechainsoutputs (class in mici.samplers)": [[10, "mici.samplers.MCMCSampleChainsOutputs"]], "markovchainmontecarlomethod (class in mici.samplers)": [[10, "mici.samplers.MarkovChainMonteCarloMethod"]], "randommetropolishmc (class in mici.samplers)": [[10, "mici.samplers.RandomMetropolisHMC"]], "staticmetropolishmc (class in mici.samplers)": [[10, "mici.samplers.StaticMetropolisHMC"]], "max_delta_h (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.max_delta_h"]], "max_delta_h (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.max_delta_h"]], "max_tree_depth (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.max_tree_depth"]], "max_tree_depth (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.max_tree_depth"]], "mici.samplers": [[10, "module-mici.samplers"]], "n_step (mici.samplers.staticmetropolishmc property)": [[10, "mici.samplers.StaticMetropolisHMC.n_step"]], "n_step_range (mici.samplers.randommetropolishmc property)": [[10, "mici.samplers.RandomMetropolisHMC.n_step_range"]], "rng (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.rng"]], "rng (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.rng"]], "rng (mici.samplers.hamiltonianmontecarlo property)": [[10, "mici.samplers.HamiltonianMonteCarlo.rng"]], "rng (mici.samplers.markovchainmontecarlomethod property)": [[10, "mici.samplers.MarkovChainMonteCarloMethod.rng"]], "rng (mici.samplers.randommetropolishmc property)": [[10, "mici.samplers.RandomMetropolisHMC.rng"]], "rng (mici.samplers.staticmetropolishmc property)": [[10, "mici.samplers.StaticMetropolisHMC.rng"]], "sample_chains() (mici.samplers.dynamicmultinomialhmc method)": [[10, "mici.samplers.DynamicMultinomialHMC.sample_chains"]], "sample_chains() (mici.samplers.dynamicslicehmc method)": [[10, "mici.samplers.DynamicSliceHMC.sample_chains"]], "sample_chains() (mici.samplers.hamiltonianmontecarlo method)": [[10, "mici.samplers.HamiltonianMonteCarlo.sample_chains"]], "sample_chains() (mici.samplers.markovchainmontecarlomethod method)": [[10, "mici.samplers.MarkovChainMonteCarloMethod.sample_chains"]], "sample_chains() (mici.samplers.randommetropolishmc method)": [[10, "mici.samplers.RandomMetropolisHMC.sample_chains"]], "sample_chains() (mici.samplers.staticmetropolishmc method)": [[10, "mici.samplers.StaticMetropolisHMC.sample_chains"]], "system (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.system"]], "system (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.system"]], "system (mici.samplers.hamiltonianmontecarlo property)": [[10, "mici.samplers.HamiltonianMonteCarlo.system"]], "system (mici.samplers.randommetropolishmc property)": [[10, "mici.samplers.RandomMetropolisHMC.system"]], "system (mici.samplers.staticmetropolishmc property)": [[10, "mici.samplers.StaticMetropolisHMC.system"]], "transitions (mici.samplers.dynamicmultinomialhmc property)": [[10, "mici.samplers.DynamicMultinomialHMC.transitions"]], "transitions (mici.samplers.dynamicslicehmc property)": [[10, "mici.samplers.DynamicSliceHMC.transitions"]], "transitions (mici.samplers.hamiltonianmontecarlo property)": [[10, "mici.samplers.HamiltonianMonteCarlo.transitions"]], "transitions (mici.samplers.markovchainmontecarlomethod property)": [[10, "mici.samplers.MarkovChainMonteCarloMethod.transitions"]], "transitions (mici.samplers.randommetropolishmc property)": [[10, "mici.samplers.RandomMetropolisHMC.transitions"]], "transitions (mici.samplers.staticmetropolishmc property)": [[10, "mici.samplers.StaticMetropolisHMC.transitions"]], "fixedpointsolver (class in mici.solvers)": [[11, "mici.solvers.FixedPointSolver"]], "projectionsolver (class in mici.solvers)": [[11, "mici.solvers.ProjectionSolver"]], "__call__() (mici.solvers.fixedpointsolver method)": [[11, "mici.solvers.FixedPointSolver.__call__"]], "__call__() (mici.solvers.projectionsolver method)": [[11, "mici.solvers.ProjectionSolver.__call__"]], "euclidean_norm() (in module mici.solvers)": [[11, "mici.solvers.euclidean_norm"]], "maximum_norm() (in module mici.solvers)": [[11, "mici.solvers.maximum_norm"]], "mici.solvers": [[11, "module-mici.solvers"]], "solve_fixed_point_direct() (in module mici.solvers)": [[11, "mici.solvers.solve_fixed_point_direct"]], "solve_fixed_point_steffensen() (in module mici.solvers)": [[11, "mici.solvers.solve_fixed_point_steffensen"]], "solve_projection_onto_manifold_newton() (in module mici.solvers)": [[11, "mici.solvers.solve_projection_onto_manifold_newton"]], "solve_projection_onto_manifold_newton_with_line_search() (in module mici.solvers)": [[11, "mici.solvers.solve_projection_onto_manifold_newton_with_line_search"]], "solve_projection_onto_manifold_quasi_newton() (in module mici.solvers)": [[11, "mici.solvers.solve_projection_onto_manifold_quasi_newton"]], "chainstage (class in mici.stagers)": [[12, "mici.stagers.ChainStage"]], "stager (class in mici.stagers)": [[12, "mici.stagers.Stager"]], "warmupstager (class in mici.stagers)": [[12, "mici.stagers.WarmUpStager"]], "windowedwarmupstager (class in mici.stagers)": [[12, "mici.stagers.WindowedWarmUpStager"]], "mici.stagers": [[12, "module-mici.stagers"]], "stages() (mici.stagers.stager method)": [[12, "mici.stagers.Stager.stages"]], "stages() (mici.stagers.warmupstager method)": [[12, "mici.stagers.WarmUpStager.stages"]], "stages() (mici.stagers.windowedwarmupstager method)": [[12, "mici.stagers.WindowedWarmUpStager.stages"]], "chainstate (class in mici.states)": [[13, "mici.states.ChainState"]], "cache_in_state() (in module mici.states)": [[13, "mici.states.cache_in_state"]], "cache_in_state_with_aux() (in module mici.states)": [[13, "mici.states.cache_in_state_with_aux"]], "copy() (mici.states.chainstate method)": [[13, "mici.states.ChainState.copy"]], "mici.states": [[13, "module-mici.states"]], "choleskyfactoredriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem"]], "constrainedeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem"]], "denseconstrainedeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem"]], "denseriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.DenseRiemannianMetricSystem"]], "diagonalriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.DiagonalRiemannianMetricSystem"]], "euclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.EuclideanMetricSystem"]], "gaussiandenseconstrainedeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem"]], "gaussianeuclideanmetricsystem (class in mici.systems)": [[14, "mici.systems.GaussianEuclideanMetricSystem"]], "riemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.RiemannianMetricSystem"]], "scalarriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.ScalarRiemannianMetricSystem"]], "softabsriemannianmetricsystem (class in mici.systems)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem"]], "system (class in mici.systems)": [[14, "mici.systems.System"]], "tractableflowsystem (class in mici.systems)": [[14, "mici.systems.TractableFlowSystem"]], "constr() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.constr"]], "constr() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.constr"]], "constr() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.constr"]], "dh1_dpos() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh1_dpos"]], "dh1_dpos() (mici.systems.system method)": [[14, "mici.systems.System.dh1_dpos"]], "dh1_dpos() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.dh1_dpos"]], "dh2_dmom() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh2_dmom"]], "dh2_dmom() (mici.systems.system method)": [[14, "mici.systems.System.dh2_dmom"]], "dh2_dmom() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.dh2_dmom"]], "dh2_dpos() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh2_dpos"]], "dh2_dpos() (mici.systems.system method)": [[14, "mici.systems.System.dh2_dpos"]], "dh2_dpos() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.dh2_dpos"]], "dh2_flow_dmom() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh2_flow_dmom"]], "dh2_flow_dmom() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.dh2_flow_dmom"]], "dh_dmom() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh_dmom"]], "dh_dmom() (mici.systems.system method)": [[14, "mici.systems.System.dh_dmom"]], "dh_dmom() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.dh_dmom"]], "dh_dpos() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.dh_dpos"]], "dh_dpos() (mici.systems.system method)": [[14, "mici.systems.System.dh_dpos"]], "dh_dpos() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.dh_dpos"]], "grad_log_det_sqrt_gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.grad_log_det_sqrt_gram"]], "grad_log_det_sqrt_gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.grad_log_det_sqrt_gram"]], "grad_log_det_sqrt_gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.grad_log_det_sqrt_gram"]], "grad_neg_log_dens() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.system method)": [[14, "mici.systems.System.grad_neg_log_dens"]], "grad_neg_log_dens() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.grad_neg_log_dens"]], "gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.gram"]], "gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.gram"]], "gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.gram"]], "h() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h"]], "h() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h"]], "h() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h"]], "h() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h"]], "h() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h"]], "h() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h"]], "h() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h"]], "h() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h"]], "h() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h"]], "h() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h"]], "h() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h"]], "h() (mici.systems.system method)": [[14, "mici.systems.System.h"]], "h() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.h"]], "h1() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h1"]], "h1() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h1"]], "h1() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h1"]], "h1() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h1"]], "h1() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h1"]], "h1() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h1"]], "h1() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h1"]], "h1() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h1"]], "h1() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h1"]], "h1() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h1"]], "h1() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h1"]], "h1() (mici.systems.system method)": [[14, "mici.systems.System.h1"]], "h1() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.h1"]], "h1_flow() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h1_flow"]], "h1_flow() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h1_flow"]], "h1_flow() (mici.systems.system method)": [[14, "mici.systems.System.h1_flow"]], "h1_flow() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.h1_flow"]], "h2() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.h2"]], "h2() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h2"]], "h2() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h2"]], "h2() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.h2"]], "h2() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.h2"]], "h2() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h2"]], "h2() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h2"]], "h2() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h2"]], "h2() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.h2"]], "h2() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.h2"]], "h2() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.h2"]], "h2() (mici.systems.system method)": [[14, "mici.systems.System.h2"]], "h2() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.h2"]], "h2_flow() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.h2_flow"]], "h2_flow() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.h2_flow"]], "hess_neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.hess_neg_log_dens"]], "inv_gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.inv_gram"]], "inv_gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.inv_gram"]], "inv_gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.inv_gram"]], "jacob_constr() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.jacob_constr"]], "jacob_constr() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.jacob_constr"]], "jacob_constr() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.jacob_constr"]], "jacob_constr_inner_product() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.jacob_constr_inner_product"]], "jacob_constr_inner_product() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.jacob_constr_inner_product"]], "jacob_constr_inner_product() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.jacob_constr_inner_product"]], "log_det_sqrt_gram() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.log_det_sqrt_gram"]], "log_det_sqrt_gram() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.log_det_sqrt_gram"]], "log_det_sqrt_gram() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.log_det_sqrt_gram"]], "metric() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.metric"]], "metric() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.metric"]], "metric() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.metric"]], "metric() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.metric"]], "metric() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.metric"]], "metric() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.metric"]], "metric_func() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.metric_func"]], "metric_func() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.metric_func"]], "mhp_constr() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.mhp_constr"]], "mhp_constr() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.mhp_constr"]], "mici.systems": [[14, "module-mici.systems"]], "mtp_neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.mtp_neg_log_dens"]], "neg_log_dens() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.neg_log_dens"]], "neg_log_dens() (mici.systems.system method)": [[14, "mici.systems.System.neg_log_dens"]], "neg_log_dens() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.neg_log_dens"]], "project_onto_cotangent_space() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.project_onto_cotangent_space"]], "project_onto_cotangent_space() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.project_onto_cotangent_space"]], "project_onto_cotangent_space() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.project_onto_cotangent_space"]], "sample_momentum() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.constrainedeuclideanmetricsystem method)": [[14, "mici.systems.ConstrainedEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.denseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.DenseConstrainedEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.euclideanmetricsystem method)": [[14, "mici.systems.EuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.gaussiandenseconstrainedeuclideanmetricsystem method)": [[14, "mici.systems.GaussianDenseConstrainedEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.gaussianeuclideanmetricsystem method)": [[14, "mici.systems.GaussianEuclideanMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.sample_momentum"]], "sample_momentum() (mici.systems.system method)": [[14, "mici.systems.System.sample_momentum"]], "sample_momentum() (mici.systems.tractableflowsystem method)": [[14, "mici.systems.TractableFlowSystem.sample_momentum"]], "vjp_metric_func() (mici.systems.choleskyfactoredriemannianmetricsystem method)": [[14, "mici.systems.CholeskyFactoredRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.denseriemannianmetricsystem method)": [[14, "mici.systems.DenseRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.diagonalriemannianmetricsystem method)": [[14, "mici.systems.DiagonalRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.riemannianmetricsystem method)": [[14, "mici.systems.RiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.scalarriemannianmetricsystem method)": [[14, "mici.systems.ScalarRiemannianMetricSystem.vjp_metric_func"]], "vjp_metric_func() (mici.systems.softabsriemannianmetricsystem method)": [[14, "mici.systems.SoftAbsRiemannianMetricSystem.vjp_metric_func"]], "correlatedmomentumtransition (class in mici.transitions)": [[15, "mici.transitions.CorrelatedMomentumTransition"]], "dynamicintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.DynamicIntegrationTransition"]], "independentmomentumtransition (class in mici.transitions)": [[15, "mici.transitions.IndependentMomentumTransition"]], "integrationtransition (class in mici.transitions)": [[15, "mici.transitions.IntegrationTransition"]], "metropolisintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MetropolisIntegrationTransition"]], "metropolisrandomintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition"]], "metropolisstaticintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition"]], "momentumtransition (class in mici.transitions)": [[15, "mici.transitions.MomentumTransition"]], "multinomialdynamicintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition"]], "slicedynamicintegrationtransition (class in mici.transitions)": [[15, "mici.transitions.SliceDynamicIntegrationTransition"]], "transition (class in mici.transitions)": [[15, "mici.transitions.Transition"]], "euclidean_no_u_turn_criterion() (in module mici.transitions)": [[15, "mici.transitions.euclidean_no_u_turn_criterion"]], "mici.transitions": [[15, "module-mici.transitions"]], "riemannian_no_u_turn_criterion() (in module mici.transitions)": [[15, "mici.transitions.riemannian_no_u_turn_criterion"]], "sample() (mici.transitions.correlatedmomentumtransition method)": [[15, "mici.transitions.CorrelatedMomentumTransition.sample"]], "sample() (mici.transitions.dynamicintegrationtransition method)": [[15, "mici.transitions.DynamicIntegrationTransition.sample"]], "sample() (mici.transitions.independentmomentumtransition method)": [[15, "mici.transitions.IndependentMomentumTransition.sample"]], "sample() (mici.transitions.integrationtransition method)": [[15, "mici.transitions.IntegrationTransition.sample"]], "sample() (mici.transitions.metropolisintegrationtransition method)": [[15, "mici.transitions.MetropolisIntegrationTransition.sample"]], "sample() (mici.transitions.metropolisrandomintegrationtransition method)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition.sample"]], "sample() (mici.transitions.metropolisstaticintegrationtransition method)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition.sample"]], "sample() (mici.transitions.momentumtransition method)": [[15, "mici.transitions.MomentumTransition.sample"]], "sample() (mici.transitions.multinomialdynamicintegrationtransition method)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition.sample"]], "sample() (mici.transitions.slicedynamicintegrationtransition method)": [[15, "mici.transitions.SliceDynamicIntegrationTransition.sample"]], "sample() (mici.transitions.transition method)": [[15, "mici.transitions.Transition.sample"]], "state_variables (mici.transitions.correlatedmomentumtransition property)": [[15, "mici.transitions.CorrelatedMomentumTransition.state_variables"]], "state_variables (mici.transitions.dynamicintegrationtransition property)": [[15, "mici.transitions.DynamicIntegrationTransition.state_variables"]], "state_variables (mici.transitions.independentmomentumtransition property)": [[15, "mici.transitions.IndependentMomentumTransition.state_variables"]], "state_variables (mici.transitions.integrationtransition property)": [[15, "mici.transitions.IntegrationTransition.state_variables"]], "state_variables (mici.transitions.metropolisintegrationtransition property)": [[15, "mici.transitions.MetropolisIntegrationTransition.state_variables"]], "state_variables (mici.transitions.metropolisrandomintegrationtransition property)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition.state_variables"]], "state_variables (mici.transitions.metropolisstaticintegrationtransition property)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition.state_variables"]], "state_variables (mici.transitions.momentumtransition property)": [[15, "mici.transitions.MomentumTransition.state_variables"]], "state_variables (mici.transitions.multinomialdynamicintegrationtransition property)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition.state_variables"]], "state_variables (mici.transitions.slicedynamicintegrationtransition property)": [[15, "mici.transitions.SliceDynamicIntegrationTransition.state_variables"]], "state_variables (mici.transitions.transition property)": [[15, "mici.transitions.Transition.state_variables"]], "statistic_types (mici.transitions.correlatedmomentumtransition property)": [[15, "mici.transitions.CorrelatedMomentumTransition.statistic_types"]], "statistic_types (mici.transitions.dynamicintegrationtransition property)": [[15, "mici.transitions.DynamicIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.independentmomentumtransition property)": [[15, "mici.transitions.IndependentMomentumTransition.statistic_types"]], "statistic_types (mici.transitions.integrationtransition property)": [[15, "mici.transitions.IntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.metropolisintegrationtransition property)": [[15, "mici.transitions.MetropolisIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.metropolisrandomintegrationtransition property)": [[15, "mici.transitions.MetropolisRandomIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.metropolisstaticintegrationtransition property)": [[15, "mici.transitions.MetropolisStaticIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.momentumtransition property)": [[15, "mici.transitions.MomentumTransition.statistic_types"]], "statistic_types (mici.transitions.multinomialdynamicintegrationtransition property)": [[15, "mici.transitions.MultinomialDynamicIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.slicedynamicintegrationtransition property)": [[15, "mici.transitions.SliceDynamicIntegrationTransition.statistic_types"]], "statistic_types (mici.transitions.transition property)": [[15, "mici.transitions.Transition.statistic_types"]], "mici.types": [[16, "module-mici.types"]], "logrepfloat (class in mici.utils)": [[17, "mici.utils.LogRepFloat"]], "hash_array() (in module mici.utils)": [[17, "mici.utils.hash_array"]], "log1m_exp() (in module mici.utils)": [[17, "mici.utils.log1m_exp"]], "log1p_exp() (in module mici.utils)": [[17, "mici.utils.log1p_exp"]], "log_diff_exp() (in module mici.utils)": [[17, "mici.utils.log_diff_exp"]], "log_sum_exp() (in module mici.utils)": [[17, "mici.utils.log_sum_exp"]], "mici.utils": [[17, "module-mici.utils"]], "val (mici.utils.logrepfloat property)": [[17, "mici.utils.LogRepFloat.val"]]}}) \ No newline at end of file