The kernel definitional equality test (t =?= s) has special support for id_delta applications. It implements the following rules
- (id_delta t) =?= t
- t =?= (id_delta t)
- (id_delta t) =?= s IF (unfold_of t) =?= s
- t =?= id_delta s IF t =?= (unfold_of s)
This is mechanism for controlling the delta reduction (aka unfolding) used in the kernel.
We use id_delta applications to address performance problems when type checking lemmas generated by the equation compiler.
Instances for punit
        
        - punit.has_sizeof
- unit.has_repr
- unit.has_to_string
- unit.has_to_format
- punit.reflect
- option_t.monad_except
- punit.subsingleton
- punit.inhabited
- punit.reflect'
- punit.unique
- punit.linear_order
- punit.densely_ordered
- punit.biheyting_algebra
- punit.boolean_algebra
- punit.complete_boolean_algebra
- unit.fintype
- punit.fintype
- punit.countable
- punit.encodable
- punit.comm_group
- punit.add_comm_group
- punit.comm_ring
- punit.cancel_comm_monoid_with_zero
- punit.normalized_gcd_monoid
- punit.canonically_ordered_add_monoid
- punit.linear_ordered_cancel_add_comm_monoid
- punit.has_smul
- punit.is_central_scalar
- punit.smul_comm_class
- punit.is_scalar_tower
- punit.smul_with_zero
- punit.mul_action
- punit.distrib_mul_action
- punit.mul_distrib_mul_action
- punit.mul_semiring_action
- punit.mul_action_with_zero
- punit.module
- punit.algebra
- punit.boolean_ring
- punit.topological_space
- punit.discrete_topology
- punit.bornology
- punit.uniform_space
- punit.metric_space
- punit.normed_add_comm_group
- punit.normed_comm_ring
- punit.normed_algebra
- punit.nonempty_fin_lin_ord
- punit.measurable_space
- punit.measurable_singleton_class
- measure_theory.measure.punit.measure_theory.measure_space
- unit.borel_space
- primcodable.unit
- fin_enum.punit
- punit.json_serializable
Instances for true
        
        
    Instances for false
        
        
    Logical not.
not P, with notation ¬ P, is the Prop which is true if and only if P is false. It is
internally represented as P → false, so one way to prove a goal ⊢ ¬ P is to use intro h,
which gives you a new hypothesis h : P and the goal ⊢ false.
A hypothesis h : ¬ P can be used in term mode as a function, so if w : P then h w : false.
Related mathlib tactic: contrapose.
Instances for not
        
        
    - refl : ∀ {α : Sort u} (a : α), a = a
Instances for eq
        
        - decidable_eq_of_subsingleton
- eq.decidable
- fin_enum.dec_eq
- con.quotient.decidable_eq
- add_con.quotient.decidable_eq
- conj_classes.decidable_eq
- bool.decidable_eq
- prod.decidable_eq
- nat.decidable_eq
- quotient.decidable_eq
- list.decidable_eq
- char.decidable_eq
- string.has_decidable_eq
- fin.decidable_eq
- unsigned.decidable_eq
- ordering.decidable_eq
- name.has_decidable_eq
- option.decidable_eq
- options.has_decidable_eq
- level.has_decidable_eq
- pos.decidable_eq
- expr.has_decidable_eq
- local_context.has_decidable_eq
- punit.decidable_eq
- tactic.binder_info.has_decidable_eq
- vm_obj_kind.decidable_eq
- expr.coord.has_dec_eq
- expr.address.has_dec_eq
- eq_is_equiv
- int.decidable_eq
- subtype.decidable_eq
- d_array.decidable_eq
- array.decidable_eq
- native.float.dec_eq
- json.decidable_eq
- widget.filter_type.decidable_eq
- widget.local_collection.decidable_eq
- feature_search.feature.decidable_eq
- feature_search.predictor_type.decidable_eq
- doc_category.decidable_eq
- empty.decidable_eq
- pempty.decidable_eq
- rbnode.color.decidable_eq
- binder_info.decidable_eq
- congr_arg_kind.decidable_eq
- binder.decidable_eq
- pexpr.decidable_eq
- widget_override.filter_type.decidable_eq
- widget_override.local_collection.decidable_eq
- tactic.transparency.decidable_eq
- function.decidable_eq_pfun
- lint_verbosity.decidable_eq
- auto.auto_config.decidable_eq
- auto.case_option.decidable_eq
- tactic.itauto.and_kind.decidable_eq
- tactic.itauto.prop.decidable_eq
- norm_cast.label.decidable_eq
- tactic.simp_arg_type.decidable_eq
- tactic.suggest.head_symbol_match.decidable_eq
- sigma.decidable_eq
- psigma.decidable_eq
- sum.decidable_eq
- units.decidable_eq
- add_units.decidable_eq
- tactic.interactive.mono_selection.decidable_eq
- plift.decidable_eq
- ulift.decidable_eq
- pnat.decidable_eq
- tactic.interactive.mono_function.decidable_eq
- multiset.has_decidable_eq
- multiset.decidable_eq_pi_multiset
- expr_lens.dir.decidable_eq
- finset.has_decidable_eq
- finset.decidable_eq_pi_finset
- vector.decidable_eq
- fintype.decidable_pi_fintype
- fintype.decidable_eq_equiv_fintype
- fintype.decidable_eq_embedding_fintype
- fintype.decidable_eq_one_hom_fintype
- fintype.decidable_eq_zero_hom_fintype
- fintype.decidable_eq_mul_hom_fintype
- fintype.decidable_eq_add_hom_fintype
- fintype.decidable_eq_monoid_hom_fintype
- fintype.decidable_eq_add_monoid_hom_fintype
- fintype.decidable_eq_monoid_with_zero_hom_fintype
- fintype.decidable_eq_ring_hom_fintype
- nat.coprime.decidable
- ulower.decidable_eq
- rat.decidable_eq
- tactic.ring.normalize_mode.decidable_eq
- linarith.ineq.decidable_eq
- prod.lex.decidable_eq
- pos_num.decidable_eq
- num.decidable_eq
- znum.decidable_eq
- tree.decidable_eq
- dfinsupp.decidable_zero
- dfinsupp.decidable_eq
- finsupp.decidable_eq
- alist.decidable_eq
- zmod.decidable_eq
- cycle.decidable_eq
- mv_polynomial.decidable_eq_mv_polynomial
- tactic.ring_exp.coeff.decidable_eq
- tactic.ring_exp.ex_type.decidable_eq
- category_theory.decidable_eq_of_unop
- nat.partition.decidable_eq
- adjoin_root.decidable_eq
- category_theory.discrete.decidable_eq
- category_theory.limits.walking_parallel_pair.decidable_eq
- category_theory.limits.walking_parallel_pair_hom.decidable_eq
- category_theory.limits.wide_pullback_shape.hom.decidable_eq
- category_theory.limits.wide_pushout_shape.hom.decidable_eq
- category_theory.limits.walking_pair.decidable_eq
- free_group.decidable_eq
- Group.surjective_of_epi_auxs.X_with_infinity.decidable_eq
- tactic.decl_reducibility.decidable_eq
- tactic.positivity.strictness.decidable_eq
- free_magma.decidable_eq
- free_add_magma.decidable_eq
- free_semigroup.decidable_eq
- free_add_semigroup.decidable_eq
- real.decidable_eq
- complex.decidable_eq
- sign_type.decidable_eq
- category_theory.bicone.decidable_eq
- category_theory.bicone_hom.decidable_eq
- tropical.decidable_eq
- box_integral.integration_params.decidable_eq
- semidirect_product.decidable_eq
- category_theory.limits.walking_parallel_family.decidable_eq
- category_theory.limits.walking_parallel_family.hom.decidable_eq
- two_pointing.decidable_eq
- simple_graph.dart.decidable_eq
- simple_graph.walk.decidable_eq
- finpartition.decidable_eq
- nzsnum.decidable_eq
- snum.decidable_eq
- computability.Γ'.decidable_eq
- turing.dir.decidable_eq
- turing.fin_tm2.K.decidable_eq
- turing.to_partrec.code.decidable_eq
- turing.partrec_to_TM2.Γ'.decidable_eq
- turing.partrec_to_TM2.K'.decidable_eq
- turing.partrec_to_TM2.cont'.decidable_eq
- turing.partrec_to_TM2.Λ'.decidable_eq
- buffer.decidable_eq
- finmap.has_decidable_eq
- thunk.decidable_eq
- lazy_list.decidable_eq
- free_product.word.decidable_eq
- free_product.word.free_product.decidable_eq
- dihedral_group.decidable_eq
- quaternion_group.decidable_eq
- hamming.decidable_eq
- uchange.decidable_eq
- zsqrtd.decidable_eq
- lucas_lehmer.X.decidable_eq
- lists'.decidable_eq
- lists.decidable_eq
- finsets.decidable_eq
- onote.decidable_eq
- nonote.decidable_eq
- omega.nat.preterm.decidable_eq
- polyrith.poly.decidable_eq
- side.decidable_eq
- tactic.rewrite_search.side.decidable_eq
- tactic.ring2.horner_expr.decidable_eq
- slim_check.eq.printable_prop
- slim_check.bool.printable_prop
- refl : ∀ {α : Sort u} (a : α), a == a
Heterogeneous equality.
Its purpose is to write down equalities between terms whose types are not definitionally equal.
For example, given x : vector α n and y : vector α (0+n), x = y doesn't typecheck but x == y does.
If you have a goal ⊢ x == y,
your first instinct should be to ask (either yourself, or on zulip)
if something has gone wrong already.
If you really do need to follow this route,
you may find the lemmas eq_rec_heq and eq_mpr_heq useful.
- fst : α
- snd : β
Instances for prod
        
        - prod.noncompact_space_left
- prod.noncompact_space_right
- continuous_map.homotopy_like.to_continuous_map_class
- prod.has_sizeof
- prod.inhabited
- prod.has_well_founded
- prod.has_repr
- lift_pair
- lift_pair₁
- lift_pair₂
- prod.has_to_string
- prod.has_to_format
- prod.has_to_tactic_format
- prod.has_reflect
- tactic_doc_entry.has_to_string
- subsingleton.prod
- prod.nonempty
- function.has_uncurry_induction
- prod.is_empty_left
- prod.is_empty_right
- prod.is_refl_left
- prod.is_refl_right
- prod.lex.is_trans
- prod.lex.is_antisymm
- prod.is_total_left
- prod.is_total_right
- nontrivial_prod_right
- nontrivial_prod_left
- prod.has_le
- prod.preorder
- prod.partial_order
- prod.lex.is_well_founded
- prod.lex.is_well_order
- prod.is_refl_preimage_fst
- prod.is_refl_preimage_snd
- prod.is_trans_preimage_fst
- prod.is_trans_preimage_snd
- prod.has_sup
- prod.has_inf
- prod.semilattice_sup
- prod.semilattice_inf
- prod.lattice
- prod.distrib_lattice
- prod.has_top
- prod.has_bot
- prod.order_top
- prod.order_bot
- prod.bounded_order
- prod.has_himp
- prod.has_hnot
- prod.has_sdiff
- prod.has_compl
- prod.generalized_heyting_algebra
- prod.generalized_coheyting_algebra
- prod.heyting_algebra
- prod.coheyting_algebra
- prod.has_mul
- prod.has_add
- prod.has_one
- prod.has_zero
- prod.has_inv
- prod.has_neg
- prod.has_involutive_inv
- prod.has_involutive_neg
- prod.has_div
- prod.has_sub
- prod.mul_zero_class
- prod.semigroup
- prod.add_semigroup
- prod.comm_semigroup
- prod.add_comm_semigroup
- prod.semigroup_with_zero
- prod.mul_one_class
- prod.add_zero_class
- prod.monoid
- prod.add_monoid
- prod.div_inv_monoid
- prod.sub_neg_monoid
- prod.division_monoid
- prod.subtraction_monoid
- prod.division_comm_monoid
- prod.subtraction_comm_monoid
- prod.group
- prod.add_group
- prod.left_cancel_semigroup
- prod.left_cancel_add_semigroup
- prod.right_cancel_semigroup
- prod.right_cancel_add_semigroup
- prod.left_cancel_monoid
- prod.left_cancel_add_monoid
- prod.right_cancel_monoid
- prod.right_cancel_add_monoid
- prod.cancel_monoid
- prod.cancel_add_monoid
- prod.comm_monoid
- prod.add_comm_monoid
- prod.cancel_comm_monoid
- prod.cancel_add_comm_monoid
- prod.mul_zero_one_class
- prod.monoid_with_zero
- prod.comm_monoid_with_zero
- prod.comm_group
- prod.add_comm_group
- tactic.interactive.mono_key.has_lt
- prod.ordered_comm_monoid
- prod.ordered_add_comm_monoid
- prod.ordered_cancel_comm_monoid
- prod.ordered_cancel_add_comm_monoid
- prod.has_exists_mul_of_le
- prod.has_exists_add_of_le
- prod.canonically_ordered_monoid
- prod.canonically_ordered_add_monoid
- prod.ordered_comm_group
- prod.ordered_add_comm_group
- prod.has_Sup
- prod.has_Inf
- prod.complete_lattice
- prod.add_monoid_with_one
- prod.add_group_with_one
- prod.fintype
- prod.infinite_of_right
- prod.infinite_of_left
- prod.has_smul
- prod.has_vadd
- prod.has_pow
- prod.is_scalar_tower
- prod.smul_comm_class
- prod.vadd_comm_class
- prod.is_central_scalar
- prod.has_faithful_smul_left
- prod.has_faithful_vadd_left
- prod.has_faithful_smul_right
- prod.has_faithful_vadd_right
- prod.smul_comm_class_both
- prod.vadd_comm_class_both
- prod.is_scalar_tower_both
- prod.mul_action
- prod.add_action
- prod.distrib_mul_action
- prod.mul_distrib_mul_action
- prod.encodable
- finite.prod.finite
- denumerable.prod
- prod.add_torsor
- prod.distrib
- prod.non_unital_non_assoc_semiring
- prod.non_unital_semiring
- prod.non_assoc_semiring
- prod.semiring
- prod.non_unital_comm_semiring
- prod.comm_semiring
- prod.non_unital_non_assoc_ring
- prod.non_unital_ring
- prod.non_assoc_ring
- prod.ring
- prod.non_unital_comm_ring
- prod.comm_ring
- prod.smul_with_zero
- prod.mul_action_with_zero
- prod.module
- prod.no_zero_smul_divisors
- prod.omega_complete_partial_order
- prod.algebra
- con.has_mem
- add_con.has_mem
- prod.locally_finite_order
- prod.locally_finite_order_top
- prod.locally_finite_order_bot
- prod.countable
- small_prod
- nat.lcm.char_p
- prod.char_p
- is_noetherian_prod
- module.finite.prod
- algebra.finite_type.prod
- category_theory.prod
- category_theory.uniform_prod
- category_theory.groupoid_prod
- category_theory.prod_category_instance_1
- category_theory.prod_category_instance_2
- prod.bifunctor
- prod.is_lawful_bifunctor
- category_theory.monoidal_category.prod_monoidal
- module.free.prod
- prod.topological_space
- prod.discrete_topology
- topological_space.prod.first_countable_topology
- topological_space.prod.second_countable_topology
- prod.compact_space
- locally_compact_space.prod
- prod.preconnected_space
- prod.connected_space
- prod.totally_disconnected_space
- prod.t0_space
- prod.t1_space
- prod.t2_space
- prod.has_continuous_const_smul
- prod.has_continuous_const_vadd
- prod.has_continuous_smul
- prod.has_continuous_vadd
- prod.has_continuous_mul
- prod.has_continuous_add
- prod.has_continuous_inv
- prod.has_continuous_neg
- prod.topological_group
- prod.topological_add_group
- prod.topological_semiring
- prod.topological_ring
- prod.order_closed_topology
- solvable_prod
- prod.ordered_smul
- prod.Sup_convergence_class
- prod.Inf_convergence_class
- prod.compact_Icc_space
- prod.uniform_space
- complete_space.prod
- uniform_space.separated.prod
- prod.pseudo_emetric_space_max
- prod.emetric_space_max
- prod.bornology
- prod.bounded_space
- prod.pseudo_metric_space_max
- prod.metric_space_max
- prod.uniform_group
- prod.uniform_add_group
- prod.has_star
- prod.has_involutive_star
- prod.star_semigroup
- prod.star_add_monoid
- prod.star_ring
- prod.star_module
- prod.has_continuous_star
- prod.seminormed_add_comm_group
- prod.normed_add_comm_group
- prod.norm_one_class
- prod.non_unital_semi_normed_ring
- prod.semi_normed_ring
- prod.non_unital_normed_ring
- prod.normed_ring
- prod.normed_space
- prod.normed_algebra
- prod.cstar_ring
- path.has_uncurry_path
- localized_module.r.setoid
- prod.measurable_space
- topological_space.pseudo_metrizable_space_prod
- topological_space.metrizable_space_prod
- prod.opens_measurable_space
- prod.borel_space
- measure_theory.measure.prod.measure_space
- prod.locally_convex_space
- sym2.rel.setoid
- young_diagram.prod.set_like
- primcodable.prod
- prod.bitraversable
- prod.is_lawful_bitraversable
- fin_enum.prod
- is_artinian_prod
- prod_charted_space
- smooth_manifold_with_corners.prod
- has_smooth_mul.prod
- has_smooth_add.sum
- prod.lie_group
- prod.lie_add_group
- prod.rootable_by
- prod.divisible_by
- is_nilpotent_prod
- nonarchimedean_group.prod.nonarchimedean_group
- nonarchimedean_add_group.prod.nonarchimedean_add_group
- nonarchimedean_ring.prod.nonarchimedean_ring
- prod.has_variable_names
- slim_check.prod.sampleable
- bundle.prod.topological_vector_bundle
- fst : α
- snd : β
Similar to prod, but α and β can be propositions.
We use this type internally to automatically generate the brec_on recursor.
- left : a
- right : b
Logical and.
and P Q, with notation P ∧ Q, is the Prop which is true precisely when P and Q are
both true.
To prove a goal ⊢ P ∧ Q, you can use the tactic split,
which gives two separate goals ⊢ P and ⊢ Q.
Given a hypothesis h : P ∧ Q, you can use the tactic cases h with hP hQ
to obtain two new hypotheses hP : P and hQ : Q. See also the obtain or rcases tactics in
mathlib.
Instances for sum
        
        - sum.has_sizeof
- sum.inhabited_left
- sum.inhabited_right
- sum.has_repr
- sum.has_to_string
- sum_has_to_format
- sum.has_reflect
- sum.monad
- sum.is_lawful_functor
- sum.is_lawful_monad
- sum.traversable
- sum.is_empty
- sum.fintype
- sum.infinite_of_left
- sum.infinite_of_right
- sum.encodable
- finite.sum.finite
- denumerable.sum
- sum.countable
- small_sum
- sum.lift_rel.is_refl
- sum.lift_rel.is_irrefl
- sum.lift_rel.is_trans
- sum.lift_rel.is_antisymm
- sum.lex.is_refl
- sum.lex.is_irrefl
- sum.lex.is_trans
- sum.lex.is_antisymm
- sum.lex.is_total
- sum.lex.is_trichotomous
- sum.lex.is_well_order
- sum.has_le
- sum.has_lt
- sum.preorder
- sum.partial_order
- sum.no_min_order
- sum.no_max_order
- sum.densely_ordered
- sum.bifunctor
- sum.is_lawful_bifunctor
- sum.is_lawful_traversable
- sum.topological_space
- sum.discrete_topology
- topological_space.sum.second_countable_topology
- sum.compact_space
- sum.totally_disconnected_space
- sum.t2_space
- sum.uniform_space
- complete_space.sum
- sum.measurable_space
- polish_space.sum
- category_theory.sum
- primcodable.sum
- sum.bitraversable
- sum.is_lawful_bitraversable
- fin_enum.sum
- sum.locally_finite_order
- sum.has_smul
- sum.has_vadd
- sum.is_scalar_tower
- sum.smul_comm_class
- sum.vadd_comm_class
- sum.is_central_scalar
- sum.has_faithful_smul_left
- sum.has_faithful_vadd_left
- sum.has_faithful_smul_right
- sum.has_faithful_vadd_right
- sum.mul_action
- sum.add_action
- slim_check.sum.sampleable
Instances for psum
        
        
    Logical or.
or P Q, with notation P ∨ Q, is the proposition which is true if and only if P or Q is
true.
To prove a goal ⊢ P ∨ Q, if you know which alternative you want to prove,
you can use the tactics left (which gives the goal ⊢ P)
or right (which gives the goal ⊢ Q).
Given a hypothesis h : P ∨ Q and goal ⊢ R,
the tactic cases h will give you two copies of the goal ⊢ R,
with the hypothesis h : P in the first, and the hypothesis h : Q in the second.
Instances for or
        
        
    - fst : α
- snd : β self.fst
Instances for sigma
        
        - sigma.has_sizeof
- sigma.has_repr
- sigma.has_to_string
- sigma.has_to_format
- sigma.is_empty_left
- sigma.inhabited
- sigma.reflect
- sigma.fintype
- sigma.encodable
- finite.sigma.finite
- denumerable.sigma
- sigma.countable
- small_sigma
- matrix.sigma_sigma_fin_matrix_has_reflect
- sigma.topological_space
- sigma.discrete_topology
- topological_space.sigma.second_countable_topology
- sigma.compact_space
- sigma.totally_disconnected_space
- sigma.t2_space
- sigma.measurable_space
- polish_space.sigma
- category_theory.sigma.sigma_hom.sigma.category_theory.category_struct
- category_theory.sigma.sigma
- fin_enum.sigma.fin_enum
- sigma.lex.is_refl
- sigma.lex.is_irrefl
- sigma.lex.is_trans
- sigma.lex.is_symm
- sigma.lex.is_antisymm
- sigma.lex.is_total
- sigma.lex.is_trichotomous
- sigma.has_le
- sigma.has_lt
- sigma.preorder
- sigma.partial_order
- sigma.locally_finite_order
- sigma.has_smul
- sigma.has_vadd
- sigma.is_scalar_tower
- sigma.smul_comm_class
- sigma.vadd_comm_class
- sigma.is_central_scalar
- sigma.has_faithful_smul
- sigma.has_faithful_vadd
- sigma.mul_action
- sigma.add_action
- sigma.has_variable_names
- slim_check.sigma.sampleable
- fst : α
- snd : β self.fst
Instances for psigma
        
        - psigma.has_sizeof
- psigma.has_well_founded
- psigma.inhabited
- psigma.fintype
- psigma.fintype_prop_left
- psigma.fintype_prop_right
- psigma.fintype_prop_prop
- finite.psigma.finite
- psigma.countable
- fin_enum.psigma.fin_enum
- fin_enum.psigma.fin_enum_prop_left
- fin_enum.psigma.fin_enum_prop_right
- fin_enum.psigma.fin_enum_prop_prop
- psigma.has_variable_names
Instances for bool
        
        - bool.has_sizeof
- bool.inhabited
- bool.has_repr
- coe_bool_to_Prop
- coe_sort_bool
- bool.has_to_string
- bool.has_to_format
- bool.has_reflect
- json.bool_coe
- bool.linear_order
- bool.nontrivial
- bool.distrib_lattice
- bool.bounded_order
- bool.boolean_algebra
- bool.fintype
- bool.countable
- bool.encodable
- bool.is_simple_order
- bool.boolean_ring
- bool.topological_space
- bool.discrete_topology
- bool.uniform_space
- bool.complete_linear_order
- bool.complete_boolean_algebra
- bool.measurable_space
- bool.measurable_singleton_class
- bool.borel_space
- primcodable.bool
- bool.random
- bool.bounded_random
- bool.non_null_json_serializable
- bool.has_variable_names
- slim_check.bool.sampleable
- val : α
- property : p self.val
Instances for subtype
        
        - zero_lt.pos_mul_strict_mono.to_pos_mul_mono
- zero_lt.mul_pos_strict_mono.to_mul_pos_mono
- zero_lt.pos_mul_mono_rev.to_pos_mul_reflect_lt
- zero_lt.mul_pos_mono_rev.to_mul_pos_reflect_lt
- zero_lt.pos_mul_strict_mono.to_pos_mul_mono_rev
- zero_lt.mul_pos_strict_mono.to_mul_pos_mono_rev
- ordered_semiring.pos_mul_strict_mono
- ordered_semiring.mul_pos_strict_mono
- canonically_ordered_comm_semiring.canonically_ordered_comm_semiring.pos_mul_mono
- canonically_ordered_comm_semiring.canonically_ordered_comm_semiring.mul_pos_mono
- subtype.countable
- subtype.has_sizeof
- subtype.has_repr
- coe_subtype
- subtype.has_to_string
- subtype.has_to_format
- subtype.subsingleton
- subtype.can_lift
- subtype.is_empty
- subtype.is_empty_false
- subtype.has_equiv
- subtype.setoid
- unique.subtype_eq
- unique.subtype_eq'
- subtype.has_le
- subtype.has_lt
- subtype.preorder
- subtype.partial_order
- subtype.linear_order
- nonempty_lt
- nonempty_gt
- with_bot.zero_lt.pos_mul_mono
- with_bot.zero_lt.mul_pos_mono
- positive.subtype.has_add
- positive.subtype.add_semigroup
- positive.subtype.add_comm_semigroup
- positive.subtype.add_left_cancel_semigroup
- positive.subtype.add_right_cancel_semigroup
- positive.covariant_class_add_lt
- positive.covariant_class_swap_add_lt
- positive.contravariant_class_add_lt
- positive.contravariant_class_swap_add_lt
- positive.contravariant_class_add_le
- positive.contravariant_class_swap_add_le
- positive.covariant_class_add_le
- positive.subtype.has_mul
- positive.nat.has_pow
- positive.subtype.semigroup
- positive.subtype.distrib
- positive.subtype.has_one
- positive.subtype.monoid
- positive.subtype.ordered_comm_monoid
- positive.subtype.linear_ordered_cancel_comm_monoid
- fintype.subtype_eq
- fintype.subtype_eq'
- list.subtype.fintype
- multiset.subtype.fintype
- finset.subtype.fintype
- subtype.fintype
- subtype.encodable
- subtype.finite
- set.finite.inhabited
- subtype.locally_finite_order
- subtype.locally_finite_order_top
- subtype.locally_finite_order_bot
- small_subtype
- is_well_order.subtype_nonempty
- fintype_nodup_list
- cycle.fintype_nodup_cycle
- cycle.fintype_nodup_nontrivial_cycle
- is_idempotent_elem.subtype.has_zero
- is_idempotent_elem.subtype.has_one
- is_idempotent_elem.subtype.has_compl
- free_group.subtype.fintype
- filter.inhabited_mem
- subtype.topological_space
- subtype.discrete_topology
- subtype.totally_disconnected_space
- subtype.t0_space
- subtype.t1_space
- subtype.t2_space
- subtype.t3_space
- subtype.order_closed_topology
- nonneg.order_bot
- nonneg.no_max_order
- nonneg.semilattice_inf
- nonneg.densely_ordered
- nonneg.inhabited
- nonneg.has_zero
- nonneg.has_add
- nonneg.has_nsmul
- nonneg.ordered_add_comm_monoid
- nonneg.linear_ordered_add_comm_monoid
- nonneg.ordered_cancel_add_comm_monoid
- nonneg.linear_ordered_cancel_add_comm_monoid
- nonneg.archimedean
- nonneg.has_one
- nonneg.has_mul
- nonneg.add_monoid_with_one
- nonneg.has_pow
- nonneg.ordered_semiring
- nonneg.ordered_comm_semiring
- nonneg.monoid_with_zero
- nonneg.comm_monoid_with_zero
- nonneg.nontrivial
- nonneg.linear_ordered_semiring
- nonneg.linear_ordered_comm_monoid_with_zero
- nonneg.canonically_ordered_add_monoid
- nonneg.canonically_ordered_comm_semiring
- nonneg.canonically_linear_ordered_add_monoid
- nonneg.has_inv
- nonneg.has_div
- nonneg.has_zpow
- nonneg.linear_ordered_semifield
- nonneg.linear_ordered_comm_group_with_zero
- nonneg.canonically_linear_ordered_semifield
- nonneg.floor_semiring
- nonneg.has_sub
- nonneg.has_ordered_sub
- subtype.uniform_space
- subtype.pseudo_emetric_space
- subtype.emetric_space
- subtype.bornology
- subtype.bounded_space
- subtype.pseudo_metric_space
- subtype.metric_space
- complex_shape.subsingleton_next
- complex_shape.subsingleton_prev
- positive.subtype.has_inv
- positive.int.has_pow
- positive.subtype.linear_ordered_comm_group
- subtype.measurable_space
- subtype.measurable_singleton_class
- measurable_set.subtype.has_mem
- measurable_set.subtype.has_emptyc
- measurable_set.subtype.has_insert
- measurable_set.subtype.has_compl
- measurable_set.subtype.has_union
- measurable_set.subtype.has_inter
- measurable_set.subtype.has_sdiff
- measurable_set.subtype.has_bot
- measurable_set.subtype.has_top
- measurable_set.subtype.partial_order
- measurable_set.subtype.distrib_lattice
- measurable_set.subtype.bounded_order
- measurable_set.subtype.boolean_algebra
- is_Lprojection.subtype.has_compl
- is_Lprojection.subtype.has_inf
- is_Lprojection.subtype.has_sup
- is_Lprojection.subtype.has_sdiff
- is_Lprojection.subtype.partial_order
- is_Lprojection.subtype.has_zero
- is_Lprojection.subtype.has_one
- is_Lprojection.subtype.bounded_order
- is_Lprojection.subtype.distrib_lattice
- is_Lprojection.subtype.boolean_algebra
- category_theory.unbundled_hom.bundled_hom
- setoid.partition.le
- setoid.partition.partial_order
- setoid.partition.complete_lattice
- nat.upto.has_lt
- fin_enum.subtype.fin_enum
- subtype.json_serializable
- subtype.non_null_json_serializable
- irrational.subtype.order_topology
- irrational.subtype.no_max_order
- irrational.subtype.no_min_order
- irrational.subtype.densely_ordered
- ωCPO.omega_complete_partial_order_equalizer
- subtype.has_variable_names
- slim_check.nat_le.sampleable
- slim_check.nat_ge.sampleable
- slim_check.nat_gt.sampleable
- slim_check.le.sampleable
- slim_check.ge.sampleable
- slim_check.int_le.sampleable
- slim_check.int_ge.sampleable
- slim_check.int_lt.sampleable
- slim_check.int_gt.sampleable
- slim_check.perm.slim_check
- slim_check.perm'.slim_check
- slim_check.injective_function.pi_injective.sampleable_ext
Instances of this typeclass
- decidable_eq_of_subsingleton
- has_lt.lt.decidable
- has_le.le.decidable
- eq.decidable
- fin_enum.dec_eq
- con.quotient.decidable_eq
- add_con.quotient.decidable_eq
- conj_classes.decidable_eq
- decidable.true
- decidable.false
- and.decidable
- or.decidable
- not.decidable
- implies.decidable
- iff.decidable
- xor.decidable
- exists_prop_decidable
- forall_prop_decidable
- ne.decidable
- bool.decidable_eq
- ite.decidable
- dite.decidable
- prod.decidable_eq
- nat.decidable_eq
- nat.decidable_le
- nat.decidable_lt
- quotient.decidable_eq
- list.decidable_eq
- list.decidable_mem
- list.has_decidable_lt
- list.has_decidable_le
- char.decidable_lt
- char.decidable_le
- char.decidable_eq
- string.has_decidable_lt
- string.has_decidable_eq
- fin.decidable_lt
- fin.decidable_le
- fin.decidable_eq
- unsigned.decidable_eq
- ordering.decidable_eq
- coe_decidable_eq
- name.lt.decidable_rel
- name.has_decidable_eq
- option.decidable_eq
- options.has_decidable_eq
- level.has_decidable_eq
- pos.decidable_eq
- expr.has_decidable_eq
- expr.lt_prop.decidable_rel
- local_context.has_decidable_eq
- local_context.decidable_rel
- local_context.has_mem.mem.decidable
- punit.decidable_eq
- tactic.binder_info.has_decidable_eq
- vm_obj_kind.decidable_eq
- expr.coord.has_dec_eq
- expr.address.has_dec_eq
- nat.decidable_dvd
- list.decidable_bex
- list.decidable_ball
- int.decidable_eq
- int.decidable_le
- int.decidable_lt
- char.decidable_is_whitespace
- char.decidable_is_upper
- char.decidable_is_lower
- char.decidable_is_alpha
- char.decidable_is_digit
- char.decidable_is_alphanum
- char.decidable_is_punctuation
- subtype.decidable_eq
- d_array.decidable_eq
- array.decidable_eq
- native.float.decidable_lt
- native.float.decidable_le
- native.float.dec_eq
- json.decidable_eq
- widget.filter_type.decidable_eq
- widget.local_collection.decidable_eq
- feature_search.feature.decidable_eq
- feature_search.predictor_type.decidable_eq
- option.decidable_forall_mem
- option.decidable_exists_mem
- doc_category.decidable_eq
- empty.decidable_eq
- pempty.decidable_eq
- rbnode.color.decidable_eq
- list.decidable_pairwise
- list.decidable_chain
- list.decidable_chain'
- list.nodup_decidable
- binder_info.decidable_eq
- congr_arg_kind.decidable_eq
- binder.decidable_eq
- pexpr.decidable_eq
- widget_override.filter_type.decidable_eq
- widget_override.local_collection.decidable_eq
- tactic.transparency.decidable_eq
- bool.decidable_forall_bool
- bool.decidable_exists_bool
- function.decidable_eq_pfun
- lint_verbosity.decidable_eq
- auto.auto_config.decidable_eq
- auto.case_option.decidable_eq
- tactic.itauto.and_kind.decidable_eq
- tactic.itauto.prop.decidable_eq
- tactic.itauto.has_lt.lt.decidable_rel
- norm_cast.label.decidable_eq
- tactic.simp_arg_type.decidable_eq
- tactic.suggest.head_symbol_match.decidable_eq
- quot.lift.decidable_pred
- quot.lift₂.decidable_pred
- quot.lift_on.decidable
- quot.lift_on₂.decidable
- quotient.lift.decidable_pred
- quotient.lift₂.decidable_pred
- quotient.lift_on.decidable
- quotient.lift_on₂.decidable
- quotient.lift_on'.decidable
- quotient.lift_on₂'.decidable
- prod.lex.decidable
- sigma.decidable_eq
- psigma.decidable_eq
- sum.decidable_eq
- sum.lift_rel.decidable
- sum.lex.decidable_rel
- order.preimage.decidable
- subtype.decidable_le
- subtype.decidable_lt
- units.decidable_eq
- add_units.decidable_eq
- is_unit.decidable
- with_bot.decidable_le
- with_bot.decidable_lt
- with_top.decidable_le
- with_top.decidable_lt
- set.decidable_sdiff
- set.decidable_inter
- set.decidable_union
- set.decidable_compl
- set.decidable_emptyset
- set.decidable_univ
- set.decidable_set_of
- set.decidable_mem_prod
- set.decidable_mem_diagonal
- set.compl.decidable_mem
- tactic.interactive.mono_selection.decidable_eq
- set.decidable_mem_Ioo
- set.decidable_mem_Ico
- set.decidable_mem_Iio
- set.decidable_mem_Icc
- set.decidable_mem_Iic
- set.decidable_mem_Ioc
- set.decidable_mem_Ici
- set.decidable_mem_Ioi
- nat.decidable_ball_lt
- nat.decidable_forall_fin
- nat.decidable_ball_le
- nat.decidable_lo_hi
- nat.decidable_lo_hi_le
- nat.decidable_exists_lt
- nat.decidable_exists_le
- plift.decidable_eq
- ulift.decidable_eq
- int.decidable_dvd
- pnat.decidable_eq
- list.decidable_sublist
- list.all₂.decidable_pred
- list.decidable_prefix
- list.decidable_suffix
- list.decidable_infix
- list.lex.decidable_rel
- tactic.interactive.mono_function.decidable_eq
- list.decidable_perm
- multiset.has_decidable_eq
- multiset.decidable_mem
- multiset.decidable_dforall_multiset
- multiset.decidable_eq_pi_multiset
- multiset.decidable_dexists_multiset
- multiset.nodup_decidable
- expr_lens.dir.decidable_eq
- finset.has_decidable_eq
- finset.decidable_mem
- finset.decidable_mem'
- finset.decidable_nonempty
- finset.decidable_dforall_finset
- finset.decidable_eq_pi_finset
- finset.decidable_dexists_finset
- finset.decidable_disjoint
- vector.decidable_eq
- finset.decidable_exists_of_decidable_subsets
- finset.decidable_forall_of_decidable_subsets
- finset.decidable_exists_of_decidable_ssubsets
- finset.decidable_forall_of_decidable_ssubsets
- list.decidable_sorted
- list.decidable_duplicate
- setoid.decidable_rel
- sym.decidable_mem
- fintype.decidable_pi_fintype
- fintype.decidable_forall_fintype
- fintype.decidable_exists_fintype
- fintype.decidable_mem_range_fintype
- fintype.decidable_eq_equiv_fintype
- fintype.decidable_eq_embedding_fintype
- fintype.decidable_eq_one_hom_fintype
- fintype.decidable_eq_zero_hom_fintype
- fintype.decidable_eq_mul_hom_fintype
- fintype.decidable_eq_add_hom_fintype
- fintype.decidable_eq_monoid_hom_fintype
- fintype.decidable_eq_add_monoid_hom_fintype
- fintype.decidable_eq_monoid_with_zero_hom_fintype
- fintype.decidable_eq_ring_hom_fintype
- fintype.decidable_injective_fintype
- fintype.decidable_surjective_fintype
- fintype.decidable_bijective_fintype
- fintype.decidable_right_inverse_fintype
- fintype.decidable_left_inverse_fintype
- nat.coprime.decidable
- ulower.decidable_eq
- rat.decidable_eq
- rat.decidable_nonneg
- rat.decidable_le
- string.decidable_lt
- string.decidable_le
- set.decidable_mem_mul
- set.decidable_mem_add
- set.decidable_mem_pow
- set.decidable_mem_nsmul
- monoid_hom.decidable_mem_mker
- add_monoid_hom.decidable_mem_mker
- set.decidable_mem_center
- subsemigroup.decidable_mem_center
- add_subsemigroup.decidable_mem_center
- set.decidable_mem_centralizer
- set.decidable_mem_add_centralizer
- subsemigroup.decidable_mem_centralizer
- add_subsemigroup.decidable_mem_centralizer
- submonoid.decidable_mem_center
- submonoid.decidable_mem_centralizer
- add_submonoid.decidable_mem_centralizer
- conj_classes.is_conj.decidable_rel
- pairwise.decidable
- finset.sup_indep.decidable
- subgroup.decidable_mem_center
- monoid_hom.decidable_mem_range
- add_monoid_hom.decidable_mem_range
- monoid_hom.decidable_mem_ker
- add_monoid_hom.decidable_mem_ker
- subsemiring.decidable_mem_center
- subring.decidable_mem_center
- tactic.ring.normalize_mode.decidable_eq
- linarith.ineq.decidable_eq
- prod.lex.decidable_eq
- pos_num.decidable_eq
- num.decidable_eq
- znum.decidable_eq
- pos_num.decidable_lt
- pos_num.decidable_le
- num.decidable_lt
- num.decidable_le
- znum.decidable_lt
- znum.decidable_le
- tree.decidable_eq
- associated.decidable_rel
- associates.has_dvd.dvd.decidable_rel
- dfinsupp.decidable_zero
- dfinsupp.decidable_eq
- finsupp.decidable_eq
- alist.decidable_eq
- alist.has_mem.mem.decidable
- part.none_decidable
- part.some_decidable
- part.of_option_decidable
- part_enat.dom.decidable
- part_enat.decidable_le
- function.is_fixed_pt.decidable
- function.fixed_points.decidable
- quotient_group.left_rel_decidable
- quotient_add_group.left_rel_decidable
- quotient_group.right_rel_decidable
- quotient_add_group.right_rel_decidable
- finsupp.decidable_le
- is_square_decidable
- nat.decidable_prime
- list.is_rotated_decidable
- list.setoid.r.decidable
- nat.modeq.decidable
- int.modeq.decidable
- zmod.decidable_eq
- cycle.decidable_eq
- cycle.has_mem.mem.decidable
- cycle.nontrivial.decidable
- cycle.nodup.decidable
- function.is_periodic_pt.decidable
- decidable_powers
- decidable_multiples
- decidable_zpowers
- decidable_zmultiples
- mv_polynomial.decidable_eq_mv_polynomial
- polynomial.monic.decidable
- nat.even.decidable_pred
- nat.odd.decidable_pred
- polynomial.is_root.decidable
- polynomial.trailing_monic.decidable
- tactic.ring_exp.coeff.decidable_eq
- tactic.ring_exp.ex_type.decidable_eq
- category_theory.decidable_eq_of_unop
- nat.partition.decidable_eq
- equiv.perm.r.decidable_rel
- equiv.perm.same_cycle.decidable_rel
- multiplicity.decidable_nat
- multiplicity.decidable_int
- equiv.perm.sum_congr_hom.decidable_mem_range
- equiv.perm.sigma_congr_right_hom.decidable_mem_range
- equiv.perm.subtype_congr_hom.decidable_mem_range
- adjoin_root.decidable_eq
- category_theory.discrete.decidable_eq
- category_theory.limits.walking_parallel_pair.decidable_eq
- category_theory.limits.walking_parallel_pair_hom.decidable_eq
- category_theory.limits.wide_pullback_shape.hom.decidable_eq
- category_theory.limits.wide_pushout_shape.hom.decidable_eq
- category_theory.limits.walking_pair.decidable_eq
- free_group.decidable_eq
- free_group.red.decidable_rel
- antisymm_rel.decidable_rel
- Group.surjective_of_epi_auxs.X_with_infinity.decidable_eq
- is_prime_pow.decidable
- seq.terminated_at_decidable
- generalized_continued_fraction.terminated_at_decidable
- tactic.decl_reducibility.decidable_eq
- tactic.positivity.strictness.decidable_eq
- free_magma.decidable_eq
- free_add_magma.decidable_eq
- free_semigroup.decidable_eq
- free_add_semigroup.decidable_eq
- int.even.decidable_pred
- int.odd.decidable_pred
- real.decidable_lt
- real.decidable_le
- real.decidable_eq
- complex.decidable_eq
- sign_type.decidable_eq
- sign_type.le.decidable_rel
- nat.squarefree.decidable_pred
- category_theory.bicone.decidable_eq
- category_theory.bicone_hom.decidable_eq
- tropical.decidable_eq
- tropical.decidable_le
- tropical.decidable_lt
- box_integral.integration_params.has_le.le.decidable_rel
- box_integral.integration_params.decidable_eq
- semidirect_product.decidable_eq
- category_theory.limits.walking_parallel_family.decidable_eq
- category_theory.limits.walking_parallel_family.hom.decidable_eq
- two_pointing.decidable_eq
- mul_salem_spencer.decidable
- add_salem_spencer.decidable
- colex.decidable_lt
- derangements.decidable_pred
- sym2.mem.decidable
- sym2.is_diag.decidable_pred
- sym2.from_rel.decidable_pred
- sym2.rel.decidable_rel
- simple_graph.bot.adj_decidable
- simple_graph.sup.adj_decidable
- simple_graph.inf.adj_decidable
- simple_graph.sdiff.adj_decidable
- simple_graph.top.adj_decidable
- simple_graph.compl.adj_decidable
- simple_graph.neighbor_set.mem_decidable
- simple_graph.decidable_mem_edge_set
- simple_graph.dart.decidable_eq
- simple_graph.decidable_mem_incidence_set
- simple_graph.decidable_mem_common_neighbors
- simple_graph.subgraph.neighbor_set.decidable_pred
- simple_graph.walk.decidable_eq
- matrix.is_adj_matrix.adj.decidable_rel
- simple_graph.is_clique.decidable
- simple_graph.is_n_clique.decidable
- finpartition.decidable_eq
- bitvec.ult.decidable
- bitvec.ugt.decidable
- nzsnum.decidable_eq
- snum.decidable_eq
- num.decidable_dvd
- pos_num.decidable_dvd
- znum.has_dvd.dvd.decidable_rel
- computability.Γ'.decidable_eq
- regular_expression.matches.decidable_pred
- turing.dir.decidable_eq
- turing.fin_tm2.K.decidable_eq
- turing.to_partrec.code.decidable_eq
- turing.partrec_to_TM2.Γ'.decidable_eq
- turing.partrec_to_TM2.K'.decidable_eq
- turing.partrec_to_TM2.cont'.decidable_eq
- turing.partrec_to_TM2.Λ'.decidable_eq
- buffer.decidable_eq
- list.palindrome.decidable
- dfinsupp.decidable_le
- finmap.has_decidable_eq
- finmap.has_mem.mem.decidable
- finmap.disjoint.decidable_rel
- fp.dec_valid_finite
- int.decidable_le_lt
- int.decidable_le_le
- int.decidable_lt_lt
- int.decidable_lt_le
- thunk.decidable_eq
- lazy_list.decidable_eq
- lazy_list.mem.decidable
- pos_num.decidable_prime
- num.decidable_prime
- ordnode.all.decidable
- ordnode.any.decidable
- ordnode.emem.decidable
- ordnode.amem.decidable
- ordnode.equiv.decidable_rel
- ordnode.mem.decidable
- ordnode.balanced_sz.dec
- ordnode.balanced.dec
- ordset.empty.decidable_pred
- ordset.mem.decidable
- pnat.decidable_pred_exists_nat
- sigma.lex.decidable
- psigma.lex.decidable
- irrational.decidable
- mv_polynomial.decidable_restrict_degree
- free_product.word.decidable_eq
- free_product.word.free_product.decidable_eq
- dihedral_group.decidable_eq
- quaternion_group.decidable_eq
- hamming.decidable_eq
- uchange.decidable_eq
- zsqrtd.decidable_eq
- zsqrtd.decidable_nonnegg
- zsqrtd.decidable_nonneg
- zsqrtd.decidable_le
- lucas_lehmer.lucas_lehmer_test.decidable_pred
- lucas_lehmer.X.decidable_eq
- heyting.is_regular.decidable_pred
- pgame.le_decidable
- pgame.lf_decidable
- pgame.lt_decidable
- pgame.equiv_decidable
- lists'.decidable_eq
- lists.decidable_eq
- lists.equiv.decidable
- lists.subset.decidable
- lists.mem.decidable
- finsets.decidable_eq
- onote.decidable_eq
- onote.decidable_top_below
- onote.decidable_NF
- nonote.decidable_eq
- omega.nat.preterm.decidable_eq
- polyrith.poly.decidable_eq
- side.decidable_eq
- tactic.rewrite_search.side.decidable_eq
- tactic.ring2.horner_expr.decidable_eq
Instances of other typeclasses for decidable
        
        
    Equations
- decidable_pred r = Π (a : α), decidable (r a)
Equations
- decidable_rel r = Π (a b : α), decidable (r a b)
Equations
Instances for option
        
        - option.has_sizeof
- option.has_repr
- coe_option
- option.has_to_string
- option.monad
- option.alternative
- option.inhabited
- option.has_to_format
- tactic.opt_to_tac
- option.has_to_tactic_format
- option.has_reflect
- option.is_lawful_monad
- option.has_mem
- option.lift_or_get_comm
- option.lift_or_get_assoc
- option.lift_or_get_idem
- option.lift_or_get_is_left_id
- option.lift_or_get_is_right_id
- option.traversable
- option.unique
- option.nontrivial
- option.fintype
- option.infinite
- option.encodable
- denumerable.option
- part.has_coe
- option.countable
- option.is_lawful_traversable
- primcodable.option
- option.json_serializable
- option.has_smul
- option.has_vadd
- option.is_scalar_tower
- option.smul_comm_class
- option.vadd_comm_class
- option.is_central_scalar
- option.has_faithful_smul
- option.has_faithful_vadd
- option.mul_action
- option.has_variable_names
- json.has_coe
Instances for list
        
        - list.has_sizeof
- list.inhabited
- list.has_append
- list.has_mem
- list.has_emptyc
- list.has_insert
- list.has_singleton
- list.is_lawful_singleton
- list.has_union
- list.has_inter
- list.has_lt
- list.has_le
- list.has_repr
- lift_list
- list.has_to_string
- list.has_to_format
- list.has_to_tactic_format
- tactic.andthen_seq_focus
- list.reflect
- list.has_subset
- list.monad
- list.is_lawful_monad
- list.alternative
- list.bin_tree_to_list
- json.array_coe
- widget.html.list_coe
- list.has_sdiff
- list.traversable
- list.reflect'
- list.unique_of_is_empty
- list.nil.is_left_id
- list.nil.is_right_id
- list.has_append.append.is_associative
- list.can_lift
- list.is_prefix.is_partial_order
- list.is_suffix.is_partial_order
- list.is_infix.is_partial_order
- list.sublist_forall₂.is_refl
- list.sublist_forall₂.is_trans
- list.lex.is_order_connected
- list.lex.is_trichotomous
- list.lex.is_asymm
- list.lex.is_strict_total_order
- list.has_lt'
- list.linear_order
- list.has_le'
- list.zip_with.is_symm_op
- list.is_setoid
- multiset.has_coe
- list.infinite
- list.encodable
- list.countable
- denumerable.denumerable_list
- small_list
- cycle.has_coe
- seq.coe_list
- list.is_lawful_traversable
- primcodable.list
- language.has_mem
- language.has_singleton
- language.has_insert
- list.non_null_json_serializable
- wseq.coe_list
- list.has_variable_names
- slim_check.list.sampleable
- list.topological_space
Instances for nat
        
        - polynomial.has_pow
- algebra_nat
- no_zero_smul_divisors.char_zero.no_zero_smul_divisors_nat
- nat.cast_coe
- nat.has_zero
- nat.has_one
- nat.has_add
- nat.has_sizeof
- nat.has_le
- nat.has_lt
- nat.has_sub
- nat.has_mul
- nat.has_dvd
- nat.inhabited
- nat.has_div
- nat.has_mod
- nat.has_repr
- nat.has_to_string
- nat_to_format
- nat.has_to_format
- nat.reflect
- nat.linear_order
- int.has_coe
- native.float.of_nat_coe
- native.float.has_nat_pow
- nat.can_lift
- monoid.has_pow
- add_monoid.has_smul_nat
- nat.well_founded_lt
- nat.lt.is_well_order
- nat.distrib_lattice
- add_monoid.nat_smul_comm_class
- add_monoid.nat_smul_comm_class'
- with_zero.nat.has_pow
- nat.nontrivial
- nat.comm_semiring
- nat.linear_ordered_semiring
- nat.linear_ordered_cancel_add_comm_monoid
- nat.linear_ordered_comm_monoid_with_zero
- nat.ordered_comm_semiring
- nat.add_comm_monoid
- nat.add_monoid
- nat.monoid
- nat.comm_monoid
- nat.comm_semigroup
- nat.semigroup
- nat.add_comm_semigroup
- nat.add_semigroup
- nat.distrib
- nat.semiring
- nat.ordered_semiring
- nat.order_bot
- nat.canonically_ordered_comm_semiring
- nat.canonically_linear_ordered_add_monoid
- nat.cancel_comm_monoid_with_zero
- nat.has_ordered_sub
- positive.nat.has_pow
- coe_pnat_nat
- nat.can_lift_pnat
- non_unital_non_assoc_semiring.nat_smul_comm_class
- non_unital_non_assoc_semiring.nat_is_scalar_tower
- fin.fin_to_nat
- nat.infinite
- add_monoid.nat_smul_with_zero
- nat.countable
- nat.encodable
- add_comm_monoid.nat_module
- add_comm_monoid.nat_is_scalar_tower
- nat.has_Inf
- nat.has_Sup
- nat.lattice
- nat.conditionally_complete_linear_order_bot
- denumerable.nat
- add_submonoid_class.has_nsmul
- submonoid_class.has_pow
- add_subgroup.has_nsmul
- subgroup.has_npow
- dfinsupp.has_nat_scalar
- finsupp.has_nat_scalar
- add_con.quotient.has_nsmul
- con.nat.has_pow
- nat.locally_finite_order
- nat.succ_order
- nat.pred_order
- nat.is_succ_archimedean
- nat.is_pred_archimedean
- enat.nat.can_lift
- cardinal.can_lift_cardinal_nat
- nat.primes.coe_nat
- nat.modeq.is_refl
- self_adjoint.nat.has_pow
- nat.wf_dvd_monoid
- nat.unique_factorization_monoid
- nat.gcd_monoid
- nat.normalized_gcd_monoid
- category_theory.linear.preadditive_nat_linear
- category_theory.functor.nat_linear
- nat.floor_semiring
- nat.archimedean
- nat.topological_space
- nat.discrete_topology
- add_monoid.has_continuous_const_smul_nat
- add_monoid.has_continuous_smul_nat
- graded_monoid.nat.has_pow
- nat.ordered_smul
- nonneg.has_nsmul
- nonneg.has_pow
- nat.uniform_space
- add_monoid.has_uniform_continuous_const_smul_nat
- nat.has_dist
- nat.metric_space
- nat.proper_space
- nat.noncompact_space
- normed_add_group_hom.has_nat_scalar
- gcd_monoid.gcd.is_idempotent
- homological_complex.has_nat_scalar
- continuous_map.has_nsmul
- continuous_map.has_pow
- homogeneous_localization.num_denom_same_deg.nat.has_pow
- homogeneous_localization.has_pow
- set.Icc.has_pow
- set.Ioc.has_pow
- lie_module_hom.has_nsmul
- ring_quot.nat.has_pow
- fractional_ideal.has_smul
- fractional_ideal.nat.has_pow
- localized_module.has_nat_smul
- nat.measurable_space
- nat.measurable_singleton_class
- monoid.has_measurable_pow
- add_monoid.has_measurable_smul_nat₂
- bounded_continuous_function.has_nat_scalar
- bounded_continuous_function.has_nat_pow
- nat.borel_space
- measure_theory.simple_func.has_nat_pow
- filter.germ.has_nat_pow
- matrix.special_linear_group.nat.has_pow
- measure_theory.ae_eq_fun.nat.has_pow
- regular_expression.nat.has_pow
- nat_bounded_random
- nat.non_null_json_serializable
- left_invariant_derivation.has_nat_scalar
- quotient_group.rootable_by
- quotient_add_group.divisible_by
- witt_vector.has_nat_scalar
- witt_vector.has_nat_pow
- truncated_witt_vector.has_nat_scalar
- truncated_witt_vector.has_nat_pow
- polyrith.nat.has_pow
- nat.has_variable_names
- slim_check.nat.sampleable
- zero_at_infty_continuous_map.has_nat_scalar
Instances for unification_constraint
        
        
    - pattern : unification_constraint
- constraints : list unification_constraint
Instances for unification_hint
        
        
    - zero : α
Instances of this typeclass
- add_zero_class.to_has_zero
- mul_zero_class.to_has_zero
- nat.has_zero
- int.has_zero
- fin.has_zero
- unsigned.has_zero
- native.float.has_zero
- order_dual.has_zero
- lex.has_zero
- zero_hom.has_zero
- add_hom.has_zero
- add_monoid_hom.has_zero
- additive.has_zero
- mul_opposite.has_zero
- add_opposite.has_zero
- pi.has_zero
- with_zero.has_zero
- prod.has_zero
- with_top.has_zero
- with_bot.has_zero
- non_unital_ring_hom.has_zero
- multiset.has_zero
- sym.has_zero
- rat.has_zero
- ulift.has_zero
- zero_mem_class.has_zero
- add_submonoid.has_zero
- add_subgroup.has_zero
- distrib_mul_action_hom.has_zero
- num.has_zero
- znum.has_zero
- linear_map.has_zero
- sub_mul_action.has_zero
- submodule.has_zero
- associates.has_zero
- dfinsupp.has_zero
- finsupp.has_zero
- linear_equiv.has_zero
- part.has_zero
- non_unital_alg_hom.has_zero
- add_con.quotient.has_zero
- enat.has_zero
- part_enat.has_zero
- cardinal.has_zero
- submodule.quotient.has_quotient.quotient.has_zero
- polynomial.has_zero
- ordinal.has_zero
- add_localization.has_zero
- localization.has_zero
- is_idempotent_elem.subtype.has_zero
- matrix.has_zero
- multilinear_map.has_zero
- alternating_map.has_zero
- perfect_closure.has_zero
- unitization.has_zero
- category_theory.limits.has_zero_morphisms.has_zero
- AddMon.filtered_colimits.colimit_has_zero
- cubic.has_zero
- triv_sq_zero_ext.has_zero
- dmatrix.has_zero
- cau_seq.has_zero
- cau_seq.completion.Cauchy.has_zero
- real.has_zero
- nonneg.has_zero
- ennreal.has_zero
- complex.has_zero
- group_seminorm.has_zero
- add_group_seminorm.has_zero
- continuous_linear_map.has_zero
- affine_map.has_zero
- normed_add_group_hom.has_zero
- sign_type.has_zero
- nat.arithmetic_function.has_zero
- mv_power_series.has_zero
- hahn_series.has_zero
- hahn_series.summable_family.has_zero
- ratfunc.has_zero
- add_freiman_hom.has_zero
- homological_complex.quiver.hom.has_zero
- continuous_map.has_zero
- homogeneous_localization.num_denom_same_deg.has_zero
- homogeneous_localization.has_zero
- set.Icc.has_zero
- set.Ico.has_zero
- unit_interval.has_zero
- lie_hom.has_zero
- lie_module_hom.has_zero
- lie_subalgebra.has_zero
- lie_submodule.has_zero
- ring_quot.has_zero
- free_lie_algebra.has_zero
- bilin_form.has_zero
- fractional_ideal.has_zero
- localized_module.has_zero
- order_add_monoid_hom.has_zero
- quaternion_algebra.has_zero
- non_unital_star_alg_hom.has_zero
- sym_alg.has_zero
- tropical.has_zero
- continuous_multilinear_map.has_zero
- box_integral.box_additive_map.has_zero
- measure_theory.outer_measure.has_zero
- measure_theory.measure.has_zero
- ereal.has_zero
- bounded_continuous_function.has_zero
- measure_theory.simple_func.has_zero
- filter.germ.has_zero
- measure_theory.ae_eq_fun.has_zero
- continuous_affine_map.has_zero
- convex_cone.has_zero
- uniform_space.completion.has_zero
- seminorm.has_zero
- derivation.has_zero
- is_Lprojection.subtype.has_zero
- measure_theory.vector_measure.has_zero
- measure_theory.jordan_decomposition.has_zero
- language.has_zero
- bitvec.has_zero
- snum.has_zero
- ε_NFA.has_zero
- regular_expression.has_zero
- holor.has_zero
- smooth_add_monoid_morphism.has_zero
- smooth_map.has_zero
- left_invariant_derivation.has_zero
- hamming.has_zero
- quadratic_form.has_zero
- measure_theory.finite_measure.has_zero
- zsqrtd.has_zero
- poly.has_zero
- padic.has_zero
- padic_int.has_zero
- valuation_ring.value_group.has_zero
- ore_localization.has_zero
- witt_vector.has_zero
- truncated_witt_vector.has_zero
- pgame.has_zero
- nat_ordinal.has_zero
- onote.has_zero
- nonote.has_zero
- surreal.has_zero
- tactic.ring2.horner_expr.has_zero
- locally_constant.has_zero
- zero_at_infty_continuous_map.has_zero
- cube.has_zero
- one : α
Instances of this typeclass
- mul_one_class.to_has_one
- add_monoid_with_one.to_has_one
- nat.has_one
- int.has_one
- fin.has_one
- unsigned.has_one
- native.float.has_one
- order_dual.has_one
- lex.has_one
- one_hom.has_one
- mul_hom.has_one
- monoid_hom.has_one
- multiplicative.has_one
- mul_opposite.has_one
- add_opposite.has_one
- pi.has_one
- with_one.has_one
- with_zero.has_one
- prod.has_one
- with_top.has_one
- with_bot.has_one
- positive.subtype.has_one
- pnat.has_one
- rat.has_one
- ulift.has_one
- one_mem_class.has_one
- submonoid.has_one
- add_submonoid.has_one
- conj_classes.has_one
- subgroup.has_one
- distrib_mul_action_hom.has_one
- pos_num.has_one
- num.has_one
- znum.has_one
- linear_map.module.End.has_one
- associates.has_one
- part.has_one
- non_unital_alg_hom.has_one
- con.quotient.has_one
- part_enat.has_one
- cardinal.has_one
- monoid_algebra.has_one
- add_monoid_algebra.has_one
- polynomial.has_one
- ordinal.has_one
- sub_mul_action.has_one
- submodule.has_one
- ideal.quotient.has_one
- localization.has_one
- is_idempotent_elem.subtype.has_one
- self_adjoint.has_one
- matrix.has_one
- category_theory.End.has_one
- algebra.tensor_product.tensor_product.has_one
- unitization.has_one
- free_group.has_one
- free_abelian_group.has_one
- Mon.filtered_colimits.colimit_has_one
- graded_monoid.ghas_one.to_has_one
- graded_monoid.grade_zero.has_one
- direct_sum.has_one
- triv_sq_zero_ext.has_one
- cau_seq.has_one
- cau_seq.completion.Cauchy.has_one
- real.has_one
- nonneg.has_one
- complex.has_one
- continuous_linear_map.has_one
- sign_type.has_one
- nat.arithmetic_function.has_one
- mv_power_series.has_one
- hahn_series.has_one
- ratfunc.has_one
- freiman_hom.has_one
- continuous_map.has_one
- homogeneous_localization.num_denom_same_deg.has_one
- homogeneous_localization.has_one
- set.Icc.has_one
- set.Ioc.has_one
- unit_interval.has_one
- lie_hom.has_one
- lie_equiv.has_one
- lie_module_hom.has_one
- lie_module_equiv.has_one
- ring_quot.has_one
- fractional_ideal.has_one
- order_monoid_hom.has_one
- quaternion_algebra.has_one
- sym_alg.has_one
- tropical.has_one
- bounded_continuous_function.has_one
- measure_theory.simple_func.has_one
- filter.germ.has_one
- matrix.special_linear_group.has_one
- measure_theory.ae_eq_fun.has_one
- uniform_space.completion.has_one
- is_Lprojection.subtype.has_one
- language.has_one
- bitvec.has_one
- nzsnum.has_one
- snum.has_one
- ε_NFA.has_one
- regular_expression.has_one
- smooth_monoid_morphism.has_one
- smooth_map.has_one
- zsqrtd.has_one
- poly.has_one
- mul_char.has_one
- lucas_lehmer.X.has_one
- padic.has_one
- padic_int.has_one
- valuation_ring.value_group.has_one
- ore_localization.has_one
- witt_vector.has_one
- truncated_witt_vector.has_one
- pgame.has_one
- nat_ordinal.has_one
- onote.has_one
- surreal.has_one
- tactic.ring2.horner_expr.has_one
- locally_constant.has_one
- cube.has_one
- add : α → α → α
Instances of this typeclass
- add_semigroup.to_has_add
- add_zero_class.to_has_add
- distrib.to_has_add
- add_mem_class.has_add
- nat.has_add
- options.has_add
- int.has_add
- fin.has_add
- unsigned.has_add
- native.float.has_add
- order_dual.has_add
- lex.has_add
- add_hom.has_add
- add_monoid_hom.has_add
- additive.has_add
- mul_opposite.has_add
- add_opposite.has_add
- pi.has_add
- with_zero.has_add
- prod.has_add
- with_top.has_add
- with_bot.has_add
- positive.subtype.has_add
- pnat.has_add
- multiset.has_add
- rat.has_add
- ulift.has_add
- add_submonoid.has_add
- add_subgroup.has_add
- pos_num.has_add
- num.has_add
- znum.has_add
- linear_map.has_add
- submodule.has_add
- dfinsupp.has_add
- dfinsupp.has_add₂
- finsupp.has_add
- part.has_add
- add_con.has_add
- part_enat.has_add
- cardinal.has_add
- polynomial.has_add
- ordinal.has_add
- add_localization.has_add
- localization.has_add
- matrix.has_add
- multilinear_map.has_add
- alternating_map.has_add
- perfect_closure.has_add
- unitization.has_add
- AddMon.filtered_colimits.colimit_has_add
- AddMagma.has_add
- triv_sq_zero_ext.has_add
- free_add_magma.has_add
- dmatrix.has_add
- cau_seq.has_add
- cau_seq.completion.Cauchy.has_add
- real.has_add
- nonneg.has_add
- complex.has_add
- group_seminorm.has_add
- add_group_seminorm.has_add
- continuous_linear_map.has_add
- affine_map.has_add
- normed_add_group_hom.has_add
- nat.arithmetic_function.has_add
- hahn_series.has_add
- hahn_series.summable_family.has_add
- ratfunc.has_add
- add_freiman_hom.has_add
- homological_complex.quiver.hom.has_add
- continuous_map.has_add
- homogeneous_ideal.has_add
- homogeneous_localization.num_denom_same_deg.has_add
- homogeneous_localization.has_add
- lie_module_hom.has_add
- ring_quot.has_add
- free_lie_algebra.has_add
- bilin_form.has_add
- fractional_ideal.has_add
- localized_module.has_add
- order_add_monoid_hom.has_add
- quaternion_algebra.has_add
- sym_alg.has_add
- tropical.has_add
- continuous_multilinear_map.has_add
- box_integral.box_additive_map.has_add
- measure_theory.outer_measure.has_add
- measure_theory.measure.has_add
- bounded_continuous_function.has_add
- measure_theory.simple_func.has_add
- filter.germ.has_add
- measure_theory.ae_eq_fun.has_add
- continuous_affine_map.has_add
- uniform_space.completion.has_add
- seminorm.has_add
- derivation.has_add
- measure_theory.vector_measure.has_add
- language.has_add
- bitvec.has_add
- snum.has_add
- many_one_degree.has_add
- regular_expression.has_add
- fp.float.has_add
- holor.has_add
- smooth_map.has_add
- left_invariant_derivation.has_add
- hamming.has_add
- quadratic_form.has_add
- measure_theory.finite_measure.has_add
- zsqrtd.has_add
- poly.has_add
- padic.has_add
- padic_int.has_add
- ore_localization.has_add
- witt_vector.has_add
- truncated_witt_vector.has_add
- pgame.has_add
- nat_ordinal.has_add
- onote.has_add
- nonote.has_add
- surreal.has_add
- polyrith.poly.has_add
- tactic.ring2.horner_expr.has_add
- locally_constant.has_add
- zero_at_infty_continuous_map.has_add
- mul : α → α → α
Instances of this typeclass
- semigroup.to_has_mul
- mul_one_class.to_has_mul
- mul_zero_class.to_has_mul
- distrib.to_has_mul
- mul_mem_class.has_mul
- nat.has_mul
- int.has_mul
- fin.has_mul
- unsigned.has_mul
- native.float.has_mul
- order_dual.has_mul
- lex.has_mul
- mul_hom.has_mul
- monoid_hom.has_mul
- monoid_with_zero_hom.has_mul
- multiplicative.has_mul
- mul_opposite.has_mul
- add_opposite.has_mul
- pi.has_mul
- with_one.has_mul
- prod.has_mul
- positive.subtype.has_mul
- pnat.has_mul
- rat.has_mul
- ulift.has_mul
- submonoid.has_mul
- add_submonoid.has_mul
- subgroup.has_mul
- pos_num.has_mul
- num.has_mul
- znum.has_mul
- linear_map.module.End.has_mul
- associates.has_mul
- part.has_mul
- con.has_mul
- cardinal.has_mul
- monoid_algebra.has_mul
- add_monoid_algebra.has_mul
- polynomial.has_mul
- sub_mul_action.has_mul
- submodule.has_mul
- ideal.quotient.has_mul
- ideal.has_mul
- localization.has_mul
- self_adjoint.has_mul
- matrix.has_mul
- category_theory.End.has_mul
- perfect_closure.has_mul
- unitization.has_mul
- free_group.has_mul
- free_abelian_group.has_mul
- Mon.filtered_colimits.colimit_has_mul
- Magma.has_mul
- graded_monoid.ghas_mul.to_has_mul
- graded_monoid.grade_zero.has_mul
- triv_sq_zero_ext.has_mul
- free_magma.has_mul
- cau_seq.has_mul
- cau_seq.completion.Cauchy.has_mul
- real.has_mul
- nonneg.has_mul
- complex.has_mul
- continuous_linear_map.has_mul
- sign_type.has_mul
- nat.arithmetic_function.has_mul
- mv_power_series.has_mul
- hahn_series.has_mul
- ratfunc.has_mul
- freiman_hom.has_mul
- continuous_map.has_mul
- homogeneous_ideal.has_mul
- homogeneous_localization.num_denom_same_deg.has_mul
- homogeneous_localization.has_mul
- set.Icc.has_mul
- set.Ico.has_mul
- set.Ioc.has_mul
- set.Ioo.has_mul
- unit_interval.has_mul
- ring_quot.has_mul
- fractional_ideal.has_mul
- order_monoid_hom.has_mul
- order_monoid_with_zero_hom.has_mul
- quaternion_algebra.has_mul
- sym_alg.has_mul
- tropical.has_mul
- bounded_continuous_function.has_mul
- measure_theory.simple_func.has_mul
- filter.germ.has_mul
- matrix.special_linear_group.has_mul
- measure_theory.ae_eq_fun.has_mul
- uniform_space.completion.has_mul
- lp.has_mul
- language.has_mul
- bitvec.has_mul
- snum.has_mul
- regular_expression.has_mul
- finsupp.has_mul
- smooth_map.has_mul
- zsqrtd.has_mul
- poly.has_mul
- mul_char.has_mul
- lucas_lehmer.X.has_mul
- padic.has_mul
- padic_int.has_mul
- valuation_ring.value_group.has_mul
- ore_localization.has_mul
- witt_vector.has_mul
- truncated_witt_vector.has_mul
- pgame.has_mul
- onote.has_mul
- nonote.has_mul
- polyrith.poly.has_mul
- tactic.ring2.horner_expr.has_mul
- locally_constant.has_mul
- zero_at_infty_continuous_map.has_mul
- inv : α → α
Instances of this typeclass
- has_involutive_inv.to_has_inv
- div_inv_monoid.to_has_inv
- order_dual.has_inv
- lex.has_inv
- units.has_inv
- monoid_hom.has_inv
- multiplicative.has_inv
- mul_opposite.has_inv
- add_opposite.has_inv
- pi.has_inv
- with_one.has_inv
- with_zero.has_inv
- prod.has_inv
- rat.has_inv
- ulift.has_inv
- subgroup_class.has_inv
- subgroup.has_inv
- part.has_inv
- con.has_inv
- self_adjoint.has_inv
- subfield.has_inv
- perfect_closure.has_inv
- free_group.has_inv
- matrix.has_inv
- Group.filtered_colimits.colimit_has_inv
- filter.has_inv
- zmod.has_inv
- cau_seq.completion.Cauchy.has_inv
- real.has_inv
- nonneg.has_inv
- ennreal.has_inv
- complex.has_inv
- mv_power_series.has_inv
- power_series.has_inv
- ratfunc.has_inv
- freiman_hom.has_inv
- continuous_map.has_inv
- fractional_ideal.has_inv
- positive.subtype.has_inv
- quaternion.has_inv
- sym_alg.has_inv
- tropical.has_inv
- measure_theory.simple_func.has_inv
- filter.germ.has_inv
- metric.sphere.has_inv
- matrix.special_linear_group.has_inv
- measure_theory.ae_eq_fun.has_inv
- free_product.has_inv
- uniform_space.completion.has_inv
- add_char.has_inv
- mul_char.has_inv
- valuation_ring.value_group.has_inv
- ore_localization.has_inv
- pgame.has_inv
- locally_constant.has_inv
- neg : α → α
Instances of this typeclass
- has_involutive_neg.to_has_neg
- sub_neg_monoid.to_has_neg
- int.has_neg
- native.float.has_neg
- order_dual.has_neg
- lex.has_neg
- add_units.has_neg
- add_monoid_hom.has_neg
- additive.has_neg
- mul_opposite.has_neg
- add_opposite.has_neg
- pi.has_neg
- units.has_neg
- with_zero.has_neg
- prod.has_neg
- fin.has_neg
- rat.has_neg
- ulift.has_neg
- add_subgroup_class.has_neg
- add_subgroup.has_neg
- znum.has_neg
- linear_map.has_neg
- sub_mul_action.has_neg
- dfinsupp.has_neg
- finsupp.has_neg
- part.has_neg
- add_con.has_neg
- linear_pmap.has_neg
- tensor_product.has_neg
- polynomial.has_neg
- localization.has_neg
- matrix.has_neg
- multilinear_map.has_neg
- alternating_map.has_neg
- perfect_closure.has_neg
- unitization.has_neg
- AddGroup.filtered_colimits.colimit_has_neg
- filter.has_neg
- triv_sq_zero_ext.has_neg
- dmatrix.has_neg
- cau_seq.has_neg
- cau_seq.completion.Cauchy.has_neg
- real.has_neg
- complex.has_neg
- continuous_linear_map.has_neg
- affine_map.has_neg
- ray_vector.has_neg
- module.ray.has_neg
- normed_add_group_hom.has_neg
- unitary.has_neg
- sign_type.has_neg
- ratfunc.has_neg
- add_freiman_hom.has_neg
- homological_complex.quiver.hom.has_neg
- continuous_map.has_neg
- homogeneous_localization.num_denom_same_deg.has_neg
- homogeneous_localization.has_neg
- lie_module_hom.has_neg
- ring_quot.has_neg
- free_lie_algebra.has_neg
- bilin_form.has_neg
- quaternion_algebra.has_neg
- sym_alg.has_neg
- continuous_multilinear_map.has_neg
- ereal.has_neg
- bounded_continuous_function.has_neg
- measure_theory.simple_func.has_neg
- filter.germ.has_neg
- matrix.special_linear_group.has_neg
- matrix.GL_pos.has_neg
- measure_theory.ae_eq_fun.has_neg
- continuous_affine_map.has_neg
- uniform_space.completion.has_neg
- derivation.has_neg
- measure_theory.vector_measure.has_neg
- bitvec.has_neg
- snum.has_neg
- fp.float.has_neg
- holor.has_neg
- left_invariant_derivation.has_neg
- hamming.has_neg
- quadratic_form.has_neg
- zsqrtd.has_neg
- poly.has_neg
- padic.has_neg
- padic_int.has_neg
- ore_localization.has_neg
- witt_vector.has_neg
- truncated_witt_vector.has_neg
- pgame.has_neg
- surreal.has_neg
- polyrith.poly.has_neg
- tactic.ring2.horner_expr.has_neg
- locally_constant.has_neg
- zero_at_infty_continuous_map.has_neg
- sub : α → α → α
Instances of this typeclass
- sub_neg_monoid.to_has_sub
- nat.has_sub
- int.has_sub
- fin.has_sub
- unsigned.has_sub
- native.float.has_sub
- order_dual.has_sub
- lex.has_sub
- add_monoid_hom.has_sub
- additive.has_sub
- mul_opposite.has_sub
- pi.has_sub
- prod.has_sub
- with_top.has_sub
- pnat.has_sub
- multiset.has_sub
- ulift.has_sub
- add_subgroup_class.has_sub
- add_subgroup.has_sub
- pos_num.has_sub
- num.has_sub
- linear_map.has_sub
- dfinsupp.has_sub
- finsupp.has_sub
- part.has_sub
- add_con.has_sub
- enat.has_sub
- polynomial.has_sub
- finsupp.tsub
- ordinal.has_sub
- matrix.has_sub
- multilinear_map.has_sub
- alternating_map.has_sub
- dmatrix.has_sub
- cau_seq.has_sub
- cau_seq.completion.Cauchy.has_sub
- real.has_sub
- nonneg.has_sub
- nnreal.has_sub
- ennreal.has_sub
- complex.has_sub
- continuous_linear_map.has_sub
- affine_map.has_sub
- normed_add_group_hom.has_sub
- ratfunc.has_sub
- add_freiman_hom.has_sub
- homological_complex.quiver.hom.has_sub
- continuous_map.has_sub
- homogeneous_localization.has_sub
- lie_module_hom.has_sub
- ring_quot.has_sub
- free_lie_algebra.has_sub
- bilin_form.has_sub
- quaternion_algebra.has_sub
- sym_alg.has_sub
- continuous_multilinear_map.has_sub
- ereal.has_sub
- bounded_continuous_function.has_sub
- measure_theory.simple_func.has_sub
- filter.germ.has_sub
- measure_theory.ae_eq_fun.has_sub
- continuous_affine_map.has_sub
- uniform_space.completion.has_sub
- derivation.has_sub
- measure_theory.vector_measure.has_sub
- measure_theory.measure.has_sub
- bitvec.has_sub
- snum.has_sub
- dfinsupp.tsub
- fp.float.has_sub
- prime_multiset.has_sub
- nnrat.has_sub
- left_invariant_derivation.has_sub
- hamming.has_sub
- quadratic_form.has_sub
- poly.has_sub
- padic.has_sub
- padic_int.has_sub
- witt_vector.has_sub
- truncated_witt_vector.has_sub
- pgame.has_sub
- onote.has_sub
- nonote.has_sub
- polyrith.poly.has_sub
- locally_constant.has_sub
- zero_at_infty_continuous_map.has_sub
- div : α → α → α
Instances of this typeclass
- euclidean_domain.has_div
- div_inv_monoid.to_has_div
- nat.has_div
- int.has_div
- fin.has_div
- unsigned.has_div
- native.float.has_div
- order_dual.has_div
- lex.has_div
- monoid_hom.has_div
- multiplicative.has_div
- add_opposite.has_div
- pi.has_div
- with_zero.has_div
- prod.has_div
- rat.has_div
- ulift.has_div
- subgroup_class.has_div
- subgroup.has_div
- num.has_div
- znum.has_div
- part.has_div
- con.has_div
- ordinal.has_div
- submodule.has_div
- polynomial.has_div
- self_adjoint.has_div
- subfield.has_div
- nonneg.has_div
- nnreal.has_div
- ratfunc.has_div
- freiman_hom.has_div
- continuous_map.has_div
- fractional_ideal.fractional_ideal_has_div
- tropical.has_div
- measure_theory.simple_func.has_div
- filter.germ.has_div
- metric.sphere.has_div
- measure_theory.ae_eq_fun.has_div
- padic.has_div
- gaussian_int.has_div
- pgame.has_div
- locally_constant.has_div
- dvd : α → α → Prop
Instances of this typeclass
- mod : α → α → α
- le : α → α → Prop
Instances of this typeclass
- with_bot.has_le
- with_top.has_le
- preorder.to_has_le
- nat.has_le
- list.has_le
- char.has_le
- fin.has_le
- local_context.has_le
- int.has_le
- unsigned.has_le
- native.float.has_le
- order_dual.has_le
- pi.has_le
- subtype.has_le
- prod.has_le
- Prop.has_le
- set.has_le
- multiplicative.has_le
- additive.has_le
- list.has_le'
- setoid.has_le
- rat.has_le
- string.has_le
- prod.lex.has_le
- pos_num.has_le
- num.has_le
- znum.has_le
- omega_complete_partial_order.chain.has_le
- con.has_le
- add_con.has_le
- part_enat.has_le
- cardinal.has_le
- linear_pmap.has_le
- finsupp.has_le
- sum.has_le
- sum.lex.has_le
- lift.subfield_with_hom.has_le
- topological_space.has_le
- cau_seq.has_le
- real.has_le
- sign_type.has_le
- category_theory.grothendieck_topology.has_le
- category_theory.pretopology.has_le
- tropical.has_le
- box_integral.box.has_le
- box_integral.prepartition.has_le
- measurable_space.has_le
- measurable_space.dynkin_system.has_le
- measure_theory.simple_func.has_le
- filter.germ.has_le
- finset.colex.has_le
- simple_graph.has_le
- finpartition.has_le
- setoid.partition.le
- snum.has_le
- many_one_degree.has_le
- dfinsupp.has_le
- semiquot.has_le
- psigma.lex.has_le
- sigma.has_le
- sigma.lex.has_le
- zsqrtd.has_le
- measure_theory.filtration.has_le
- valuation_ring.value_group.has_le
- pgame.has_le
- surreal.has_le
- lt : α → α → Prop
Instances of this typeclass
- with_bot.has_lt
- with_top.has_lt
- preorder.to_has_lt
- nat.has_lt
- list.has_lt
- char.has_lt
- string.has_lt
- fin.has_lt
- name.has_lt
- expr.has_lt
- expr.coord.has_lt
- int.has_lt
- unsigned.has_lt
- native.float.has_lt
- pos.has_lt
- tactic.itauto.prop.has_lt
- order_dual.has_lt
- subtype.has_lt
- tactic.interactive.mono_key.has_lt
- multiplicative.has_lt
- additive.has_lt
- list.has_lt'
- pi.lex.has_lt
- rat.has_lt
- string.has_lt'
- linarith.monom.has_lt
- prod.lex.has_lt
- pos_num.has_lt
- num.has_lt
- znum.has_lt
- sum.has_lt
- sum.lex.has_lt
- cau_seq.has_lt
- real.has_lt
- tropical.has_lt
- finset.colex.has_lt
- snum.has_lt
- nat.upto.has_lt
- psigma.lex.has_lt
- sigma.has_lt
- sigma.lex.has_lt
- zsqrtd.has_lt
- pgame.has_lt
- surreal.has_lt
- append : α → α → α
Instances of this typeclass
- andthen : α → β → σ
Instances of this typeclass
- union : α → α → α
- inter : α → α → α
- sdiff : α → α → α
Instances of this typeclass
- generalized_coheyting_algebra.to_has_sdiff
- biheyting_algebra.to_has_sdiff
- generalized_boolean_algebra.to_has_sdiff
- boolean_algebra.to_has_sdiff
- list.has_sdiff
- pi.has_sdiff
- prod.has_sdiff
- finset.has_sdiff
- part.has_sdiff
- topological_space.clopens.has_sdiff
- topological_space.compact_opens.has_sdiff
- measurable_set.subtype.has_sdiff
- is_Lprojection.subtype.has_sdiff
- simple_graph.has_sdiff
- finmap.has_sdiff
- Set.has_sdiff
- Class.has_sdiff
- equiv : α → α → Prop
Instances of this typeclass
- subset : α → α → Prop
- ssubset : α → α → Prop
Instances of this typeclass
Type classes has_emptyc and has_insert are
used to implement polymorphic notation for collections.
Example: {a, b, c} = insert a (insert b (singleton c)).
Note that we use pair in the name of lemmas about {x, y} = insert x (singleton y).
- emptyc : α
Instances of this typeclass
- list.has_emptyc
- local_context.has_emptyc
- set.has_emptyc
- widget.html.has_emptyc
- multiset.has_emptyc
- finset.has_emptyc
- sym.has_emptyc
- alist.has_emptyc
- cycle.has_emptyc
- topological_space.opens.has_emptyc
- algebraic_geometry.Scheme.has_emptyc
- measurable_set.subtype.has_emptyc
- turing.list_blank.has_emptyc
- finmap.has_emptyc
- ordnode.has_emptyc
- ordset.has_emptyc
- finsets.has_emptyc
- pSet.has_emptyc
- Set.has_emptyc
- Class.has_emptyc
- insert : α → γ → γ
- singleton : α → β
- sep : (α → Prop) → γ → γ
Instances of this typeclass
- mem : α → γ → Prop
Instances of this typeclass
- set_like.has_mem
- list.has_mem
- local_context.has_mem
- set.has_mem
- array.has_mem
- option.has_mem
- rbtree.has_mem
- rbmap.has_mem
- buffer.has_mem
- widget_override.interactive_expression.expr.address.has_mem
- multiset.has_mem
- finset.has_mem
- sym.has_mem
- alist.has_mem
- part.has_mem
- omega_complete_partial_order.chain.has_mem
- con.has_mem
- add_con.has_mem
- cycle.has_mem
- associates.factor_set.has_mem
- stream.has_mem
- computation.has_mem
- seq.has_mem
- filter.has_mem
- filter_basis.has_mem
- ultrafilter.has_mem
- topological_space.opens.has_mem
- affine_subspace.has_mem
- box_integral.box.has_mem
- box_integral.prepartition.has_mem
- box_integral.tagged_prepartition.has_mem
- measurable_set.subtype.has_mem
- group_filter_basis.has_mem
- add_group_filter_basis.has_mem
- ring_filter_basis.has_mem
- module_filter_basis.group_filter_basis.has_mem
- geometry.simplicial_complex.has_mem
- configuration.dual.has_mem
- sym2.has_mem
- language.has_mem
- nat.partrec.code.has_mem
- finmap.has_mem
- semiquot.has_mem
- hash_map.has_mem
- lazy_list.has_mem
- ordnode.has_mem
- ordset.has_mem
- wseq.has_mem
- open_subgroup.has_mem
- open_add_subgroup.has_mem
- structure_groupoid.has_mem
- order.cofinal.has_mem
- composition_series.has_mem
- order.pfilter.has_mem
- lists'.has_mem
- lists.has_mem
- pSet.has_mem
- Set.has_mem
- Class.has_mem
- pow : α → β → α
Instances of this typeclass
- polynomial.has_pow
- native.float.has_float_pow
- native.float.has_nat_pow
- monoid.has_pow
- div_inv_monoid.has_pow
- order_dual.has_pow
- lex.has_pow
- pi.has_pow
- with_zero.nat.has_pow
- with_zero.int.has_pow
- add_opposite.has_pow
- positive.nat.has_pow
- prod.has_pow
- ulift.has_pow
- submonoid_class.has_pow
- subgroup_class.has_zpow
- subgroup.has_npow
- subgroup.has_zpow
- con.nat.has_pow
- con.has_zpow
- cardinal.has_pow
- ordinal.has_pow
- nat.monoid.prime_pow
- self_adjoint.nat.has_pow
- self_adjoint.int.has_pow
- category_theory.equivalence.int.has_pow
- subfield.int.has_pow
- graded_monoid.nat.has_pow
- nonneg.has_pow
- nonneg.has_zpow
- continuous_map.has_pow
- continuous_map.has_zpow
- homogeneous_localization.num_denom_same_deg.nat.has_pow
- homogeneous_localization.has_pow
- set.Icc.has_pow
- set.Ioc.has_pow
- ring_quot.nat.has_pow
- fractional_ideal.nat.has_pow
- complex.has_pow
- real.has_pow
- nnreal.real.has_pow
- ennreal.real.has_pow
- positive.int.has_pow
- tropical.has_pow
- bounded_continuous_function.has_nat_pow
- measure_theory.simple_func.has_nat_pow
- measure_theory.simple_func.has_int_pow
- filter.germ.has_nat_pow
- filter.germ.has_int_pow
- int.has_pow
- matrix.special_linear_group.nat.has_pow
- measure_theory.ae_eq_fun.nat.has_pow
- measure_theory.ae_eq_fun.has_int_pow
- regular_expression.nat.has_pow
- witt_vector.has_nat_pow
- truncated_witt_vector.has_nat_pow
- onote.has_pow
- polyrith.nat.has_pow
Instances for bit0
        
        
    Instances for bit1
        
        
    - insert_emptyc_eq : ∀ (x : α), {x} = {x}
- sizeof : α → ℕ
Instances of this typeclass
- default_has_sizeof
- slim_check.sampleable_ext.wf
- slim_check.sampleable.wf
- nat.has_sizeof
- prod.has_sizeof
- sum.has_sizeof
- psum.has_sizeof
- sigma.has_sizeof
- psigma.has_sizeof
- punit.has_sizeof
- bool.has_sizeof
- option.has_sizeof
- list.has_sizeof
- subtype.has_sizeof
- bin_tree.has_sizeof_inst
- inhabited.has_sizeof_inst
- ulift.has_sizeof_inst
- plift.has_sizeof_inst
- has_well_founded.has_sizeof_inst
- setoid.has_sizeof_inst
- char.has_sizeof_inst
- char.has_sizeof
- string_imp.has_sizeof_inst
- string.iterator_imp.has_sizeof_inst
- string.has_sizeof
- has_repr.has_sizeof_inst
- ordering.has_sizeof_inst
- has_lift.has_sizeof_inst
- has_lift_t.has_sizeof_inst
- has_coe.has_sizeof_inst
- has_coe_t.has_sizeof_inst
- has_coe_to_fun.has_sizeof_inst
- has_coe_to_sort.has_sizeof_inst
- has_coe_t_aux.has_sizeof_inst
- has_to_string.has_sizeof_inst
- name.has_sizeof_inst
- functor.has_sizeof_inst
- has_pure.has_sizeof_inst
- has_seq.has_sizeof_inst
- has_seq_left.has_sizeof_inst
- has_seq_right.has_sizeof_inst
- applicative.has_sizeof_inst
- has_orelse.has_sizeof_inst
- alternative.has_sizeof_inst
- has_bind.has_sizeof_inst
- monad.has_sizeof_inst
- has_monad_lift.has_sizeof_inst
- has_monad_lift_t.has_sizeof_inst
- monad_functor.has_sizeof_inst
- monad_functor_t.has_sizeof_inst
- monad_run.has_sizeof_inst
- format.color.has_sizeof_inst
- monad_fail.has_sizeof_inst
- pos.has_sizeof_inst
- binder_info.has_sizeof_inst
- reducibility_hints.has_sizeof_inst
- environment.projection_info.has_sizeof_inst
- environment.implicit_infer_kind.has_sizeof_inst
- tactic.transparency.has_sizeof_inst
- tactic.new_goals.has_sizeof_inst
- tactic.apply_cfg.has_sizeof_inst
- param_info.has_sizeof_inst
- fun_info.has_sizeof_inst
- subsingleton_info.has_sizeof_inst
- occurrences.has_sizeof_inst
- tactic.rewrite_cfg.has_sizeof_inst
- tactic.dsimp_config.has_sizeof_inst
- tactic.dunfold_config.has_sizeof_inst
- tactic.delta_config.has_sizeof_inst
- tactic.unfold_proj_config.has_sizeof_inst
- tactic.simp_config.has_sizeof_inst
- tactic.simp_intros_config.has_sizeof_inst
- interactive.loc.has_sizeof_inst
- cc_config.has_sizeof_inst
- congr_arg_kind.has_sizeof_inst
- tactic.interactive.case_tag.has_sizeof_inst
- tactic.interactive.case_tag.match_result.has_sizeof_inst
- tactic.unfold_config.has_sizeof_inst
- except.has_sizeof_inst
- except_t.has_sizeof_inst
- monad_except.has_sizeof_inst
- monad_except_adapter.has_sizeof_inst
- state_t.has_sizeof_inst
- monad_state.has_sizeof_inst
- monad_state_adapter.has_sizeof_inst
- reader_t.has_sizeof_inst
- monad_reader.has_sizeof_inst
- monad_reader_adapter.has_sizeof_inst
- option_t.has_sizeof_inst
- vm_obj_kind.has_sizeof_inst
- vm_decl_kind.has_sizeof_inst
- ematch_config.has_sizeof_inst
- smt_pre_config.has_sizeof_inst
- smt_config.has_sizeof_inst
- rsimp.config.has_sizeof_inst
- expr.coord.has_sizeof_inst
- preorder.has_sizeof_inst
- partial_order.has_sizeof_inst
- linear_order.has_sizeof_inst
- int.has_sizeof_inst
- d_array.has_sizeof_inst
- widget.mouse_event_kind.has_sizeof_inst
- feature_search.feature_cfg.has_sizeof_inst
- feature_search.predictor_type.has_sizeof_inst
- feature_search.predictor_cfg.has_sizeof_inst
- has_abs.has_sizeof_inst
- has_pos_part.has_sizeof_inst
- has_neg_part.has_sizeof_inst
- dlist.has_sizeof_inst
- doc_category.has_sizeof_inst
- tactic_doc_entry.has_sizeof_inst
- pempty.has_sizeof_inst
- rbnode.has_sizeof_inst
- rbnode.color.has_sizeof_inst
- random_gen.has_sizeof_inst
- std_gen.has_sizeof_inst
- io.error.has_sizeof_inst
- io.mode.has_sizeof_inst
- io.process.stdio.has_sizeof_inst
- io.process.spawn_args.has_sizeof_inst
- monad_io.has_sizeof_inst
- monad_io_terminal.has_sizeof_inst
- monad_io_net_system.has_sizeof_inst
- monad_io_file_system.has_sizeof_inst
- monad_io_environment.has_sizeof_inst
- monad_io_process.has_sizeof_inst
- monad_io_random.has_sizeof_inst
- to_additive.value_type.has_sizeof_inst
- function.has_uncurry.has_sizeof_inst
- lint_verbosity.has_sizeof_inst
- tactic.explode.status.has_sizeof_inst
- auto.auto_config.has_sizeof_inst
- auto.case_option.has_sizeof_inst
- tactic.itauto.and_kind.has_sizeof_inst
- tactic.itauto.prop.has_sizeof_inst
- tactic.itauto.proof.has_sizeof_inst
- can_lift.has_sizeof_inst
- norm_cast.label.has_sizeof_inst
- _nest_1_1._nest_1_1.tactic.tactic_script._mut_.has_sizeof_inst
- _nest_1_1.tactic.tactic_script.has_sizeof_inst
- _nest_1_1.list.tactic.tactic_script.has_sizeof_inst
- tactic.tactic_script.has_sizeof_inst
- simps_cfg.has_sizeof_inst
- applicative_transformation.has_sizeof_inst
- traversable.has_sizeof_inst
- is_lawful_traversable.has_sizeof_inst
- tactic.suggest.head_symbol_match.has_sizeof_inst
- has_vadd.has_sizeof_inst
- has_vsub.has_sizeof_inst
- has_smul.has_sizeof_inst
- semigroup.has_sizeof_inst
- add_semigroup.has_sizeof_inst
- comm_semigroup.has_sizeof_inst
- add_comm_semigroup.has_sizeof_inst
- left_cancel_semigroup.has_sizeof_inst
- add_left_cancel_semigroup.has_sizeof_inst
- right_cancel_semigroup.has_sizeof_inst
- add_right_cancel_semigroup.has_sizeof_inst
- mul_one_class.has_sizeof_inst
- add_zero_class.has_sizeof_inst
- add_monoid.has_sizeof_inst
- monoid.has_sizeof_inst
- add_comm_monoid.has_sizeof_inst
- comm_monoid.has_sizeof_inst
- add_left_cancel_monoid.has_sizeof_inst
- left_cancel_monoid.has_sizeof_inst
- add_right_cancel_monoid.has_sizeof_inst
- right_cancel_monoid.has_sizeof_inst
- add_cancel_monoid.has_sizeof_inst
- cancel_monoid.has_sizeof_inst
- add_cancel_comm_monoid.has_sizeof_inst
- cancel_comm_monoid.has_sizeof_inst
- has_involutive_neg.has_sizeof_inst
- has_involutive_inv.has_sizeof_inst
- div_inv_monoid.has_sizeof_inst
- sub_neg_monoid.has_sizeof_inst
- subtraction_monoid.has_sizeof_inst
- division_monoid.has_sizeof_inst
- subtraction_comm_monoid.has_sizeof_inst
- division_comm_monoid.has_sizeof_inst
- group.has_sizeof_inst
- add_group.has_sizeof_inst
- comm_group.has_sizeof_inst
- add_comm_group.has_sizeof_inst
- has_bracket.has_sizeof_inst
- fun_like.has_sizeof_inst
- embedding_like.has_sizeof_inst
- equiv_like.has_sizeof_inst
- unique.has_sizeof_inst
- equiv.has_sizeof_inst
- has_compl.has_sizeof_inst
- has_sup.has_sizeof_inst
- has_inf.has_sizeof_inst
- has_nat_cast.has_sizeof_inst
- add_monoid_with_one.has_sizeof_inst
- add_comm_monoid_with_one.has_sizeof_inst
- has_int_cast.has_sizeof_inst
- add_group_with_one.has_sizeof_inst
- add_comm_group_with_one.has_sizeof_inst
- mul_zero_class.has_sizeof_inst
- semigroup_with_zero.has_sizeof_inst
- mul_zero_one_class.has_sizeof_inst
- monoid_with_zero.has_sizeof_inst
- cancel_monoid_with_zero.has_sizeof_inst
- comm_monoid_with_zero.has_sizeof_inst
- cancel_comm_monoid_with_zero.has_sizeof_inst
- group_with_zero.has_sizeof_inst
- comm_group_with_zero.has_sizeof_inst
- units.has_sizeof_inst
- add_units.has_sizeof_inst
- zero_hom.has_sizeof_inst
- zero_hom_class.has_sizeof_inst
- add_hom.has_sizeof_inst
- add_hom_class.has_sizeof_inst
- add_monoid_hom.has_sizeof_inst
- add_monoid_hom_class.has_sizeof_inst
- one_hom.has_sizeof_inst
- one_hom_class.has_sizeof_inst
- mul_hom.has_sizeof_inst
- mul_hom_class.has_sizeof_inst
- monoid_hom.has_sizeof_inst
- monoid_hom_class.has_sizeof_inst
- monoid_with_zero_hom.has_sizeof_inst
- monoid_with_zero_hom_class.has_sizeof_inst
- is_nonstrict_strict_order.has_sizeof_inst
- semilattice_sup.has_sizeof_inst
- semilattice_inf.has_sizeof_inst
- lattice.has_sizeof_inst
- distrib_lattice.has_sizeof_inst
- has_top.has_sizeof_inst
- has_bot.has_sizeof_inst
- order_top.has_sizeof_inst
- order_bot.has_sizeof_inst
- bounded_order.has_sizeof_inst
- has_himp.has_sizeof_inst
- has_hnot.has_sizeof_inst
- generalized_heyting_algebra.has_sizeof_inst
- generalized_coheyting_algebra.has_sizeof_inst
- heyting_algebra.has_sizeof_inst
- coheyting_algebra.has_sizeof_inst
- biheyting_algebra.has_sizeof_inst
- generalized_boolean_algebra.has_sizeof_inst
- boolean_algebra.has_sizeof_inst
- function.embedding.has_sizeof_inst
- add_action.has_sizeof_inst
- mul_action.has_sizeof_inst
- distrib_mul_action.has_sizeof_inst
- mul_distrib_mul_action.has_sizeof_inst
- add_equiv.has_sizeof_inst
- add_equiv_class.has_sizeof_inst
- mul_equiv.has_sizeof_inst
- mul_equiv_class.has_sizeof_inst
- distrib.has_sizeof_inst
- left_distrib_class.has_sizeof_inst
- right_distrib_class.has_sizeof_inst
- non_unital_non_assoc_semiring.has_sizeof_inst
- non_unital_semiring.has_sizeof_inst
- non_assoc_semiring.has_sizeof_inst
- semiring.has_sizeof_inst
- non_unital_comm_semiring.has_sizeof_inst
- comm_semiring.has_sizeof_inst
- has_distrib_neg.has_sizeof_inst
- non_unital_non_assoc_ring.has_sizeof_inst
- non_unital_ring.has_sizeof_inst
- non_assoc_ring.has_sizeof_inst
- ring.has_sizeof_inst
- non_unital_comm_ring.has_sizeof_inst
- comm_ring.has_sizeof_inst
- equiv_functor.has_sizeof_inst
- rel_hom.has_sizeof_inst
- rel_hom_class.has_sizeof_inst
- rel_embedding.has_sizeof_inst
- rel_iso.has_sizeof_inst
- tactic.interactive.mono_cfg.has_sizeof_inst
- tactic.interactive.mono_selection.has_sizeof_inst
- order_hom.has_sizeof_inst
- order_iso_class.has_sizeof_inst
- ordered_comm_monoid.has_sizeof_inst
- ordered_add_comm_monoid.has_sizeof_inst
- linear_ordered_add_comm_monoid.has_sizeof_inst
- linear_ordered_comm_monoid.has_sizeof_inst
- zero_le_one_class.has_sizeof_inst
- linear_ordered_comm_monoid_with_zero.has_sizeof_inst
- linear_ordered_add_comm_monoid_with_top.has_sizeof_inst
- canonically_ordered_add_monoid.has_sizeof_inst
- canonically_ordered_monoid.has_sizeof_inst
- canonically_linear_ordered_add_monoid.has_sizeof_inst
- canonically_linear_ordered_monoid.has_sizeof_inst
- ordered_cancel_add_comm_monoid.has_sizeof_inst
- ordered_cancel_comm_monoid.has_sizeof_inst
- linear_ordered_cancel_add_comm_monoid.has_sizeof_inst
- linear_ordered_cancel_comm_monoid.has_sizeof_inst
- has_ordered_sub.has_sizeof_inst
- ordered_add_comm_group.has_sizeof_inst
- ordered_comm_group.has_sizeof_inst
- linear_ordered_add_comm_group.has_sizeof_inst
- linear_ordered_add_comm_group_with_top.has_sizeof_inst
- linear_ordered_comm_group.has_sizeof_inst
- add_comm_group.positive_cone.has_sizeof_inst
- add_comm_group.total_positive_cone.has_sizeof_inst
- non_unital_ring_hom.has_sizeof_inst
- non_unital_ring_hom_class.has_sizeof_inst
- ring_hom.has_sizeof_inst
- ring_hom_class.has_sizeof_inst
- ordered_semiring.has_sizeof_inst
- ordered_comm_semiring.has_sizeof_inst
- linear_ordered_semiring.has_sizeof_inst
- ordered_ring.has_sizeof_inst
- ordered_comm_ring.has_sizeof_inst
- linear_ordered_ring.has_sizeof_inst
- linear_ordered_comm_ring.has_sizeof_inst
- ring.positive_cone.has_sizeof_inst
- ring.total_positive_cone.has_sizeof_inst
- canonically_ordered_comm_semiring.has_sizeof_inst
- linear_ordered_comm_group_with_zero.has_sizeof_inst
- has_Sup.has_sizeof_inst
- has_Inf.has_sizeof_inst
- complete_semilattice_Sup.has_sizeof_inst
- complete_semilattice_Inf.has_sizeof_inst
- complete_lattice.has_sizeof_inst
- complete_linear_order.has_sizeof_inst
- order.frame.has_sizeof_inst
- order.coframe.has_sizeof_inst
- complete_distrib_lattice.has_sizeof_inst
- complete_boolean_algebra.has_sizeof_inst
- galois_insertion.has_sizeof_inst
- galois_coinsertion.has_sizeof_inst
- invertible.has_sizeof_inst
- tactic.interactive.rep_arity.has_sizeof_inst
- multiset.has_sizeof
- expr_lens.dir.has_sizeof_inst
- finset.has_sizeof_inst
- fintype.has_sizeof_inst
- smul_with_zero.has_sizeof_inst
- mul_action_with_zero.has_sizeof_inst
- encodable.has_sizeof_inst
- rat.has_sizeof_inst
- has_rat_cast.has_sizeof_inst
- division_semiring.has_sizeof_inst
- division_ring.has_sizeof_inst
- semifield.has_sizeof_inst
- field.has_sizeof_inst
- linear_ordered_semifield.has_sizeof_inst
- linear_ordered_field.has_sizeof_inst
- canonically_linear_ordered_semifield.has_sizeof_inst
- euclidean_domain.has_sizeof_inst
- tactic.abel.normalize_mode.has_sizeof_inst
- module.has_sizeof_inst
- module.core.has_sizeof_inst
- set_like.has_sizeof_inst
- mul_mem_class.has_sizeof_inst
- add_mem_class.has_sizeof_inst
- subsemigroup.has_sizeof_inst
- add_subsemigroup.has_sizeof_inst
- one_mem_class.has_sizeof_inst
- zero_mem_class.has_sizeof_inst
- submonoid.has_sizeof_inst
- submonoid_class.has_sizeof_inst
- add_submonoid.has_sizeof_inst
- add_submonoid_class.has_sizeof_inst
- conditionally_complete_lattice.has_sizeof_inst
- conditionally_complete_linear_order.has_sizeof_inst
- conditionally_complete_linear_order_bot.has_sizeof_inst
- denumerable.has_sizeof_inst
- add_torsor.has_sizeof_inst
- ring_equiv.has_sizeof_inst
- ring_equiv_class.has_sizeof_inst
- inv_mem_class.has_sizeof_inst
- neg_mem_class.has_sizeof_inst
- subgroup_class.has_sizeof_inst
- add_subgroup_class.has_sizeof_inst
- subgroup.has_sizeof_inst
- add_subgroup.has_sizeof_inst
- add_submonoid_with_one_class.has_sizeof_inst
- subsemiring_class.has_sizeof_inst
- subsemiring.has_sizeof_inst
- subring_class.has_sizeof_inst
- subring.has_sizeof_inst
- mul_semiring_action.has_sizeof_inst
- mul_action_hom.has_sizeof_inst
- smul_hom_class.has_sizeof_inst
- distrib_mul_action_hom.has_sizeof_inst
- distrib_mul_action_hom_class.has_sizeof_inst
- mul_semiring_action_hom.has_sizeof_inst
- mul_semiring_action_hom_class.has_sizeof_inst
- tactic.ring.normalize_mode.has_sizeof_inst
- tactic.ring.ring_nf_cfg.has_sizeof_inst
- linarith.ineq.has_sizeof_inst
- linarith.comp.has_sizeof_inst
- linarith.comp_source.has_sizeof_inst
- pos_num.has_sizeof_inst
- num.has_sizeof_inst
- znum.has_sizeof_inst
- tree.has_sizeof_inst
- has_star.has_sizeof_inst
- has_involutive_star.has_sizeof_inst
- star_semigroup.has_sizeof_inst
- star_add_monoid.has_sizeof_inst
- star_ring.has_sizeof_inst
- star_ordered_ring.has_sizeof_inst
- star_hom_class.has_sizeof_inst
- linear_map.has_sizeof_inst
- semilinear_map_class.has_sizeof_inst
- linear_map.compatible_smul.has_sizeof_inst
- linear_equiv.has_sizeof_inst
- semilinear_equiv_class.has_sizeof_inst
- sub_mul_action.has_sizeof_inst
- submodule.has_sizeof_inst
- normalization_monoid.has_sizeof_inst
- gcd_monoid.has_sizeof_inst
- normalized_gcd_monoid.has_sizeof_inst
- dfinsupp.has_sizeof_inst
- finsupp.has_sizeof_inst
- absolute_value.has_sizeof_inst
- alist.has_sizeof_inst
- tactic.tfae.arrow.has_sizeof_inst
- flag.has_sizeof_inst
- part.has_sizeof_inst
- omega_complete_partial_order.has_sizeof_inst
- omega_complete_partial_order.continuous_hom.has_sizeof_inst
- algebra.has_sizeof_inst
- alg_hom.has_sizeof_inst
- alg_hom_class.has_sizeof_inst
- alg_equiv.has_sizeof_inst
- alg_equiv_class.has_sizeof_inst
- non_unital_alg_hom.has_sizeof_inst
- non_unital_alg_hom_class.has_sizeof_inst
- add_con.has_sizeof_inst
- con.has_sizeof_inst
- locally_finite_order.has_sizeof_inst
- locally_finite_order_top.has_sizeof_inst
- locally_finite_order_bot.has_sizeof_inst
- succ_order.has_sizeof_inst
- pred_order.has_sizeof_inst
- linear_pmap.has_sizeof_inst
- has_quotient.has_sizeof_inst
- basis.has_sizeof_inst
- tensor_product.compatible_smul.has_sizeof_inst
- polynomial.has_sizeof_inst
- initial_seg.has_sizeof_inst
- principal_seg.has_sizeof_inst
- Well_order.has_sizeof_inst
- subalgebra.has_sizeof_inst
- valuation.has_sizeof_inst
- valuation_class.has_sizeof_inst
- add_submonoid.localization_map.has_sizeof_inst
- submonoid.localization_map.has_sizeof_inst
- submonoid.localization_with_zero_map.has_sizeof_inst
- tactic.ring_exp.coeff.has_sizeof_inst
- tactic.ring_exp.ex_type.has_sizeof_inst
- quiver.has_sizeof_inst
- prefunctor.has_sizeof_inst
- category_theory.category_struct.has_sizeof_inst
- category_theory.category.has_sizeof_inst
- category_theory.functor.has_sizeof_inst
- category_theory.nat_trans.has_sizeof_inst
- category_theory.iso.has_sizeof_inst
- category_theory.full.has_sizeof_inst
- category_theory.full_subcategory.has_sizeof_inst
- category_theory.equivalence.has_sizeof_inst
- category_theory.is_equivalence.has_sizeof_inst
- category_theory.adjunction.has_sizeof_inst
- category_theory.is_left_adjoint.has_sizeof_inst
- category_theory.is_right_adjoint.has_sizeof_inst
- category_theory.adjunction.core_hom_equiv.has_sizeof_inst
- category_theory.adjunction.core_unit_counit.has_sizeof_inst
- category_theory.groupoid.has_sizeof_inst
- category_theory.split_mono.has_sizeof_inst
- category_theory.split_epi.has_sizeof_inst
- category_theory.split_mono_category.has_sizeof_inst
- category_theory.split_epi_category.has_sizeof_inst
- category_theory.comma.has_sizeof_inst
- category_theory.comma_morphism.has_sizeof_inst
- category_theory.comm_sq.lift_struct.has_sizeof_inst
- category_theory.concrete_category.has_sizeof_inst
- category_theory.has_forget₂.has_sizeof_inst
- category_theory.bundled.has_sizeof_inst
- category_theory.bundled_hom.has_sizeof_inst
- category_theory.bundled_hom.parent_projection.has_sizeof_inst
- pequiv.has_sizeof_inst
- composition.has_sizeof_inst
- composition_as_set.has_sizeof_inst
- nat.partition.has_sizeof_inst
- multilinear_map.has_sizeof_inst
- alternating_map.has_sizeof_inst
- subfield_class.has_sizeof_inst
- subfield.has_sizeof_inst
- intermediate_field.has_sizeof_inst
- power_basis.has_sizeof_inst
- perfect_ring.has_sizeof_inst
- lift.subfield_with_hom.has_sizeof_inst
- free_algebra.pre.has_sizeof_inst
- category_theory.discrete.has_sizeof_inst
- category_theory.limits.cone.has_sizeof_inst
- category_theory.limits.cocone.has_sizeof_inst
- category_theory.limits.cone_morphism.has_sizeof_inst
- category_theory.limits.cocone_morphism.has_sizeof_inst
- category_theory.limits.is_limit.has_sizeof_inst
- category_theory.limits.is_colimit.has_sizeof_inst
- category_theory.limits.limit_cone.has_sizeof_inst
- category_theory.limits.colimit_cocone.has_sizeof_inst
- category_theory.limits.preserves_limit.has_sizeof_inst
- category_theory.limits.preserves_colimit.has_sizeof_inst
- category_theory.limits.preserves_limits_of_shape.has_sizeof_inst
- category_theory.limits.preserves_colimits_of_shape.has_sizeof_inst
- category_theory.limits.preserves_limits_of_size.has_sizeof_inst
- category_theory.limits.preserves_colimits_of_size.has_sizeof_inst
- category_theory.limits.reflects_limit.has_sizeof_inst
- category_theory.limits.reflects_colimit.has_sizeof_inst
- category_theory.limits.reflects_limits_of_shape.has_sizeof_inst
- category_theory.limits.reflects_colimits_of_shape.has_sizeof_inst
- category_theory.limits.reflects_limits_of_size.has_sizeof_inst
- category_theory.limits.reflects_colimits_of_size.has_sizeof_inst
- category_theory.limits.walking_parallel_pair.has_sizeof_inst
- category_theory.limits.walking_parallel_pair_hom.has_sizeof_inst
- category_theory.limits.wide_pullback_shape.hom.has_sizeof_inst
- category_theory.limits.wide_pushout_shape.hom.has_sizeof_inst
- category_theory.bicategory.has_sizeof_inst
- category_theory.is_skeleton_of.has_sizeof_inst
- category_theory.limits.walking_pair.has_sizeof_inst
- category_theory.limits.mono_factorisation.has_sizeof_inst
- category_theory.limits.is_image.has_sizeof_inst
- category_theory.limits.image_factorisation.has_sizeof_inst
- category_theory.limits.image_map.has_sizeof_inst
- category_theory.limits.has_image_maps.has_sizeof_inst
- category_theory.limits.strong_epi_mono_factorisation.has_sizeof_inst
- category_theory.limits.has_zero_morphisms.has_sizeof_inst
- category_theory.preadditive.has_sizeof_inst
- category_theory.linear.has_sizeof_inst
- category_theory.fin_category.has_sizeof_inst
- category_theory.limits.preserves_finite_limits.has_sizeof_inst
- category_theory.limits.preserves_finite_colimits.has_sizeof_inst
- category_theory.limits.bicone.has_sizeof_inst
- category_theory.limits.bicone.is_bilimit.has_sizeof_inst
- category_theory.limits.limit_bicone.has_sizeof_inst
- category_theory.limits.binary_bicone.has_sizeof_inst
- category_theory.limits.binary_bicone.is_bilimit.has_sizeof_inst
- category_theory.limits.binary_biproduct_data.has_sizeof_inst
- category_theory.limits.preserves_biproduct.has_sizeof_inst
- category_theory.limits.preserves_biproducts_of_shape.has_sizeof_inst
- category_theory.limits.preserves_finite_biproducts.has_sizeof_inst
- category_theory.limits.preserves_biproducts.has_sizeof_inst
- category_theory.limits.preserves_binary_biproduct.has_sizeof_inst
- category_theory.limits.preserves_binary_biproducts.has_sizeof_inst
- Module.has_sizeof_inst
- Algebra.has_sizeof_inst
- category_theory.liftable_cone.has_sizeof_inst
- category_theory.liftable_cocone.has_sizeof_inst
- category_theory.creates_limit.has_sizeof_inst
- category_theory.creates_limits_of_shape.has_sizeof_inst
- category_theory.creates_limits_of_size.has_sizeof_inst
- category_theory.creates_colimit.has_sizeof_inst
- category_theory.creates_colimits_of_shape.has_sizeof_inst
- category_theory.creates_colimits_of_size.has_sizeof_inst
- category_theory.lifts_to_limit.has_sizeof_inst
- category_theory.lifts_to_colimit.has_sizeof_inst
- bifunctor.has_sizeof_inst
- is_lawful_bifunctor.has_sizeof_inst
- category_theory.reflective.has_sizeof_inst
- category_theory.limits.walking_multicospan.has_sizeof_inst
- category_theory.limits.walking_multispan.has_sizeof_inst
- category_theory.limits.walking_multicospan.hom.has_sizeof_inst
- category_theory.limits.walking_multispan.hom.has_sizeof_inst
- category_theory.limits.multicospan_index.has_sizeof_inst
- category_theory.limits.multispan_index.has_sizeof_inst
- top_hom.has_sizeof_inst
- bot_hom.has_sizeof_inst
- bounded_order_hom.has_sizeof_inst
- top_hom_class.has_sizeof_inst
- bot_hom_class.has_sizeof_inst
- bounded_order_hom_class.has_sizeof_inst
- sup_hom.has_sizeof_inst
- inf_hom.has_sizeof_inst
- sup_bot_hom.has_sizeof_inst
- inf_top_hom.has_sizeof_inst
- lattice_hom.has_sizeof_inst
- bounded_lattice_hom.has_sizeof_inst
- sup_hom_class.has_sizeof_inst
- inf_hom_class.has_sizeof_inst
- sup_bot_hom_class.has_sizeof_inst
- inf_top_hom_class.has_sizeof_inst
- lattice_hom_class.has_sizeof_inst
- bounded_lattice_hom_class.has_sizeof_inst
- boolean_ring.has_sizeof_inst
- Pointed.has_sizeof_inst
- Pointed.hom.has_sizeof_inst
- Bipointed.has_sizeof_inst
- Bipointed.hom.has_sizeof_inst
- BoundedOrder.has_sizeof_inst
- SemilatticeSup.has_sizeof_inst
- SemilatticeInf.has_sizeof_inst
- BoundedLattice.has_sizeof_inst
- BoundedDistribLattice.has_sizeof_inst
- category_theory.monoidal_category.has_sizeof_inst
- category_theory.lax_monoidal_functor.has_sizeof_inst
- category_theory.monoidal_functor.has_sizeof_inst
- category_theory.free_monoidal_category.has_sizeof_inst
- category_theory.free_monoidal_category.hom.has_sizeof_inst
- category_theory.free_monoidal_category.normal_monoidal_object.has_sizeof_inst
- category_theory.quotient.has_sizeof_inst
- quiver.path.has_sizeof_inst
- category_theory.prelax_functor.has_sizeof_inst
- category_theory.oplax_functor.has_sizeof_inst
- category_theory.oplax_functor.pseudo_core.has_sizeof_inst
- category_theory.pseudofunctor.has_sizeof_inst
- category_theory.free_bicategory.hom.has_sizeof_inst
- category_theory.free_bicategory.hom₂.has_sizeof_inst
- category_theory.bicategory.lift_hom.has_sizeof_inst
- category_theory.bicategory.lift_hom₂.has_sizeof_inst
- category_theory.bicategory.bicategorical_coherence.has_sizeof_inst
- category_theory.monoidal_category.lift_obj.has_sizeof_inst
- category_theory.monoidal_category.lift_hom.has_sizeof_inst
- category_theory.monoidal_category.monoidal_coherence.has_sizeof_inst
- category_theory.closed.has_sizeof_inst
- category_theory.monoidal_closed.has_sizeof_inst
- category_theory.exact_pairing.has_sizeof_inst
- category_theory.has_right_dual.has_sizeof_inst
- category_theory.has_left_dual.has_sizeof_inst
- category_theory.right_rigid_category.has_sizeof_inst
- category_theory.left_rigid_category.has_sizeof_inst
- category_theory.rigid_category.has_sizeof_inst
- category_theory.monoidal_nat_trans.has_sizeof_inst
- category_theory.braided_category.has_sizeof_inst
- category_theory.symmetric_category.has_sizeof_inst
- category_theory.lax_braided_functor.has_sizeof_inst
- category_theory.braided_functor.has_sizeof_inst
- dual_pair.has_sizeof_inst
- Group.surjective_of_epi_auxs.X_with_infinity.has_sizeof_inst
- category_theory.is_split_coequalizer.has_sizeof_inst
- category_theory.regular_mono.has_sizeof_inst
- category_theory.regular_mono_category.has_sizeof_inst
- category_theory.regular_epi.has_sizeof_inst
- category_theory.regular_epi_category.has_sizeof_inst
- category_theory.normal_mono.has_sizeof_inst
- category_theory.normal_mono_category.has_sizeof_inst
- category_theory.normal_epi.has_sizeof_inst
- category_theory.normal_epi_category.has_sizeof_inst
- category_theory.non_preadditive_abelian.has_sizeof_inst
- category_theory.abelian.has_sizeof_inst
- category_theory.functor.reflects_exact_sequences.has_sizeof_inst
- category_theory.monoidal_preadditive.has_sizeof_inst
- category_theory.monoidal_linear.has_sizeof_inst
- AddCommGroup.colimits.prequotient.has_sizeof_inst
- category_theory.limits.preserves_filtered_colimits.has_sizeof_inst
- category_theory.limits.preserves_cofiltered_limits.has_sizeof_inst
- category_theory.functorial.has_sizeof_inst
- category_theory.lax_monoidal.has_sizeof_inst
- category_theory.splitting.has_sizeof_inst
- Module.colimits.prequotient.has_sizeof_inst
- category_theory.projective_presentation.has_sizeof_inst
- Mon.colimits.prequotient.has_sizeof_inst
- CommRing.colimits.prequotient.has_sizeof_inst
- lazy_list.has_sizeof_inst
- generalized_continued_fraction.pair.has_sizeof_inst
- generalized_continued_fraction.has_sizeof_inst
- floor_semiring.has_sizeof_inst
- floor_ring.has_sizeof_inst
- generalized_continued_fraction.int_fract_pair.has_sizeof_inst
- filter.has_sizeof_inst
- filter_basis.has_sizeof_inst
- filter.countable_filter_basis.has_sizeof_inst
- ultrafilter.has_sizeof_inst
- tactic.decl_reducibility.has_sizeof_inst
- topological_space.has_sizeof_inst
- bornology.has_sizeof_inst
- compact_exhaustion.has_sizeof_inst
- homeomorph.has_sizeof_inst
- continuous_map.has_sizeof_inst
- continuous_map_class.has_sizeof_inst
- Sup_hom.has_sizeof_inst
- Inf_hom.has_sizeof_inst
- frame_hom.has_sizeof_inst
- complete_lattice_hom.has_sizeof_inst
- Sup_hom_class.has_sizeof_inst
- Inf_hom_class.has_sizeof_inst
- frame_hom_class.has_sizeof_inst
- complete_lattice_hom_class.has_sizeof_inst
- topological_space.closeds.has_sizeof_inst
- topological_space.clopens.has_sizeof_inst
- topological_space.compacts.has_sizeof_inst
- topological_space.nonempty_compacts.has_sizeof_inst
- topological_space.positive_compacts.has_sizeof_inst
- topological_space.compact_opens.has_sizeof_inst
- add_group_with_zero_nhd.has_sizeof_inst
- group_topology.has_sizeof_inst
- add_group_topology.has_sizeof_inst
- ring_topology.has_sizeof_inst
- cubic.has_sizeof_inst
- graded_monoid.ghas_one.has_sizeof_inst
- graded_monoid.ghas_mul.has_sizeof_inst
- graded_monoid.gmonoid.has_sizeof_inst
- graded_monoid.gcomm_monoid.has_sizeof_inst
- direct_sum.gnon_unital_non_assoc_semiring.has_sizeof_inst
- direct_sum.gsemiring.has_sizeof_inst
- direct_sum.gcomm_semiring.has_sizeof_inst
- direct_sum.gring.has_sizeof_inst
- direct_sum.gcomm_ring.has_sizeof_inst
- direct_sum.galgebra.has_sizeof_inst
- direct_sum.decomposition.has_sizeof_inst
- free_magma.has_sizeof_inst
- free_add_magma.has_sizeof_inst
- intermediate_field.insert.has_sizeof_inst
- real.has_sizeof_inst
- uniform_space.core.has_sizeof_inst
- uniform_space.has_sizeof_inst
- has_edist.has_sizeof_inst
- pseudo_emetric_space.has_sizeof_inst
- emetric_space.has_sizeof_inst
- has_dist.has_sizeof_inst
- pseudo_metric_space.has_sizeof_inst
- has_nndist.has_sizeof_inst
- metric_space.has_sizeof_inst
- abstract_completion.has_sizeof_inst
- complex.has_sizeof_inst
- add_group_seminorm.has_sizeof_inst
- group_seminorm.has_sizeof_inst
- locally_bounded_map.has_sizeof_inst
- locally_bounded_map_class.has_sizeof_inst
- isometric.has_sizeof_inst
- has_norm.has_sizeof_inst
- seminormed_add_comm_group.has_sizeof_inst
- normed_add_comm_group.has_sizeof_inst
- has_nnnorm.has_sizeof_inst
- continuous_linear_map.has_sizeof_inst
- continuous_semilinear_map_class.has_sizeof_inst
- continuous_linear_equiv.has_sizeof_inst
- continuous_semilinear_equiv_class.has_sizeof_inst
- non_unital_semi_normed_ring.has_sizeof_inst
- semi_normed_ring.has_sizeof_inst
- non_unital_normed_ring.has_sizeof_inst
- normed_ring.has_sizeof_inst
- normed_division_ring.has_sizeof_inst
- semi_normed_comm_ring.has_sizeof_inst
- normed_comm_ring.has_sizeof_inst
- normed_field.has_sizeof_inst
- nontrivially_normed_field.has_sizeof_inst
- densely_normed_field.has_sizeof_inst
- normed_space.has_sizeof_inst
- normed_algebra.has_sizeof_inst
- local_equiv.has_sizeof_inst
- local_homeomorph.has_sizeof_inst
- normed_linear_ordered_group.has_sizeof_inst
- normed_linear_ordered_field.has_sizeof_inst
- affine_map.has_sizeof_inst
- affine_equiv.has_sizeof_inst
- normed_add_torsor.has_sizeof_inst
- affine_subspace.has_sizeof_inst
- linear_isometry.has_sizeof_inst
- semilinear_isometry_class.has_sizeof_inst
- linear_isometry_equiv.has_sizeof_inst
- semilinear_isometry_equiv_class.has_sizeof_inst
- affine_isometry.has_sizeof_inst
- affine_isometry_equiv.has_sizeof_inst
- topological_lattice.has_sizeof_inst
- normed_lattice_add_comm_group.has_sizeof_inst
- closure_operator.has_sizeof_inst
- lower_adjoint.has_sizeof_inst
- normed_add_group_hom.has_sizeof_inst
- is_R_or_C.has_sizeof_inst
- sign_type.has_sizeof_inst
- hahn_series.has_sizeof_inst
- hahn_series.summable_family.has_sizeof_inst
- ratfunc.has_sizeof_inst
- add_freiman_hom.has_sizeof_inst
- freiman_hom.has_sizeof_inst
- add_freiman_hom_class.has_sizeof_inst
- freiman_hom_class.has_sizeof_inst
- complex_shape.has_sizeof_inst
- category_theory.has_shift.has_sizeof_inst
- category_theory.shift_mk_core.has_sizeof_inst
- homological_complex.has_sizeof_inst
- homological_complex.hom.has_sizeof_inst
- chain_complex.mk_struct.has_sizeof_inst
- cochain_complex.mk_struct.has_sizeof_inst
- category_theory.differential_object.has_sizeof_inst
- category_theory.differential_object.hom.has_sizeof_inst
- homotopy.has_sizeof_inst
- homotopy_equiv.has_sizeof_inst
- algebraic_geometry.PresheafedSpace.has_sizeof_inst
- algebraic_geometry.PresheafedSpace.hom.has_sizeof_inst
- category_theory.presieve.functor_pushforward_structure.has_sizeof_inst
- category_theory.sieve.has_sizeof_inst
- category_theory.grothendieck_topology.has_sizeof_inst
- category_theory.grothendieck_topology.cover.arrow.has_sizeof_inst
- category_theory.grothendieck_topology.cover.relation.has_sizeof_inst
- category_theory.pretopology.has_sizeof_inst
- category_theory.SheafOfTypes.has_sizeof_inst
- category_theory.SheafOfTypes.hom.has_sizeof_inst
- category_theory.Sheaf.has_sizeof_inst
- category_theory.Sheaf.hom.has_sizeof_inst
- category_theory.bicone.has_sizeof_inst
- category_theory.bicone_hom.has_sizeof_inst
- category_theory.presieve.cover_by_image_structure.has_sizeof_inst
- category_theory.pairwise.has_sizeof_inst
- category_theory.pairwise.hom.has_sizeof_inst
- algebraic_geometry.SheafedSpace.has_sizeof_inst
- algebraic_geometry.LocallyRingedSpace.has_sizeof_inst
- algebraic_geometry.LocallyRingedSpace.hom.has_sizeof_inst
- TopCommRing.has_sizeof_inst
- Top.prelocal_predicate.has_sizeof_inst
- Top.local_predicate.has_sizeof_inst
- algebraic_geometry.Scheme.has_sizeof_inst
- algebraic_geometry.Scheme.open_cover.has_sizeof_inst
- EllipticCurve.has_sizeof_inst
- category_theory.glue_data.has_sizeof_inst
- Top.glue_data.has_sizeof_inst
- Top.glue_data.mk_core.has_sizeof_inst
- algebraic_geometry.PresheafedSpace.glue_data.has_sizeof_inst
- algebraic_geometry.SheafedSpace.glue_data.has_sizeof_inst
- algebraic_geometry.LocallyRingedSpace.glue_data.has_sizeof_inst
- algebraic_geometry.Scheme.glue_data.has_sizeof_inst
- spectral_map.has_sizeof_inst
- spectral_map_class.has_sizeof_inst
- graded_ring.has_sizeof_inst
- homogeneous_ideal.has_sizeof_inst
- homogeneous_localization.num_denom_same_deg.has_sizeof_inst
- nonempty_fin_lin_ord.has_sizeof_inst
- category_theory.idempotents.karoubi.has_sizeof_inst
- category_theory.idempotents.karoubi.hom.has_sizeof_inst
- continuous_map.homotopy.has_sizeof_inst
- continuous_map.homotopy_like.has_sizeof_inst
- continuous_map.homotopy_with.has_sizeof_inst
- path.has_sizeof_inst
- continuous_map.homotopy_equiv.has_sizeof_inst
- simplicial_object.splitting.has_sizeof_inst
- simplicial_object.split.has_sizeof_inst
- simplicial_object.split.hom.has_sizeof_inst
- lie_ring.has_sizeof_inst
- lie_algebra.has_sizeof_inst
- lie_ring_module.has_sizeof_inst
- lie_module.has_sizeof_inst
- lie_hom.has_sizeof_inst
- lie_equiv.has_sizeof_inst
- lie_module_hom.has_sizeof_inst
- lie_module_equiv.has_sizeof_inst
- lie_subalgebra.has_sizeof_inst
- lie_submodule.has_sizeof_inst
- is_jordan.has_sizeof_inst
- is_comm_jordan.has_sizeof_inst
- ring_quot.has_sizeof_inst
- cartan_matrix.generators.has_sizeof_inst
- bilin_form.has_sizeof_inst
- linear_recurrence.has_sizeof_inst
- is_dedekind_domain.height_one_spectrum.has_sizeof_inst
- category_theory.injective_presentation.has_sizeof_inst
- module.Baer.extension_of.has_sizeof_inst
- basis.smith_normal_form.has_sizeof_inst
- order_add_monoid_hom.has_sizeof_inst
- order_add_monoid_hom_class.has_sizeof_inst
- order_monoid_hom.has_sizeof_inst
- order_monoid_hom_class.has_sizeof_inst
- order_monoid_with_zero_hom.has_sizeof_inst
- order_monoid_with_zero_hom_class.has_sizeof_inst
- order_ring_hom.has_sizeof_inst
- order_ring_iso.has_sizeof_inst
- order_ring_hom_class.has_sizeof_inst
- order_ring_iso_class.has_sizeof_inst
- conditionally_complete_linear_ordered_field.has_sizeof_inst
- shelf.has_sizeof_inst
- shelf_hom.has_sizeof_inst
- rack.has_sizeof_inst
- quandle.has_sizeof_inst
- rack.pre_envel_group.has_sizeof_inst
- rack.pre_envel_group_rel'.has_sizeof_inst
- quaternion_algebra.has_sizeof_inst
- quaternion_algebra.basis.has_sizeof_inst
- is_CHSH_tuple.has_sizeof_inst
- non_unital_star_alg_hom.has_sizeof_inst
- non_unital_star_alg_hom_class.has_sizeof_inst
- star_alg_hom.has_sizeof_inst
- star_alg_hom_class.has_sizeof_inst
- star_subalgebra.has_sizeof_inst
- continuous_multilinear_map.has_sizeof_inst
- box_integral.box.has_sizeof_inst
- box_integral.prepartition.has_sizeof_inst
- box_integral.tagged_prepartition.has_sizeof_inst
- box_integral.integration_params.has_sizeof_inst
- box_integral.box_additive_map.has_sizeof_inst
- measurable_space.has_sizeof_inst
- measurable_space.dynkin_system.has_sizeof_inst
- measure_theory.outer_measure.has_sizeof_inst
- measure_theory.measure.has_sizeof_inst
- measure_theory.measure_space.has_sizeof_inst
- measurable_equiv.has_sizeof_inst
- measure_theory.measure.finite_spanning_sets_in.has_sizeof_inst
- matrix.transvection_struct.has_sizeof_inst
- has_measurable_pow.has_sizeof_inst
- urysohns.CU.has_sizeof_inst
- bounded_continuous_function.has_sizeof_inst
- bounded_continuous_map_class.has_sizeof_inst
- measure_theory.simple_func.has_sizeof_inst
- affine.simplex.has_sizeof_inst
- affine_basis.has_sizeof_inst
- continuous_linear_map.nonlinear_right_inverse.has_sizeof_inst
- has_inner.has_sizeof_inst
- inner_product_space.has_sizeof_inst
- inner_product_space.core.has_sizeof_inst
- stieltjes_function.has_sizeof_inst
- continuous_affine_map.has_sizeof_inst
- implicit_function_data.has_sizeof_inst
- convex_cone.has_sizeof_inst
- measure_theory.content.has_sizeof_inst
- orthonormal_basis.has_sizeof_inst
- cont_diff_bump_of_inner.has_sizeof_inst
- cont_diff_bump.has_sizeof_inst
- topological_fiber_bundle.pretrivialization.has_sizeof_inst
- topological_fiber_bundle.trivialization.has_sizeof_inst
- topological_fiber_bundle_core.has_sizeof_inst
- topological_fiber_prebundle.has_sizeof_inst
- group_filter_basis.has_sizeof_inst
- add_group_filter_basis.has_sizeof_inst
- ring_filter_basis.has_sizeof_inst
- module_filter_basis.has_sizeof_inst
- seminorm.has_sizeof_inst
- shrinking_lemma.partial_refinement.has_sizeof_inst
- partition_of_unity.has_sizeof_inst
- bump_covering.has_sizeof_inst
- geometry.simplicial_complex.has_sizeof_inst
- hilbert_basis.has_sizeof_inst
- derivation.has_sizeof_inst
- module.oriented.has_sizeof_inst
- enorm.has_sizeof_inst
- picard_lindelof.has_sizeof_inst
- picard_lindelof.fun_space.has_sizeof_inst
- vitali_family.has_sizeof_inst
- measure_theory.vector_measure.has_sizeof_inst
- measure_theory.jordan_decomposition.has_sizeof_inst
- besicovitch.satellite_config.has_sizeof_inst
- besicovitch.ball_package.has_sizeof_inst
- besicovitch.tau_package.has_sizeof_inst
- upgraded_polish_space.has_sizeof_inst
- wstar_algebra.has_sizeof_inst
- von_neumann_algebra.has_sizeof_inst
- category_theory.ProjectiveResolution.has_sizeof_inst
- category_theory.InjectiveResolution.has_sizeof_inst
- semidirect_product.has_sizeof_inst
- category_theory.additive_category.has_sizeof_inst
- category_theory.limits.walking_parallel_family.has_sizeof_inst
- category_theory.limits.walking_parallel_family.hom.has_sizeof_inst
- category_theory.is_kernel_pair.has_sizeof_inst
- category_theory.monad.has_sizeof_inst
- category_theory.comonad.has_sizeof_inst
- category_theory.monad_hom.has_sizeof_inst
- category_theory.comonad_hom.has_sizeof_inst
- category_theory.monad.algebra.has_sizeof_inst
- category_theory.monad.algebra.hom.has_sizeof_inst
- category_theory.comonad.coalgebra.has_sizeof_inst
- category_theory.comonad.coalgebra.hom.has_sizeof_inst
- category_theory.monadic_right_adjoint.has_sizeof_inst
- category_theory.comonadic_left_adjoint.has_sizeof_inst
- category_theory.oplax_nat_trans.has_sizeof_inst
- category_theory.oplax_nat_trans.modification.has_sizeof_inst
- two_pointing.has_sizeof_inst
- Twop.has_sizeof_inst
- category_theory.cartesian_closed_functor.has_sizeof_inst
- category_theory.unbundled_hom.has_sizeof_inst
- category_theory.sigma.sigma_hom.has_sizeof_inst
- category_theory.endofunctor.algebra.has_sizeof_inst
- category_theory.endofunctor.algebra.hom.has_sizeof_inst
- category_theory.endofunctor.coalgebra.has_sizeof_inst
- category_theory.endofunctor.coalgebra.hom.has_sizeof_inst
- category_theory.half_braiding.has_sizeof_inst
- category_theory.center.hom.has_sizeof_inst
- category_theory.enriched_category.has_sizeof_inst
- category_theory.enriched_functor.has_sizeof_inst
- category_theory.graded_nat_trans.has_sizeof_inst
- category_theory.grothendieck.has_sizeof_inst
- category_theory.grothendieck.hom.has_sizeof_inst
- category_theory.limits.diagram_of_cones.has_sizeof_inst
- category_theory.limits.coproduct_disjoint.has_sizeof_inst
- category_theory.limits.coproducts_disjoint.has_sizeof_inst
- category_theory.localization.construction.loc_quiver.has_sizeof_inst
- Mon_.has_sizeof_inst
- Mon_.hom.has_sizeof_inst
- CommMon_.has_sizeof_inst
- Mod.has_sizeof_inst
- Mod.hom.has_sizeof_inst
- category_theory.noetherian.has_sizeof_inst
- category_theory.artinian.has_sizeof_inst
- category_theory.Mat_.has_sizeof_inst
- category_theory.grothendieck_topology.subpresheaf.has_sizeof_inst
- category_theory.triangulated.triangle.has_sizeof_inst
- category_theory.triangulated.triangle_morphism.has_sizeof_inst
- category_theory.triangulated.pretriangulated.has_sizeof_inst
- category_theory.triangulated.pretriangulated.triangulated_functor_struct.has_sizeof_inst
- category_theory.triangulated.pretriangulated.triangulated_functor.has_sizeof_inst
- category_theory.with_terminal.has_sizeof_inst
- category_theory.with_initial.has_sizeof_inst
- configuration.has_points.has_sizeof_inst
- configuration.has_lines.has_sizeof_inst
- configuration.projective_plane.has_sizeof_inst
- combinatorics.line.has_sizeof_inst
- combinatorics.line.almost_mono.has_sizeof_inst
- combinatorics.line.color_focused.has_sizeof_inst
- quiver.total.has_sizeof_inst
- quiver.arborescence.has_sizeof_inst
- quiver.has_reverse.has_sizeof_inst
- upper_set.has_sizeof_inst
- lower_set.has_sizeof_inst
- simple_graph.has_sizeof_inst
- simple_graph.dart.has_sizeof_inst
- simple_graph.subgraph.has_sizeof_inst
- simple_graph.walk.has_sizeof_inst
- finpartition.has_sizeof_inst
- indexed_partition.has_sizeof_inst
- simple_graph.partition.has_sizeof_inst
- young_diagram.has_sizeof_inst
- primcodable.has_sizeof_inst
- DFA.has_sizeof_inst
- nzsnum.has_sizeof_inst
- snum.has_sizeof_inst
- computability.encoding.has_sizeof_inst
- computability.fin_encoding.has_sizeof_inst
- computability.Γ'.has_sizeof_inst
- NFA.has_sizeof_inst
- ε_NFA.has_sizeof_inst
- nat.partrec.code.has_sizeof_inst
- regular_expression.has_sizeof_inst
- turing.pointed_map.has_sizeof_inst
- turing.tape.has_sizeof_inst
- turing.dir.has_sizeof_inst
- turing.TM0.stmt.has_sizeof_inst
- turing.TM0.cfg.has_sizeof_inst
- turing.TM1.stmt.has_sizeof_inst
- turing.TM1.cfg.has_sizeof_inst
- turing.TM1to1.Λ'.has_sizeof_inst
- turing.TM0to1.Λ'.has_sizeof_inst
- turing.TM2.stmt.has_sizeof_inst
- turing.TM2.cfg.has_sizeof_inst
- turing.TM2to1.st_act.has_sizeof_inst
- turing.TM2to1.Λ'.has_sizeof_inst
- turing.fin_tm2.has_sizeof_inst
- turing.evals_to.has_sizeof_inst
- turing.evals_to_in_time.has_sizeof_inst
- turing.tm2_computable_aux.has_sizeof_inst
- turing.tm2_computable.has_sizeof_inst
- turing.tm2_computable_in_time.has_sizeof_inst
- turing.tm2_computable_in_poly_time.has_sizeof_inst
- turing.to_partrec.code.has_sizeof_inst
- turing.to_partrec.cont.has_sizeof_inst
- turing.to_partrec.cfg.has_sizeof_inst
- turing.partrec_to_TM2.Γ'.has_sizeof_inst
- turing.partrec_to_TM2.K'.has_sizeof_inst
- turing.partrec_to_TM2.cont'.has_sizeof_inst
- turing.partrec_to_TM2.Λ'.has_sizeof_inst
- bitraversable.has_sizeof_inst
- is_lawful_bitraversable.has_sizeof_inst
- has_fix.has_sizeof_inst
- fin2.has_sizeof_inst
- fin2.is_lt.has_sizeof_inst
- mvfunctor.has_sizeof_inst
- lawful_fix.has_sizeof_inst
- writer_t.has_sizeof_inst
- monad_writer.has_sizeof_inst
- monad_writer_adapter.has_sizeof_inst
- monad_cont.label.has_sizeof_inst
- monad_cont.has_sizeof_inst
- is_lawful_monad_cont.has_sizeof_inst
- uliftable.has_sizeof_inst
- bounded_random.has_sizeof_inst
- random.has_sizeof_inst
- cfilter.has_sizeof_inst
- filter.realizer.has_sizeof_inst
- ctop.has_sizeof_inst
- ctop.realizer.has_sizeof_inst
- locally_finite.realizer.has_sizeof_inst
- parse_result.has_sizeof_inst
- fin_enum.has_sizeof_inst
- finmap.has_sizeof_inst
- semiquot.has_sizeof_inst
- fp.rmode.has_sizeof_inst
- fp.float_cfg.has_sizeof_inst
- fp.float.has_sizeof_inst
- hash_map.has_sizeof_inst
- ordnode.has_sizeof_inst
- W_type.has_sizeof_inst
- pfunctor.has_sizeof_inst
- mvpfunctor.has_sizeof_inst
- pfunctor.approx.cofix_a.has_sizeof_inst
- pfunctor.M_intl.has_sizeof_inst
- mvpfunctor.M.path.has_sizeof_inst
- mvpfunctor.W_path.has_sizeof_inst
- pnat.xgcd_type.has_sizeof_inst
- pnat.xgcd_type.has_sizeof
- mvqpf.has_sizeof_inst
- qpf.has_sizeof_inst
- has_finite_inter.has_sizeof_inst
- W_type.nat_α.has_sizeof_inst
- W_type.list_α.has_sizeof_inst
- circle_deg1_lift.has_sizeof_inst
- flow.has_sizeof_inst
- open_add_subgroup.has_sizeof_inst
- open_subgroup.has_sizeof_inst
- affine.simplex.points_with_circumcenter_index.has_sizeof_inst
- structure_groupoid.has_sizeof_inst
- pregroupoid.has_sizeof_inst
- charted_space.has_sizeof_inst
- charted_space_core.has_sizeof_inst
- structomorph.has_sizeof_inst
- topological_vector_bundle.pretrivialization.has_sizeof_inst
- topological_vector_bundle.trivialization.has_sizeof_inst
- topological_vector_bundle.has_sizeof_inst
- topological_vector_bundle_core.has_sizeof_inst
- topological_vector_prebundle.has_sizeof_inst
- model_with_corners.has_sizeof_inst
- basic_smooth_vector_bundle_core.has_sizeof_inst
- cont_mdiff_map.has_sizeof_inst
- smooth_add_monoid_morphism.has_sizeof_inst
- smooth_monoid_morphism.has_sizeof_inst
- left_invariant_derivation.has_sizeof_inst
- smooth_bump_function.has_sizeof_inst
- locally_constant.has_sizeof_inst
- diffeomorph.has_sizeof_inst
- smooth_bump_covering.has_sizeof_inst
- smooth_partition_of_unity.has_sizeof_inst
- divisible_by.has_sizeof_inst
- rootable_by.has_sizeof_inst
- is_free_group.has_sizeof_inst
- free_product.word.has_sizeof_inst
- free_product.word.pair.has_sizeof_inst
- free_product.neword.has_sizeof_inst
- is_free_groupoid.has_sizeof_inst
- sylow.has_sizeof_inst
- dihedral_group.has_sizeof_inst
- quaternion_group.has_sizeof_inst
- quadratic_form.has_sizeof_inst
- quadratic_form.isometry.has_sizeof_inst
- clifford_algebra.even_hom.has_sizeof_inst
- projectivization.subspace.has_sizeof_inst
- first_order.language.has_sizeof_inst
- first_order.language.Structure.has_sizeof_inst
- first_order.language.hom.has_sizeof_inst
- first_order.language.embedding.has_sizeof_inst
- first_order.language.equiv.has_sizeof_inst
- first_order.language.hom_class.has_sizeof_inst
- first_order.language.strong_hom_class.has_sizeof_inst
- first_order.language.Lhom.has_sizeof_inst
- first_order.language.Lequiv.has_sizeof_inst
- first_order.language.term.has_sizeof_inst
- first_order.language.bounded_formula.has_sizeof_inst
- first_order.language.substructure.has_sizeof_inst
- first_order.language.elementary_embedding.has_sizeof_inst
- first_order.language.elementary_substructure.has_sizeof_inst
- first_order.language.Theory.Model.has_sizeof_inst
- first_order.language.prestructure.has_sizeof_inst
- first_order.language.is_ordered.has_sizeof_inst
- absolute_value.is_admissible.has_sizeof_inst
- valued.has_sizeof_inst
- zsqrtd.has_sizeof_inst
- add_char.primitive_add_char.has_sizeof_inst
- mul_char.has_sizeof_inst
- mul_char_class.has_sizeof_inst
- slash_action.has_sizeof_inst
- FinPartialOrder.has_sizeof_inst
- FinBoolAlg.has_sizeof_inst
- CompHaus.has_sizeof_inst
- has_btw.has_sizeof_inst
- has_sbtw.has_sizeof_inst
- circular_preorder.has_sizeof_inst
- circular_partial_order.has_sizeof_inst
- circular_order.has_sizeof_inst
- concept.has_sizeof_inst
- order.ideal.has_sizeof_inst
- order.cofinal.has_sizeof_inst
- grade_order.has_sizeof_inst
- grade_min_order.has_sizeof_inst
- grade_max_order.has_sizeof_inst
- grade_bounded_order.has_sizeof_inst
- jordan_holder_lattice.has_sizeof_inst
- composition_series.has_sizeof_inst
- order.pfilter.has_sizeof_inst
- order.ideal.prime_pair.has_sizeof_inst
- measure_theory.filtration.has_sizeof_inst
- Action.has_sizeof_inst
- Action.hom.has_sizeof_inst
- valuation_subring.has_sizeof_inst
- ideal.filtration.has_sizeof_inst
- ore_localization.ore_set.has_sizeof_inst
- ring_invo.has_sizeof_inst
- witt_vector.has_sizeof_inst
- witt_vector.isocrystal.has_sizeof_inst
- witt_vector.isocrystal_hom.has_sizeof_inst
- witt_vector.isocrystal_equiv.has_sizeof_inst
- pgame.has_sizeof_inst
- pgame.restricted.has_sizeof_inst
- pgame.relabelling.has_sizeof_inst
- pgame.inv_ty.has_sizeof_inst
- pgame.short.has_sizeof_inst
- pgame.list_short.has_sizeof_inst
- pgame.state.has_sizeof_inst
- lists'.has_sizeof_inst
- lists.has_sizeof
- onote.has_sizeof_inst
- pSet.has_sizeof_inst
- pSet.definable.has_sizeof_inst
- omega.ee.has_sizeof_inst
- omega.ee_state.has_sizeof_inst
- omega.int.preterm.has_sizeof_inst
- omega.int.preform.has_sizeof_inst
- omega.nat.preterm.has_sizeof_inst
- omega.nat.preform.has_sizeof_inst
- polyrith.poly.has_sizeof_inst
- polyrith.sage_json_success.has_sizeof_inst
- polyrith.sage_json_failure.has_sizeof_inst
- has_variable_names.has_sizeof_inst
- tactic.eliminate.generalization_mode.has_sizeof_inst
- side.has_sizeof_inst
- tactic.rewrite_search.side.has_sizeof_inst
- tactic.rewrite_search.dir_pair.has_sizeof_inst
- _nest_2_2.tactic.rewrite_search.using_conv.app_addr._mut_.has_sizeof_inst
- _nest_2_2.tactic.rewrite_search.using_conv.app_addr.has_sizeof_inst
- _nest_2_2.option.tactic.rewrite_search.using_conv.app_addr.has_sizeof_inst
- _nest_2_1.tactic.rewrite_search._nest_1_1.tactic.rewrite_search.using_conv.app_addr.dir_pair.has_sizeof_inst
- _nest_1_1.tactic.rewrite_search.using_conv.app_addr.has_sizeof_inst
- _nest_1_1.option.tactic.rewrite_search.using_conv.app_addr.has_sizeof_inst
- tactic.rewrite_search.using_conv.app_addr.has_sizeof_inst
- tactic.rewrite_search.using_conv.splice_result.has_sizeof_inst
- tactic.ring2.csring_expr.has_sizeof_inst
- tactic.ring2.horner_expr.has_sizeof_inst
- slim_check.sampleable.has_sizeof_inst
- slim_check.sampleable_functor.has_sizeof_inst
- slim_check.sampleable_bifunctor.has_sizeof_inst
- slim_check.sampleable_ext.has_sizeof_inst
- slim_check.test_result.has_sizeof_inst
- slim_check.slim_check_cfg.has_sizeof_inst
- slim_check.printable_prop.has_sizeof_inst
- slim_check.testable.has_sizeof_inst
- slim_check.total_function.has_sizeof_inst
- slim_check.injective_function.has_sizeof_inst
- slim_check.injective_function.has_sizeof
- continuous_add_monoid_hom.has_sizeof_inst
- continuous_monoid_hom.has_sizeof_inst
- continuous_add_monoid_hom_class.has_sizeof_inst
- continuous_monoid_hom_class.has_sizeof_inst
- with_ideal.has_sizeof_inst
- Profinite.has_sizeof_inst
- discrete_quotient.has_sizeof_inst
- CpltSepUniformSpace.has_sizeof_inst
- cocompact_map.has_sizeof_inst
- cocompact_map_class.has_sizeof_inst
- zero_at_infty_continuous_map.has_sizeof_inst
- zero_at_infty_continuous_map_class.has_sizeof_inst
- continuous_open_map.has_sizeof_inst
- continuous_open_map_class.has_sizeof_inst
- gen_loop.has_sizeof_inst
- Gromov_Hausdorff.aux_gluing_struct.has_sizeof_inst
- continuous_order_hom.has_sizeof_inst
- continuous_order_hom_class.has_sizeof_inst
- pseudo_epimorphism.has_sizeof_inst
- esakia_hom.has_sizeof_inst
- pseudo_epimorphism_class.has_sizeof_inst
- esakia_hom_class.has_sizeof_inst
- priestley_space.has_sizeof_inst
- clopen_upper_set.has_sizeof_inst
- uniform_equiv.has_sizeof_inst
- module_doc_info.has_sizeof_inst
- ext_tactic_doc_entry.has_sizeof_inst
- slim_check.total_function.has_sizeof
Equations
- default_has_sizeof α = {sizeof := default.sizeof α}
Equations
- nat.has_sizeof = {sizeof := nat.sizeof}
Equations
- prod.has_sizeof α β = {sizeof := prod.sizeof _inst_2}
Equations
- sum.has_sizeof α β = {sizeof := sum.sizeof _inst_2}
Equations
- psum.has_sizeof α β = {sizeof := psum.sizeof _inst_2}
Equations
- sigma.has_sizeof α β = {sizeof := sigma.sizeof (λ (a : α), _inst_2 a)}
Equations
- psigma.has_sizeof α β = {sizeof := psigma.sizeof (λ (a : α), _inst_2 a)}
Equations
- punit.has_sizeof = {sizeof := punit.sizeof}
Equations
- bool.has_sizeof = {sizeof := bool.sizeof}
Equations
- option.has_sizeof α = {sizeof := option.sizeof _inst_1}
Equations
- list.has_sizeof α = {sizeof := list.sizeof _inst_1}
Equations
- subtype.has_sizeof p = {sizeof := subtype.sizeof p}
Equations
- combinator.K a b = a
Equations
- combinator.S x y z = x z (y z)
- empty : Π {α : Type u}, bin_tree α
- leaf : Π {α : Type u}, α → bin_tree α
- node : Π {α : Type u}, bin_tree α → bin_tree α → bin_tree α
Auxiliary datatype for #[ ... ] notation. #[1, 2, 3, 4] is notation for
bin_tree.node (bin_tree.node (bin_tree.leaf 1) (bin_tree.leaf 2)) (bin_tree.node (bin_tree.leaf 3) (bin_tree.leaf 4))
We use this notation to input long sequences without exhausting the system stack space.
Later, we define a coercion from bin_tree into list.
Instances for bin_tree
        
        - bin_tree.has_sizeof_inst
- list.bin_tree_to_list
- bin_tree.inhabited
- bin_tree.has_variable_names
Like by apply_instance, but not dependent on the tactic framework.